cuibm A GPU Accelerated Immersed Boundary Method

Size: px
Start display at page:

Download "cuibm A GPU Accelerated Immersed Boundary Method"

Transcription

1 cuibm A GPU Accelerated Immersed Boundary Method S. K. Layton, A. Krishnan and L. A. Barba Corresponding author: labarba@bu.edu Department of Mechanical Engineering, Boston University, Boston, MA, 225, USA. Abstract: A projection-based immersed boundary method (IBM) is dominated by sparse linear algebra routines. Using the open-source CUSP library, we observe a speedup with respect to a single CPU core which reflects the constraints of a bandwidth-dominated problem on the GPU. Nevertheless, GPUs offer the capacity to solve large problems on commodity hardware. This work includes validation and a convergence study of the GPU-accelerated IBM, and various optimizations. Keywords: Immersed Boundary, Computational Fluid Dynamics, GPU Computing. Introduction Conventional CFD techniques require the generation of a mesh that conforms to the geometry of any boundaries in the fluid domain. The immersed boundary method (IBM), in contrast, allows using a grid that does not conform to solid boundaries. In the IBM, the fluid is represented by an Eulerian grid (typically a Cartesian grid) and the solid boundary points are represented by a collection of Lagrangian points. This has several advantages. Mesh generation is trivial, and simulations involving moving solid bodies and boundaries are made simpler. The Navier-Stokes equations are solved on the entire grid (including points within the solid), and the effect of the solid body is modelled by adding a singular force distribution f along the solid boundary to the fluid which enforces the no-slip condition. The governing equations are: u t + u u = p + ν u + f(ξ(s, t))δ(ξ x)ds, s u =, u(ξ(s, t)) = u(x)δ(x ξ)dx = u B (ξ(s, t)), s where u B is the velocity of the body at the boundary point locations. The different IBM formulations use different techniques to calculate the forcing term, f. The IBM was introduced in 972 by Peskin [3] to model blood flow within the elastic membranes of the heart. It experienced a revival in the 99s thanks to increased computational capacity and growing interest in moving-boundary problems. The reader can find various IBM formulations described in the 25 review by Mittal and Iaccarino []. In the present work, we implement the algorithm presented in [4] for the solution of two-dimensional incompressible viscous flows with immersed boundaries, explained in detail in 2. To our knowledge, the IBM has not previously been implemented on the GPU. The perspective of doing so is the capacity of solving large three-dimensional moving boundary problems on commodity hardware. (a) (b) (c)

2 2 Immersed Boundary Projection Method The Navier-Stokes equations (a)-(c) are discretized on a staggered grid and we obtain the following set of algebraic equations: Âu n+ ˆr n = Ĝφ + ˆbc + Ĥf ˆDu n+ = bc 2 (2a) (2b) Êu n+ = u n+ B. (2c) Here, φ and f are vectors containing the pressure and the values of the singular force at the boundary points of the immersed boundary respectively. The velocity at the current time step u n is known; ˆbc and bc 2 are obtained from the boundary conditions on the velocity; Ĥ and Ê are the regularization and interpolation matrices respectively. These matrices are used to transfer values of the flow variables between the Eulerian and Lagrangian grids. The above system of equations can be solved to obtain the velocity field at time step n +, the pressure (to a constant) and the body forces. But the left-hand side matrix is indefinite, and solving the system directly would be ill-advised. For time stepping, an explicit second order Adams-Bashforth scheme is used for the convection terms and Crank-Nicolson is used for diffusion. All spatial derivatives are calculated using central differences. By performing appropriate transformations (see [4] for details), one can show that the above system is equivalent to: ( A Q Q T ) ( q n+ λ ) = ( r r 2 ), (3) where q n+ is the momentum flux at each cell boundary and λ is a vector containing both the pressure and the body force values. Consider an N th order approximation of the inverse of matrix A, given by B N. We can now perform the same factorisation as described in [2] to obtain the following set of equations, which can be solved to obtain the velocity distribution at time step n + : Aq = r Q T B N Qλ = Q T q r 2 q n+ = q B N Qλ (4a) (4b) (4c) Only the left hand side of (3) is affected by the factorisation, and hence r and r 2 remain the same. This factorisation is very advantageous as the two linear systems (4a) and (4b) that we now need to solve can be made positive definite, and can be solved efficiently using the conjugate gradient method. In the absence of an immersed boundary, this set of equations is the same as that solved in the traditional fractional step method or projection method [2]. The projection step (4c) simultaneously ensures a divergence-free velocity field and that the no-slip condition on the immersed boundary is satisfied in the next time step. 3 Implementation The matrices A, Q and Q T are sparse, the vectors q n+ and λ are dense, and all operations require tools for sparse linear algebra. To take advantage of the GPU, we need some way of both representing and operating on these matrices and vectors on the device. Currently, there are two main choices for this: CUSPARSE, part of NVIDIA s CUDA, or the external library, CUSP. The CUSP library is being developed by several NVIDIA employees with minimal software dependencies and released freely under an open-

3 Time [s] Average over timesteps (a) Timing breakdown AXPY Apply BCs Conversion Force Calculation Force Output Generate bc Generate r2 Generate rn MMM Mat vec Mem Transfer Output Preconditioner Solve Solve 2 Transfer q Transpose Update B Update QT Time [s] CPU GPU 2 # of unknowns 3 4 x 6 (b) Solving linear equations Figure : (a) Timing breakdown for flow past a cylinder at Re = 4 using the GPU code. (b) Comparison of time taken to solve a system of linear equations Ax = b on the CPU and GPU. A is chosen as the standard 5-pt Poisson stencil. source license. We use the CUSP library for several reasons: it is actively developed and separate from the main CUDA distribution, allowing for faster addition of new features (such as new pre-conditioners, solvers, etc.); and, all objects/methods from the library are usable on both CPU and GPU. This allows us the flexibility to, for example, perform branching-heavy code on the CPU, before trivially transferring to the device and running (for instance) a linear solve, where it will be significantly faster. It also allows us to maintain both a CPU and GPU code. Figure (a) shows a breakdown of the timings from an example run ( time steps of flow past a cylinder at Re = 4). The mesh comprises of 4 8 cells, resulting in systems of over 3, unknowns. Even in this relatively small test, the time is dominated by the solution of a linear system, denoted by Solve 2. Speeding up this linear solve is the major motivation for using the GPU. Figure (b) shows a timing comparison between the CPU and GPU using CUSP s conjugate gradient solver. The system being solved in this case is given by a traditional 5-point Poisson stencil, which while not directly used in the IBM code, gives a good measure of relative performance. The plot shows the wall-clock time required to solve to a relative accuracy of 5 for numbers of unknowns ranging from 25 to 4 6. For large systems, the GPU solve is significantly faster, with a speedup of 8 for the largest system shown. Our choice of tools allows us to easily perform all sparse linear algebra operations on the GPU. On the other hand, there are parts of the algorithm that cannot easily be expressed using linear algebra, such as generating the convection term using a finite-difference stencil and applying boundary conditions to the velocities (which involves modifying select values of appropriate arrays). One possible way of performing these actions is to transfer data from the GPU, do the calculations on the CPU and transfer the modified vector(s) back to the GPU every time step this incurs a prohibitively high cost in memory transfers. The alternative is to use custom-written CUDA kernels utilizing all appropriate techniques, including the use of shared memory, to perform these operations on the GPU. This requires access to the underlying data from the CUSP data structures, and can be done using the Thrust library, on which CUSP was built. The combination of accelerated linear algebra and custom kernels on the GPU has resulted in initial runs showing up to 7 speedup over our equivalent CPU code, for the problem sizes we ran. This is almost as good as the 8 speedup experienced by the 5-point Poisson solver in Figure (b).

4 4 Validation 4. Couette flow between concentric cylinders As a validation test, we calculate the flow between two concentric cylinders of radius r i =.5 and r o = centered at the origin. The outer cylinder is held stationary while the inner cylinder is impulsively rotated from rest with an angular velocity of Ω =.5. The cylinders are contained in a square stationary box of side.5 centered at the origin. The fluid in the entire domain is initially at rest and the calculations were carried out for kinematic viscosity ν =.3. The steady-state analytical solution for this flow is known. The velocity distribution in the interior of the inner cylinder is the same as for solid body rotation and the azimuthal velocity between the two cylinders is given by: u θ (r) = Ωr i (r o /r r/r o ) (r o /r i r i /r o ). (5) We compared this to the numerical solution for six different grid sizes ranging from to Table shows the L 2 and L norms of the relative errors and Figure 2(b) shows that the scheme is first-order accurate in space, as expected for the IBM formulation we used x5 grid Analytical Solution L-2 norm L-inf norm st Order convergence u (r).2.5. Error norm r (a)... (b) Cell width Figure 2: (a) Comparison of the numerical solution on a 5 5 grid with the analytical solution and (b) convergence study, showing errors for different grid sizes. To verify the temporal order of convergence, we ran a simulation from t = to t = 8 on a 5 5 grid, using different time steps ( t =.,.5 and.25). Both first- and third-order accurate expansions of B N were used and the calculated orders of convergence (using the L 2 norms of the differences in the solutions) at various times have been summarised in Table, and are as expected. Order of convergence Order of convergence Time (N = ) (N = 3) Table : Calculated order of convergence at different times for Couette-flow validation.

5 Drag Coefficient Time (a) (b) Figure 3: Steady state vorticity field (a) and time varying drag coefficient (b) for external flow over a circular cylinder at Reynolds number 4. The contour lines in (a) are drawn from -3 to 3 in steps of External flow over a circular cylinder We also carried out computations to simulate external flow over a circular cylinder at Reynolds number 4. The cylinder is of diameter d = centered at the origin and is placed in an external flow with freestream velocity u =. The simulation was carried out on a 2 2 grid with uniform cell spacing in the entire domain, which was a square with opposite corners at ( 5, 5) and (5, 5). The velocity at the inlet, top and bottom of the domain was fixed to the freestream velocity and the outlet boundary condition used was u t + u u x =. The initial condition was a uniform velocity field in the entire domain. The vorticity field obtained for this case is shown in Figure 3(a) and the time varying drag coefficient is plotted in Figure 3(b). The drag coefficient at steady state is found to be.6, which is in good agreement with the expected value [5]. 5 Conclusions and Future Work At this time, we have a validated GPU code for the projection IBM, and we have shown convergence with the expected rates. Using the free and open-source CUSP and Thrust libraries to provide sparse linear algebra functionality, a speedup of 7 over the equivalent CPU code was obtained for the largest tested problem. In the final paper we will provide a more extensive study of optimizations, timing and breakdowns and demonstrate moving boundary applications. References [] R. Mittal and G. Iaccarino. Immersed boundary methods. Ann. Rev. Fluid Mech., 37():239 26, 25. [2] J. B. Perot. An analysis of the fractional step method. J. Comp. Phys., 8():5 58, 993. [3] C.S. Peskin. Flow patterns around heart valves: A numerical method. J. Comp. Phys., (2):252 27, 972. [4] K. Taira and T. Colonius. The immersed boundary method: A projection approach. J. Comp. Phys., 225(2):28 237, 27. [5] D. J. Tritton. Experiments on the flow past a circular cylinder at low Reynolds numbers. J. Fluid Mech., 6(4): , 959.

arxiv: v2 [cs.ce] 9 Apr 2016

arxiv: v2 [cs.ce] 9 Apr 2016 cuibm A GPU-accelerated Immersed Boundary Method S. K. Layton a, Anush Krishnan a, L. A. Barba a, a Department of Mechanical Engineering, Boston University, Boston, MA, 5, USA. arxiv:9.354v [cs.ce] 9 Apr

More information

Investigation of cross flow over a circular cylinder at low Re using the Immersed Boundary Method (IBM)

Investigation of cross flow over a circular cylinder at low Re using the Immersed Boundary Method (IBM) Computational Methods and Experimental Measurements XVII 235 Investigation of cross flow over a circular cylinder at low Re using the Immersed Boundary Method (IBM) K. Rehman Department of Mechanical Engineering,

More information

ALE Seamless Immersed Boundary Method with Overset Grid System for Multiple Moving Objects

ALE Seamless Immersed Boundary Method with Overset Grid System for Multiple Moving Objects Tenth International Conference on Computational Fluid Dynamics (ICCFD10), Barcelona,Spain, July 9-13, 2018 ICCFD10-047 ALE Seamless Immersed Boundary Method with Overset Grid System for Multiple Moving

More information

Driven Cavity Example

Driven Cavity Example BMAppendixI.qxd 11/14/12 6:55 PM Page I-1 I CFD Driven Cavity Example I.1 Problem One of the classic benchmarks in CFD is the driven cavity problem. Consider steady, incompressible, viscous flow in a square

More information

The Immersed Interface Method

The Immersed Interface Method The Immersed Interface Method Numerical Solutions of PDEs Involving Interfaces and Irregular Domains Zhiiin Li Kazufumi Ito North Carolina State University Raleigh, North Carolina Society for Industrial

More information

An Accurate Cartesian Grid Method for Viscous Incompressible Flows with Complex Immersed Boundaries

An Accurate Cartesian Grid Method for Viscous Incompressible Flows with Complex Immersed Boundaries Journal of Computational Physics 156, 209 240 (1999) Article ID jcph.1999.6356, available online at http://www.idealibrary.com on An Accurate Cartesian Grid Method for Viscous Incompressible Flows with

More information

An Embedded Boundary Method with Adaptive Mesh Refinements

An Embedded Boundary Method with Adaptive Mesh Refinements An Embedded Boundary Method with Adaptive Mesh Refinements Marcos Vanella and Elias Balaras 8 th World Congress on Computational Mechanics, WCCM8 5 th European Congress on Computational Methods in Applied

More information

MESHLESS SOLUTION OF INCOMPRESSIBLE FLOW OVER BACKWARD-FACING STEP

MESHLESS SOLUTION OF INCOMPRESSIBLE FLOW OVER BACKWARD-FACING STEP Vol. 12, Issue 1/2016, 63-68 DOI: 10.1515/cee-2016-0009 MESHLESS SOLUTION OF INCOMPRESSIBLE FLOW OVER BACKWARD-FACING STEP Juraj MUŽÍK 1,* 1 Department of Geotechnics, Faculty of Civil Engineering, University

More information

Computational Study of Laminar Flowfield around a Square Cylinder using Ansys Fluent

Computational Study of Laminar Flowfield around a Square Cylinder using Ansys Fluent MEGR 7090-003, Computational Fluid Dynamics :1 7 Spring 2015 Computational Study of Laminar Flowfield around a Square Cylinder using Ansys Fluent Rahul R Upadhyay Master of Science, Dept of Mechanical

More information

Development of an Integrated Computational Simulation Method for Fluid Driven Structure Movement and Acoustics

Development of an Integrated Computational Simulation Method for Fluid Driven Structure Movement and Acoustics Development of an Integrated Computational Simulation Method for Fluid Driven Structure Movement and Acoustics I. Pantle Fachgebiet Strömungsmaschinen Karlsruher Institut für Technologie KIT Motivation

More information

Using a Single Rotating Reference Frame

Using a Single Rotating Reference Frame Tutorial 9. Using a Single Rotating Reference Frame Introduction This tutorial considers the flow within a 2D, axisymmetric, co-rotating disk cavity system. Understanding the behavior of such flows is

More information

A singular value decomposition based generalized finite difference method for fluid solid interaction problems

A singular value decomposition based generalized finite difference method for fluid solid interaction problems Fluid Structure Interaction V 25 A singular value decomposition based generalized finite difference method for fluid solid interaction problems P. Yu, K. S. Yeo, X. Y. Wang & S. J. Ang Department of Mechanical

More information

Comparison Between Different Immersed Boundary Conditions for Simulation of Complex Fluid Flows

Comparison Between Different Immersed Boundary Conditions for Simulation of Complex Fluid Flows Copyright 2011 Tech Science Press FDMP, vol.7, no.3, pp.241-258, 2011 Comparison Between Different Immersed Boundary Conditions for Simulation of Complex Fluid Flows A. Mark 1 2, R. Rundqvist 1 and F.

More information

The 3D DSC in Fluid Simulation

The 3D DSC in Fluid Simulation The 3D DSC in Fluid Simulation Marek K. Misztal Informatics and Mathematical Modelling, Technical University of Denmark mkm@imm.dtu.dk DSC 2011 Workshop Kgs. Lyngby, 26th August 2011 Governing Equations

More information

The Development of a Navier-Stokes Flow Solver with Preconditioning Method on Unstructured Grids

The Development of a Navier-Stokes Flow Solver with Preconditioning Method on Unstructured Grids Proceedings of the International MultiConference of Engineers and Computer Scientists 213 Vol II, IMECS 213, March 13-15, 213, Hong Kong The Development of a Navier-Stokes Flow Solver with Preconditioning

More information

Stream Function-Vorticity CFD Solver MAE 6263

Stream Function-Vorticity CFD Solver MAE 6263 Stream Function-Vorticity CFD Solver MAE 66 Charles O Neill April, 00 Abstract A finite difference CFD solver was developed for transient, two-dimensional Cartesian viscous flows. Flow parameters are solved

More information

Axisymmetric Viscous Flow Modeling for Meridional Flow Calculation in Aerodynamic Design of Half-Ducted Blade Rows

Axisymmetric Viscous Flow Modeling for Meridional Flow Calculation in Aerodynamic Design of Half-Ducted Blade Rows Memoirs of the Faculty of Engineering, Kyushu University, Vol.67, No.4, December 2007 Axisymmetric Viscous Flow Modeling for Meridional Flow alculation in Aerodynamic Design of Half-Ducted Blade Rows by

More information

FAST ALGORITHMS FOR CALCULATIONS OF VISCOUS INCOMPRESSIBLE FLOWS USING THE ARTIFICIAL COMPRESSIBILITY METHOD

FAST ALGORITHMS FOR CALCULATIONS OF VISCOUS INCOMPRESSIBLE FLOWS USING THE ARTIFICIAL COMPRESSIBILITY METHOD TASK QUARTERLY 12 No 3, 273 287 FAST ALGORITHMS FOR CALCULATIONS OF VISCOUS INCOMPRESSIBLE FLOWS USING THE ARTIFICIAL COMPRESSIBILITY METHOD ZBIGNIEW KOSMA Institute of Applied Mechanics, Technical University

More information

1.2 Numerical Solutions of Flow Problems

1.2 Numerical Solutions of Flow Problems 1.2 Numerical Solutions of Flow Problems DIFFERENTIAL EQUATIONS OF MOTION FOR A SIMPLIFIED FLOW PROBLEM Continuity equation for incompressible flow: 0 Momentum (Navier-Stokes) equations for a Newtonian

More information

Strömningslära Fluid Dynamics. Computer laboratories using COMSOL v4.4

Strömningslära Fluid Dynamics. Computer laboratories using COMSOL v4.4 UMEÅ UNIVERSITY Department of Physics Claude Dion Olexii Iukhymenko May 15, 2015 Strömningslära Fluid Dynamics (5FY144) Computer laboratories using COMSOL v4.4!! Report requirements Computer labs must

More information

Numerical Simulation of Coupled Fluid-Solid Systems by Fictitious Boundary and Grid Deformation Methods

Numerical Simulation of Coupled Fluid-Solid Systems by Fictitious Boundary and Grid Deformation Methods Numerical Simulation of Coupled Fluid-Solid Systems by Fictitious Boundary and Grid Deformation Methods Decheng Wan 1 and Stefan Turek 2 Institute of Applied Mathematics LS III, University of Dortmund,

More information

Lab 9: FLUENT: Transient Natural Convection Between Concentric Cylinders

Lab 9: FLUENT: Transient Natural Convection Between Concentric Cylinders Lab 9: FLUENT: Transient Natural Convection Between Concentric Cylinders Objective: The objective of this laboratory is to introduce how to use FLUENT to solve both transient and natural convection problems.

More information

Introduction to the immersed boundary method

Introduction to the immersed boundary method Introduction to the immersed boundary method Motivation. Hydrodynamics and boundary conditions The incompressible Navier-Stokes equations, ( ) u ρ + (u )u = p + ρν 2 u + f, () t are partial differential

More information

Solving Partial Differential Equations on Overlapping Grids

Solving Partial Differential Equations on Overlapping Grids **FULL TITLE** ASP Conference Series, Vol. **VOLUME**, **YEAR OF PUBLICATION** **NAMES OF EDITORS** Solving Partial Differential Equations on Overlapping Grids William D. Henshaw Centre for Applied Scientific

More information

Studies of the Continuous and Discrete Adjoint Approaches to Viscous Automatic Aerodynamic Shape Optimization

Studies of the Continuous and Discrete Adjoint Approaches to Viscous Automatic Aerodynamic Shape Optimization Studies of the Continuous and Discrete Adjoint Approaches to Viscous Automatic Aerodynamic Shape Optimization Siva Nadarajah Antony Jameson Stanford University 15th AIAA Computational Fluid Dynamics Conference

More information

A higher-order finite volume method with collocated grid arrangement for incompressible flows

A higher-order finite volume method with collocated grid arrangement for incompressible flows Computational Methods and Experimental Measurements XVII 109 A higher-order finite volume method with collocated grid arrangement for incompressible flows L. Ramirez 1, X. Nogueira 1, S. Khelladi 2, J.

More information

A COUPLED FINITE VOLUME SOLVER FOR THE SOLUTION OF LAMINAR TURBULENT INCOMPRESSIBLE AND COMPRESSIBLE FLOWS

A COUPLED FINITE VOLUME SOLVER FOR THE SOLUTION OF LAMINAR TURBULENT INCOMPRESSIBLE AND COMPRESSIBLE FLOWS A COUPLED FINITE VOLUME SOLVER FOR THE SOLUTION OF LAMINAR TURBULENT INCOMPRESSIBLE AND COMPRESSIBLE FLOWS L. Mangani Maschinentechnik CC Fluidmechanik und Hydromaschinen Hochschule Luzern Technik& Architektur

More information

Numerical Methods in Aerodynamics. Fluid Structure Interaction. Lecture 4: Fluid Structure Interaction

Numerical Methods in Aerodynamics. Fluid Structure Interaction. Lecture 4: Fluid Structure Interaction Fluid Structure Interaction Niels N. Sørensen Professor MSO, Ph.D. Department of Civil Engineering, Alborg University & Wind Energy Department, Risø National Laboratory Technical University of Denmark

More information

Computational Fluid Dynamics - Incompressible Flows

Computational Fluid Dynamics - Incompressible Flows Computational Fluid Dynamics - Incompressible Flows March 25, 2008 Incompressible Flows Basis Functions Discrete Equations CFD - Incompressible Flows CFD is a Huge field Numerical Techniques for solving

More information

Backward facing step Homework. Department of Fluid Mechanics. For Personal Use. Budapest University of Technology and Economics. Budapest, 2010 autumn

Backward facing step Homework. Department of Fluid Mechanics. For Personal Use. Budapest University of Technology and Economics. Budapest, 2010 autumn Backward facing step Homework Department of Fluid Mechanics Budapest University of Technology and Economics Budapest, 2010 autumn Updated: October 26, 2010 CONTENTS i Contents 1 Introduction 1 2 The problem

More information

FEMLAB Exercise 1 for ChE366

FEMLAB Exercise 1 for ChE366 FEMLAB Exercise 1 for ChE366 Problem statement Consider a spherical particle of radius r s moving with constant velocity U in an infinitely long cylinder of radius R that contains a Newtonian fluid. Let

More information

FOURTH ORDER COMPACT FORMULATION OF STEADY NAVIER-STOKES EQUATIONS ON NON-UNIFORM GRIDS

FOURTH ORDER COMPACT FORMULATION OF STEADY NAVIER-STOKES EQUATIONS ON NON-UNIFORM GRIDS International Journal of Mechanical Engineering and Technology (IJMET Volume 9 Issue 10 October 2018 pp. 179 189 Article ID: IJMET_09_10_11 Available online at http://www.iaeme.com/ijmet/issues.asp?jtypeijmet&vtype9&itype10

More information

Aeroacoustic computations with a new CFD solver based on the Lattice Boltzmann Method

Aeroacoustic computations with a new CFD solver based on the Lattice Boltzmann Method Aeroacoustic computations with a new CFD solver based on the Lattice Boltzmann Method D. Ricot 1, E. Foquet 2, H. Touil 3, E. Lévêque 3, H. Machrouki 4, F. Chevillotte 5, M. Meldi 6 1: Renault 2: CS 3:

More information

Tutorial School on Fluid Dynamics: Topics in Turbulence May 24-28, 2010

Tutorial School on Fluid Dynamics: Topics in Turbulence May 24-28, 2010 Applications of Large-eddy Simulation to Biological Flows Tutorial School on Fluid Dynamics: Topics in Turbulence May 24-28, 2010 Methodologies & Applications Elias Balaras Fischell Department of Bioengineering

More information

Efficient Tridiagonal Solvers for ADI methods and Fluid Simulation

Efficient Tridiagonal Solvers for ADI methods and Fluid Simulation Efficient Tridiagonal Solvers for ADI methods and Fluid Simulation Nikolai Sakharnykh - NVIDIA San Jose Convention Center, San Jose, CA September 21, 2010 Introduction Tridiagonal solvers very popular

More information

Two-Phase flows on massively parallel multi-gpu clusters

Two-Phase flows on massively parallel multi-gpu clusters Two-Phase flows on massively parallel multi-gpu clusters Peter Zaspel Michael Griebel Institute for Numerical Simulation Rheinische Friedrich-Wilhelms-Universität Bonn Workshop Programming of Heterogeneous

More information

Validation of an Automatic Mesh Generation Technique in Engine Simulations

Validation of an Automatic Mesh Generation Technique in Engine Simulations International Multidimensional Engine Modeling User's Group Meeting April,, Detroit, Michigan Validation of an Automatic Mesh Generation Technique in Engine s Abstract Long Liang, Anthony Shelburn, Cheng

More information

IMPLEMENTATION OF AN IMMERSED BOUNDARY METHOD IN SPECTRAL-ELEMENT SOFTWARE

IMPLEMENTATION OF AN IMMERSED BOUNDARY METHOD IN SPECTRAL-ELEMENT SOFTWARE Seventh International Conference on CFD in the Minerals and Process Industries CSIRO, Melbourne, Australia 9- December 29 IMPLEMENTATION OF AN IMMERSED BOUNDARY METHOD IN SPECTRAL-ELEMENT SOFTWARE Daniel

More information

Potsdam Propeller Test Case (PPTC)

Potsdam Propeller Test Case (PPTC) Second International Symposium on Marine Propulsors smp 11, Hamburg, Germany, June 2011 Workshop: Propeller performance Potsdam Propeller Test Case (PPTC) Olof Klerebrant Klasson 1, Tobias Huuva 2 1 Core

More information

Introduction to the immersed boundary method

Introduction to the immersed boundary method Introduction to the immersed boundary method by Timm Krüger (info@timm-krueger.de), last updated on September 27, 20 Motivation. Hydrodynamics and boundary conditions The incompressible Navier-Stokes equations,

More information

Inviscid Flows. Introduction. T. J. Craft George Begg Building, C41. The Euler Equations. 3rd Year Fluid Mechanics

Inviscid Flows. Introduction. T. J. Craft George Begg Building, C41. The Euler Equations. 3rd Year Fluid Mechanics Contents: Navier-Stokes equations Inviscid flows Boundary layers Transition, Reynolds averaging Mixing-length models of turbulence Turbulent kinetic energy equation One- and Two-equation models Flow management

More information

Transactions on Modelling and Simulation vol 20, 1998 WIT Press, ISSN X

Transactions on Modelling and Simulation vol 20, 1998 WIT Press,   ISSN X Parallel indirect multipole BEM analysis of Stokes flow in a multiply connected domain M.S. Ingber*, A.A. Mammoli* & J.S. Warsa* "Department of Mechanical Engineering, University of New Mexico, Albuquerque,

More information

A 3D VOF model in cylindrical coordinates

A 3D VOF model in cylindrical coordinates A 3D VOF model in cylindrical coordinates Marmar Mehrabadi and Markus Bussmann Department of Mechanical and Industrial Engineering, University of Toronto Recently, volume of fluid (VOF) methods have improved

More information

CFD MODELING FOR PNEUMATIC CONVEYING

CFD MODELING FOR PNEUMATIC CONVEYING CFD MODELING FOR PNEUMATIC CONVEYING Arvind Kumar 1, D.R. Kaushal 2, Navneet Kumar 3 1 Associate Professor YMCAUST, Faridabad 2 Associate Professor, IIT, Delhi 3 Research Scholar IIT, Delhi e-mail: arvindeem@yahoo.co.in

More information

An Eulerian Immersed Boundary Method for Flow Simulations over Stationary and Moving Rigid Bodies

An Eulerian Immersed Boundary Method for Flow Simulations over Stationary and Moving Rigid Bodies An Eulerian Immersed Boundary for Flow Simulations over Stationary and Moving Rigid Bodies Evelise R. Corbalan Góis evelise@sc.usp.br University of São Paulo School of Engineering, São Carlos 13566-590

More information

Computational Simulation of the Wind-force on Metal Meshes

Computational Simulation of the Wind-force on Metal Meshes 16 th Australasian Fluid Mechanics Conference Crown Plaza, Gold Coast, Australia 2-7 December 2007 Computational Simulation of the Wind-force on Metal Meshes Ahmad Sharifian & David R. Buttsworth Faculty

More information

CUDA. Fluid simulation Lattice Boltzmann Models Cellular Automata

CUDA. Fluid simulation Lattice Boltzmann Models Cellular Automata CUDA Fluid simulation Lattice Boltzmann Models Cellular Automata Please excuse my layout of slides for the remaining part of the talk! Fluid Simulation Navier Stokes equations for incompressible fluids

More information

Steady Flow: Lid-Driven Cavity Flow

Steady Flow: Lid-Driven Cavity Flow STAR-CCM+ User Guide Steady Flow: Lid-Driven Cavity Flow 2 Steady Flow: Lid-Driven Cavity Flow This tutorial demonstrates the performance of STAR-CCM+ in solving a traditional square lid-driven cavity

More information

Analysis of the Flow in Hermetic Compressor Valves Using the Immersed Boundary Method

Analysis of the Flow in Hermetic Compressor Valves Using the Immersed Boundary Method Purdue University Purdue e-pubs International Compressor Engineering Conference School of Mechanical Engineering 010 Analysis of the Flow in Hermetic Compressor Valves Using the Immersed Boundary Method

More information

Coupled Analysis of FSI

Coupled Analysis of FSI Coupled Analysis of FSI Qin Yin Fan Oct. 11, 2008 Important Key Words Fluid Structure Interface = FSI Computational Fluid Dynamics = CFD Pressure Displacement Analysis = PDA Thermal Stress Analysis = TSA

More information

Eulerian Techniques for Fluid-Structure Interactions - Part II: Applications

Eulerian Techniques for Fluid-Structure Interactions - Part II: Applications Published in Lecture Notes in Computational Science and Engineering Vol. 103, Proceedings of ENUMATH 2013, pp. 755-762, Springer, 2014 Eulerian Techniques for Fluid-Structure Interactions - Part II: Applications

More information

A Study of the Development of an Analytical Wall Function for Large Eddy Simulation of Turbulent Channel and Rectangular Duct Flow

A Study of the Development of an Analytical Wall Function for Large Eddy Simulation of Turbulent Channel and Rectangular Duct Flow University of Wisconsin Milwaukee UWM Digital Commons Theses and Dissertations August 2014 A Study of the Development of an Analytical Wall Function for Large Eddy Simulation of Turbulent Channel and Rectangular

More information

Tutorial 17. Using the Mixture and Eulerian Multiphase Models

Tutorial 17. Using the Mixture and Eulerian Multiphase Models Tutorial 17. Using the Mixture and Eulerian Multiphase Models Introduction: This tutorial examines the flow of water and air in a tee junction. First you will solve the problem using the less computationally-intensive

More information

Available online at ScienceDirect. Parallel Computational Fluid Dynamics Conference (ParCFD2013)

Available online at  ScienceDirect. Parallel Computational Fluid Dynamics Conference (ParCFD2013) Available online at www.sciencedirect.com ScienceDirect Procedia Engineering 61 ( 2013 ) 81 86 Parallel Computational Fluid Dynamics Conference (ParCFD2013) An OpenCL-based parallel CFD code for simulations

More information

Hydro-elastic analysis of a propeller using CFD and FEM co-simulation

Hydro-elastic analysis of a propeller using CFD and FEM co-simulation Fifth International Symposium on Marine Propulsors smp 17, Espoo, Finland, June 2017 Hydro-elastic analysis of a propeller using CFD and FEM co-simulation Vesa Nieminen 1 1 VTT Technical Research Centre

More information

Incompressible Viscous Flow Simulations Using the Petrov-Galerkin Finite Element Method

Incompressible Viscous Flow Simulations Using the Petrov-Galerkin Finite Element Method Copyright c 2007 ICCES ICCES, vol.4, no.1, pp.11-18, 2007 Incompressible Viscous Flow Simulations Using the Petrov-Galerkin Finite Element Method Kazuhiko Kakuda 1, Tomohiro Aiso 1 and Shinichiro Miura

More information

Application of A Priori Error Estimates for Navier-Stokes Equations to Accurate Finite Element Solution

Application of A Priori Error Estimates for Navier-Stokes Equations to Accurate Finite Element Solution Application of A Priori Error Estimates for Navier-Stokes Equations to Accurate Finite Element Solution P. BURDA a,, J. NOVOTNÝ b,, J. ŠÍSTE a, a Department of Mathematics Czech University of Technology

More information

Computational Fluid Dynamics using OpenCL a Practical Introduction

Computational Fluid Dynamics using OpenCL a Practical Introduction 19th International Congress on Modelling and Simulation, Perth, Australia, 12 16 December 2011 http://mssanz.org.au/modsim2011 Computational Fluid Dynamics using OpenCL a Practical Introduction T Bednarz

More information

Performance of Implicit Solver Strategies on GPUs

Performance of Implicit Solver Strategies on GPUs 9. LS-DYNA Forum, Bamberg 2010 IT / Performance Performance of Implicit Solver Strategies on GPUs Prof. Dr. Uli Göhner DYNAmore GmbH Stuttgart, Germany Abstract: The increasing power of GPUs can be used

More information

Adarsh Krishnamurthy (cs184-bb) Bela Stepanova (cs184-bs)

Adarsh Krishnamurthy (cs184-bb) Bela Stepanova (cs184-bs) OBJECTIVE FLUID SIMULATIONS Adarsh Krishnamurthy (cs184-bb) Bela Stepanova (cs184-bs) The basic objective of the project is the implementation of the paper Stable Fluids (Jos Stam, SIGGRAPH 99). The final

More information

Module 1: Introduction to Finite Difference Method and Fundamentals of CFD Lecture 13: The Lecture deals with:

Module 1: Introduction to Finite Difference Method and Fundamentals of CFD Lecture 13: The Lecture deals with: The Lecture deals with: Some more Suggestions for Improvement of Discretization Schemes Some Non-Trivial Problems with Discretized Equations file:///d /chitra/nptel_phase2/mechanical/cfd/lecture13/13_1.htm[6/20/2012

More information

Coupling of STAR-CCM+ to Other Theoretical or Numerical Solutions. Milovan Perić

Coupling of STAR-CCM+ to Other Theoretical or Numerical Solutions. Milovan Perić Coupling of STAR-CCM+ to Other Theoretical or Numerical Solutions Milovan Perić Contents The need to couple STAR-CCM+ with other theoretical or numerical solutions Coupling approaches: surface and volume

More information

2.7 Cloth Animation. Jacobs University Visualization and Computer Graphics Lab : Advanced Graphics - Chapter 2 123

2.7 Cloth Animation. Jacobs University Visualization and Computer Graphics Lab : Advanced Graphics - Chapter 2 123 2.7 Cloth Animation 320491: Advanced Graphics - Chapter 2 123 Example: Cloth draping Image Michael Kass 320491: Advanced Graphics - Chapter 2 124 Cloth using mass-spring model Network of masses and springs

More information

Compressible Flow in a Nozzle

Compressible Flow in a Nozzle SPC 407 Supersonic & Hypersonic Fluid Dynamics Ansys Fluent Tutorial 1 Compressible Flow in a Nozzle Ahmed M Nagib Elmekawy, PhD, P.E. Problem Specification Consider air flowing at high-speed through a

More information

Immersed Boundary Method in FOAM

Immersed Boundary Method in FOAM Immersed Boundary Method in FOAM Theory, Implementation and Use Hrvoje Jasak and Željko Tuković Chalmers University, Gothenburg Faculty of Mechanical Engineering and Naval Architecture, Zagreb Immersed

More information

Possibility of Implicit LES for Two-Dimensional Incompressible Lid-Driven Cavity Flow Based on COMSOL Multiphysics

Possibility of Implicit LES for Two-Dimensional Incompressible Lid-Driven Cavity Flow Based on COMSOL Multiphysics Possibility of Implicit LES for Two-Dimensional Incompressible Lid-Driven Cavity Flow Based on COMSOL Multiphysics Masanori Hashiguchi 1 1 Keisoku Engineering System Co., Ltd. 1-9-5 Uchikanda, Chiyoda-ku,

More information

Introduction to C omputational F luid Dynamics. D. Murrin

Introduction to C omputational F luid Dynamics. D. Murrin Introduction to C omputational F luid Dynamics D. Murrin Computational fluid dynamics (CFD) is the science of predicting fluid flow, heat transfer, mass transfer, chemical reactions, and related phenomena

More information

Three-dimensional numerical simulations of flapping wings at low Reynolds numbers

Three-dimensional numerical simulations of flapping wings at low Reynolds numbers Three-dimensional numerical simulations of flapping wings at low Reynolds numbers OpenFOAM Workshop, Zagreb Frank Bos, Bas van Oudheusden, Hester Bijl 7-9 June 2007 1/22 Delft University of Technology

More information

Computation of Velocity, Pressure and Temperature Distributions near a Stagnation Point in Planar Laminar Viscous Incompressible Flow

Computation of Velocity, Pressure and Temperature Distributions near a Stagnation Point in Planar Laminar Viscous Incompressible Flow Excerpt from the Proceedings of the COMSOL Conference 8 Boston Computation of Velocity, Pressure and Temperature Distributions near a Stagnation Point in Planar Laminar Viscous Incompressible Flow E. Kaufman

More information

Verification of Moving Mesh Discretizations

Verification of Moving Mesh Discretizations Verification of Moving Mesh Discretizations Krzysztof J. Fidkowski High Order CFD Workshop Kissimmee, Florida January 6, 2018 How can we verify moving mesh results? Goal: Demonstrate accuracy of flow solutions

More information

Rotating Moving Boundary Analysis Using ANSYS 5.7

Rotating Moving Boundary Analysis Using ANSYS 5.7 Abstract Rotating Moving Boundary Analysis Using ANSYS 5.7 Qin Yin Fan CYBERNET SYSTEMS CO., LTD. Rich Lange ANSYS Inc. As subroutines in commercial software, APDL (ANSYS Parametric Design Language) provides

More information

MASSACHUSETTS INSTITUTE OF TECHNOLOGY. Analyzing wind flow around the square plate using ADINA Project. Ankur Bajoria

MASSACHUSETTS INSTITUTE OF TECHNOLOGY. Analyzing wind flow around the square plate using ADINA Project. Ankur Bajoria MASSACHUSETTS INSTITUTE OF TECHNOLOGY Analyzing wind flow around the square plate using ADINA 2.094 - Project Ankur Bajoria May 1, 2008 Acknowledgement I would like to thank ADINA R & D, Inc for the full

More information

Solution Recording and Playback: Vortex Shedding

Solution Recording and Playback: Vortex Shedding STAR-CCM+ User Guide 6663 Solution Recording and Playback: Vortex Shedding This tutorial demonstrates how to use the solution recording and playback module for capturing the results of transient phenomena.

More information

Numerical and theoretical analysis of shock waves interaction and reflection

Numerical and theoretical analysis of shock waves interaction and reflection Fluid Structure Interaction and Moving Boundary Problems IV 299 Numerical and theoretical analysis of shock waves interaction and reflection K. Alhussan Space Research Institute, King Abdulaziz City for

More information

FLUENT Secondary flow in a teacup Author: John M. Cimbala, Penn State University Latest revision: 26 January 2016

FLUENT Secondary flow in a teacup Author: John M. Cimbala, Penn State University Latest revision: 26 January 2016 FLUENT Secondary flow in a teacup Author: John M. Cimbala, Penn State University Latest revision: 26 January 2016 Note: These instructions are based on an older version of FLUENT, and some of the instructions

More information

Solved with COMSOL Multiphysics 4.0a. COPYRIGHT 2010 COMSOL AB.

Solved with COMSOL Multiphysics 4.0a. COPYRIGHT 2010 COMSOL AB. Journal Bearing Introduction Journal bearings are used to carry radial loads, for example, to support a rotating shaft. A simple journal bearing consists of two rigid cylinders. The outer cylinder (bearing)

More information

C. A. D. Fraga Filho 1,2, D. F. Pezzin 1 & J. T. A. Chacaltana 1. Abstract

C. A. D. Fraga Filho 1,2, D. F. Pezzin 1 & J. T. A. Chacaltana 1. Abstract Advanced Computational Methods and Experiments in Heat Transfer XIII 15 A numerical study of heat diffusion using the Lagrangian particle SPH method and the Eulerian Finite-Volume method: analysis of convergence,

More information

Flow and Heat Transfer in a Mixing Elbow

Flow and Heat Transfer in a Mixing Elbow Flow and Heat Transfer in a Mixing Elbow Objectives The main objectives of the project are to learn (i) how to set up and perform flow simulations with heat transfer and mixing, (ii) post-processing and

More information

Using Multiple Rotating Reference Frames

Using Multiple Rotating Reference Frames Tutorial 9. Using Multiple Rotating Reference Frames Introduction Many engineering problems involve rotating flow domains. One example is the centrifugal blower unit that is typically used in automotive

More information

Introduction to Computational Fluid Dynamics Mech 122 D. Fabris, K. Lynch, D. Rich

Introduction to Computational Fluid Dynamics Mech 122 D. Fabris, K. Lynch, D. Rich Introduction to Computational Fluid Dynamics Mech 122 D. Fabris, K. Lynch, D. Rich 1 Computational Fluid dynamics Computational fluid dynamics (CFD) is the analysis of systems involving fluid flow, heat

More information

Verification of Laminar and Validation of Turbulent Pipe Flows

Verification of Laminar and Validation of Turbulent Pipe Flows 1 Verification of Laminar and Validation of Turbulent Pipe Flows 1. Purpose ME:5160 Intermediate Mechanics of Fluids CFD LAB 1 (ANSYS 18.1; Last Updated: Aug. 1, 2017) By Timur Dogan, Michael Conger, Dong-Hwan

More information

CGT 581 G Fluids. Overview. Some terms. Some terms

CGT 581 G Fluids. Overview. Some terms. Some terms CGT 581 G Fluids Bedřich Beneš, Ph.D. Purdue University Department of Computer Graphics Technology Overview Some terms Incompressible Navier-Stokes Boundary conditions Lagrange vs. Euler Eulerian approaches

More information

A High-Order Accurate Unstructured GMRES Solver for Poisson s Equation

A High-Order Accurate Unstructured GMRES Solver for Poisson s Equation A High-Order Accurate Unstructured GMRES Solver for Poisson s Equation Amir Nejat * and Carl Ollivier-Gooch Department of Mechanical Engineering, The University of British Columbia, BC V6T 1Z4, Canada

More information

COMPUTATIONAL FLUID DYNAMICS ANALYSIS OF ORIFICE PLATE METERING SITUATIONS UNDER ABNORMAL CONFIGURATIONS

COMPUTATIONAL FLUID DYNAMICS ANALYSIS OF ORIFICE PLATE METERING SITUATIONS UNDER ABNORMAL CONFIGURATIONS COMPUTATIONAL FLUID DYNAMICS ANALYSIS OF ORIFICE PLATE METERING SITUATIONS UNDER ABNORMAL CONFIGURATIONS Dr W. Malalasekera Version 3.0 August 2013 1 COMPUTATIONAL FLUID DYNAMICS ANALYSIS OF ORIFICE PLATE

More information

Direct numerical simulation. in an annular pipe. of turbulent flow. Paolo Luchini & Maurizio Quadrio

Direct numerical simulation. in an annular pipe. of turbulent flow. Paolo Luchini & Maurizio Quadrio P.Luchini & M.Quadrio SIMAI 2000 - Ischia - 9.6.2000 Direct numerical simulation of turbulent flow in an annular pipe Paolo Luchini & Maurizio Quadrio Dipartimento di Ingegneria Aerospaziale del Politecnico

More information

Imagery for 3D geometry design: application to fluid flows.

Imagery for 3D geometry design: application to fluid flows. Imagery for 3D geometry design: application to fluid flows. C. Galusinski, C. Nguyen IMATH, Université du Sud Toulon Var, Supported by ANR Carpeinter May 14, 2010 Toolbox Ginzburg-Landau. Skeleton 3D extension

More information

Characteristic Aspects of SPH Solutions

Characteristic Aspects of SPH Solutions Characteristic Aspects of SPH Solutions for Free Surface Problems: Source and Possible Treatment of High Frequency Numerical Oscillations of Local Loads. A. Colagrossi*, D. Le Touzé & G.Colicchio* *INSEAN

More information

Computational Fluid Dynamics (CFD) using Graphics Processing Units

Computational Fluid Dynamics (CFD) using Graphics Processing Units Computational Fluid Dynamics (CFD) using Graphics Processing Units Aaron F. Shinn Mechanical Science and Engineering Dept., UIUC Accelerators for Science and Engineering Applications: GPUs and Multicores

More information

Art Checklist. Journal Code: Article No: 7087

Art Checklist. Journal Code: Article No: 7087 Art Checklist Journal Code: JCPH Article No: 7087 Disk Recd Disk Disk Usable Art # Y/N Format Y/N Remarks Fig.1 N Fig.2 N Fig.3 N Fig.4 Y WMF Y Fig.5 Y WMF Y Fig.6a Y WMF Y Fig.6b Y WMF Y Fig.7 Y WMF Y

More information

Implementation of a new discrete Immersed Boundary Method in OpenFOAM

Implementation of a new discrete Immersed Boundary Method in OpenFOAM Implementation of a new discrete Immersed Boundary Method in OpenFOAM CONSTANT Eddy*, COLIN-BELLOT Clothilde, FAVIER Julien, MELIGA Philippe, SERRE Éric Aix-Marseille Université, CNRS, Ecole Centrale Marseille,

More information

This tutorial illustrates how to set up and solve a problem involving solidification. This tutorial will demonstrate how to do the following:

This tutorial illustrates how to set up and solve a problem involving solidification. This tutorial will demonstrate how to do the following: Tutorial 22. Modeling Solidification Introduction This tutorial illustrates how to set up and solve a problem involving solidification. This tutorial will demonstrate how to do the following: Define a

More information

Application of Wray-Agarwal Turbulence Model for Accurate Numerical Simulation of Flow Past a Three-Dimensional Wing-body

Application of Wray-Agarwal Turbulence Model for Accurate Numerical Simulation of Flow Past a Three-Dimensional Wing-body Washington University in St. Louis Washington University Open Scholarship Mechanical Engineering and Materials Science Independent Study Mechanical Engineering & Materials Science 4-28-2016 Application

More information

ENERGY-224 Reservoir Simulation Project Report. Ala Alzayer

ENERGY-224 Reservoir Simulation Project Report. Ala Alzayer ENERGY-224 Reservoir Simulation Project Report Ala Alzayer Autumn Quarter December 3, 2014 Contents 1 Objective 2 2 Governing Equations 2 3 Methodolgy 3 3.1 BlockMesh.........................................

More information

Numerical Modeling Study for Fish Screen at River Intake Channel ; PH (505) ; FAX (505) ;

Numerical Modeling Study for Fish Screen at River Intake Channel ; PH (505) ; FAX (505) ; Numerical Modeling Study for Fish Screen at River Intake Channel Jungseok Ho 1, Leslie Hanna 2, Brent Mefford 3, and Julie Coonrod 4 1 Department of Civil Engineering, University of New Mexico, Albuquerque,

More information

Center for Computational Science

Center for Computational Science Center for Computational Science Toward GPU-accelerated meshfree fluids simulation using the fast multipole method Lorena A Barba Boston University Department of Mechanical Engineering with: Felipe Cruz,

More information

Fast Multipole Method on the GPU

Fast Multipole Method on the GPU Fast Multipole Method on the GPU with application to the Adaptive Vortex Method University of Bristol, Bristol, United Kingdom. 1 Introduction Particle methods Highly parallel Computational intensive Numerical

More information

Computation of Incompressible Navier-Stokes Equations by Local RBF-based Differential Quadrature Method

Computation of Incompressible Navier-Stokes Equations by Local RBF-based Differential Quadrature Method Copyright c 25 Tech Science Press CMES, vol7, no2, pp95-25, 25 Computation of Incompressible Navier-Stokes Equations by Local RBF-based Differential Quadrature Method C Shu,2,HDing 2, KS Yeo 2 Abstract:

More information

Development of immersed boundary methods for complex geometries

Development of immersed boundary methods for complex geometries Center for Turbulence Research Annual Research Briefs 1998 325 Development of immersed boundary methods for complex geometries By J. Mohd-Yusof 1. Motivation and objectives For fluid dynamics simulations,

More information

NUMERICAL 3D TRANSONIC FLOW SIMULATION OVER A WING

NUMERICAL 3D TRANSONIC FLOW SIMULATION OVER A WING Review of the Air Force Academy No.3 (35)/2017 NUMERICAL 3D TRANSONIC FLOW SIMULATION OVER A WING Cvetelina VELKOVA Department of Technical Mechanics, Naval Academy Nikola Vaptsarov,Varna, Bulgaria (cvetelina.velkova1985@gmail.com)

More information

Comparison of different solvers for two-dimensional steady heat conduction equation ME 412 Project 2

Comparison of different solvers for two-dimensional steady heat conduction equation ME 412 Project 2 Comparison of different solvers for two-dimensional steady heat conduction equation ME 412 Project 2 Jingwei Zhu March 19, 2014 Instructor: Surya Pratap Vanka 1 Project Description The purpose of this

More information