Numerical Hydrodynamics: A Primer. Wilhelm Kley Institut für Astronomie & Astrophysik & Kepler Center for Astro and Particle Physics Tübingen

Size: px
Start display at page:

Download "Numerical Hydrodynamics: A Primer. Wilhelm Kley Institut für Astronomie & Astrophysik & Kepler Center for Astro and Particle Physics Tübingen"

Transcription

1 A Primer Wilhelm Kley Institut für Astronomie & Astrophysik & Kepler Center for Astro and Particle Physics Tübingen Bad Honnef 2016

2 Hydrodynamics: Hydrodynamic Equations The Euler-Equations in conservative form read ρ + (ρ u) = 0 (1) (ρ u) + (ρ u u) = p + ρ k (2) (ρɛ) + (ρɛ u) = p u (3) u: Velocity, k: external forces, ɛ specific internal energy The equations describe the conservation of mass, momentum and energy. For completion we need an equation of state (eos): p = (γ 1) ρɛ (4) Using this and eq. (3), we can rewrite the energy equation as an equation for the pressure p + (p u) = (γ 1)p u (5) W. Kley Numerical Hydrodynamics: A Primer Bad Honnef

3 Hydrodynamics: Reformulating Expanding the divergences on the left side and use for the momentum and energy equation the continuity equation ρ + ( u )ρ = ρ u (6) u + ( u ) u = 1 ρ p + k (7) p + ( u )p = γp u (8) Since all quantities depend on space ( r) and time (t), for example ρ( r, t), we can use for the left side the total time derivative (Lagrange-Formulation). For example, for the density one obtains Dρ Dt = ρ + ( u )ρ = ρ u. (9) The Operator D Dt = + u (10) is called material derivative (equivalent to the total time derivative, d/dt). W. Kley Numerical Hydrodynamics: A Primer Bad Honnef

4 Hydrodynamics: Lagrange-Formulation Use now the material derivative Dρ Dt D u Dt Dp Dt = ρ u (11) = 1 ρ p + k (12) = γp u (13) These equations describe the change of the quantities in the comoving frame = Lagrange-Formulation. For the Euler-Formulation, one analysed the changes at a specific, fixed point in space! The Lagrange-Formulation can be used conveniently for 1D-problems, for example the radial stellar oscillations, using comoving mass-shells. For the Euler-Formulation a fixed grid is used. W. Kley Numerical Hydrodynamics: A Primer Bad Honnef

5 The problem Consider the evolution of the full time-dependent hydrodynamic equations. The non-linear partial differential equations of hydrodynamics will be solved numerically Continuum Discretisation W. Kley Numerical Hydrodynamics: A Primer Bad Honnef

6 Method of solution Grid-based methods (Euler) Particle methods (Lagrange) fixed Grid - matter flows through grid ( ) u ρ + u u = p Methods: finite differences non-conservative Control Volume conservative Riemann-solver wave properties Problem: Discontinuities moving Grid/Particle - flow moved grid ρ d u = p dt Well known method: Smoothed Particle Hydrodynamics, SPH smeared out particles good for free boundaries, self-gravity W. Kley Numerical Hydrodynamics: A Primer Bad Honnef

7 consider: 1D Euler equations describe conservation of mass, momentum and energy ρ + ρu x ρu + ρuu x ρɛ + ρɛu x ρ: density u: velocity p: pressure ɛ: internal specific energy (Energy/Mass) with the equation of state γ: adiabatic exponent partial differential equation in space and time need discretisation in space and time. = 0 (14) = p x = p u x (15) (16) p = (γ 1)ρɛ (17) W. Kley Numerical Hydrodynamics: A Primer Bad Honnef

8 Discretisation ψ Consider funktion: ψ(x, t) discretisation in space cover with a grid x = x max x min N ψ n j j 1 j j+1 cell average of ψ(x, t) at the grdipoint x j at time t n X ψj n = ψ(x j, t n ) 1 (j+1/2) x ψ(x, n t)dx x (j 1/2) x ψ n j is piecewise constant. j spatial index, n time step. W. Kley Numerical Hydrodynamics: A Primer Bad Honnef

9 Integration in time Consider general equation ψ = L(ψ(x, t)) (18) with a (spatial) differential operator L. typical Discretisation (1. order in time), at time: t = t n = n t ψ ψ(t + t) ψ(t) t = ψn+1 ψ n t now at a special location, the grid point x j (with moving terms) = L(ψ n ) (19) ψ n+1 j = ψ n j + tl(ψ n k ) (20) L(ψk n ): discretised differential operator L (here explicit) - k in L(ψ k ): set of spatial indices: - typical for 2. order: k {j 2, j 1, j, j + 1, j + 2} (need information from left and right, 5 point Stencil ) W. Kley Numerical Hydrodynamics: A Primer Bad Honnef

10 Operator-Splitting A L i ( A), i = 1, 2 individul (Differential-)operators applied to the quantities A = (ρ, u, ɛ). Here, for 1D ideal hydrodynamics = L 1 ( A) + L 2 ( A) (21) L 1 : Advection L 2 : pressure, or external forces To solve the full equation the solution is split in several substeps A 1 = A n + tl 1 ( A n ) A n+1 = A 2 = A 1 + tl 2 ( A 1 ) (22) L i is the differential operator to L i. W. Kley Numerical Hydrodynamics: A Primer Bad Honnef

11 advection-step In explicit conservation form ρ (ρu) (ρɛ) = ρu x = (ρuu) x = (ρɛu) x for u = (u 1, u 2, u 3 ) and f = (f 1, f 2, f 3 ) we have: u = (ρ, ρu, ρɛ) and f = (ρ u, ρuu, ρɛu). u + f ( u) = 0 (23) x This step yields: ρ n ρ 1 = ρ n+1, u n u 1, ɛ n ɛ 1 W. Kley Numerical Hydrodynamics: A Primer Bad Honnef

12 Force terms Momentum equation u n+1 j = u j t u 1 ρ n+1 j = 1 p ρ x ( ) pj p j 1 x (24) for j = 2, N (25) energy equation ɛ = p u ρ x ( ) ɛ n+1 p j uj+1 u j j = ɛ j t ρ n+1 x j (26) for j = 1, N (27) on the right hand side we use the actual values for u, ɛ and p, i.e. here u 1, p 1, ɛ 1. This step yields: u 1 u n+1, ɛ 1 ɛ n+1 W. Kley Numerical Hydrodynamics: A Primer Bad Honnef

13 Model equation for advection The continuity equation was Here, F m = ρu is the mass flow ρ + ρu x = 0 (28) Using the notation ρ ψ and u a = const. we obtain the Linear Advection Equation ψ + a ψ x = 0. (29) with a constant velocity a, the solution is a wave traveling to the right using ψ(x, t = 0) = f (x) we get ψ(x, t) = f (x at) Here f (x) is the initial condition at time t = 0, that is shifted by the advection with a constant velocity a to the right. The numerics should maintain this property as accurately as possible. W. Kley Numerical Hydrodynamics: A Primer Bad Honnef

14 Linear Advection FTCS: Forward Time Centered Space algorithm ψ + a ψ x = 0 (30) ψ j 1 ψ j ψ j+1 Specify the grid : and write it follows ψ j n ψ x j n x = ψn+1 j j 1 t ψ n j = ψn j+1 ψn j 1 2 x x x j j+1 ψ n+1 j = ψj n a t ( ψ n 2 x j+1 ψj 1) n (31) (32) (33) The method looks well motivated: but it is unstable for all t! W. Kley Numerical Hydrodynamics: A Primer Bad Honnef

15 Upwind-Method I or ψ ψ + aψ x = 0 (34) + a ψ x = 0 (35) ψ α a t a: constant (velocity) > 0 ψ(x, t) arbitrary transport quantity change of ψ in grid cell j ψ n+1 j x = ψ n j x + t(f in F out ) (36) in out The flux F in is for constant ψ j F in = a ψ n j 1 (37) F out = a ψ n j (38) Upwind-Method Information comes from upstream j 1 j j+1 purple regions will be transported into the next neighbour cell X W. Kley Numerical Hydrodynamics: A Primer Bad Honnef

16 Upwind-Method II Extension for non-constant states ( F in = a ψ I x j 1/2 a t ) 2 (39) ψ α a t ψ I(x) ψ I (x) interpolation polynomial Here linear interpolation (straight line) This yields F in = a [ ψj 1 n + 1 ] }{{} 2 (1 σ) ψ j 1 (40) 1st Order } {{ } 2nd Order with σ = a t/ x ψ j ψ x x xj ψ I (x) = ψ n j in out j 1 j j+1 + x x j x ψ j (41) ψ j undivided differences 2nd order upwind ψ I (x) is evaluated in the middle of the purple area. X W. Kley Numerical Hydrodynamics: A Primer Bad Honnef

17 Undivided Difference a) ψ j = 0 Upwind, 1st Order, piece-wise constant b) ψ j = 1 ( ) 2 ψj+1 ψ j 1 Fromm, centered derivative c) ψ j = ψ j ψ j 1 Beam-Warming, upwind slope d) ψ j = ψ j+1 ψ j Lax-Wendroff, downwind slope Often used is the 2nd Order Upwind (van Leer) Geometric Mean (maintains the Monotonicity) 2 (ψ j+1 ψ j )(ψ j ψ j 1 ) (ψ j+1 ψ j 1 ) if (ψ j+1 ψ j )(ψ j ψ j 1 ) > 0 ψ j = 0 otherwise (42) The derivatives are evaluated at the corresponding time step level or the intermediate time step W. Kley Numerical Hydrodynamics: A Primer Bad Honnef

18 t t n+1 n+1/2 t n ψ n j 1 Using two steps: n+1 ψj ~ n+1/2 ψ ψ~ n+1/2 j 1/2 j+1/2 ψ n j Lax-Wendroff Method ψ n j+1 predictor-step (at intermediate time t n+1/2 ) Schematic overview of the method uses centered spatial and temporal differences that makes it 2nd order in space and time ψ n+1/2 j+1/2 = 1 ( ) ψj n + ψj+1 n σ ( ) ψj+1 n 2 2 ψn j The corrector-step (to new time t n+1 ) ψ n+1 j = ψ n j σ ( ψ n+1/2 j+1/2 ψ n+1/2 j 1/2 ) (43) (44) W. Kley Numerical Hydrodynamics: A Primer Bad Honnef

19 ψ(x) Example: Linar Advection Upwind - (Diffusive) 1 Linear Advection (N=600,t=40): Upwind, sigma=0.8 Analytic Upwind 0.8 Square function: Width 0.6 in the intervall [ 1, 1] velocity a = 1, until t = 40 periodic boundaries σ = a t/ x = (Courant no.) Van Leer Linear Advection (N=600,t=40): Van Leer, sigma=0.8 Analytic Van Leer Phi-Achse X-Achse Lax-Wendroff - (Dispersive) Linear Advection (N=600,t=40): Lax Wendroff, sigma=0.8 Analytic Lax Wendroff Phi-Achse 0.4 Phi-Achse X-Achse X-Achse W. Kley Numerical Hydrodynamics: A Primer Bad Honnef

20 Stability analysis I Substitute for the solution a Fourier series (von Neumann 1940/50s) consider simplifying one component, and analyse its growth properties ψ n j = V n e iθj (45) here, θ is defined through grid size x and the total length L θ = 2π x L Consider simple Upwind method with σ = a t/ x (46) Substituting eq. (45) ψ n+1 j ψ n j + σ(ψ n j ψ n j 1 ) = 0 (47) V n+1 e iθj = V n e iθj + σv n [ e iθ(j 1) e iθj] dividing by V n and e iθj yields V n+1 V n ( ) = 1 + σ e iθ 1 (48) W. Kley Numerical Hydrodynamics: A Primer Bad Honnef

21 Stability annalysis II For the square of the absolute value one obtains λ(θ) V n+1 2 [ ( )] [ ( )] V n = 1 + σ e iθ σ e iθ 1 ( ) ( ) = 1 + σ e iθ + e iθ 2 σ 2 e iθ + e iθ 2 = 1 + σ(1 σ)(2 cos θ 2) ( ) θ = 1 4σ(1 σ) sin 2 2 (49) The method is now stable, if the magnitude of the amplification factor λ(θ) is smaller than unity. The upwind-method is stable for 0 < σ < 1, the λ(θ) < 1. Rewritten x t < f CFL (50) a with the Courant-faktor f CFL < 1. Typically f CFL = 0.5. Theorem: Courant-Friedrich-Levy There is no explizit, consistent and stable finite difference method which is unconditionally stable (i.e. for all t). W. Kley Numerical Hydrodynamics: A Primer Bad Honnef

22 Modified Equation I Consider again Upwind method mit σ = a t/ x ψ n+1 j ψ n j + σ(ψ n j ψ n j 1 ) = 0 (51) substitute differences by derivatives, i.e. Taylor-series (up to 2. order) ( ψ t+1 ψ ψ 2 t t2 +O( t 3 )+σ x x 1 2 ) ψ 2 x 2 x 2 +O( t x 2 ) = 0 (52) divied by t, and substitute for σ ψ + a ψ x ( ψ t t a 2 ψ x 2 x ) + O( t 2 ) + O( x 2 ) = 0 (53) Use wave equation ψ tt = a 2 ψ xx modified equation (index M) ψ M + a ψ M x The FDE adds a new diffusive term to the original PDE = 1 2 a x (1 σ) 2 ψ M x 2 (54) W. Kley Numerical Hydrodynamics: A Primer Bad Honnef

23 Modified Equation II with the diffusion coefficient D = 1 a x (1 σ) (55) 2 Note: only for D > 0 this is a diffusion equation, and it follows σ < 1 for stability. (Hirt-method). For Upwind-Method D > 0 Diffusion. Lax-Wendroff yields ψ M The equation has the form + a ψ M x = t2 a σ ( ) σ 2 3 ψ 1 M x 3 (56) ψ t + aψ x = µψ xxx (57) µ = t 2 a ( σ 2 1 ) (58) σ This implies Dispersion. Here: waves are too slow (µ < 0) Oscillations behind the diskontinuity (cp. square function) W. Kley Numerical Hydrodynamics: A Primer Bad Honnef

24 The time step From the above analysis: the time step t has to be limited for a stable numerical evolution. For the linear Advection (with the velocity a) we find t < x (59) a In the more general case the sound speed has to be included and it follows the Courant-Friedrich-Lewy-condition t < x c s + u physically this means that information cannot travel in one timestep more than one gridcell. Typically one writes x t = f C c s + u with the Courant-Factor f C. For 2D situations: f C 0.5. Only for impliciten methods there are (theoretically) no limitations of t. (60) (61) W. Kley Numerical Hydrodynamics: A Primer Bad Honnef

25 Time step size - graphically The numerical region of dependence (dashed line) should be larger than the physical one (gray shaded area) since x/ t > a. The complete information from inside the physical sound cone should be considered. W. Kley Numerical Hydrodynamics: A Primer Bad Honnef

26 Multi-dimensional Grid definition (in 2D, staggered): skalers in cell centers (hier: ρ, ɛ, p, v 3, ψ) Vectors ar interfaces (here: v 1, v 2 ) Fluxes across cell boundaries Top: mass flux bottom: X-momentum (griud shifted) from: ZEUS-2D: A radiation magnetohydrodynamics code for astrophysical flows in two space dimensions. I in The Astrophysical Journal Suppl., by Jim Stone and Mike Norman, Use Operator-Splitting and Directional Splitting: The x and y direction are dealt with subseuqently. First x-scans, then y-scans. W. Kley Numerical Hydrodynamics: A Primer Bad Honnef

27 Summary: Numerics Numerical methods should resemble the conservation properties. write equations in conservative form Numerical Methods should resemble the wave properties. Shock-Capturing methods, Riemann-solver Numerical Methods should control discontinuites. need diffusion ( stability) either explicitly (artificial viscosity) or intrinsically (through method) Numerical methods should be accurate min. 2nd order in space and time Freely available codes: ZEUS: classical Upwind-Code, 2nd order, staggered grid, RMHD ATHENA: successo of ZEUS: Riemann solver, centered grid, MHD NIRVANA: 3D, AMR, finite volume code, MHD PLUTO: 3D, relativistic, Riemann-solver/finite volume, MHD GADGET: W. Kley Numerical Hydrodynamics: A Primer Bad Honnef

28 Hydrodynamics: Wave structure Consider one-dimensional equtions (motion in x-direction): From Euler equations: With p = (γ 1)ρɛ and separation of derivatives ρ + ρu ρu ρɛ As Vector equation mit x = 0 + ρuu x = p x + ρɛu x = p u x W = ρ u p = W ρ + u ρ x + ρ u x = 0 u + u u x + 1 p ρ x = 0 p + u p u x + γp x = 0 + A W x = 0 (62) und A = Equations are non-linear and coupled. Try decoupling: Diagonalisation of A u ρ 0 0 u 1/ρ 0 γp u (63) W. Kley Numerical Hydrodynamics: A Primer Bad Honnef

29 Hydrodynamics: Diagonalisation Eigenvalues (EV) det(a) = It follows u λ ρ 0 0 u λ 1/ρ = (u λ) u λ 1/ρ 0 γp u λ γp u λ [ ] = (u λ) (u λ) 2 γp/ρ = 0 (64) λ 0 = u λ ± = u ± c s (65) with the sound speed cs 2 = γp ρ The Eigenvalues are the charakteristic velocities, with which the information is spreading. It is a combination of fluid velocity (u) and sound speed (c s) 3 real Eigenvalues A diagonalisable (66) Q 1 AQ = Λ (67) Q is built up from the Eigenvalues to the EV (λ i, i = 0, +, ), Λ is a diagonal matrix. W. Kley Numerical Hydrodynamics: A Primer Bad Honnef

30 Hydrodynamics: Charakteristic Variables For Q it follows 1 ρ 1 2 c s 1 ρ c s Q = und Q 1 cs 2 1 = ρc s 1 2 ρc ρc s s ρc s We had and Define: W + A W x = 0 (68) Q 1 AQ = Λ dv Q 1 dw also dw = Qdv (69) Multiply eq. (68) with Q 1 v + Λ v x = 0 (70) v = (v 0, v +, v ) are the charakteristic Variables: v i = const. in curves dx dt = λ i W. Kley Numerical Hydrodynamics: A Primer Bad Honnef

31 Hydrodynamics: The variable v 0 from the definitions dv 0 = dρ 1 c 2 s dp (71) v 0 + λ 0 v 0 x = 0 mit λ 0 = u (72) What is dv 0? From thermodynamics (1. Law) for specific quantities) ( ) 1 Tds = dɛ + p d = dɛ p ( ) 1 ρ ρ d 2 ρ with p = (γ 1)ρɛ, ɛ = c vt, γ = c p/c v it follows [ ds = cp dρ dp ] = cp ρ cs 2 ρ dv 0 (74) = s + u s x = 0 (75) i.e. s is const. along stream lines, hence ds dt (73) = 0 (76) W. Kley Numerical Hydrodynamics: A Primer Bad Honnef

32 Hydrodynamics: Riemann-Invariants For the additional variables with it follows v ± + (u ± c s) v± x = 0 (77) dv ± = du ± 1 ρc s dp (78) v ± = u ± Let the entropy constant everywhere (i.e. p = K ρ γ ) dp ρc s. (79) = v ± = u ± 2cs γ 1 (80) Riemann-Invariants: v ± = const. on curves dx dt = u ± c s W. Kley Numerical Hydrodynamics: A Primer Bad Honnef

33 Hydrodynamics: Steepening of sound waves Linearisation of the Euler-equation resukts in the wave equation for the perturbations: ρ 1 = c 2 2 ρ 1 Example for (receeding) shock wave s (81) t x 2 but: c s is not constant steepening Diskontinuities W. Kley Numerical Hydrodynamics: A Primer Bad Honnef

34 Examples: Shocktube Initial discontinuity in a tube at position x 0 (one-dimensional) Bereich 2 Riemann-Problem Bereich 1 Jump in pressure (p) and density (ρ) Diskontinuität P2 Evolution: - a shock wave to the right (X 4 ) ρ 2 (supersonically u sh > c s ) - a contact discontinuity ρ 1 P1 density jump (along X 3 ) - a rarefaction wave x (between X 1 and X 2 ) 0 W. Kley Numerical Hydrodynamics: A Primer Bad Honnef

35 Examples: Sod-Shocktube A standard test problem for numerical hydrodynamics, x [0, 1] with X 0 = 0.5, γ = 1.4 ρ 1 = 1.0, p 1 = 1.0, ɛ 1 = 2.5, T 1 = 1 and ρ 2 = 0.1, p 2 = 0.125, ɛ 2 = 2.0, T 2 = 0.8 Hier solution with van Leer method (at time t = after 228 time steps:) Velocity Temperature Shock-Tube: Sod; Mono: Geometric Mean; Nx=100, Nt=228, dt= Density Pressure Red: Exact Green: Numerics The solution is: self similar obtained through stretching X-Axis X-Axis W. Kley Numerical Hydrodynamics: A Primer Bad Honnef

36 Examples: Sedov-Explosion An example for bomb explosions (Sedov & Taylor, 1950s), analytical solution (Sedov) Basic setup for Supernovae-outbusts, e.g. estimate of the remnant size Standard test problem of multi-dimensional hydrodynamics, e.g. for x, y [0, 1] [0, 1] Energy-Input at origin, E = 1, in ρ = 1, γ = 1.4, grid points Here: solution with van Leer method (solve for total energy variable). Plotted: density W. Kley Numerical Hydrodynamics: A Primer Bad Honnef

37 Examples: Water droplet: SPH Water sphere (R=30cm), Basin (1x1 m, 60cm high) Incl. surface tension, time in seconds (TU-München, 2002) (Website) W. Kley Numerical Hydrodynamics: A Primer Bad Honnef

38 Examples: Ster formation: SPH Molecular Cloud Mass: 50 M Diameter: 1.2 LJ = 76,000 AU Temperature: 10 K (M. Bate, 2002) W. Kley Numerical Hydrodynamics: A Primer Bad Honnef

39 Examples: Kelvin-Helmholtz Instability I W. Kley Numerical Hydrodynamics: A Primer Bad Honnef

40 Examples: Kelvin-Helmholtz Instability II Direct comparision: moving < > fixed grid Left: Moving grid (Voronoi-Tesselation) Right: fixed square grid (Euler) with grid motion displayed (Kevin Schaal, Tübingen) Youtube channel W. Kley Numerical Hydrodynamics: A Primer Bad Honnef

41 Examples: Kelvin-Helmholtz Instability III (Boulder (NCAR), USA) W. Kley Numerical Hydrodynamics: A Primer Bad Honnef

42 Examples: Rayleigh-Taylor Instability PPM Code, 128 Nodes, ASCI Blue-Pacific ID System at LLNL Grid Cells (LLNL, 1999) (Web-Link) W. Kley Numerical Hydrodynamics: A Primer Bad Honnef

43 Examples: Diesel Injection Finite Volumen Method (FOAM) Velocity, Temperature, Particles (+Isosurfaces) (Nabla Ltd, 2004) W. Kley Numerical Hydrodynamics: A Primer Bad Honnef

44 Examples: Cataclysmic Variable: Grid y x W. Kley Numerical Hydrodynamics: A Primer Bad Honnef

45 Examples: Kataclysmic Variable: Disk formation RH2D Code, Van Leer slope Gridpoints, mass ratio: q = m 2 /m 1 = 0.15 W. Kley Numerical Hydrodynamics: A Primer Bad Honnef

Numerical Solutions for Hyperbolic Systems of Conservation Laws: from Godunov Method to Adaptive Mesh Refinement

Numerical Solutions for Hyperbolic Systems of Conservation Laws: from Godunov Method to Adaptive Mesh Refinement Numerical Solutions for Hyperbolic Systems of Conservation Laws: from Godunov Method to Adaptive Mesh Refinement Romain Teyssier CEA Saclay Romain Teyssier 1 Outline - Euler equations, MHD, waves, hyperbolic

More information

The one-dimensional equations for the fluid dynamics of a gas can be written in conservation form as follows:

The one-dimensional equations for the fluid dynamics of a gas can be written in conservation form as follows: Topic 7 Fluid Dynamics Lecture The Riemann Problem and Shock Tube Problem A simple one dimensional model of a gas was introduced by G.A. Sod, J. Computational Physics 7, 1 (1978), to test various algorithms

More information

Advection / Hyperbolic PDEs. PHY 604: Computational Methods in Physics and Astrophysics II

Advection / Hyperbolic PDEs. PHY 604: Computational Methods in Physics and Astrophysics II Advection / Hyperbolic PDEs Notes In addition to the slides and code examples, my notes on PDEs with the finite-volume method are up online: https://github.com/open-astrophysics-bookshelf/numerical_exercises

More information

Fluid Dynamics. Part 2. Massimo Ricotti. University of Maryland. Fluid Dynamics p.1/17

Fluid Dynamics. Part 2. Massimo Ricotti. University of Maryland. Fluid Dynamics p.1/17 Fluid Dynamics p.1/17 Fluid Dynamics Part 2 Massimo Ricotti ricotti@astro.umd.edu University of Maryland Fluid Dynamics p.2/17 Schemes Based on Flux-conservative Form By their very nature, the fluid equations

More information

CapSel Euler The Euler equations. conservation laws for 1D dynamics of compressible gas. = 0 m t + (m v + p) x

CapSel Euler The Euler equations. conservation laws for 1D dynamics of compressible gas. = 0 m t + (m v + p) x CapSel Euler - 01 The Euler equations keppens@rijnh.nl conservation laws for 1D dynamics of compressible gas ρ t + (ρ v) x = 0 m t + (m v + p) x = 0 e t + (e v + p v) x = 0 vector of conserved quantities

More information

A Finite Volume Code for 1D Gas Dynamics

A Finite Volume Code for 1D Gas Dynamics A Finite Volume Code for 1D Gas Dynamics Michael Lavell Department of Applied Mathematics and Statistics 1 Introduction A finite volume code is constructed to solve conservative systems, such as Euler

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

Chapter 1. Introduction

Chapter 1. Introduction Chapter 1 Introduction Many astrophysical scenarios are modeled using the field equations of fluid dynamics. Fluids are generally challenging systems to describe analytically, as they form a nonlinear

More information

Fluid Dynamics. Massimo Ricotti. University of Maryland. Fluid Dynamics p.1/14

Fluid Dynamics. Massimo Ricotti. University of Maryland. Fluid Dynamics p.1/14 Fluid Dynamics p.1/14 Fluid Dynamics Massimo Ricotti ricotti@astro.umd.edu University of Maryland Fluid Dynamics p.2/14 The equations of fluid dynamics are coupled PDEs that form an IVP (hyperbolic). Use

More information

Chapter 3. Finite Difference Methods for Hyperbolic Equations Introduction Linear convection 1-D wave equation

Chapter 3. Finite Difference Methods for Hyperbolic Equations Introduction Linear convection 1-D wave equation Chapter 3. Finite Difference Methods for Hyperbolic Equations 3.1. Introduction Most hyperbolic problems involve the transport of fluid properties. In the equations of motion, the term describing the transport

More information

Sung-Ik Sohn and Jun Yong Shin

Sung-Ik Sohn and Jun Yong Shin Commun. Korean Math. Soc. 17 (2002), No. 1, pp. 103 120 A SECOND ORDER UPWIND METHOD FOR LINEAR HYPERBOLIC SYSTEMS Sung-Ik Sohn and Jun Yong Shin Abstract. A second order upwind method for linear hyperbolic

More information

State of the Art MHD Methods for Astrophysical Applications p.1/32

State of the Art MHD Methods for Astrophysical Applications p.1/32 State of the Art MHD Methods for Astrophysical Applications Scott C. Noble February 25, 2004 CTA, Physics Dept., UIUC State of the Art MHD Methods for Astrophysical Applications p.1/32 Plan of Attack Is

More information

The RAMSES code and related techniques I. Hydro solvers

The RAMSES code and related techniques I. Hydro solvers The RAMSES code and related techniques I. Hydro solvers Outline - The Euler equations - Systems of conservation laws - The Riemann problem - The Godunov Method - Riemann solvers - 2D Godunov schemes -

More information

The Center for Astrophysical Thermonuclear Flashes. FLASH Hydrodynamics

The Center for Astrophysical Thermonuclear Flashes. FLASH Hydrodynamics The Center for Astrophysical Thermonuclear Flashes FLASH Hydrodynamics Jonathan Dursi (CITA), Alan Calder (FLASH) B. Fryxell, T. Linde, A. Mignone, G. Wiers Many others! Mar 23, 2005 An Advanced Simulation

More information

CapSel Roe Roe solver.

CapSel Roe Roe solver. CapSel Roe - 01 Roe solver keppens@rijnh.nl modern high resolution, shock-capturing schemes for Euler capitalize on known solution of the Riemann problem originally developed by Godunov always use conservative

More information

The Euler Equations! Advection! λ 1. λ 2. λ 3. ρ ρu. c 2 = γp/ρ. E = e + u 2 /2 H = h + u 2 /2; h = e + p/ρ. 0 u 1/ρ. u p. t + A f.

The Euler Equations! Advection! λ 1. λ 2. λ 3. ρ ρu. c 2 = γp/ρ. E = e + u 2 /2 H = h + u 2 /2; h = e + p/ρ. 0 u 1/ρ. u p. t + A f. http://www.nd.edu/~gtryggva/cfd-course/! Advection! Grétar Tryggvason! Spring! The Euler equations for D flow:! where! Define! Ideal Gas:! ρ ρu ρu + ρu + p = x ( / ) ρe ρu E + p ρ E = e + u / H = h + u

More information

PDEs, part 3: Hyperbolic PDEs

PDEs, part 3: Hyperbolic PDEs PDEs, part 3: Hyperbolic PDEs Anna-Karin Tornberg Mathematical Models, Analysis and Simulation Fall semester, 2011 Hyperbolic equations (Sections 6.4 and 6.5 of Strang). Consider the model problem (the

More information

AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS

AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS 1 / 31 AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS Linearization and Characteristic Relations 1 / 31 AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS

More information

Godunov methods in GANDALF

Godunov methods in GANDALF Godunov methods in GANDALF Stefan Heigl David Hubber Judith Ngoumou USM, LMU, München 28th October 2015 Why not just stick with SPH? SPH is perfectly adequate in many scenarios but can fail, or at least

More information

Numerical Solutions to Partial Differential Equations

Numerical Solutions to Partial Differential Equations Numerical Solutions to Partial Differential Equations Zhiping Li LMAM and School of Mathematical Sciences Peking University Introduction to Hyperbolic Equations The Hyperbolic Equations n-d 1st Order Linear

More information

Computational Astrophysics

Computational Astrophysics 16 th Chris Engelbrecht Summer School, January 2005 3: 1 Computational Astrophysics Lecture 3: Magnetic fields Paul Ricker University of Illinois at Urbana-Champaign National Center for Supercomputing

More information

Numerical Methods for Conservation Laws WPI, January 2006 C. Ringhofer C2 b 2

Numerical Methods for Conservation Laws WPI, January 2006 C. Ringhofer C2 b 2 Numerical Methods for Conservation Laws WPI, January 2006 C. Ringhofer ringhofer@asu.edu, C2 b 2 2 h2 x u http://math.la.asu.edu/ chris Last update: Jan 24, 2006 1 LITERATURE 1. Numerical Methods for Conservation

More information

Finite Volume Schemes: an introduction

Finite Volume Schemes: an introduction Finite Volume Schemes: an introduction First lecture Annamaria Mazzia Dipartimento di Metodi e Modelli Matematici per le Scienze Applicate Università di Padova mazzia@dmsa.unipd.it Scuola di dottorato

More information

NUMERICAL METHODS IN ASTROPHYSICS An Introduction

NUMERICAL METHODS IN ASTROPHYSICS An Introduction -1 Series in Astronomy and Astrophysics NUMERICAL METHODS IN ASTROPHYSICS An Introduction Peter Bodenheimer University of California Santa Cruz, USA Gregory P. Laughlin University of California Santa Cruz,

More information

Chapter 10 Exercises

Chapter 10 Exercises Chapter 10 Exercises From: Finite Difference Methods for Ordinary and Partial Differential Equations by R. J. LeVeque, SIAM, 2007. http://www.amath.washington.edu/ rl/fdmbook Exercise 10.1 (One-sided and

More information

Various lecture notes for

Various lecture notes for Various lecture notes for 18311. R. R. Rosales (MIT, Math. Dept., 2-337) April 12, 2013 Abstract Notes, both complete and/or incomplete, for MIT s 18.311 (Principles of Applied Mathematics). These notes

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

NUMERICAL SOLUTION OF HYPERBOLIC PARTIAL DIFFERENTIAL EQUATIONS

NUMERICAL SOLUTION OF HYPERBOLIC PARTIAL DIFFERENTIAL EQUATIONS NUMERICAL SOLUTION OF HYPERBOLIC PARTIAL DIFFERENTIAL EQUATIONS JOHN A. TRANGENSTEIN Department of Mathematics, Duke University Durham, NC 27708-0320 Ш CAMBRIDGE ЩР UNIVERSITY PRESS Contents 1 Introduction

More information

Numerical methods Revised March 2001

Numerical methods Revised March 2001 Revised March 00 By R. W. Riddaway (revised by M. Hortal) Table of contents. Some introductory ideas. Introduction. Classification of PDE's.3 Existence and uniqueness.4 Discretization.5 Convergence, consistency

More information

0.2. CONSERVATION LAW FOR FLUID 9

0.2. CONSERVATION LAW FOR FLUID 9 0.2. CONSERVATION LAW FOR FLUID 9 Consider x-component of Eq. (26), we have D(ρu) + ρu( v) dv t = ρg x dv t S pi ds, (27) where ρg x is the x-component of the bodily force, and the surface integral is

More information

Lecture 17: Initial value problems

Lecture 17: Initial value problems Lecture 17: Initial value problems Let s start with initial value problems, and consider numerical solution to the simplest PDE we can think of u/ t + c u/ x = 0 (with u a scalar) for which the solution

More information

Investigation of an implicit solver for the simulation of bubble oscillations using Basilisk

Investigation of an implicit solver for the simulation of bubble oscillations using Basilisk Investigation of an implicit solver for the simulation of bubble oscillations using Basilisk D. Fuster, and S. Popinet Sorbonne Universités, UPMC Univ Paris 6, CNRS, UMR 79 Institut Jean Le Rond d Alembert,

More information

0.3.4 Burgers Equation and Nonlinear Wave

0.3.4 Burgers Equation and Nonlinear Wave 16 CONTENTS Solution to step (discontinuity) initial condition u(x, 0) = ul if X < 0 u r if X > 0, (80) u(x, t) = u L + (u L u R ) ( 1 1 π X 4νt e Y 2 dy ) (81) 0.3.4 Burgers Equation and Nonlinear Wave

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

FDM for wave equations

FDM for wave equations FDM for wave equations Consider the second order wave equation Some properties Existence & Uniqueness Wave speed finite!!! Dependence region Analytical solution in 1D Finite difference discretization Finite

More information

Basics on Numerical Methods for Hyperbolic Equations

Basics on Numerical Methods for Hyperbolic Equations Basics on Numerical Methods for Hyperbolic Equations Professor Dr. E F Toro Laboratory of Applied Mathematics University of Trento, Italy eleuterio.toro@unitn.it http://www.ing.unitn.it/toro October 8,

More information

1 Introduction to MATLAB

1 Introduction to MATLAB L3 - December 015 Solving PDEs numerically (Reports due Thursday Dec 3rd, carolinemuller13@gmail.com) In this project, we will see various methods for solving Partial Differential Equations (PDEs) using

More information

Diffusion / Parabolic Equations. PHY 688: Numerical Methods for (Astro)Physics

Diffusion / Parabolic Equations. PHY 688: Numerical Methods for (Astro)Physics Diffusion / Parabolic Equations Summary of PDEs (so far...) Hyperbolic Think: advection Real, finite speed(s) at which information propagates carries changes in the solution Second-order explicit methods

More information

Numerical Simulations. Duncan Christie

Numerical Simulations. Duncan Christie Numerical Simulations Duncan Christie Motivation There isn t enough time to derive the necessary methods to do numerical simulations, but there is enough time to survey what methods and codes are available

More information

3.3. Phase and Amplitude Errors of 1-D Advection Equation

3.3. Phase and Amplitude Errors of 1-D Advection Equation 3.3. Phase and Amplitude Errors of 1-D Advection Equation Reading: Duran section 2.4.2. Tannehill et al section 4.1.2. The following example F.D. solutions of a 1D advection equation show errors in both

More information

Math 660-Lecture 23: Gudonov s method and some theories for FVM schemes

Math 660-Lecture 23: Gudonov s method and some theories for FVM schemes Math 660-Lecture 3: Gudonov s method and some theories for FVM schemes 1 The idea of FVM (You can refer to Chapter 4 in the book Finite volume methods for hyperbolic problems ) Consider the box [x 1/,

More information

Computational Fluid Dynamics. PHY 688: Numerical Methods for (Astro)Physics

Computational Fluid Dynamics. PHY 688: Numerical Methods for (Astro)Physics Computational Fluid Dynamics Hydrodynamics When we discussed PDEs, we focused so far on scalar PDEs Often we wish to study systems of PDEs. Here we'll look at the equations of hydrodynamics Nonlinear system

More information

PHYS 643 Week 4: Compressible fluids Sound waves and shocks

PHYS 643 Week 4: Compressible fluids Sound waves and shocks PHYS 643 Week 4: Compressible fluids Sound waves and shocks Sound waves Compressions in a gas propagate as sound waves. The simplest case to consider is a gas at uniform density and at rest. Small perturbations

More information

The RAMSES code and related techniques 2- MHD solvers

The RAMSES code and related techniques 2- MHD solvers The RAMSES code and related techniques 2- MHD solvers Outline - The ideal MHD equations - Godunov method for 1D MHD equations - Ideal MHD in multiple dimensions - Cell-centered variables: divergence B

More information

Approximate Harten-Lax-Van Leer (HLL) Riemann Solvers for Relativistic hydrodynamics and MHD

Approximate Harten-Lax-Van Leer (HLL) Riemann Solvers for Relativistic hydrodynamics and MHD Approximate Harten-Lax-Van Leer (HLL) Riemann Solvers for Relativistic hydrodynamics and MHD Andrea Mignone Collaborators: G. Bodo, M. Ugliano Dipartimento di Fisica Generale, Universita di Torino (Italy)

More information

Spatial Discretization

Spatial Discretization Spatial Discretization Shengtai Li and Hui Li Los Alamos National Laboratory 1 Overview Finite Difference Method Finite Difference for Linear Advection Equation 3 Conservation Laws Modern Finite Difference

More information

Partial differential equations

Partial differential equations Partial differential equations Many problems in science involve the evolution of quantities not only in time but also in space (this is the most common situation)! We will call partial differential equation

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

7 Hyperbolic Differential Equations

7 Hyperbolic Differential Equations Numerical Analysis of Differential Equations 243 7 Hyperbolic Differential Equations While parabolic equations model diffusion processes, hyperbolic equations model wave propagation and transport phenomena.

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

Multi-D MHD and B = 0

Multi-D MHD and B = 0 CapSel DivB - 01 Multi-D MHD and B = 0 keppens@rijnh.nl multi-d MHD and MHD wave anisotropies dimensionality > 1 non-trivial B = 0 constraint even if satisfied exactly t = 0: can numerically generate B

More information

A New Fourth-Order Non-Oscillatory Central Scheme For Hyperbolic Conservation Laws

A New Fourth-Order Non-Oscillatory Central Scheme For Hyperbolic Conservation Laws A New Fourth-Order Non-Oscillatory Central Scheme For Hyperbolic Conservation Laws A. A. I. Peer a,, A. Gopaul a, M. Z. Dauhoo a, M. Bhuruth a, a Department of Mathematics, University of Mauritius, Reduit,

More information

Radiative & Magnetohydrodynamic Shocks

Radiative & Magnetohydrodynamic Shocks Chapter 4 Radiative & Magnetohydrodynamic Shocks I have been dealing, so far, with non-radiative shocks. Since, as we have seen, a shock raises the density and temperature of the gas, it is quite likely,

More information

K. Ambika and R. Radha

K. Ambika and R. Radha Indian J. Pure Appl. Math., 473: 501-521, September 2016 c Indian National Science Academy DOI: 10.1007/s13226-016-0200-9 RIEMANN PROBLEM IN NON-IDEAL GAS DYNAMICS K. Ambika and R. Radha School of Mathematics

More information

Tutorial 2. Introduction to numerical schemes

Tutorial 2. Introduction to numerical schemes 236861 Numerical Geometry of Images Tutorial 2 Introduction to numerical schemes c 2012 Classifying PDEs Looking at the PDE Au xx + 2Bu xy + Cu yy + Du x + Eu y + Fu +.. = 0, and its discriminant, B 2

More information

Numerical Methods for Modern Traffic Flow Models. Alexander Kurganov

Numerical Methods for Modern Traffic Flow Models. Alexander Kurganov Numerical Methods for Modern Traffic Flow Models Alexander Kurganov Tulane University Mathematics Department www.math.tulane.edu/ kurganov joint work with Pierre Degond, Université Paul Sabatier, Toulouse

More information

Hydraulic Modelling for Drilling Automation

Hydraulic Modelling for Drilling Automation Hydraulic Modelling for Drilling Automation CASA Day Harshit Bansal April 19, 2017 Where innovation starts Team: Supervisors at TU/e : W.H.A. Schilders, N. van de Wouw, B. Koren, L. Iapichino Collaborators:

More information

2.29 Numerical Fluid Mechanics Spring 2015 Lecture 13

2.29 Numerical Fluid Mechanics Spring 2015 Lecture 13 REVIEW Lecture 12: Spring 2015 Lecture 13 Grid-Refinement and Error estimation Estimation of the order of convergence and of the discretization error Richardson s extrapolation and Iterative improvements

More information

Commissariat à l Energie Atomique - Saclay Department of Nuclear Energy Fluid Modeling and Simulation. MIT, November 3rd, 2008

Commissariat à l Energie Atomique - Saclay Department of Nuclear Energy Fluid Modeling and Simulation. MIT, November 3rd, 2008 ON THE NUMERICAL SIMULATION OF GENERAL MULTI-FIELD TWO-PHASE FLOW MODELS Anela KUMBARO Commissariat à l Energie Atomique - Saclay Department of Nuclear Energy Fluid Modeling and Simulation MIT, November

More information

Numerical resolution of a two-component compressible fluid model with interfaces

Numerical resolution of a two-component compressible fluid model with interfaces Numerical resolution of a two-component compressible fluid model with interfaces Bruno Després and Frédéric Lagoutière February, 25 Abstract We study a totally conservative algorithm for moving interfaces

More information

3 Hydrostatic Equilibrium

3 Hydrostatic Equilibrium 3 Hydrostatic Equilibrium Reading: Shu, ch 5, ch 8 31 Timescales and Quasi-Hydrostatic Equilibrium Consider a gas obeying the Euler equations: Dρ Dt = ρ u, D u Dt = g 1 ρ P, Dɛ Dt = P ρ u + Γ Λ ρ Suppose

More information

ENO and WENO schemes. Further topics and time Integration

ENO and WENO schemes. Further topics and time Integration ENO and WENO schemes. Further topics and time Integration Tefa Kaisara CASA Seminar 29 November, 2006 Outline 1 Short review ENO/WENO 2 Further topics Subcell resolution Other building blocks 3 Time Integration

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

Conservation of Mass (Eulerian Framework)

Conservation of Mass (Eulerian Framework) CME306 / CS205B Homework 1 (Theory) Conservation of Mass (Eulerian Framework) 1. In an Eulerian framework, the strong form of Conservation of Mass takes the form below. Please briefly explain the three

More information

Comparison of Approximate Riemann Solvers

Comparison of Approximate Riemann Solvers Comparison of Approximate Riemann Solvers Charlotte Kong May 0 Department of Mathematics University of Reading Supervisor: Dr P Sweby A dissertation submitted in partial fulfilment of the requirement for

More information

Lecture Notes on Numerical Schemes for Flow and Transport Problems

Lecture Notes on Numerical Schemes for Flow and Transport Problems Lecture Notes on Numerical Schemes for Flow and Transport Problems by Sri Redeki Pudaprasetya sr pudap@math.itb.ac.id Department of Mathematics Faculty of Mathematics and Natural Sciences Bandung Institute

More information

Info. No lecture on Thursday in a week (March 17) PSet back tonight

Info. No lecture on Thursday in a week (March 17) PSet back tonight Lecture 0 8.086 Info No lecture on Thursday in a week (March 7) PSet back tonight Nonlinear transport & conservation laws What if transport becomes nonlinear? Remember: Nonlinear transport A first attempt

More information

Prof. dr. A. Achterberg, Astronomical Dept., IMAPP, Radboud Universiteit

Prof. dr. A. Achterberg, Astronomical Dept., IMAPP, Radboud Universiteit Prof. dr. A. Achterberg, Astronomical Dept., IMAPP, Radboud Universiteit Rough breakdown of MHD shocks Jump conditions: flux in = flux out mass flux: ρv n magnetic flux: B n Normal momentum flux: ρv n

More information

Gas Dynamics: Basic Equations, Waves and Shocks

Gas Dynamics: Basic Equations, Waves and Shocks Astrophysical Dynamics, VT 010 Gas Dynamics: Basic Equations, Waves and Shocks Susanne Höfner Susanne.Hoefner@fysast.uu.se Astrophysical Dynamics, VT 010 Gas Dynamics: Basic Equations, Waves and Shocks

More information

MASSACHUSETTS INSTITUTE OF TECHNOLOGY DEPARTMENT OF MECHANICAL ENGINEERING CAMBRIDGE, MASSACHUSETTS NUMERICAL FLUID MECHANICS FALL 2011

MASSACHUSETTS INSTITUTE OF TECHNOLOGY DEPARTMENT OF MECHANICAL ENGINEERING CAMBRIDGE, MASSACHUSETTS NUMERICAL FLUID MECHANICS FALL 2011 MASSACHUSETTS INSTITUTE OF TECHNOLOGY DEPARTMENT OF MECHANICAL ENGINEERING CAMBRIDGE, MASSACHUSETTS 02139 2.29 NUMERICAL FLUID MECHANICS FALL 2011 QUIZ 2 The goals of this quiz 2 are to: (i) ask some general

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

Shock Waves. 1 Steepening of sound waves. We have the result that the velocity of a sound wave in an arbitrary reference frame is given by: kˆ.

Shock Waves. 1 Steepening of sound waves. We have the result that the velocity of a sound wave in an arbitrary reference frame is given by: kˆ. Shock Waves Steepening of sound waves We have the result that the velocity of a sound wave in an arbitrary reference frame is given by: v u kˆ c s kˆ where u is the velocity of the fluid and k is the wave

More information

Lecture Notes on Numerical Schemes for Flow and Transport Problems

Lecture Notes on Numerical Schemes for Flow and Transport Problems Lecture Notes on Numerical Schemes for Flow and Transport Problems by Sri Redeki Pudaprasetya sr pudap@math.itb.ac.id Department of Mathematics Faculty of Mathematics and Natural Sciences Bandung Institute

More information

Numerical Hydraulics

Numerical Hydraulics ETHZ, Fall 017 Numerical Hydraulics Assignment 4 Numerical solution of 1D solute transport using Matlab http://www.bafg.de/ http://warholian.com Numerical Hydraulics Assignment 4 ETH 017 1 Introduction

More information

arxiv: v4 [astro-ph.im] 27 Apr 2011

arxiv: v4 [astro-ph.im] 27 Apr 2011 A ROBUST NUMERICAL SCHEME FOR HIGHLY COMPRESSIBLE MAGNETOHYDRODYNAMICS: NONLINEAR STABILITY, IMPLEMENTATION AND TESTS K. WAAGAN, C. FEDERRATH, AND C. KLINGENBERG arxiv:1101.3007v4 [astro-ph.im] 27 Apr

More information

Various Hydro Solvers in FLASH3

Various Hydro Solvers in FLASH3 The Center for Astrophysical Thermonuclear Flashes Various Hydro Solvers in FLASH3 Dongwook Lee FLASH3 Tutorial June 22-23, 2009 An Advanced Simulation and Computing (ASC) Academic Strategic Alliances

More information

Numerical and mathematical analysis of a five-equation model for two-phase flow

Numerical and mathematical analysis of a five-equation model for two-phase flow SINTEF Energy Research Master s Thesis PFE-Master Numerical and mathematical analysis of a five-equation model for two-phase flow Author Pedro José Martínez Ferrer Supervisors Svend Tollak Munkejord Tore

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

Block-Structured Adaptive Mesh Refinement

Block-Structured Adaptive Mesh Refinement Block-Structured Adaptive Mesh Refinement Lecture 2 Incompressible Navier-Stokes Equations Fractional Step Scheme 1-D AMR for classical PDE s hyperbolic elliptic parabolic Accuracy considerations Bell

More information

X i t react. ~min i max i. R ij smallest. X j. Physical processes by characteristic timescale. largest. t diff ~ L2 D. t sound. ~ L a. t flow.

X i t react. ~min i max i. R ij smallest. X j. Physical processes by characteristic timescale. largest. t diff ~ L2 D. t sound. ~ L a. t flow. Physical processes by characteristic timescale Diffusive timescale t diff ~ L2 D largest Sound crossing timescale t sound ~ L a Flow timescale t flow ~ L u Free fall timescale Cooling timescale Reaction

More information

Applying Asymptotic Approximations to the Full Two-Fluid Plasma System to Study Reduced Fluid Models

Applying Asymptotic Approximations to the Full Two-Fluid Plasma System to Study Reduced Fluid Models 0-0 Applying Asymptotic Approximations to the Full Two-Fluid Plasma System to Study Reduced Fluid Models B. Srinivasan, U. Shumlak Aerospace and Energetics Research Program, University of Washington, Seattle,

More information

Implicit kinetic relaxation schemes. Application to the plasma physic

Implicit kinetic relaxation schemes. Application to the plasma physic Implicit kinetic relaxation schemes. Application to the plasma physic D. Coulette 5, E. Franck 12, P. Helluy 12, C. Courtes 2, L. Navoret 2, L. Mendoza 2, F. Drui 2 ABPDE II, Lille, August 2018 1 Inria

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

Numerical Solution Techniques in Mechanical and Aerospace Engineering

Numerical Solution Techniques in Mechanical and Aerospace Engineering Numerical Solution Techniques in Mechanical and Aerospace Engineering Chunlei Liang LECTURE 9 Finite Volume method II 9.1. Outline of Lecture Conservation property of Finite Volume method Apply FVM to

More information

Solutions to ODEs and PDEs: Numerical analysis using R (Cambridge University Press, ISBN: )

Solutions to ODEs and PDEs: Numerical analysis using R (Cambridge University Press, ISBN: ) Solutions to ODEs and PDEs: Numerical analysis using R (Cambridge University Press, ISBN: 978-1-107-11561-3) Graham W. Griffiths City University, UK. Chapter Abstracts Chapter 1 ODE integration methods

More information

Chp 4: Non-linear Conservation Laws; the Scalar Case. By Prof. Dinshaw S. Balsara

Chp 4: Non-linear Conservation Laws; the Scalar Case. By Prof. Dinshaw S. Balsara Chp 4: Non-linear Conservation Laws; the Scalar Case By Prof. Dinshaw S. Balsara 1 4.1) Introduction We have seen that monotonicity preserving reconstruction and iemann solvers are essential building blocks

More information

Fraunhofer Institute for Computer Graphics Research Interactive Graphics Systems Group, TU Darmstadt Fraunhoferstrasse 5, Darmstadt, Germany

Fraunhofer Institute for Computer Graphics Research Interactive Graphics Systems Group, TU Darmstadt Fraunhoferstrasse 5, Darmstadt, Germany Scale Space and PDE methods in image analysis and processing Arjan Kuijper Fraunhofer Institute for Computer Graphics Research Interactive Graphics Systems Group, TU Darmstadt Fraunhoferstrasse 5, 64283

More information

Answers to Problem Set Number 04 for MIT (Spring 2008)

Answers to Problem Set Number 04 for MIT (Spring 2008) Answers to Problem Set Number 04 for 18.311 MIT (Spring 008) Rodolfo R. Rosales (MIT, Math. Dept., room -337, Cambridge, MA 0139). March 17, 008. Course TA: Timothy Nguyen, MIT, Dept. of Mathematics, Cambridge,

More information

The Euler Equation of Gas-Dynamics

The Euler Equation of Gas-Dynamics The Euler Equation of Gas-Dynamics A. Mignone October 24, 217 In this lecture we study some properties of the Euler equations of gasdynamics, + (u) = ( ) u + u u + p = a p + u p + γp u = where, p and u

More information

Projection Dynamics in Godunov-Type Schemes

Projection Dynamics in Godunov-Type Schemes JOURNAL OF COMPUTATIONAL PHYSICS 142, 412 427 (1998) ARTICLE NO. CP985923 Projection Dynamics in Godunov-Type Schemes Kun Xu and Jishan Hu Department of Mathematics, Hong Kong University of Science and

More information

arxiv: v1 [physics.comp-ph] 22 Feb 2013

arxiv: v1 [physics.comp-ph] 22 Feb 2013 Numerical Methods and Causality in Physics Muhammad Adeel Ajaib 1 University of Delaware, Newark, DE 19716, USA arxiv:1302.5601v1 [physics.comp-ph] 22 Feb 2013 Abstract We discuss physical implications

More information

A Space-Time Expansion Discontinuous Galerkin Scheme with Local Time-Stepping for the Ideal and Viscous MHD Equations

A Space-Time Expansion Discontinuous Galerkin Scheme with Local Time-Stepping for the Ideal and Viscous MHD Equations A Space-Time Expansion Discontinuous Galerkin Scheme with Local Time-Stepping for the Ideal and Viscous MHD Equations Ch. Altmann, G. Gassner, F. Lörcher, C.-D. Munz Numerical Flow Models for Controlled

More information

Outline of lectures. Adding more physics. Doing Better: source terms in CTU unsplit integrator

Outline of lectures. Adding more physics. Doing Better: source terms in CTU unsplit integrator Grid-based methods for hydrodynamics, MHD, and radiation hydrodynamics. Outline of lectures (Four lectures) Lecture 1. Introduction to physics and numerics Lecture 2. Operator split (ZEUS-like) methods

More information

Free energy concept Free energy approach LBM implementation Parameters

Free energy concept Free energy approach LBM implementation Parameters BINARY LIQUID MODEL A. Kuzmin J. Derksen Department of Chemical and Materials Engineering University of Alberta Canada August 22,2011 / LBM Workshop OUTLINE 1 FREE ENERGY CONCEPT 2 FREE ENERGY APPROACH

More information

Truncation Error Estimates for Mesh Refinement in Lagrangian Hydrocodes Sarah Lianne Cole

Truncation Error Estimates for Mesh Refinement in Lagrangian Hydrocodes Sarah Lianne Cole UNIVERSITY OF READING DEPARTMENT OF MATHEMATICS AND STATISTICS Truncation Error Estimates for Mesh Refinement in Lagrangian Hydrocodes Sarah Lianne Cole Thesis submitted for the degree of Doctor of Philosophy

More information

arxiv: v3 [astro-ph] 2 Jun 2008

arxiv: v3 [astro-ph] 2 Jun 2008 Modelling discontinuities and Kelvin-Helmholtz instabilities in SPH Daniel J. Price arxiv:0709.2772v3 [astro-ph] 2 Jun 2008 Abstract School of Physics, University of Exeter, Exeter EX4 4QL, UK In this

More information

III. PLASMA DYNAMICS

III. PLASMA DYNAMICS III. PLASMA DYNAMICS Prof. S. C. Brown Prof. H. H. Woodson D. T. Kyrazis Prof. O. K. Mawardi Dr. I. C. T. Nisbet A. T. Lewis Prof. D. O. Akhurst D. A. East J. K. Oddson Prof. D. C. Pridmore-Brown Z. J.

More information

Basic Aspects of Discretization

Basic Aspects of Discretization Basic Aspects of Discretization Solution Methods Singularity Methods Panel method and VLM Simple, very powerful, can be used on PC Nonlinear flow effects were excluded Direct numerical Methods (Field Methods)

More information

Advection in two dimensions

Advection in two dimensions Lecture 0 Advection in two dimensions 6. Stability of multiple terms (in multiple dimensions) When we analyzed the stability of time-stepping methods we tended to consider either a single damping term

More information

Definition and Construction of Entropy Satisfying Multiresolution Analysis (MRA)

Definition and Construction of Entropy Satisfying Multiresolution Analysis (MRA) Utah State University DigitalCommons@USU All Graduate Theses and Dissertations Graduate Studies 6 Definition and Construction of Entropy Satisfying Multiresolution Analysis (MRA Ju Y. Yi Utah State University

More information