Scientific Computing I

Size: px
Start display at page:

Download "Scientific Computing I"

Transcription

1 Scientific Computing I Module 10: Case Study Computational Fluid Dynamics Michael Bader Winter 2012/2013 Module 10: Case Study Computational Fluid Dynamics, Winter 2012/2013 1

2 Fluid mechanics as a Discipline Prominent discipline of application for numerical simulations: experimental fluid mechanics: wind tunnel studies, laser Doppler anemometry, hot wire techniques,... theoretical fluid mechanics: investigations concerning the derivation of turbulence models, e.g. computational fluid mechanics (CFD): numerical simulations Many fields of application: aerodynamics: aircraft design, car design,... thermodynamics: heating, cooling,... process engineering: combustion material science: crystal growth astrophysics: accretion disks geophysics: mantle convection, climate/weather prediction, tsunami simulation,... Module 10: Case Study Computational Fluid Dynamics, Winter 2012/2013 2

3 Part I: Modelling Mathematical Models for CFD Advection and Diffusion Advection Equation Advection-Diffusion Equation Euler Equations 1D Euler Equations Conservation Laws in Higher Dimensions 2D Euler Equations Navier-Stokes Equations Conservation and Convection Form Incompressible Equations Viscous Forces Boundary Conditions Module 10: Case Study Computational Fluid Dynamics, Winter 2012/2013 3

4 Fluids and Flows ideal or real fluids ideal : no resistance to tangential forces compressible or incompressible fluids volume change of gases (vs. liquids?) under pressure viscous or inviscid fluids think of the different characteristics of honey and water Newtonian and non-newtonian fluids the latter may show some elastic behaviour (e.g. in liquids with particles like blood) laminar or turbulent flows turbulence: unsteady, 3D, high vorticity, vortices of different scales, high transport of energy between scales Module 10: Case Study Computational Fluid Dynamics, Winter 2012/2013 4

5 Mathematical Models for CFD typically: all require different models our focus here: incompressible, viscous, Newtonian, laminar incompressible Navier-Stokes Equations Shallow Water Equations starting point: continuum mechanics macroscopic properties (pressure, density, velocity field) compared to stochastic or micro-/mesoscopic approaches (lattice Boltzman method, e.g.) relies on basic conservation laws (remember the heat equation): conservation of mass and momentum (and energy) additionally: slight focus on Finite Volume Methods Module 10: Case Study Computational Fluid Dynamics, Winter 2012/2013 5

6 Advection Equation F(a,t) v(a,t) q(x,t) F(b,t) v(b,t) a b x Conservation of some quantity q in a fluid domain Ω = [a, b] with given velocity v(x, t): b total amount/mass of q in Ω = [a, b] is given by q(x, t) dx change of mass can only happen due to in-/outflow at a and b: b b q(x, t) dx = F (a, t) F (b, t) = F(x, t) b a t = F(x, t) dx x a a note: F (a, t) and F(b, t) denote an inflow into the domain Ω Module 10: Case Study Computational Fluid Dynamics, Winter 2012/ a

7 Advection Equation (2) F(a,t) v(a,t) q(x,t) F(b,t) v(b,t) a b x Consider flux function F (x, t) depends on velocity v(x, t), density q(x, t) and the pipe s cross-sectional area A(x): F(x, t) = A(x)v(x, t)q(x, t) for simplicity, we set A(x) = 1, and obtain: b b q(x, t) dx = t a a b F (x, t) dx = x a ( ) v(x, t)q(x, t) dx x Module 10: Case Study Computational Fluid Dynamics, Winter 2012/2013 7

8 Advection Equation (3) F(a,t) v(a,t) q(x,t) F(b,t) v(b,t) a b x Advection Equation: for smooth functions, we may write: b a t q(x, t) dx = b b ( ) q(x, t) dx = v(x, t)q(x, t) dx t x a a as this equation has to hold for any Ω = [a, b], we demand: ( ) q(x, t) = v(x, t)q(x, t) t x or short: q t + (vq) x = 0 Module 10: Case Study Computational Fluid Dynamics, Winter 2012/2013 8

9 Advection and Diffusion Diffusion even in a fluid at rest, an inhomogeneous density q(x, t) will slowly change towards a uniform density q 0 due to molecular processes diffusion Fick s law of diffusion: resulting flux is prop. to gradient of q F diff = βq x to model both advection and diffusion, we have F = vq + βq x, and thus q t + (vq) x = βq xx special case q t = 0 advection-diffusion equation : βq xx + (vq) x = 0 Module 10: Case Study Computational Fluid Dynamics, Winter 2012/2013 9

10 1D Euler Equations with our quantity q being the mass density ρ, we obtain an equation for the conservation of mass: ρ t + (vρ) x = 0 another conservation property is that of momentum ρv; here, the flux term includes the pressure p: F mom = ρv 2 + p thus, we obtain as equation for the conservation of momentum: (ρv) t + (ρv 2 + p) x = 0 we obtain a system of two PDEs, the 1D Euler Equations to close the system, we need a relation between ρ and p (using the ideal gas law, e.g.) we might add an equation for temperature (derived from the conservation of internal energy) Module 10: Case Study Computational Fluid Dynamics, Winter 2012/

11 Conservation Laws in Higher Dimensions in 2D, a conservation law for quantity q takes the form: or similar in 3D: q t + F (q) x + G(q) y = 0 q t + F (q) x + G(q) y + H(q) z = 0 for advection, the flux functions are F (q) = uq G(q) = vq H(q) = wq where u, v, w are the velocity components in the three space dimensions x, y, z hence, for 2D we obtain a conservation law such as q t + (uq) x + (vq) y = 0 Module 10: Case Study Computational Fluid Dynamics, Winter 2012/

12 2D Euler Equations in 2D, with velocity components u(x, y, t) and v(x, y, t) the equation for conservation of mass reads: ρ t + (ρu) x + (ρv) y = 0 similar, the two equation for conservation of momentum are: (ρu) t + (ρu 2 + p) x + (ρuv) y = 0 (ρv) t + (ρuv) x + (ρv 2 + p) y = 0 again, we assume constant temperature, and we need a relation between ρ and p to close the system the Euler equations model an inviscid (ideal) fluid we also neglect additional source terms, such as for gravity forces, etc. Module 10: Case Study Computational Fluid Dynamics, Winter 2012/

13 Navier-Stokes Equations mass conservation/continuity equation is the same as for the Euler equations: or, written in vector notation: ρ t + (ρu) x + (ρv) y + (ρw) z = 0 ρ + (ρ u) = 0, t u u = x + v y + w z momentum conservation/momentum equations (ρ u) + ( u ρ u) σ f = 0 t with σ being the stress tensor, which includes the pressure p and viscous forces: σ = pi +... f models external (volume) forces (gravity, e.g.) Module 10: Case Study Computational Fluid Dynamics, Winter 2012/

14 Navier-Stokes Equations Conservation and Convection Form the equations for mass and momentum, on the previous slide, are given in the so-called conservation form with the equations (ρ u) = u ρ+ρ u and (ρ u u) = u ( (ρ u) ) +(ρ u ) u, we obtain: ρ + u ρ + ρ u = 0 t t (ρ u) + u( (ρ u) ) + (ρ u ) u σ f = 0 with t (ρ u) = ρ t u + u t ρ and applying u t ρ + u( (ρ u) ) = u ( t ρ + (ρ u)) = 0, we obtain for the momentum equation in convection form ( ) ρ u + ( u ) u σ f = 0 t Module 10: Case Study Computational Fluid Dynamics, Winter 2012/

15 Navier-Stokes Equations Incompressible Equations in the convective forms ρ + u ρ + ρ u = 0 t ( ) ρ u + ( u ) u σ f = 0 t we assume that the density ρ is constant: t ρ = 0, ρ = 0 we obtain obtain the incompressible Navier-Stokes equations: u = 0 ( ) ρ u + ( u ) u σ f = 0 t incompressible : the density does not change due to pressure or temperature, e.g. Module 10: Case Study Computational Fluid Dynamics, Winter 2012/

16 Viscous Forces Open question: stress tensor σ σ includes pressure p and viscosity tensor τ: σ = pi + τ Newtonian fluids: viscous stresses proportional to the strain rate (first derivatives) isotropic, incompressible fluids, Stokes assumption (no volume viscosity), then σ = p + µ u µ the dynamic viscosity Incompressible Navier-Stokes equations: u = 0 ( ) ρ u + ( u ) u = p + µ u + f t Module 10: Case Study Computational Fluid Dynamics, Winter 2012/

17 Dynamic Similarity of Flows Dimensionless Form of the Navier-Stokes Equations we scale our unknowns to typical length scale L and velocity u : x x L t u t L u u u p p p ρu 2 and obtain the dimensionless form of the Navier-Stokes equations: u = 0 t u + ( u ) u = p + 1 Re u + f introducing the Reynolds number Re := µ ρu L important corollary: flows with the same Reynolds number will show the same behaviour Module 10: Case Study Computational Fluid Dynamics, Winter 2012/

18 Boundary Conditions (here only velocity) no-slip: the fluid can not penetrate the wall and sticks to it u = 0. free-slip: the fluid can not penetrate the wall but does not stick to it u n = 0, u n = 0. inflow: both tangential and normal velocity components are prescribed u = u inflow. outflow: should be do nothing ; simple option: all velocity components do not change in normal direction u n = 0. periodic: same velocity and pressure at inlet and outlet u in = u out. Module 10: Case Study Computational Fluid Dynamics, Winter 2012/

19 Part II: A Finite Difference/Volume Method for the Incompressible Navier-Stokes Equations Numerical Treatment Spatial Derivatives Finite Volume Discretisation and Upwind Flux Marker-and-Cell Method, Staggered Grid Discretization of Continuity Equation Discretization of Momentum Equation Time Discretization Chorin Projection Implementation Module 10: Case Study Computational Fluid Dynamics, Winter 2012/

20 Finite Volume Discretisation Advection-Diffusion Equation compute tracer concentration q with diffusion β and convection v: βq xx + (vq) x = 0 on Ω = (0, 1) with boundary conditions q(0) = 1 and q(1) = 0. equidistant grid points x i = ih, grid cells [x i, x i+1 ] back to representation via conservation law (for one grid cell): xi+1 x i x x i+1 F (x) dx = F(x) = 0 x i with F(x) = F (q(x)) = βq x (x) + vq(x). we need to compute the flux F at the boundaries of the grid cells; however, assume q(x) piecewise constant within the grid cells Module 10: Case Study Computational Fluid Dynamics, Winter 2012/

21 Finite Volume Discretisation Advection-Diffusion Equation (2) wanted: compute F(x i ) with F(q(x)) = βq x (x) + vq(x) where q(x) := q i for each Ω i = [x i, x i+1 ] computing the diffusive flux is straightforward: options for advective flux vq: symmetric flux: βq x xi+1 = β q(x i+1) q(x i ) h upwind flux: vq xi+1 = vq(x i) + vq(x i+1 ) 2 vq { vq(xi ) if v > 0 xi+1 = vq(x i+1 ) if v < 0 Module 10: Case Study Computational Fluid Dynamics, Winter 2012/

22 Finite Volume Discretisation Advection-Diffusion Equation (3) system of equations: for all i x i+1 F (x) = F (x i+1 ) F(x i ) = 0 x i for symmetric flux: β q(x i+1) 2q(x i ) + q(x i 1 ) h 2 + v q(x i+1) q(x i 1 ) = 0 2h leads to non-physical behaviour as soon as β < vh 2 (observe signs of matrix elements!) system of equations for upwind flux (assume v > 0): β q(x i+1) 2q(x i ) + q(x i 1 ) h 2 + v q(x i) q(x i 1 ) = 0 h stable, but overly diffusive solutions (positive definite matrix) Module 10: Case Study Computational Fluid Dynamics, Winter 2012/

23 Marker-and-Cell Method Staggered Grid Marker-and-Cell method (Harlow and Welch, 1965): discretization scheme: Finite Differences can be shown to be equivalent to Finite Volumes, however based on a so-called staggered grid: Cartesian grid (rectangular grid cells), with cell centres at x i,j := (ih, jh), e.g. pressure located in cell centres velocities (those in normal direction) located on cell edges Module 10: Case Study Computational Fluid Dynamics, Winter 2012/

24 Spatial Discretisation Continuity Equation: mass conservation: discretise u evaluate derivative at cell centres, allows central derivatives: ( u) i,j = u x + v i,j y u i,j u i 1,j + v i,j v i,j 1 i,j h h remember: u i,j and v i,j located on cell edges notation: ( u) i,j := ( u) xi,j (evaluate expression at cell centre x i,j ) Module 10: Case Study Computational Fluid Dynamics, Winter 2012/

25 Spatial Discretisation Pressure Terms note: velocities located on midpoints of cell edges u v t =... i+ 1 2,j t =... i,j+ 1 2 thus, all derivatives need to be approximated at midpoints of cell edges! pressure term p: central differences for first derivatives (as pressure is located in cell centres) p x p i+1,j p i,j p i+ 1 2,j h y p i,j+1 p i,j i,j+ 1 h 2 Module 10: Case Study Computational Fluid Dynamics, Winter 2012/

26 Spatial Discretisation Diffusion Term for diffusion term u: use standard 5- or 7-point stencil 2D: 3D: u i,j u i 1,j + u i,j 1 4u i,j + u i+1,j + u i,j+1 h 2 u i,j,k u i 1,j,k + u i,j 1,k + u i,j,k 1 6u i,j,k + u i+1,j,k + u i,j+1,k + u i,j,k+1 h 2 Module 10: Case Study Computational Fluid Dynamics, Winter 2012/

27 Spatial Discretisation Convection Terms treat derivatives of nonlinear terms ( u ) u: central differences (for momentum equation in x-direction): u u u i+1,j u i 1,j x u i,j v u i+ 1 2,j 2h y v u i,j+1 u i,j 1 xi+ i+ 1 2,j 1 2h 2,j with v ( ) xi+ = vi,j + v i,j 1 + v i+1,j + v i+1,j 1,j 2 upwind differences (for momentum equation in x-direction): u u u i,j u i 1,j x u i,j v u xi+ 2h y v u i,j u i,j 1 xi+ 1 1 xi+ 2h 2,j 1 2,j 2,j if u i,j > 0 and v xi+ > 0 1,j 2 code for CFD lab will mix central and upwind differences (and is based on conservation form of convection terms) Module 10: Case Study Computational Fluid Dynamics, Winter 2012/

28 Time Discretisation recall the incompressible Navier-Stokes equations: u = 0 t u + ( u ) u = p + 1 Re u + f note the role of the unknowns: 2 or 3 equations for velocities (x, y, and z component) resulting from momentum conservation 4th equation (mass conservation) to close the system; required to determine pressure p however, p does not occur explicitly in mass conservation possible approach: Chorin s projection method p acts as a variable to enforce the mass conservation as side condition Module 10: Case Study Computational Fluid Dynamics, Winter 2012/

29 Time Discretisation Chorin Projection explicit Euler scheme for momentum equation: ( u (n+1) = u (n) + τ p + 1 ( ) ) Re u(n) u (n) u (n) + g Chorin projection compute intermediate velocity that neglects pressure: ( u (n+ 1 1 ( ) ) 2 ) = u (n) + τ Re u(n) u (n) u (n) + g, u (n+1) = u (n+ 1 2 ) τ p u (n+1) needs to satisfy mass conservation: u (n+1) = 0 leads to a Poisson equation for the pressure: ( ) u (n+ 1 2 ) τ p = 0 p = 1 ( u (n+ 1 )) 2 τ thus, system of linear equations to be solved in each time step Module 10: Case Study Computational Fluid Dynamics, Winter 2012/

30 Implementation geometry representation as a flag field (Marker-and-Cell) flag field as an array of booleans: input data (boundary conditions) and output data (computed results) as arrays Module 10: Case Study Computational Fluid Dynamics, Winter 2012/

31 Implementation (2) Lab course Scientific Computing Computational Fluid Dynamics : modular C-code parallelization: simple data parallelism, domain decomposition straightforward MPI-based parallelization (exchange of ghost layers) target architectures: parallel computers with distributed memory clusters possible extensions: free-surface flows ( the falling drop ) multigrid solver for the pressure equation heat transfer or turbulence models Module 10: Case Study Computational Fluid Dynamics, Winter 2012/

32 Part III: The Shallow Water Equations and Finite Volumes Revisited The Shallow Water Equations Modelling Scenario: Tsunami Simulation Finite Volume Discretisation Central and Upwind Fluxes Lax-Friedrichs Flux Towards Tsunami Simulation Wave Speed of Tsunamis Treatment of Bathymetry Data The SWE Code Model and Discretisation Module 10: Case Study Computational Fluid Dynamics, Winter 2012/

33 The Shallow Water Equations h hu + t x hv hu hu gh2 + y huv hv huv hv gh2 = S(t, x, y) Comments on modelling: generalized 2D hyperbolic PDE: q = (h, hu, hv) T t q + x F(q) + G(q) = S(t, x, y) y derived from conservations laws for mass and momentum may be derived by vertical averaging from the 3D incompressible Navier-Stokes equations compare to Euler equations: density ρ vs. water depth h Module 10: Case Study Computational Fluid Dynamics, Winter 2012/

34 Modelling Scenario: Tsunami Simulation The Ocean as Shallow Water?? compare horizontal ( 1000 km) to vertical ( 5 km) length scale wave lengths large compared to water depth vertical flow may be neglected; movement of the entire water column Module 10: Case Study Computational Fluid Dynamics, Winter 2012/

35 Modelling Scenario: Tsunami Simulation (2) Tsunami Modelling with the Shallow Water equations: source term S(x, y) includes bathymetry data (i.e., elevation of ocean floor) Coriolis forces, friction, etc., as possible further terms boundary conditions are difficult: coastal inundation, outflow at domain boundaries Module 10: Case Study Computational Fluid Dynamics, Winter 2012/

36 Finite Volume Discretisation discretise system of PDEs t q + x F(q) + G(q) = S(t, x, y) y with h hu hv q := hu F (q) := hu gh2 G(q) := huv hv huv hv gh2 basic form of numerical schemes: Q (n+1) i,j = Q (n) i,j τ h ( F (n) i+ 1 2,j F (n) i 1 2,j ) τ h ( ) G (n) G (n) i,j+ 1 2 i,j 1 2 where F (n) i+ 1 G(n) 2,j,,... approximate the flux functions F (q) and i,j+ 1 2 G(q) at the grid cell boundaries Module 10: Case Study Computational Fluid Dynamics, Winter 2012/

37 Central and Upwind Fluxes define fluxes F (n) i+ 1 G(n) 2,j,,... via 1D numerical flux function F: i,j+ 1 2 F (n) i+ 1 2 central flux: F (n) i+ 1 2 = F ( Q (n) i = F ( Q (n) i, Q (n) ) i+1, Q (n) ) 1 ( i+1 := 2 G (n) = F ( Q (n) j 1 j 1, ) Q(n) j 2 F ( Q (n) i ) ( (n) ) ) + F Q leads to unstable methods for convective transport upwind flux (here, for h-equation, F (h) = hu): F (n) i+ 1 2 = F ( h (n) i, h (n) i+1 stable, but includes artificial diffusion { ) hu i if u i+ 1 := 2 hu i+1 if u i+ 1 2 i+1 > 0 < 0 Module 10: Case Study Computational Fluid Dynamics, Winter 2012/

38 (Local) Lax-Friedrichs Flux classical Lax-Friedrichs method uses as numerical flux: F (n) = F ( Q (n) i+ 1 i, Q (n) ) 1 ( i+1 := F ( Q (n) ) ( (n) i + F Q 2 2 i+1) ) h ( (n) ) Q i+1 2τ Q(n) i can be interpreted as central flux plus diffusion flux: h ( (n) Q i+1 2τ ) h 2 Q(n) i = 2τ Q(n) i+1 Q(n) i with diffusion coefficient h2 2τ, where c := h τ is some kind of velocity ( one grid cell per time step ) idea of local Lax-Friedrichs method: use the appropriate velocity F (n) := 1 ( F ( Q (n) ) ( (n) ) ) i+ 1 i + F Q i+1 a i h ( (n) Q i+1 ) Q(n) i Module 10: Case Study Computational Fluid Dynamics, Winter 2012/

39 Wave Speed of Tsunamis consider the 1D case t ( h hu ) + ( ) hu x hu gh2 = 0 with q = (q 1, q 2 ) T := (h, hu) T, we obtain ( ) q1 + ( ) q 2 t q 2 x q2 2/q = 0 2 gq2 1 write in convective form: t ( q1 q 2 ) + f x ( q1 ) = 0 q 2 with ( ) ( ) ( ) f f1 /q = 1 f 1 /q = f 2 /q 1 f 2 /q 2 q2 2/q2 1 + gq = 1 2q 2 /q 1 u 2 + gh 2u Module 10: Case Study Computational Fluid Dynamics, Winter 2012/

40 Wave Speed of Tsunamis (2) compute eigenvectors and eigenvalues of f : λ 1/2 = u ± ( ) gh r 1/2 1 = u ± gh and then with f = RΛR 1, where R := (r 1, r 2 ) and Λ := diag(λ 1, λ 2 ), we can diagonalise the PDE: ( ) w1 + Λ ( ) w1 = 0, w = R 1 q t w 2 x w 2 for small changes in h and small velocities, we thus obtain that waves are advected (i.e., travel) at speed λ 1/2 ± gh recall local Lax-Friedrichs method: F (n) := 1 i ( F ( Q (n) i choose a i+ 1 = max{λ k } 2 ) ( (n) ) ) + F Q i+1 a i ( Q (n) i Q (n) ) i 1 Module 10: Case Study Computational Fluid Dynamics, Winter 2012/

41 Shallow Water Equations with Bathymetry h b h hu + hu hu t x 2 gh2 + hv 0 huv = (ghb) x y hv huv hv gh2 (ghb) y Questions for numerics: treat (bh) x and (bh) y as source terms or include these into flux computations? preserve certain properties of solutions e.g., lake at rest Module 10: Case Study Computational Fluid Dynamics, Winter 2012/

42 Shallow Water Equations with Bathymetry (2) Consider Lake at Rest Scenario: at rest : velocities u = 0 and v = 0 examine local Lax-Friedrichs flux in h equation: F (n) = 1 ( ) (hu) (n) i+ 1 i + (hu) (n) i+1 a i+ 1 ( 2 (n) h i ) h(n) i = 0 F (n) F (n) = a i+ 1 ( 2 (n) i+ 1 2 i h 1 i h(n) i ) a i ( h (n) i h (n) i 1) = 0 note: a i± 1 gh and if b i 1 b i b i+1 then h i 1 h i h i+1 2 thus: lake at rest not an equilibrium solution for local Lax-Friedrichs flux Additional problems: complicated numerics close to the shore in particular: wetting and drying (inundation of the coast) Module 10: Case Study Computational Fluid Dynamics, Winter 2012/

43 SWE An Education-Oriented Shallow Water Code Model & Discretisation Simplified setting (no friction, no viscosity, no coriolis forces, etc.): h hu hv hu + hu gh2 + huv = S(t, x, y). hv huv hv gh2 t x y Finite Volume Discretization: generalized 2D hyperbolic PDE: q = (h, hu, hv) T Wave propagation form: t q + x F(q) + G(q) = S(t, x, y) y Q n+1 i,j = Q n i,j t x t y ( ) A + Q i 1/2,j + A Qi+1/2,j n ( ) B + Q i,j 1/2 + B Qi,j+1/2 n. Module 10: Case Study Computational Fluid Dynamics, Winter 2012/

44 SWE An Education-Oriented Shallow Water Code Model & Discretisation Simplified setting (no friction, no viscosity, no coriolis forces, etc.): h hu hv hu + hu gh2 + huv = S(t, x, y). hv huv hv gh2 t x y Flux Computation on Edges: Wave propagation form: Q n+1 i,j = Q n i,j t x t y ( ) A + Q i 1/2,j + A Qi+1/2,j n ( ) B + Q i,j 1/2 + B Qi,j+1/2 n. simple fluxes: Rusanov/(local) Lax-Friedrich more advanced: f-wave or (augmented) Riemann solvers (George, 2008; LeVeque, 2011), no limiters Module 10: Case Study Computational Fluid Dynamics, Winter 2012/

45 SWE An Education-Oriented Shallow Water Code Unknowns and Numerical Fluxes B Q i,j+0.5 A + Q i 0.5,j h ij (hu) (hv) ij ij b ij A Q i+0.5,j B + Q i,j 0.5 Unknowns and Numerical Fluxes: unknowns h, hu, hv, and b located in cell centers two sets of net updates /numerical fluxes per edge: A + Q i 1/2,j, B Q i,j+1/2, etc. Module 10: Case Study Computational Fluid Dynamics, Winter 2012/

46 SWE An Education-Oriented Shallow Water Code Patches of Cartesian Grid Blocks j=ny+1 j=ny j=ny+1 j=ny j=1 j=0 i=0 i=1 i=nx i=nx+1 j=1 j=0 i=0 i=1 i=nx i=nx+1 Spatial Discretization: regular Cartesian meshes; allow multiple patches ghost and copy layers to implement boundary conditions, for more complicated domains, and for parallelization Module 10: Case Study Computational Fluid Dynamics, Winter 2012/

47 References and Literature Course material is mostly based on: R. J. LeVeque: Finite Volume Methods for Hyperbolic Equations, Cambridge Texts in Applied Mathematics, M. Griebel, T. Dornseifer and T. Neunhoeffer: Numerical Simulation in Fluid Dynamics: A Practical Introduction, SIAM Monographs on Mathematical Modeling and Computation, SIAM, Shallow Water Code SWE: Module 10: Case Study Computational Fluid Dynamics, Winter 2012/

fluid mechanics as a prominent discipline of application for numerical

fluid mechanics as a prominent discipline of application for numerical 1. fluid mechanics as a prominent discipline of application for numerical simulations: experimental fluid mechanics: wind tunnel studies, laser Doppler anemometry, hot wire techniques,... theoretical fluid

More information

SWE Anatomy of a Parallel Shallow Water Code

SWE Anatomy of a Parallel Shallow Water Code SWE Anatomy of a Parallel Shallow Water Code CSCS-FoMICS-USI Summer School on Computer Simulations in Science and Engineering Michael Bader July 8 19, 2013 Computer Simulations in Science and Engineering,

More information

Chapter 5. The Differential Forms of the Fundamental Laws

Chapter 5. The Differential Forms of the Fundamental Laws Chapter 5 The Differential Forms of the Fundamental Laws 1 5.1 Introduction Two primary methods in deriving the differential forms of fundamental laws: Gauss s Theorem: Allows area integrals of the equations

More information

Chapter 9: Differential Analysis of Fluid Flow

Chapter 9: Differential Analysis of Fluid Flow of Fluid Flow Objectives 1. Understand how the differential equations of mass and momentum conservation are derived. 2. Calculate the stream function and pressure field, and plot streamlines for a known

More information

The Shallow Water Equations

The Shallow Water Equations The Shallow Water Equations Clint Dawson and Christopher M. Mirabito Institute for Computational Engineering and Sciences University of Texas at Austin clint@ices.utexas.edu September 29, 2008 The Shallow

More information

Chapter 9: Differential Analysis

Chapter 9: Differential Analysis 9-1 Introduction 9-2 Conservation of Mass 9-3 The Stream Function 9-4 Conservation of Linear Momentum 9-5 Navier Stokes Equation 9-6 Differential Analysis Problems Recall 9-1 Introduction (1) Chap 5: Control

More information

Differential relations for fluid flow

Differential relations for fluid flow Differential relations for fluid flow In this approach, we apply basic conservation laws to an infinitesimally small control volume. The differential approach provides point by point details of a flow

More information

Numerical methods for the Navier- Stokes equations

Numerical methods for the Navier- Stokes equations Numerical methods for the Navier- Stokes equations Hans Petter Langtangen 1,2 1 Center for Biomedical Computing, Simula Research Laboratory 2 Department of Informatics, University of Oslo Dec 6, 2012 Note:

More information

High-resolution finite volume methods for hyperbolic PDEs on manifolds

High-resolution finite volume methods for hyperbolic PDEs on manifolds High-resolution finite volume methods for hyperbolic PDEs on manifolds Randall J. LeVeque Department of Applied Mathematics University of Washington Supported in part by NSF, DOE Overview High-resolution

More information

Soft Bodies. Good approximation for hard ones. approximation breaks when objects break, or deform. Generalization: soft (deformable) bodies

Soft Bodies. Good approximation for hard ones. approximation breaks when objects break, or deform. Generalization: soft (deformable) bodies Soft-Body Physics Soft Bodies Realistic objects are not purely rigid. Good approximation for hard ones. approximation breaks when objects break, or deform. Generalization: soft (deformable) bodies Deformed

More information

A Study on Numerical Solution to the Incompressible Navier-Stokes Equation

A Study on Numerical Solution to the Incompressible Navier-Stokes Equation A Study on Numerical Solution to the Incompressible Navier-Stokes Equation Zipeng Zhao May 2014 1 Introduction 1.1 Motivation One of the most important applications of finite differences lies in the field

More information

Game Physics. Game and Media Technology Master Program - Utrecht University. Dr. Nicolas Pronost

Game Physics. Game and Media Technology Master Program - Utrecht University. Dr. Nicolas Pronost Game and Media Technology Master Program - Utrecht University Dr. Nicolas Pronost Soft body physics Soft bodies In reality, objects are not purely rigid for some it is a good approximation but if you hit

More information

Homework 4 in 5C1212; Part A: Incompressible Navier- Stokes, Finite Volume Methods

Homework 4 in 5C1212; Part A: Incompressible Navier- Stokes, Finite Volume Methods Homework 4 in 5C11; Part A: Incompressible Navier- Stokes, Finite Volume Methods Consider the incompressible Navier Stokes in two dimensions u x + v y = 0 u t + (u ) x + (uv) y + p x = 1 Re u + f (1) v

More information

7 The Navier-Stokes Equations

7 The Navier-Stokes Equations 18.354/12.27 Spring 214 7 The Navier-Stokes Equations In the previous section, we have seen how one can deduce the general structure of hydrodynamic equations from purely macroscopic considerations and

More information

An Overview of Fluid Animation. Christopher Batty March 11, 2014

An Overview of Fluid Animation. Christopher Batty March 11, 2014 An Overview of Fluid Animation Christopher Batty March 11, 2014 What distinguishes fluids? What distinguishes fluids? No preferred shape. Always flows when force is applied. Deforms to fit its container.

More information

CHAPTER 7 SEVERAL FORMS OF THE EQUATIONS OF MOTION

CHAPTER 7 SEVERAL FORMS OF THE EQUATIONS OF MOTION CHAPTER 7 SEVERAL FORMS OF THE EQUATIONS OF MOTION 7.1 THE NAVIER-STOKES EQUATIONS Under the assumption of a Newtonian stress-rate-of-strain constitutive equation and a linear, thermally conductive medium,

More information

2. FLUID-FLOW EQUATIONS SPRING 2019

2. FLUID-FLOW EQUATIONS SPRING 2019 2. FLUID-FLOW EQUATIONS SPRING 2019 2.1 Introduction 2.2 Conservative differential equations 2.3 Non-conservative differential equations 2.4 Non-dimensionalisation Summary Examples 2.1 Introduction Fluid

More information

STEADY AND UNSTEADY 2D NUMERICAL SOLUTION OF GENERALIZED NEWTONIAN FLUIDS FLOW. Radka Keslerová, Karel Kozel

STEADY AND UNSTEADY 2D NUMERICAL SOLUTION OF GENERALIZED NEWTONIAN FLUIDS FLOW. Radka Keslerová, Karel Kozel Conference Applications of Mathematics 1 in honor of the th birthday of Michal Křížek. Institute of Mathematics AS CR, Prague 1 STEADY AND UNSTEADY D NUMERICAL SOLUTION OF GENERALIZED NEWTONIAN FLUIDS

More information

Numerical Heat and Mass Transfer

Numerical Heat and Mass Transfer Master Degree in Mechanical Engineering Numerical Heat and Mass Transfer 15-Convective Heat Transfer Fausto Arpino f.arpino@unicas.it Introduction In conduction problems the convection entered the analysis

More information

Conservation of Mass. Computational Fluid Dynamics. The Equations Governing Fluid Motion

Conservation of Mass. Computational Fluid Dynamics. The Equations Governing Fluid Motion http://www.nd.edu/~gtryggva/cfd-course/ http://www.nd.edu/~gtryggva/cfd-course/ Computational Fluid Dynamics Lecture 4 January 30, 2017 The Equations Governing Fluid Motion Grétar Tryggvason Outline Derivation

More information

Fundamentals of Fluid Dynamics: Elementary Viscous Flow

Fundamentals of Fluid Dynamics: Elementary Viscous Flow Fundamentals of Fluid Dynamics: Elementary Viscous Flow Introductory Course on Multiphysics Modelling TOMASZ G. ZIELIŃSKI bluebox.ippt.pan.pl/ tzielins/ Institute of Fundamental Technological Research

More information

Conservation Laws and Finite Volume Methods

Conservation Laws and Finite Volume Methods Conservation Laws and Finite Volume Methods AMath 574 Winter Quarter, 2011 Randall J. LeVeque Applied Mathematics University of Washington January 3, 2011 R.J. LeVeque, University of Washington AMath 574,

More information

PDE Solvers for Fluid Flow

PDE Solvers for Fluid Flow PDE Solvers for Fluid Flow issues and algorithms for the Streaming Supercomputer Eran Guendelman February 5, 2002 Topics Equations for incompressible fluid flow 3 model PDEs: Hyperbolic, Elliptic, Parabolic

More information

Fluid Animation. Christopher Batty November 17, 2011

Fluid Animation. Christopher Batty November 17, 2011 Fluid Animation Christopher Batty November 17, 2011 What distinguishes fluids? What distinguishes fluids? No preferred shape Always flows when force is applied Deforms to fit its container Internal forces

More information

Before we consider two canonical turbulent flows we need a general description of turbulence.

Before we consider two canonical turbulent flows we need a general description of turbulence. Chapter 2 Canonical Turbulent Flows Before we consider two canonical turbulent flows we need a general description of turbulence. 2.1 A Brief Introduction to Turbulence One way of looking at turbulent

More information

Fluid Dynamics Exercises and questions for the course

Fluid Dynamics Exercises and questions for the course Fluid Dynamics Exercises and questions for the course January 15, 2014 A two dimensional flow field characterised by the following velocity components in polar coordinates is called a free vortex: u r

More information

Open boundary conditions in numerical simulations of unsteady incompressible flow

Open boundary conditions in numerical simulations of unsteady incompressible flow Open boundary conditions in numerical simulations of unsteady incompressible flow M. P. Kirkpatrick S. W. Armfield Abstract In numerical simulations of unsteady incompressible flow, mass conservation can

More information

Finite Volume Method

Finite Volume Method Finite Volume Method An Introduction Praveen. C CTFD Division National Aerospace Laboratories Bangalore 560 037 email: praveen@cfdlab.net April 7, 2006 Praveen. C (CTFD, NAL) FVM CMMACS 1 / 65 Outline

More information

Riemann Solvers and Numerical Methods for Fluid Dynamics

Riemann Solvers and Numerical Methods for Fluid Dynamics Eleuterio R Toro Riemann Solvers and Numerical Methods for Fluid Dynamics A Practical Introduction With 223 Figures Springer Table of Contents Preface V 1. The Equations of Fluid Dynamics 1 1.1 The Euler

More information

Constrained Transport Method for the Finite Volume Evolution Galerkin Schemes with Application in Astrophysics

Constrained Transport Method for the Finite Volume Evolution Galerkin Schemes with Application in Astrophysics Project work at the Department of Mathematics, TUHH Constrained Transport Method for the Finite Volume Evolution Galerkin Schemes with Application in Astrophysics Katja Baumbach April 4, 005 Supervisor:

More information

Chapter 2: Fluid Dynamics Review

Chapter 2: Fluid Dynamics Review 7 Chapter 2: Fluid Dynamics Review This chapter serves as a short review of basic fluid mechanics. We derive the relevant transport equations (or conservation equations), state Newton s viscosity law leading

More information

ENGR Heat Transfer II

ENGR Heat Transfer II ENGR 7901 - Heat Transfer II Convective Heat Transfer 1 Introduction In this portion of the course we will examine convection heat transfer principles. We are now interested in how to predict the value

More information

Conservation Laws and Finite Volume Methods

Conservation Laws and Finite Volume Methods Conservation Laws and Finite Volume Methods AMath 574 Winter Quarter, 2017 Randall J. LeVeque Applied Mathematics University of Washington January 4, 2017 http://faculty.washington.edu/rjl/classes/am574w2017

More information

Math background. Physics. Simulation. Related phenomena. Frontiers in graphics. Rigid fluids

Math background. Physics. Simulation. Related phenomena. Frontiers in graphics. Rigid fluids Fluid dynamics Math background Physics Simulation Related phenomena Frontiers in graphics Rigid fluids Fields Domain Ω R2 Scalar field f :Ω R Vector field f : Ω R2 Types of derivatives Derivatives measure

More information

Introduction to numerical simulation of fluid flows

Introduction to numerical simulation of fluid flows Introduction to numerical simulation of fluid flows Mónica de Mier Torrecilla Technical University of Munich Winterschool April 2004, St. Petersburg (Russia) 1 Introduction The central task in natural

More information

Numerical Simulation of Newtonian and Non-Newtonian Flows in Bypass

Numerical Simulation of Newtonian and Non-Newtonian Flows in Bypass Numerical Simulation of Newtonian and Non-Newtonian Flows in Bypass Vladimír Prokop, Karel Kozel Czech Technical University Faculty of Mechanical Engineering Department of Technical Mathematics Vladimír

More information

Principles of Convection

Principles of Convection Principles of Convection Point Conduction & convection are similar both require the presence of a material medium. But convection requires the presence of fluid motion. Heat transfer through the: Solid

More information

Introduction to the Finite Volumes Method. Application to the Shallow Water Equations. Jaime Miguel Fe Marqués

Introduction to the Finite Volumes Method. Application to the Shallow Water Equations. Jaime Miguel Fe Marqués Introduction to the Finite Volumes Method. Application to the Shallow Water Equations. Jaime Miguel Fe Marqués Contents Preliminary considerations 3. Study of the movement of a fluid................ 3.

More information

Getting started: CFD notation

Getting started: CFD notation PDE of p-th order Getting started: CFD notation f ( u,x, t, u x 1,..., u x n, u, 2 u x 1 x 2,..., p u p ) = 0 scalar unknowns u = u(x, t), x R n, t R, n = 1,2,3 vector unknowns v = v(x, t), v R m, m =

More information

Notes: Outline. Diffusive flux. Notes: Notes: Advection-diffusion

Notes: Outline. Diffusive flux. Notes: Notes: Advection-diffusion Outline This lecture Diffusion and advection-diffusion Riemann problem for advection Diagonalization of hyperbolic system, reduction to advection equations Characteristics and Riemann problem for acoustics

More information

Introduction to Fluid Mechanics

Introduction to Fluid Mechanics Introduction to Fluid Mechanics Tien-Tsan Shieh April 16, 2009 What is a Fluid? The key distinction between a fluid and a solid lies in the mode of resistance to change of shape. The fluid, unlike the

More information

V (r,t) = i ˆ u( x, y,z,t) + ˆ j v( x, y,z,t) + k ˆ w( x, y, z,t)

V (r,t) = i ˆ u( x, y,z,t) + ˆ j v( x, y,z,t) + k ˆ w( x, y, z,t) IV. DIFFERENTIAL RELATIONS FOR A FLUID PARTICLE This chapter presents the development and application of the basic differential equations of fluid motion. Simplifications in the general equations and common

More information

Chapter 1. Continuum mechanics review. 1.1 Definitions and nomenclature

Chapter 1. Continuum mechanics review. 1.1 Definitions and nomenclature Chapter 1 Continuum mechanics review We will assume some familiarity with continuum mechanics as discussed in the context of an introductory geodynamics course; a good reference for such problems is Turcotte

More information

Chapter 1: Basic Concepts

Chapter 1: Basic Concepts What is a fluid? A fluid is a substance in the gaseous or liquid form Distinction between solid and fluid? Solid: can resist an applied shear by deforming. Stress is proportional to strain Fluid: deforms

More information

Math 575-Lecture Viscous Newtonian fluid and the Navier-Stokes equations

Math 575-Lecture Viscous Newtonian fluid and the Navier-Stokes equations Math 575-Lecture 13 In 1845, tokes extended Newton s original idea to find a constitutive law which relates the Cauchy stress tensor to the velocity gradient, and then derived a system of equations. The

More information

The Hopf equation. The Hopf equation A toy model of fluid mechanics

The Hopf equation. The Hopf equation A toy model of fluid mechanics The Hopf equation A toy model of fluid mechanics 1. Main physical features Mathematical description of a continuous medium At the microscopic level, a fluid is a collection of interacting particles (Van

More information

Characteristics for IBVP. Notes: Notes: Periodic boundary conditions. Boundary conditions. Notes: In x t plane for the case u > 0: Solution:

Characteristics for IBVP. Notes: Notes: Periodic boundary conditions. Boundary conditions. Notes: In x t plane for the case u > 0: Solution: AMath 574 January 3, 20 Today: Boundary conditions Multi-dimensional Wednesday and Friday: More multi-dimensional Reading: Chapters 8, 9, 20 R.J. LeVeque, University of Washington AMath 574, January 3,

More information

Contents. I Introduction 1. Preface. xiii

Contents. I Introduction 1. Preface. xiii Contents Preface xiii I Introduction 1 1 Continuous matter 3 1.1 Molecules................................ 4 1.2 The continuum approximation.................... 6 1.3 Newtonian mechanics.........................

More information

AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS

AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS 1 / 29 AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS Hierarchy of Mathematical Models 1 / 29 AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS 2 / 29

More information

1. INTRODUCTION TO CFD SPRING 2018

1. INTRODUCTION TO CFD SPRING 2018 1. INTRODUCTION TO CFD SPRING 018 1.1 What is computational fluid dynamics? 1. Basic principles of CFD 1.3 Stages in a CFD simulation 1.4 Fluid-flow equations 1.5 The main discretisation methods Appendices

More information

Computational Astrophysics

Computational Astrophysics Computational Astrophysics Lecture 1: Introduction to numerical methods Lecture 2:The SPH formulation Lecture 3: Construction of SPH smoothing functions Lecture 4: SPH for general dynamic flow Lecture

More information

Notes: Outline. Shock formation. Notes: Notes: Shocks in traffic flow

Notes: Outline. Shock formation. Notes: Notes: Shocks in traffic flow Outline Scalar nonlinear conservation laws Traffic flow Shocks and rarefaction waves Burgers equation Rankine-Hugoniot conditions Importance of conservation form Weak solutions Reading: Chapter, 2 R.J.

More information

Pressure-velocity correction method Finite Volume solution of Navier-Stokes equations Exercise: Finish solving the Navier Stokes equations

Pressure-velocity correction method Finite Volume solution of Navier-Stokes equations Exercise: Finish solving the Navier Stokes equations Today's Lecture 2D grid colocated arrangement staggered arrangement Exercise: Make a Fortran program which solves a system of linear equations using an iterative method SIMPLE algorithm Pressure-velocity

More information

( ) Notes. Fluid mechanics. Inviscid Euler model. Lagrangian viewpoint. " = " x,t,#, #

( ) Notes. Fluid mechanics. Inviscid Euler model. Lagrangian viewpoint.  =  x,t,#, # Notes Assignment 4 due today (when I check email tomorrow morning) Don t be afraid to make assumptions, approximate quantities, In particular, method for computing time step bound (look at max eigenvalue

More information

Turbulence - Theory and Modelling GROUP-STUDIES:

Turbulence - Theory and Modelling GROUP-STUDIES: Lund Institute of Technology Department of Energy Sciences Division of Fluid Mechanics Robert Szasz, tel 046-0480 Johan Revstedt, tel 046-43 0 Turbulence - Theory and Modelling GROUP-STUDIES: Turbulence

More information

Discrete Projection Methods for Incompressible Fluid Flow Problems and Application to a Fluid-Structure Interaction

Discrete Projection Methods for Incompressible Fluid Flow Problems and Application to a Fluid-Structure Interaction Discrete Projection Methods for Incompressible Fluid Flow Problems and Application to a Fluid-Structure Interaction Problem Jörg-M. Sautter Mathematisches Institut, Universität Düsseldorf, Germany, sautter@am.uni-duesseldorf.de

More information

AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS

AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS 1 / 43 AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS Treatment of Boundary Conditions These slides are partially based on the recommended textbook: Culbert

More information

COURSE NUMBER: ME 321 Fluid Mechanics I 3 credit hour. Basic Equations in fluid Dynamics

COURSE NUMBER: ME 321 Fluid Mechanics I 3 credit hour. Basic Equations in fluid Dynamics COURSE NUMBER: ME 321 Fluid Mechanics I 3 credit hour Basic Equations in fluid Dynamics Course teacher Dr. M. Mahbubur Razzaque Professor Department of Mechanical Engineering BUET 1 Description of Fluid

More information

CONVECTIVE HEAT TRANSFER

CONVECTIVE HEAT TRANSFER CONVECTIVE HEAT TRANSFER Mohammad Goharkhah Department of Mechanical Engineering, Sahand Unversity of Technology, Tabriz, Iran CHAPTER 3 LAMINAR BOUNDARY LAYER FLOW LAMINAR BOUNDARY LAYER FLOW Boundary

More information

Two-Dimensional Unsteady Flow in a Lid Driven Cavity with Constant Density and Viscosity ME 412 Project 5

Two-Dimensional Unsteady Flow in a Lid Driven Cavity with Constant Density and Viscosity ME 412 Project 5 Two-Dimensional Unsteady Flow in a Lid Driven Cavity with Constant Density and Viscosity ME 412 Project 5 Jingwei Zhu May 14, 2014 Instructor: Surya Pratap Vanka 1 Project Description The objective of

More information

Lattice Boltzmann Method for Fluid Simulations

Lattice Boltzmann Method for Fluid Simulations Lattice Boltzmann Method for Fluid Simulations Yuanxun Bill Bao & Justin Meskas April 14, 2011 1 Introduction In the last two decades, the Lattice Boltzmann method (LBM) has emerged as a promising tool

More information

Introduction to Aerodynamics. Dr. Guven Aerospace Engineer (P.hD)

Introduction to Aerodynamics. Dr. Guven Aerospace Engineer (P.hD) Introduction to Aerodynamics Dr. Guven Aerospace Engineer (P.hD) Aerodynamic Forces All aerodynamic forces are generated wither through pressure distribution or a shear stress distribution on a body. The

More information

Lecture 2: Hydrodynamics at milli micrometer scale

Lecture 2: Hydrodynamics at milli micrometer scale 1 at milli micrometer scale Introduction Flows at milli and micro meter scales are found in various fields, used for several processes and open up possibilities for new applications: Injection Engineering

More information

n i,j+1/2 q i,j * qi+1,j * S i+1/2,j

n i,j+1/2 q i,j * qi+1,j * S i+1/2,j Helsinki University of Technology CFD-group/ The Laboratory of Applied Thermodynamics MEMO No CFD/TERMO-5-97 DATE: December 9,997 TITLE A comparison of complete vs. simplied viscous terms in boundary layer

More information

ON USING ARTIFICIAL COMPRESSIBILITY METHOD FOR SOLVING TURBULENT FLOWS

ON USING ARTIFICIAL COMPRESSIBILITY METHOD FOR SOLVING TURBULENT FLOWS Conference Applications of Mathematics 212 in honor of the 6th birthday of Michal Křížek. Institute of Mathematics AS CR, Prague 212 ON USING ARTIFICIAL COMPRESSIBILITY METHOD FOR SOLVING TURBULENT FLOWS

More information

Turbulent Boundary Layers & Turbulence Models. Lecture 09

Turbulent Boundary Layers & Turbulence Models. Lecture 09 Turbulent Boundary Layers & Turbulence Models Lecture 09 The turbulent boundary layer In turbulent flow, the boundary layer is defined as the thin region on the surface of a body in which viscous effects

More information

Research of Micro-Rectangular-Channel Flow Based on Lattice Boltzmann Method

Research of Micro-Rectangular-Channel Flow Based on Lattice Boltzmann Method Research Journal of Applied Sciences, Engineering and Technology 6(14): 50-55, 013 ISSN: 040-7459; e-issn: 040-7467 Maxwell Scientific Organization, 013 Submitted: November 08, 01 Accepted: December 8,

More information

Fluid Mechanics Theory I

Fluid Mechanics Theory I Fluid Mechanics Theory I Last Class: 1. Introduction 2. MicroTAS or Lab on a Chip 3. Microfluidics Length Scale 4. Fundamentals 5. Different Aspects of Microfluidcs Today s Contents: 1. Introduction to

More information

Numerical Methods in Geophysics. Introduction

Numerical Methods in Geophysics. Introduction : Why numerical methods? simple geometries analytical solutions complex geometries numerical solutions Applications in geophysics seismology geodynamics electromagnetism... in all domains History of computers

More information

1. INTRODUCTION TO CFD SPRING 2019

1. INTRODUCTION TO CFD SPRING 2019 1. INTRODUCTION TO CFD SPRING 2019 1.1 What is computational fluid dynamics? 1.2 Basic principles of CFD 1.3 Stages in a CFD simulation 1.4 Fluid-flow equations 1.5 The main discretisation methods Appendices

More information

Notes 4: Differential Form of the Conservation Equations

Notes 4: Differential Form of the Conservation Equations Low Speed Aerodynamics Notes 4: Differential Form of the Conservation Equations Deriving Conservation Equations From the Laws of Physics Physical Laws Fluids, being matter, must obey the laws of Physics.

More information

3. FORMS OF GOVERNING EQUATIONS IN CFD

3. FORMS OF GOVERNING EQUATIONS IN CFD 3. FORMS OF GOVERNING EQUATIONS IN CFD 3.1. Governing and model equations in CFD Fluid flows are governed by the Navier-Stokes equations (N-S), which simpler, inviscid, form is the Euler equations. For

More information

AE/ME 339. Computational Fluid Dynamics (CFD) K. M. Isaac. Momentum equation. Computational Fluid Dynamics (AE/ME 339) MAEEM Dept.

AE/ME 339. Computational Fluid Dynamics (CFD) K. M. Isaac. Momentum equation. Computational Fluid Dynamics (AE/ME 339) MAEEM Dept. AE/ME 339 Computational Fluid Dynamics (CFD) 9//005 Topic7_NS_ F0 1 Momentum equation 9//005 Topic7_NS_ F0 1 Consider the moving fluid element model shown in Figure.b Basis is Newton s nd Law which says

More information

Wave Propagation Software, Computational Science, and Reproducible Research

Wave Propagation Software, Computational Science, and Reproducible Research Wave Propagation Software, Computational Science, and Reproducible Research Randall J. LeVeque Department of Applied Mathematics University of Washington Supported in part by NSF and DOE Outline Hyperbolic

More information

Two-layer shallow water system and its applications

Two-layer shallow water system and its applications Proceedings of Symposia in Applied Mathematics Two-layer shallow water system and its applications Jihwan Kim and Randall J. LeVeque Abstract. The multi-layer shallow water system is derived by depth averaging

More information

CFD in COMSOL Multiphysics

CFD in COMSOL Multiphysics CFD in COMSOL Multiphysics Mats Nigam Copyright 2016 COMSOL. Any of the images, text, and equations here may be copied and modified for your own internal use. All trademarks are the property of their respective

More information

Computational Fluid Dynamics-1(CFDI)

Computational Fluid Dynamics-1(CFDI) بسمه تعالی درس دینامیک سیالات محاسباتی 1 دوره کارشناسی ارشد دانشکده مهندسی مکانیک دانشگاه صنعتی خواجه نصیر الدین طوسی Computational Fluid Dynamics-1(CFDI) Course outlines: Part I A brief introduction to

More information

1. The Properties of Fluids

1. The Properties of Fluids 1. The Properties of Fluids [This material relates predominantly to modules ELP034, ELP035] 1.1 Fluids 1.1 Fluids 1.2 Newton s Law of Viscosity 1.3 Fluids Vs Solids 1.4 Liquids Vs Gases 1.5 Causes of viscosity

More information

CFD Analysis for Thermal Behavior of Turbulent Channel Flow of Different Geometry of Bottom Plate

CFD Analysis for Thermal Behavior of Turbulent Channel Flow of Different Geometry of Bottom Plate International Journal Of Engineering Research And Development e-issn: 2278-067X, p-issn: 2278-800X, www.ijerd.com Volume 13, Issue 9 (September 2017), PP.12-19 CFD Analysis for Thermal Behavior of Turbulent

More information

Part I. Discrete Models. Part I: Discrete Models. Scientific Computing I. Motivation: Heat Transfer. A Wiremesh Model (2) A Wiremesh Model

Part I. Discrete Models. Part I: Discrete Models. Scientific Computing I. Motivation: Heat Transfer. A Wiremesh Model (2) A Wiremesh Model Part I: iscrete Models Scientific Computing I Module 5: Heat Transfer iscrete and Continuous Models Tobias Neckel Winter 04/05 Motivation: Heat Transfer Wiremesh Model A Finite Volume Model Time ependent

More information

Chapter 6: Incompressible Inviscid Flow

Chapter 6: Incompressible Inviscid Flow Chapter 6: Incompressible Inviscid Flow 6-1 Introduction 6-2 Nondimensionalization of the NSE 6-3 Creeping Flow 6-4 Inviscid Regions of Flow 6-5 Irrotational Flow Approximation 6-6 Elementary Planar Irrotational

More information

Fluid Mechanics. Spring 2009

Fluid Mechanics. Spring 2009 Instructor: Dr. Yang-Cheng Shih Department of Energy and Refrigerating Air-Conditioning Engineering National Taipei University of Technology Spring 2009 Chapter 1 Introduction 1-1 General Remarks 1-2 Scope

More information

Detailed Outline, M E 320 Fluid Flow, Spring Semester 2015

Detailed Outline, M E 320 Fluid Flow, Spring Semester 2015 Detailed Outline, M E 320 Fluid Flow, Spring Semester 2015 I. Introduction (Chapters 1 and 2) A. What is Fluid Mechanics? 1. What is a fluid? 2. What is mechanics? B. Classification of Fluid Flows 1. Viscous

More information

The behaviour of high Reynolds flows in a driven cavity

The behaviour of high Reynolds flows in a driven cavity The behaviour of high Reynolds flows in a driven cavity Charles-Henri BRUNEAU and Mazen SAAD Mathématiques Appliquées de Bordeaux, Université Bordeaux 1 CNRS UMR 5466, INRIA team MC 351 cours de la Libération,

More information

Clawpack Tutorial Part I

Clawpack Tutorial Part I Clawpack Tutorial Part I Randall J. LeVeque Applied Mathematics University of Washington Conservation Laws Package www.clawpack.org (pdf s will be posted and green links can be clicked) Some collaborators

More information

Flow simulation on moving boundary-fitted grids and application to fluid-structure interaction problems

Flow simulation on moving boundary-fitted grids and application to fluid-structure interaction problems Flow simulation on moving boundary-fitted grids and application to fluid-structure interaction problems Martin Engel and Michael Griebel Institute of Numerical Simulation, University of Bonn, Wegelerstr.

More information

Fluid Dynamics: Theory, Computation, and Numerical Simulation Second Edition

Fluid Dynamics: Theory, Computation, and Numerical Simulation Second Edition Fluid Dynamics: Theory, Computation, and Numerical Simulation Second Edition C. Pozrikidis m Springer Contents Preface v 1 Introduction to Kinematics 1 1.1 Fluids and solids 1 1.2 Fluid parcels and flow

More information

Heat and Mass Transfer Prof. S.P. Sukhatme Department of Mechanical Engineering Indian Institute of Technology, Bombay

Heat and Mass Transfer Prof. S.P. Sukhatme Department of Mechanical Engineering Indian Institute of Technology, Bombay Heat and Mass Transfer Prof. S.P. Sukhatme Department of Mechanical Engineering Indian Institute of Technology, Bombay Lecture No. 18 Forced Convection-1 Welcome. We now begin our study of forced convection

More information

High-Resolution Finite Volume Methods and Adaptive Mesh Refinement

High-Resolution Finite Volume Methods and Adaptive Mesh Refinement High-Resolution Finite Volume Methods and Adaptive Mesh Refinement Randall J. LeVeque Department of Applied Mathematics University of Washington CLAWPACK and TsunamiClaw Software http://www.amath.washington.edu/~claw

More information

Numerical Investigation of Thermal Performance in Cross Flow Around Square Array of Circular Cylinders

Numerical Investigation of Thermal Performance in Cross Flow Around Square Array of Circular Cylinders Numerical Investigation of Thermal Performance in Cross Flow Around Square Array of Circular Cylinders A. Jugal M. Panchal, B. A M Lakdawala 2 A. M. Tech student, Mechanical Engineering Department, Institute

More information

Supplementary Information for Engineering and Analysis of Surface Interactions in a Microfluidic Herringbone Micromixer

Supplementary Information for Engineering and Analysis of Surface Interactions in a Microfluidic Herringbone Micromixer Supplementary Information for Engineering and Analysis of Surface Interactions in a Microfluidic Herringbone Micromixer Thomas P. Forbes and Jason G. Kralj National Institute of Standards and Technology,

More information

Viscous Fluids. Amanda Meier. December 14th, 2011

Viscous Fluids. Amanda Meier. December 14th, 2011 Viscous Fluids Amanda Meier December 14th, 2011 Abstract Fluids are represented by continuous media described by mass density, velocity and pressure. An Eulerian description of uids focuses on the transport

More information

Masters in Mechanical Engineering. Problems of incompressible viscous flow. 2µ dx y(y h)+ U h y 0 < y < h,

Masters in Mechanical Engineering. Problems of incompressible viscous flow. 2µ dx y(y h)+ U h y 0 < y < h, Masters in Mechanical Engineering Problems of incompressible viscous flow 1. Consider the laminar Couette flow between two infinite flat plates (lower plate (y = 0) with no velocity and top plate (y =

More information

A unifying model for fluid flow and elastic solid deformation: a novel approach for fluid-structure interaction and wave propagation

A unifying model for fluid flow and elastic solid deformation: a novel approach for fluid-structure interaction and wave propagation A unifying model for fluid flow and elastic solid deformation: a novel approach for fluid-structure interaction and wave propagation S. Bordère a and J.-P. Caltagirone b a. CNRS, Univ. Bordeaux, ICMCB,

More information

Several forms of the equations of motion

Several forms of the equations of motion Chapter 6 Several forms of the equations of motion 6.1 The Navier-Stokes equations Under the assumption of a Newtonian stress-rate-of-strain constitutive equation and a linear, thermally conductive medium,

More information

Numerical simulation of steady and unsteady flow for generalized Newtonian fluids

Numerical simulation of steady and unsteady flow for generalized Newtonian fluids Journal of Physics: Conference Series PAPER OPEN ACCESS Numerical simulation of steady and unsteady flow for generalized Newtonian fluids To cite this article: Radka Keslerová et al 2016 J. Phys.: Conf.

More information

Chapter 2: Basic Governing Equations

Chapter 2: Basic Governing Equations -1 Reynolds Transport Theorem (RTT) - Continuity Equation -3 The Linear Momentum Equation -4 The First Law of Thermodynamics -5 General Equation in Conservative Form -6 General Equation in Non-Conservative

More information

A recovery-assisted DG code for the compressible Navier-Stokes equations

A recovery-assisted DG code for the compressible Navier-Stokes equations A recovery-assisted DG code for the compressible Navier-Stokes equations January 6 th, 217 5 th International Workshop on High-Order CFD Methods Kissimmee, Florida Philip E. Johnson & Eric Johnsen Scientific

More information

Zonal modelling approach in aerodynamic simulation

Zonal modelling approach in aerodynamic simulation Zonal modelling approach in aerodynamic simulation and Carlos Castro Barcelona Supercomputing Center Technical University of Madrid Outline 1 2 State of the art Proposed strategy 3 Consistency Stability

More information

Welcome to MECH 280. Ian A. Frigaard. Department of Mechanical Engineering, University of British Columbia. Mech 280: Frigaard

Welcome to MECH 280. Ian A. Frigaard. Department of Mechanical Engineering, University of British Columbia. Mech 280: Frigaard Welcome to MECH 280 Ian A. Frigaard Department of Mechanical Engineering, University of British Columbia Lectures 1 & 2: Learning goals/concepts: What is a fluid Apply continuum hypothesis Stress and viscosity

More information