High-resolution finite volume methods for hyperbolic PDEs on manifolds

Size: px
Start display at page:

Download "High-resolution finite volume methods for hyperbolic PDEs on manifolds"

Transcription

1 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

2 Overview High-resolution methods for first-order hyperbolic systems Shock waves in nonlinear problems Heterogeneous media with discontinuous properties Godunov-type methods based on Riemann solvers Second-order correction terms with limiters to minimize dissipation and dispersion

3 Software CLAWPACK (Conservation LAWs Package): claw Includes a preliminary version of CLAWMAN for manifolds. Developed by Derek Bale (relativistic flow) James Rossmanith (geophysical flow on the sphere) Also includes AMRCLAW for adaptive mesh refinement on rectangular patches (with Marsha Berger).

4 AMR on a manifold Pressure at time t = Pressure at time t =.5 Pressure at time t =

5 Outline Brief review of Godunov-type methods wave propagation approach f-wave approach for discontinous fluxes and source terms curvilinear grids in flat space manifolds: parallel transport data to cell edges Express in local orthonormal frame Solve locally-flat Riemann problem Metric terms and geometric source term naturally incorporated References: rjl/publications and /students J. Pons, Font, Ibanez, Marti, Miralles, General relativistic hydrodynamics with special relativistic Riemann solvers, Astron. Astrophys. 339 (998),

6 Finite-difference Methods Pointwise values Q n i q(x i, t n ) Approximate derivatives by finite differences Assumes smoothness Finite-volume Methods Approximate cell averages: Q n i x Integral form of conservation law, xi+/2 x i /2 q(x, t n ) dx t xi+/2 x i /2 q(x, t) dx = f(q(x i /2, t)) f(q(x i+/2, t)) leads to conservation law q t + f x = 0 but also directly to numerical method.

7 Godunov s method Q n i defines a piecewise constant function q n (x, t n ) = Q n i for x i /2 < x < x i+/2 Discontinuities at cell interfaces = Riemann problems. t n+ ag replacements t n Q n+ i Q n i q n (x i /2, t) q (Q i, Q i ) for t > t n. F n i /2 = k tn+ t n f(q (Q n i, Q n i )) dt = f(q (Q n i, Q n i )).

8 Riemann solution for the Euler equations rarefaction wave contact shock ρ l u l ρ l u p ρ r u p ρ r u r p l p r The Roe solver uses the solution to a linear system q t + Âi /2q x = 0. All waves are simply discontinuities. Typically a fine approximation if jumps are approximately correct.

9 Wave-propagation viewpoint For linear system q t + Aq x = 0, the Riemann solution consists of waves W p propagating at constant speed λ p. eplacements λ 2 t W 2 i /2 W i /2 W i+/2 W 3 i /2 Q i Q i = m α p i /2 rp m W p i /2. p= p= Q n+ i = Q n i x[ t λ 2 Wi /2 2 + λ3 Wi /2 3 + λ Wi+/2 ].

10 High-resolution method for systems Q n+ i = Q n i t x [ A + Q i /2 + A Q i+/2 ] t x ( F i+/2 F i /2 ) Correction flux: F i /2 = 2 A Q i /2 = A + Q i /2 = M w p= M w (s p i /2 ) W p i /2, p= M w (s p i /2 )+ W p i /2, p= ( s p i /2 t ) x sp i /2 W p i /2 where W p i /2 is a limited version of Wp i /2.

11 CLAWPACK claw/ Fortran codes with Matlab graphics routines. Many examples and applications to run or modify. d, 2d, and 3d. User supplies: Riemann solver, splitting data into waves and fluctuations (Need not be in conservation form) Boundary condition routine to extend data to ghost cells Standard bc.f routine includes many standard BC s Initial conditions qinit.f

12 Some applications Gas dynamics, Euler equations Waves in heterogeneous / random media Acoustics, ultrasound, seismology Elasticity, plasticity, soil liquifaction Flow in porous media, groundwater contamination, oil recovery Geophysical flow on the sphere Shallow water equations, bottom topography, tsunami propagation Chemotaxis and pattern formation Traffic flow Crystal growth Multi-fluid, multi-phase flows, bubbly flow Streamfunction vorticity form of incompressible flow Projection methods for incompressible flow Combustion, detonation waves Astrophysics: binary stars, planetary nebulae, jets Magnetohydrodynamics, shallow water MHD Relativistic flow, black hole accretion Numerical relativity Einstein equations, gravity waves, cosmology

13 Spatially-varying flux functions In one dimension: q t + f(q, x) x = 0 Examples: Nonlinear elasticity in heterogeneous materials Traffic flow on roads with varying conditions Flow through heterogeneous porous media Solving conservation laws on curved manifolds

14 Riemann problem for spatially-varying flux q t + f(q, x) x = 0 Cell-centered discretization: Flux f i (q) defined in ith cell. eplacements W i /2 W 2 i /2 W 3 i /2 Q l i /2 Q r i /2 Q i Q i q t + f i (q) x = 0 q t + f i (q) x = 0 Flux-based wave decomposition: f i (Q i ) f i (Q i ) = m p= β p i /2 rp i /2 m p= Z p i /2

15 Wave-propagation algorithm using f-waves Q n+ i = Q n i t x [A+ Q i /2 + A Q i+/2 ] t x [ F i+/2 F i /2 ] Standard version: Q i Q i = m p= Wp i /2 A Q i+/2 = A + Q i /2 = F i /2 = 2 m (s p i+/2 ) W p i+/2 p= m (s p i /2 )+ W p i /2 p= m p= ( s p i /2 t ) x sp i /2 W p i /2.

16 Wave-propagation algorithm using f-waves Q n+ i = Q n i t x [A+ Q i /2 + A Q i+/2 ] t x [ F i+/2 F i /2 ] Using f-waves: f i (Q i ) f i (Q i ) = m p= Zp i /2 A Q i /2 = A + Q i /2 = F i /2 = 2 p:s p i /2 <0 Z p i /2, p:s p i /2 >0 Z p i /2, m p= ( sgn(s p i /2 ) t ) x sp i /2 Z p i /2

17 Source terms q t + f(q) x = ψ(q) Quasi-steady problems with near-cancellation: f(q) x and ψ both large but q t 0. Examples: Atmosphere or stellar dynamics with gravity balanced by hydrostatic pressure Shallow water equations in a lake over bottom topography

18 Source terms q t + f(q) x = ψ(q) Quasi-steady problems with near-cancellation: f(q) x and ψ both large but q t 0. Examples: Atmosphere or stellar dynamics with gravity balanced by hydrostatic pressure Shallow water equations in a lake over bottom topography Fractional step method: Alternate between. q t + f(x) x = 0, 2. q t = ψ(q) Large motions induced in each step should cancel out, but won t numerically.

19 Riemann problem with a delta-function source term eplacements q t + f(q) x = xψ i /2 δ(x x i /2 ) W i /2 W 2 i /2 W 3 i /2 Q l i /2 Q r i /2 Q i Q i q t + f i (q) x = 0 q t + f i (q) x = 0 Flux is no longer continuous: f(q r i /2 ) f(ql i /2 ) = xψ i /2. f i (Q i ) f i (Q i ) xψ i /2 = m p= β p i /2 rp i /2 m p= Z p i /2

20 Multidimensional Hyperbolic Problems Integral form of conservation law: d q(x, y, t) dx dy = dt Ω Ω n f(q) ds. If q is smooth then the divergence theorem gives d q(x, y, t) dx dy = dt f(q) dx dy, or Ω True for all Ω = Ω [ q t + f(q) ] Ω dx dy = 0. q t + f(q) x + g(q) y = 0,

21 Finite volume method in 2D ements y x j+/2 i /2 y j /2 Q ij Q n ij x y yj+/2 y j /2 xi+/2 x i /2 q(x, y, t n ) dx d x i /2 x i+/2 d dt C ij q(x, y, t) dx dy = yj+/2 y j /2 f(q(x i+/2, y, t) dy yj+/2 y j /2 f(q(x i /2, y, t) dy + xi+/2 x i /2 g(q(x, y j+/2, t) dx xi+/2 x i /2 g(q(x, y j /2, t) dx. Suggests the unsplit method Q n+ ij = Q n ij t x [F n i+/2,j F n i /2,j ] t y [Gn i,j+/2 Gn i,j /2 ],

22 Unsplit Godunov in 2D At each cell edge, the flux is determined by solving a Riemann problem in the normal direction with data from the neighboring cells. q t + f(q) x = 0 F n i+/2,j = f(q (Q n ij, Q n i+,j)) q t + g(q) y = 0 G n i,j /2 = g(q (Q n i,j, Qn ij ))

23 Finite volume method on a curvilinear grid (Flat space) Two possible approaches:. Transform equations to computational space. Discretize equations that include metric terms, source terms. 2. Update cell averages in physical space. Solve d Riemann problems for physical equations in direction normal to cell edges to compute flux.

24 Example: Linear acoustics Homogeneous medium with density ρ, bulk modulus K, sound speed c, p = pressure, u = velocity, T = pi = stress tensor t p + h t um + h ( ) h u k x k = 0 ( ) h T km x k = Γ m nk T kn.

25 One approach: Discretize these equations directly in computational coordinates x k. t p + h t um + h Note: Spatially varying flux functions Source term conservative? ( ) h u k x k = 0 ( ) h T km x k = Γ m nk T kn.

26 Better approach: Update cell average of q over physical finite volume cell Store Cartesian velocity components u, v in each cell. At each cell edge, use data on each side to compute normal velocities at edge, solve d Riemann problem in normal direction, scale resulting waves by length of side, use to update cell average

27 Grid mapping: cements x 2 PSfrag replacements x x x 2 J = [ ] x/ x x/ x 2 y/ x y/ x 2, H = J T J = [ ] h h 2, h = det(h). h 2 h 22 Lengths of sides in physical space h x, h 22 x 2, Area of cell h x x 2. Flux differencing around boundary approximates covariant divergence of flux.

28 Shallow water flow into a cylinder 5 5 q() at time t =.5 5 q() at time t = q() at time t =.5 5 q() at time t =

29 Acoustics on a manifold t p + h t um + h ( ) h u k x k = 0 ( ) h T km x k = Γ m nk T kn. Now we must represent velocities in computational coordinates

30 At each cell edge: Parallel transport cell-centered velocities to edge, Change coordinates to a local orthonormal frame at cell edge to obtain normal and tangential velocities, Solve d Riemann problem normal to cell edge (assuming locally flat) Scale resulting waves by length of side, transform back to cell-centered coordinates, Update cell averages.

31 CLAWMAN software Currently only 2d. Requires metric tensor H 2 2 matrix as function of x and x 2, Used to compute scaling factors for edge lengths, cell areas, Used for orthonormalization at cell edges. Christoffel symbols are needed for parallel transport Computed by finite differencing H.

32 Parallel Transport x k um +Γ m nk un = 0 or x k [ u u 2 ] Γ +[ k Γ 2k Γ 2 k Γ 2 2k ] [ u u 2 ] = 0. Approximate using Taylor series: u m ( x k ± 2 xk ) u m (x k ) 2 xk Γ m nk un (x k ).

33 Parallel Transport for acoustics For acoustics with q = (p, u, u 2 ) T, solve Riemann problem with q l i /2,j = (I [ Γ k Γ 2k 0 Γ 2 k Γ 2 2k ]) q i,j and q r i /2,j = (I + [ Γ k Γ 2k 0 Γ 2 k Γ 2 2k ]) q i,j

34 f-wave formulation Split jump in fluxes F into waves. F = I Γ k Γ 2k 0 Γ 2 k Γ 2 2k ij f ij I Γ k Γ 2k 0 Γ 2 k Γ 2 2k fi,j i,j = f ij f i,j x ψ i /2,j where ψ i /2,j = 2 [ 0 Γ T + Γ 2 T 2 Γ 2 T + Γ 2 2 T 2 ] ij + [ 0 Γ T + Γ 2 T 2 Γ 2 T + Γ 2 2 T 2 ] i,j This is n = portion of the source term ψ = Γ m nk T kn.

35 Acoustics on a manifold t p + h t um + h ( ) h u k x k = 0 ( ) h T km x k = Γ m nk T kn. With finite volume formulation, Source term is automatically incorporated by parallel transport of fluxes, Covariant divergence is handled by use of edge lengths and cell volume, Parallel transport and orthonormalization allows use of standard flat-space Riemann solver at interface.

36 Cubed sphere grid Six logically rectangular grids are patched together. Data is transferred between patches using ghost cells

37 Shallow water on the sphere t=0 D 2D Scatterplot of depth vs. lattitude (from north to south pole) Solid line is exact solution from D equation 0.25 eplacements

38 Shallow water on the sphere t=0 D 2D Scatterplot of depth vs. lattitude (from north to south pole) Solid line is exact solution from D equation 0.25 eplacements t =.25 t = 2.5 D 2D PSfrag replacements 0.25 eplacements t = D 2D

39 Outline Brief review of Godunov-type methods wave propagation approach f-wave approach for discontinous fluxes and source terms curvilinear grids in flat space manifolds: parallel transport data to cell edges Express in local orthonormal frame Solve locally-flat Riemann problem Metric terms and geometric source term naturally incorporated References: rjl/publications and /students J. Pons, Font, Ibanez, Marti, Miralles, General relativistic hydrodynamics with special relativistic Riemann solvers, Astron. Astrophys. 339 (998),

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

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

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

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

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

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 Slides posted at http://www.clawpack.org/links/tutorials http://faculty.washington.edu/rjl/tutorials

More information

ADAPTIVE MESH REFINEMENT USING WAVE-PROPAGATION ALGORITHMS FOR HYPERBOLIC SYSTEMS

ADAPTIVE MESH REFINEMENT USING WAVE-PROPAGATION ALGORITHMS FOR HYPERBOLIC SYSTEMS SIAM J. NUMER. ANAL. c 998 Society for Industrial and Applied Mathematics Vol. 35, No. 6, pp. 2298 236, December 998 9 ADAPTIVE MESH REFINEMENT USING WAVE-PROPAGATION ALGORITHMS FOR HYPERBOLIC SYSTEMS

More information

Poroelasticity simulation in CLAWPACK for geophysical and biological applications

Poroelasticity simulation in CLAWPACK for geophysical and biological applications Poroelasticity simulation in CLAWPACK for geophysical and biological applications October 27, 2012 Joint work with Randall J. LeVeque (University of Washington) and Yvonne Ou (University of Delaware) Supported

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

AMath 574 February 11, 2011

AMath 574 February 11, 2011 AMath 574 February 11, 2011 Today: Entropy conditions and functions Lax-Wendroff theorem Wednesday February 23: Nonlinear systems Reading: Chapter 13 R.J. LeVeque, University of Washington AMath 574, February

More information

Introduction to Partial Differential Equations

Introduction to Partial Differential Equations Introduction to Partial Differential Equations Partial differential equations arise in a number of physical problems, such as fluid flow, heat transfer, solid mechanics and biological processes. These

More information

Scientific Computing I

Scientific Computing I 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 Fluid mechanics as a Discipline

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

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

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

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

Calculating Storm Surge and Other Coastal Hazards Using Geoclaw

Calculating Storm Surge and Other Coastal Hazards Using Geoclaw Calculating Storm Surge and Other Coastal Hazards Using Geoclaw Kyle T. Mandli Department of Applied Mathematics University of Washington Seattle, WA, USA Modeling and Computations of Shallow-Water Coastal

More information

Phase Plane Behavior of Solitary Waves in Nonlinear Layered Media

Phase Plane Behavior of Solitary Waves in Nonlinear Layered Media Phase Plane Behavior of Solitary Waves in Nonlinear Layered Media Randall J. LeVeque 1 and Darryl H. Yong 2 1 Department of Applied Mathematics, University of Washington, Box 35242, Seattle, WA 98195-242

More information

Wave propagation methods for hyperbolic problems on mapped grids

Wave propagation methods for hyperbolic problems on mapped grids Wave propagation methods for hyperbolic problems on mapped grids A France-Taiwan Orchid Project Progress Report 2008-2009 Keh-Ming Shyue Department of Mathematics National Taiwan University Taiwan ISCM

More information

Advanced numerical methods for nonlinear advectiondiffusion-reaction. Peter Frolkovič, University of Heidelberg

Advanced numerical methods for nonlinear advectiondiffusion-reaction. Peter Frolkovič, University of Heidelberg Advanced numerical methods for nonlinear advectiondiffusion-reaction equations Peter Frolkovič, University of Heidelberg Content Motivation and background R 3 T Numerical modelling advection advection

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

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

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

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

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

Finite volume approximation of the relativistic Burgers equation on a Schwarzschild (anti-)de Sitter spacetime

Finite volume approximation of the relativistic Burgers equation on a Schwarzschild (anti-)de Sitter spacetime Turkish Journal of Mathematics http:// journals. tubitak. gov. tr/ math/ Research Article Turk J Math 2017 41: 1027 1041 c TÜBİTAK doi:10.906/mat-1602-8 Finite volume approximation of the relativistic

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

MATHEMATICAL ASPECTS OF NUMERICAL SOLUTION OF HYPERBOLIC SYSTEMS

MATHEMATICAL ASPECTS OF NUMERICAL SOLUTION OF HYPERBOLIC SYSTEMS K CHAPMAN & HALL/CRC Monographs and Surveys in Pure and Applied Mathematics I 18 MATHEMATICAL ASPECTS OF NUMERICAL SOLUTION OF HYPERBOLIC SYSTEMS ANDREI G. KULIKOVSKII NIKOLAI V. POGORELOV ANDREI YU. SEMENOV

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

Conservation Laws & Applications

Conservation Laws & Applications Rocky Mountain Mathematics Consortium Summer School Conservation Laws & Applications Lecture V: Discontinuous Galerkin Methods James A. Rossmanith Department of Mathematics University of Wisconsin Madison

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

Numerical simulation of cylindrical solitary waves in periodic media

Numerical simulation of cylindrical solitary waves in periodic media Numerical simulation of cylindrical solitary waves in periodic media Manuel Quezada de Luna David I. Ketcheson June, 3 Abstract We study the behavior of nonlinear waves in a two-dimensional medium with

More information

Deforming Composite Grids for Fluid Structure Interactions

Deforming Composite Grids for Fluid Structure Interactions Deforming Composite Grids for Fluid Structure Interactions Jeff Banks 1, Bill Henshaw 1, Don Schwendeman 2 1 Center for Applied Scientific Computing, Lawrence Livermore National Laboratory, Livermore,

More information

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

Computational Astrophysics 7 Hydrodynamics with source terms

Computational Astrophysics 7 Hydrodynamics with source terms Computational Astrophysics 7 Hydrodynamics with source terms Oscar Agertz Outline - Optically thin radiative hydrodynamics - Relaxation towards the diffusion limit - Hydrodynamics with gravity source term

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

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

A Well-Balanced Path-Integral f-wave Method for Hyperbolic Problems with Source Terms

A Well-Balanced Path-Integral f-wave Method for Hyperbolic Problems with Source Terms A Well-Balanced Path-Integral f-wave Method for Hyperbolic Problems with Source Terms Randall J. LeVeque 1 Abstract. Systems of hyperbolic partial differential equations with source terms (balance laws)

More information

The RAMSES code and related techniques 4. Source terms

The RAMSES code and related techniques 4. Source terms The RAMSES code and related techniques 4. Source terms Outline - Optically thin radiative hydrodynamics - Relaxation towards the diffusion limit - Hydrodynamics with gravity source term - Relaxation towards

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

Numerical Methods for Hyperbolic Conservation Laws Lecture 4

Numerical Methods for Hyperbolic Conservation Laws Lecture 4 Numerical Methods for Hyperbolic Conservation Laws Lecture 4 Wen Shen Department of Mathematics, Penn State University Email: wxs7@psu.edu Oxford, Spring, 018 Lecture Notes online: http://personal.psu.edu/wxs7/notesnumcons/

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

Fourier Spectral Computing for PDEs on the Sphere

Fourier Spectral Computing for PDEs on the Sphere Fourier Spectral Computing for PDEs on the Sphere an FFT-based method with implicit-explicit timestepping a simple & efficient approach Dave Muraki, Andrea Blazenko & Kevin Mitchell Mathematics, Simon

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

Well-balanced DG scheme for Euler equations with gravity

Well-balanced DG scheme for Euler equations with gravity Well-balanced DG scheme for Euler equations with gravity Praveen Chandrashekar praveen@tifrbng.res.in Center for Applicable Mathematics Tata Institute of Fundamental Research Bangalore 560065 Higher Order

More information

General Relativistic Magnetohydrodynamics Equations

General Relativistic Magnetohydrodynamics Equations General Relativistic Magnetohydrodynamics Equations Ioana Duţan IMPRS Students Workshop Berggasthof Lansegger, Austria, 28-31 Aug 2006 Ioana Duţan, GRMHD Equations p.1/22 Introductory remarks (General)

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 general well-balanced finite volume scheme for Euler equations with gravity

A general well-balanced finite volume scheme for Euler equations with gravity A general well-balanced finite volume scheme for Euler equations with gravity Jonas P. Berberich, Praveen Chandrashekar, Christian Klingenberg Abstract We present a second order well-balanced Godunov-type

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

The Navier-Stokes Equations

The Navier-Stokes Equations s University of New Hampshire February 22, 202 and equations describe the non-relativistic time evolution of mass and momentum in fluid substances. mass density field: ρ = ρ(t, x, y, z) velocity field:

More information

Shock-capturing Schemes for a Collisionless Two-fluid Plasma Model

Shock-capturing Schemes for a Collisionless Two-fluid Plasma Model Shock-capturing Schemes for a Collisionless Two-fluid Plasma Model E. Alec Johnson Department of Mathematics, UW-Madison Presented on August 29, 2 at Sandia National Laboratories c 23, Kenneth Lang, Tufts

More information

Quick Recapitulation of Fluid Mechanics

Quick Recapitulation of Fluid Mechanics Quick Recapitulation of Fluid Mechanics Amey Joshi 07-Feb-018 1 Equations of ideal fluids onsider a volume element of a fluid of density ρ. If there are no sources or sinks in, the mass in it will change

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

DEVELOPMENT AND APPLICATION OF GENERALIZED MUSTA SCHEMES

DEVELOPMENT AND APPLICATION OF GENERALIZED MUSTA SCHEMES European Conference on Computational Fluid Dynamics ECCOMAS CFD 26 P. Wesseling, E. Oñate and J. Périaux (Eds) c TU Delft, The Netherlands, 26 DEVELOPMENT AND APPLICATION OF GENERALIZED MUSTA SCHEMES V.

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

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

Earth System Modeling Domain decomposition

Earth System Modeling Domain decomposition Earth System Modeling Domain decomposition Graziano Giuliani International Centre for Theorethical Physics Earth System Physics Section Advanced School on Regional Climate Modeling over South America February

More information

Application of a Laser Induced Fluorescence Model to the Numerical Simulation of Detonation Waves in Hydrogen-Oxygen-Diluent Mixtures

Application of a Laser Induced Fluorescence Model to the Numerical Simulation of Detonation Waves in Hydrogen-Oxygen-Diluent Mixtures Supplemental material for paper published in the International J of Hydrogen Energy, Vol. 30, 6044-6060, 2014. http://dx.doi.org/10.1016/j.ijhydene.2014.01.182 Application of a Laser Induced Fluorescence

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

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

Rotation & nonlinear effects in shallow water: the Rossby adjustment problem

Rotation & nonlinear effects in shallow water: the Rossby adjustment problem Rotation & nonlinear effects in shallow water: the Rossby adjustment problem Ross Tulloch April 29, 2004 1 1 Shallow water equations Consider, as in [6], a homogeneous incompressible 2D fluid in a channel

More information

Advanced Methods for Numerical Fluid Dynamics and Heat Transfer (MVKN70)

Advanced Methods for Numerical Fluid Dynamics and Heat Transfer (MVKN70) 2017-08-24 Advanced Methods for Numerical Fluid Dynamics and Heat Transfer (MVKN70) 1 Lectures and course plans Week 1, 2: RY: Dr. Rixin Yu: tel: 222 3814; e-mail: rixin.yu@energy.lth.se Week 3; BS: Prof.

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

Advanced numerical methods for transport and reaction in porous media. Peter Frolkovič University of Heidelberg

Advanced numerical methods for transport and reaction in porous media. Peter Frolkovič University of Heidelberg Advanced numerical methods for transport and reaction in porous media Peter Frolkovič University of Heidelberg Content R 3 T a software package for numerical simulation of radioactive contaminant transport

More information

Numerical Simulation of Rarefied Gases using Hyperbolic Moment Equations in Partially-Conservative Form

Numerical Simulation of Rarefied Gases using Hyperbolic Moment Equations in Partially-Conservative Form Numerical Simulation of Rarefied Gases using Hyperbolic Moment Equations in Partially-Conservative Form Julian Koellermeier, Manuel Torrilhon May 18th, 2017 FU Berlin J. Koellermeier 1 / 52 Partially-Conservative

More information

Discretization of PDEs and Tools for the Parallel Solution of the Resulting Systems

Discretization of PDEs and Tools for the Parallel Solution of the Resulting Systems Discretization of PDEs and Tools for the Parallel Solution of the Resulting Systems Stan Tomov Innovative Computing Laboratory Computer Science Department The University of Tennessee Wednesday April 4,

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

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

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 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

Finite volumes for complex applications In this paper, we study finite-volume methods for balance laws. In particular, we focus on Godunov-type centra

Finite volumes for complex applications In this paper, we study finite-volume methods for balance laws. In particular, we focus on Godunov-type centra Semi-discrete central schemes for balance laws. Application to the Broadwell model. Alexander Kurganov * *Department of Mathematics, Tulane University, 683 St. Charles Ave., New Orleans, LA 708, USA kurganov@math.tulane.edu

More information

Derivation of relativistic Burgers equation on de Sitter background

Derivation of relativistic Burgers equation on de Sitter background Derivation of relativistic Burgers equation on de Sitter background BAVER OKUTMUSTUR Middle East Technical University Department of Mathematics 06800 Ankara TURKEY baver@metu.edu.tr TUBA CEYLAN Middle

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

Bound-preserving high order schemes in computational fluid dynamics Chi-Wang Shu

Bound-preserving high order schemes in computational fluid dynamics Chi-Wang Shu Bound-preserving high order schemes in computational fluid dynamics Chi-Wang Shu Division of Applied Mathematics Brown University Outline Introduction Maximum-principle-preserving for scalar conservation

More information

On the Comparison of the Finite Volume and Discontinuous Galerkin Methods

On the Comparison of the Finite Volume and Discontinuous Galerkin Methods Diploma Thesis Institute for Numerical Simulation, TUHH On the Comparison of the Finite Volume and Discontinuous Galerkin Methods Corrected version Katja Baumbach August 17, 2006 Supervisor: Prof. Dr.

More information

An Improved Ghost-cell Immersed Boundary Method for Compressible Inviscid Flow Simulations. Thesis by Cheng Chi

An Improved Ghost-cell Immersed Boundary Method for Compressible Inviscid Flow Simulations. Thesis by Cheng Chi An Improved Ghost-cell Immersed Boundary Method for Compressible Inviscid Flow Simulations Thesis by Cheng Chi In Partial Fulfillment of the Requirements For the Degree of Masters of Science King Abdullah

More information

The shallow water equations Lecture 8. (photo due to Clark Little /SWNS)

The shallow water equations Lecture 8. (photo due to Clark Little /SWNS) The shallow water equations Lecture 8 (photo due to Clark Little /SWNS) The shallow water equations This lecture: 1) Derive the shallow water equations 2) Their mathematical structure 3) Some consequences

More information

NUMERICAL SIMULATION OF FLUID-STRUCTURE INTERACTION PROBLEMS WITH DYNAMIC FRACTURE

NUMERICAL SIMULATION OF FLUID-STRUCTURE INTERACTION PROBLEMS WITH DYNAMIC FRACTURE NUMERICAL SIMULATION OF FLUID-STRUCTURE INTERACTION PROBLEMS WITH DYNAMIC FRACTURE Kevin G. Wang (1), Patrick Lea (2), and Charbel Farhat (3) (1) Department of Aerospace, California Institute of Technology

More information

Do Finite Volume Methods Need a Mesh?

Do Finite Volume Methods Need a Mesh? Do Finite Volume Methods Need a Mesh? Michael Junk Fachbereich Mathematik, Universität Kaiserslautern, 67663 Kaiserslautern, Germany Abstract. In this article, finite volume discretizations of hyperbolic

More information

We briefly discuss two examples for solving wave propagation type problems with finite differences, the acoustic and the seismic problem.

We briefly discuss two examples for solving wave propagation type problems with finite differences, the acoustic and the seismic problem. Excerpt from GEOL557 Numerical Modeling of Earth Systems by Becker and Kaus 2016 1 Wave propagation Figure 1: Finite difference discretization of the 2D acoustic problem. We briefly discuss two examples

More information

Nonlinear Solitary Wave Basis Functions for Long Time Solution of Wave Equation

Nonlinear Solitary Wave Basis Functions for Long Time Solution of Wave Equation Nonlinear Solitary Wave Basis Functions for Long Time Solution of Wave Equation John Steinhoff Subhashini Chitta Nonlinear Waves --Theory and Applications Beijing - June, 2008 Objective Simulate short

More information

Richard A. Mould. Basic Relativity. With 144 Figures. Springer-Verlag New York Berlin Heidelberg London Paris Tokyo Hong Kong Barcelona Budapest

Richard A. Mould. Basic Relativity. With 144 Figures. Springer-Verlag New York Berlin Heidelberg London Paris Tokyo Hong Kong Barcelona Budapest Richard A. Mould Basic Relativity With 144 Figures Springer-Verlag New York Berlin Heidelberg London Paris Tokyo Hong Kong Barcelona Budapest Contents Preface vii PARTI 1. Principles of Relativity 3 1.1

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

A Very Brief Introduction to Conservation Laws

A Very Brief Introduction to Conservation Laws A Very Brief Introduction to Wen Shen Department of Mathematics, Penn State University Summer REU Tutorial, May 2013 Summer REU Tutorial, May 2013 1 / The derivation of conservation laws A conservation

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

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

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

From An Apple To Black Holes Gravity in General Relativity

From An Apple To Black Holes Gravity in General Relativity From An Apple To Black Holes Gravity in General Relativity Gravity as Geometry Central Idea of General Relativity Gravitational field vs magnetic field Uniqueness of trajectory in space and time Uniqueness

More information

The Divergence Theorem Stokes Theorem Applications of Vector Calculus. Calculus. Vector Calculus (III)

The Divergence Theorem Stokes Theorem Applications of Vector Calculus. Calculus. Vector Calculus (III) Calculus Vector Calculus (III) Outline 1 The Divergence Theorem 2 Stokes Theorem 3 Applications of Vector Calculus The Divergence Theorem (I) Recall that at the end of section 12.5, we had rewritten Green

More information

Solving PDEs Numerically on Manifolds with Arbitrary Spatial Topologies

Solving PDEs Numerically on Manifolds with Arbitrary Spatial Topologies Solving PDEs Numerically on Manifolds with Arbitrary Spatial Topologies Lee Lindblom Theoretical Astrophysics, Caltech Center for Astrophysics and Space Sciences, UC San Diego. Collaborators: Béla Szilágyi,

More information

General Relativity and Cosmology Mock exam

General Relativity and Cosmology Mock exam Physikalisches Institut Mock Exam Universität Bonn 29. June 2011 Theoretische Physik SS 2011 General Relativity and Cosmology Mock exam Priv. Doz. Dr. S. Förste Exercise 1: Overview Give short answers

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

The Physics of Fluids and Plasmas

The Physics of Fluids and Plasmas The Physics of Fluids and Plasmas An Introduction for Astrophysicists ARNAB RAI CHOUDHURI CAMBRIDGE UNIVERSITY PRESS Preface Acknowledgements xiii xvii Introduction 1 1. 3 1.1 Fluids and plasmas in the

More information

Mathematical Concepts & Notation

Mathematical Concepts & Notation Mathematical Concepts & Notation Appendix A: Notation x, δx: a small change in x t : the partial derivative with respect to t holding the other variables fixed d : the time derivative of a quantity that

More information

Accretion Disks I. High Energy Astrophysics: Accretion Disks I 1/60

Accretion Disks I. High Energy Astrophysics: Accretion Disks I 1/60 Accretion Disks I References: Accretion Power in Astrophysics, J. Frank, A. King and D. Raine. High Energy Astrophysics, Vol. 2, M.S. Longair, Cambridge University Press Active Galactic Nuclei, J.H. Krolik,

More information

11.3 MATLAB for Partial Differential Equations

11.3 MATLAB for Partial Differential Equations 276 3. Generate the shape functions N (i) j = a (i) j where i =1, 2, 3,..., m and j =1, 2, 3,..., m. + b (i) j x + c(i) j y (11.2.17) 4. Compute the integrals for matrix elements α ij and vector elements

More information

Numerical Relativity in Spherical Polar Coordinates: Calculations with the BSSN Formulation

Numerical Relativity in Spherical Polar Coordinates: Calculations with the BSSN Formulation Numerical Relativity in Spherical Polar Coordinates: Calculations with the BSSN Formulation Pedro Montero Max-Planck Institute for Astrophysics Garching (Germany) 28/01/13 in collaboration with T.Baumgarte,

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

HIGH-RESOLUTION FINITE VOLUME METHODS FOR DUSTY GAS JETS AND PLUMES

HIGH-RESOLUTION FINITE VOLUME METHODS FOR DUSTY GAS JETS AND PLUMES HIGH-RESOLUTION FINITE VOLUME METHODS FOR DUSTY GAS JETS AND PLUMES MARICA PELANTI AND RANDALL J. LEVEQUE Abstract. We consider a model for dusty gas flow that consists of the compressible Euler equations

More information