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

Size: px
Start display at page:

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

Transcription

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

2 Lectures and course plans Week 1, 2: RY: Dr. Rixin Yu: tel: ; Week 3; BS: Prof. Bengt Sundén: tel: , ; Week 4,5,: JR: Prof. Johan Revstedt tel: ; Two guest lectures, Theory test 2

3 Course contents Previous CFD course Low speed(incompressible), flow problem with simple physics Basic numerical methods, mainly using finite volume methods This advanced course Flow problems with complex physics High speed, compressible flow (weak 1, 4-5) Shock-wave, discontinuity Multi-physics flow problems Reacting flow (weak 2) Advanced heat transfer : thermal radiation problem (weak 3) Other branches of multi-physics flow problem (not cover in detail )» Multiphase flows» Magnetohydrodynamics (MHD)» Micro-fluid, non-newtonian.. 3

4 Lecture 1.a An overview of computation methods applicable to fluid-related problems 4

5 General overview of CFD methods Different frameworks of computational methods (able to deal with the fluidmechanics problems in a whole) Classic methods (P.D.E. (NS) discretization onto a grid approximation ) Finite volume/finite difference Discretization on a grid (mesh) with known connectivity» Numerical Schemes to turn the problems of solving a system of P.D.E.s into solve an approximated set of algebraic equations.» Basic tools: Taylor expansion, interpolation/extarpolation.» Concepts: Order of accuracy (truncation error), Von Nueman stability analysis, boundary conditions treatments, The nature way towards extension to handle complex problem» (Adaptive) mesh refinement / Finite element, (pseudo) spectral methods (X) Other methods Meshfree methods (Smooth particle hydrodynamics, X) Lattice Boltzmann Methods (X) 5

6 Spectral methods (Discrete Fourier transform) f x න መf k e ikx signal Finite Difference Finite Volume. Finite element? Spectral method 6

7 Spectral method The basis functions ψ k x : = e ikx form an orthogonal basis, ψ k x ψ k x dx = e ikx e ik x dx = δ kk Calculate Fourier coeff. መf k = න f x e ikx Discrete fast-fourier-transform, computationally-efficient, reducing operation counts from O(N 2 ) to O( N log(n) ), where N is grid count. - The simplest version is Cooley-Tukey algorithm for N=2 m, other advanced FFT algorithm version can handle N as prime number. - FFTW (free software, parallel implementation available) For each basis function, it is easy to handle derivative x eikx = i k e ikx 2 x 2 eikx = i k 2 e ikx = k 2 e ikx 7

8 Spectral method: example A simple linear partial differential equation (Poisson eq.) 2 x u x, y = g x, y, y2 Write u and g on Fourier basis Given g x, y = g x + 2π, y = g(x, y + 2π) with x, y [0,2π] u x, y : = j k u j,k e i(jx+ky) and g x, y : = j k g j,k e i(jx+ky) l. h. s = 2 x y 2 r. h. s. = g(x, y) u x, y : = u j,k (j 2 + k 2 )e i(jx+ky) j k = e i(jx+ky) j k g j,k For each (j,k), it become a simple algebraic relation. u j,k = g j,k (j 2 + k 2 ) 8

9 Spectral methods for PDE with nonlinear terms As a simplification to the incompressible NS t u + u u = p + ν 2 u; u = 0 The nonlinear viscous burger s eq. t u xu 2 = xx u, for x 0,2π, t > 0 u x, t : = k u k (t)e ikx t u k + ik 2 u p u q + k 2 u k = 0 k p+q=k For each k, it now relates to other (many) p and q 9

10 Pseudo-spectral methods for nonlinear PDE nonlinear burger s eq t u xu 2 = xx u Go to x space for x 0,2π, t > 0 u x, t k u k (t)e ikx u u = U(x, t) back to k space k U k (t)e ikx t u k ik U k (t) + k 2 u k = 0 k Time advancement u k t n+1 u k t n t n+1 t n 10

11 Spectral method Spectral methods and Finite Element Method are closely related Spectral methods use a global basis functions that are nonzero over whole domain. Excellent error properties of exponential convergence FEM can be viewed as using a local basis functions that are non-zero only on small subdomain. Spectral methods works better with simple-geometry(e.g. periodic) having smooth solutions, it can be less expensive. Spectral methods are not good discontinuous problem, (no known 3D spectral shock capture results), link to Gibbs phenomenon. Functional approximation of square wave using 5 harmonics 25 harmonics 125 harmonics 11

12 General overview of CFD methods Different frameworks of computational methods (able to deal with the fluid-mechanics problems in a whole) Classic methods (P.D.E. (NS) discretization onto a grid approximation ) Finite volume/finite difference Finite element, (pseudo) spectral methods (X) Other methods Meshfree methods (Smooth particle hydrodynamics, X) Lattice Boltzmann Methods (X) 12

13 Meshfree methods Smooth particle hydrodynamics (SPH) SPH of dam break from youtube Useful refernce: wikipedia M.B. Liu, G.R. Liu, Smoothed Particle Hydrodynamics (SPH): an Overview and Recent Developments, Arch Comput. Methods Eng, 2010, 17:25 DOI /s

14 SPH It is a mesh-free lagrangian methods to simulate continuum media. Initially developed in 1977 for astrophysical problems, then is extended to many fields, volcanology and oceanography... Ideals: The gas cloud is represents by a set of discrete blob of gas, these particles interacts with neighboring particles through a repelling force(pressure), but otherwise like normal moving particle. 14

15 SPH methods SPH Dividing fluid into a set of discrete particles elements. These elements have a spatial length over which their properties are smoothed by a kernel function. Physical properties at a certain location receive contributions from nearby particles, the contribution of each particle are weighted according to their distance from the particle interests. Spatial derivative of a quantile can be easily obtained. Only solve equation of motion for all particles, which is a set of ODE equations. Easy mass and energy conservation, particles themselves represent mass. No negative density can happen. Pressure can be evaluated directly from weighted contribution of neighboring particles, instead of solving the (Poisson) equations. as in grid-based technique. 15

16 SPH Divergence-Free SPH for Incompressible and Viscous Fluids, from youtube 16

17 SPH Benefits over traditional grid/based technique. Versatile, easy to deal with problems of free surface, deformable boundary and moving interface. SPH can do real-time simulation water/air simulations(for games) For problems with complicate geometry setting or problems with large deformation, SPH can self-adapt its resolution (computing power is automatically focused to there where mass is). Analogous to grid-based methods, it become an automatic version of adaptive mesh refinements (AMR) without technique complexity. Simple and robust method, easier for numerical implementation: Challenges and problems To quickly find the nearest neighboring particles Connectivity information is not available as grid-based method Require large number of particles, less accurate, Noise due to discrete approximation of kernel interpolants, large numerical shear viscosity Tends to smear out shocks and contact discontinuity 17

18 General overview of CFD methods Different frameworks of computational methods (able to deal with the fluid-mechanics problems in a whole) Classic methods (P.D.E. (NS) discretization onto a grid approximation ) Finite volume/finite difference Finite element, (pseudo) spectral methods (X) Other methods Meshfree methods (Smooth particle hydronamics, X) Lattice Boltzmann Methods (X) 18

19 Lattice Boltzmann Method 19 Slide taken from Steven Orzag s presentation

20 LBM Cellular Automaton, conway s game of life(1970) Very simple set of rules: Any live cell with fewer than two live neighbours dies, as if caused by underpopulation. Any live cell with two or three live neighbours lives on to the next generation. Any live cell with more than three live neighbours dies, as if by overpopulation. Any dead cell with exactly three live neighbours becomes a live cell, as if by reproduction. creates complex life-like patterns! 20

21 Lattice Boltzmann methods(lbm) Different levels of observations(microscopic<mesoscopic<macroscopic) Macroscopic behavior of a system may not dependent on the details of the microscopic interactions. In the middle mesoscopic level, keep some part of the particle concept, allow those particles only staying in the lattice points, therefore only finite number of discrete velocity values 21

22 LBM Cell automaton rules for modeling gas dynamics: Particle only live in nodes of a given Lattice. A finite number of allowed states for each node, n i r, t Two stage evolutions 1: Stream n i r + λc i, t + Δt = n i r, t 2: collide n i r + λc i, t + Δt n i r, t = Ω i n r, t Lattice Boltzmann Method Use a probability function: f i (t, x, V) Similar to Boltzmann eq. for gas dynamics Average the probity to compute Fluid quantities. Model the collision term Relax toward equilibrium state 22

23 Lattice Boltzmann methods(lbm) Advantages Fundamental research tool Theoretically appealing: the knowledge of interaction between molecules can directly incorporate physical terms Success in wide range of applications Complex, multiphase/multicomponent flows. Coupled flow with heat transfer and chemical reactions. Multiphase flow with small droplet and bubbles, flow through porous media. Run efficiently on massively parallel architectures, LBM algorithm is local (cell interacts with only neighbors) and explicit in time. computer cluster, GPU, even FPGA(mobile chips). Parallel post-processing LBM algorithm is 1 st order PDE, much simple for programming than Naiver-stokes equation based solver. Easy boundary conditions treatment 23

24 Lattice Boltzmann methods(lbm) Limitations: Only limited number of commercial software is available. The method is relatively new! Numerical instability can develop when viscosity become small. High Mach number flows in aerodynamics is still difficult for LBM. Shock-discontinuity, strong gradients. 24

25 Lecture 1.b Review 1D hyperbolic equations Emphasis on physical perspective, not rigorous math. Analytical treatment of discontinuity The Riemann problem 25

26 Book Reference book chapter and online materials for lectures of week 1 Computational fluid mechanics and heat transfer, by J.C. Tannehill, D. A. Anderson and R. H. Pletcher Chapter 4.4: Introduction, Online lecture notes for Numerical Fluid Dynamics by C.P.Dullemond, University of Heidelberg, Chapter 2: Hyperbolic equations Chapter 4: Numerical schemes for advection (II) Chapter 6: Numerical hydrodynamics: Riemann solvers (I) 26

27 Classification of PDEs Elliptic, Parabolic, Hyperbolic 27

28 Simplest advection equation Consider the simplest advection equation: t q(x, t) + u q(x, t) = 0, x given initial conditions q x, t = 0. If u is constant in space x and time t The solutions become a propagating wave: q(x, t) = q(x u t, 0) 28

29 Hyperbolic equation Simplest advection equation, with constant u LHS = t q(x, t) + u q(x, t) = 0, x Introduce a new coordinate x 0, t (x, t), x x 0, t = x 0 + u t t x 0, t = t D q Dt t q x0, t = t q t t + x q t x = q 1 t =0 + q u x q holds constant for different t, along the entire trajectory x x 0, t starting at x 0. D q Dt is analogy to the concept of material derivative used in fluid mechanics 3Δt u 2Δt Δt t = 0 x 0 x = x 0 + ut x (x, t) plane 29

30 Advection equation with space dependent u(x) t q(x, t) + u(x) q(x, t) = 0, x New coordinate x, t x 0, t x x 0, t = x t u x x 0, t dt t(x 0, t ) = t D q Dt t q x0, t = t q t t + x q t x = 0 x = u(x) t 3Δt 2Δt Δt t = 0 x 0 x 30

31 Advection equation of conservative quantity with space dependent velocity u(x) t q(x, t) + x Integrate for x a < x < x b Rewrite u x q x, t = 0 x b t න q dx + u x b q x b, t u x a q x a, t = 0, x a t q x, t + u x x q x, t = q(x, t) u x x D Dt q = q(x, t) u x x 3Δt 2Δt Δt t = 0 x 0 x A general form t q(x, t) + f(q, x) = 0 x 31

32 General Flux-form of conservation equation t q(x, t) + F(q, x) = 0 x F q + t q ቚ F q = x=const x x ቚ q=const Example 1 F q, x u x q Example 2 Linear Previous eq. t q(x, t) + x F q ቚ x=const = u(x) F x ቚ = q(x, t) u x q=const x Jacobian u x q x, t = 0 Inviscid burge s eq. F q, x 1 2 q2 t q + x (1 2 q2 ) = 0 t q + q x q = 0 F(q, x) has no x-dependency Nonlinear 32

33 What about a set of equations Q q 1 q m Conservative (flux) form t Q + F(Q, x) = 0 x t q 1 q m + x F 1 (q 1,, q m ; x) F m (q 1,, q m ; x) = 0 Non-conservative form F Q + t Q ቚ F Q = x,cons x x ቚ Q,cons t q 1 q m + F 1 F 1 q 1 q m F m F m q 1 q m x q 1 q m = x F 1 F m t Q + J x Q = x F J F Q is m m matrix 33

34 A set of equations Simple (linearly) decoupled example with Jacobian already in the diagonal form t Q q 1 q 2, m = 2 q 1 q 2 + u u 2 x q 1 q 2 = 0 t q 1 + u 1 x q 1 = 0 t q 2 + u 2 x q 2 = 0 q 1 q 2 u 1 u 2 space 34

35 A set of equations When Jacobian is not in diagonal form Eigenvalues/eigenvectors: J m m e m 1 = λ e m 1 Q + J Q = rhs=0 t x J e (1) ; ; e (m) = e (1) ; ; e (m) λ λ m J m m E m m = E m m Λ m m J = EΛE 1 E 1 t Q + E 1 EΛE 1 x Q = 0 t Q + (EΛE 1 ) x Q = 0 t (E 1 Q) + λ λ x (E 1 Q) = 0 m Q E 1 Q t Q + Λ x Q = 0 35

36 Inviscid burgers equation Nonlinear hyperbolic equation Inviscid burge s eq. t q + x (1 2 q2 ) = 0 D Dt q t q + q x (q) = 0 q Note: Before discontinuity develops, q along along any characteristic line should be constant, therefore the slope(the trajectory advection velocity) of characteristic lines remain constant. 36 space

37 The Riemann problem for inviscid-burgers equation The Riemann problem: Initial value problem composed of a conservation equation together with piecewise constant data having a single discontinuity shockwave Expansion q R q L?? q L q R space?? space 37

38 The Riemann problem Analytic solution for inviscid-burgers equation shockwave Expansion, Rarefaction waves q R q L q L q R space space Wave diagram from solving Riemann problem for inviscid burges equation 38

39 Solution of Riemann problem for inviscid burgers equation q l > > q r q r t 2 q l t 2 t 0 t 1 t 0 t 1 shockwave Expansion wave space c = q l+q r 2, it is the speed of the middle value point An observation: for the shockwave solution which is a simple translation of discontinuity, it seems can be modelled by a linear advection equation,with c as the advection speed. 39

40 Exact (Analytic) solutions: Solution of Riemann problem for inviscid burgers equation 1) Galilean invariance (q = q c; x = x + ct; t = t ) t q x q 2 = 0 2) Self-similarity: Given initial condition: q x > 0 +, t = 0 = u r ; q x < 0 +, t = 0 = u l q x, t = φ x t ; for t > 0 t q x q2 = 0 a +a a a space x a, x > 0+ q x, t = ቊ a, x < 0 q x, t = ቐ t, a < x t < a a, outside above 40

41 The Riemann problem Solve for a simple (linear, decoupled) set of equations t q 1 q 2 + u u 2 x q 1 q 2 = 0 Characteristics lines for q 1 and q 2 41

42 The Riemann problem for the nonlinear Euler equations (three coupled equations) The classic shock tube problem: quite complex. p(x, t 0 ) ρ x, t 0 v(x, t 0 ) t 0 1) Self similar ( x x 0 ) t 2) 5 regime due to 3 wave characters (note Euler eq. are for 3 variables p, v, ρ) a) Rarefaction fan b) contact discontinuity c) Shock (Rankine-Hugoniot relation) p(x, t 1 ) ρ(x, t 1 ) v(x, t 1 ) t 1 42

September, Advanced Methods for Numerical Fluid Dynamics and Heat Transfer (MVKN70) Rixin Yu

September, Advanced Methods for Numerical Fluid Dynamics and Heat Transfer (MVKN70) Rixin Yu September, 2018 Advanced Methods for Numerical Fluid Dynamics and Heat Transfer (MVKN70) Rixin Yu 1 Course plans Week 1: RY (Basic discretization) Week 2 & 3: RY (Compressible flow) Week 4 & 5.1 BS (Heat

More information

Chapter 1 Direct Modeling for Computational Fluid Dynamics

Chapter 1 Direct Modeling for Computational Fluid Dynamics Chapter 1 Direct Modeling for Computational Fluid Dynamics Computational fluid dynamics (CFD) is a scientific discipline, which aims to capture fluid motion in a discretized space. The description of the

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

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

Direct Modeling for Computational Fluid Dynamics

Direct Modeling for Computational Fluid Dynamics Direct Modeling for Computational Fluid Dynamics Kun Xu February 20, 2013 Computational fluid dynamics (CFD) is new emerging scientific discipline, and targets to simulate fluid motion in different scales.

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

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

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

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

PDEs, part 1: Introduction and elliptic PDEs

PDEs, part 1: Introduction and elliptic PDEs PDEs, part 1: Introduction and elliptic PDEs Anna-Karin Tornberg Mathematical Models, Analysis and Simulation Fall semester, 2013 Partial di erential equations The solution depends on several variables,

More information

Particle-Simulation Methods for Fluid Dynamics

Particle-Simulation Methods for Fluid Dynamics Particle-Simulation Methods for Fluid Dynamics X. Y. Hu and Marco Ellero E-mail: Xiangyu.Hu and Marco.Ellero at mw.tum.de, WS 2012/2013: Lectures for Mechanical Engineering Institute of Aerodynamics Technical

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

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

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

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

More information

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

Elliptic Problems / Multigrid. PHY 604: Computational Methods for Physics and Astrophysics II

Elliptic Problems / Multigrid. PHY 604: Computational Methods for Physics and Astrophysics II Elliptic Problems / Multigrid Summary of Hyperbolic PDEs We looked at a simple linear and a nonlinear scalar hyperbolic PDE There is a speed associated with the change of the solution Explicit methods

More information

Chapter 6. Finite Element Method. Literature: (tiny selection from an enormous number of publications)

Chapter 6. Finite Element Method. Literature: (tiny selection from an enormous number of publications) Chapter 6 Finite Element Method Literature: (tiny selection from an enormous number of publications) K.J. Bathe, Finite Element procedures, 2nd edition, Pearson 2014 (1043 pages, comprehensive). Available

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

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

3. FORMS OF GOVERNING EQUATIONS IN CFD

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

More information

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

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

Introduction LECTURE 1

Introduction LECTURE 1 LECTURE 1 Introduction The source of all great mathematics is the special case, the concrete example. It is frequent in mathematics that every instance of a concept of seemingly great generality is in

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

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

Topics in Fluid Dynamics: Classical physics and recent mathematics

Topics in Fluid Dynamics: Classical physics and recent mathematics Topics in Fluid Dynamics: Classical physics and recent mathematics Toan T. Nguyen 1,2 Penn State University Graduate Student Seminar @ PSU Jan 18th, 2018 1 Homepage: http://math.psu.edu/nguyen 2 Math blog:

More information

Waves in a Shock Tube

Waves in a Shock Tube Waves in a Shock Tube Ivan Christov c February 5, 005 Abstract. This paper discusses linear-wave solutions and simple-wave solutions to the Navier Stokes equations for an inviscid and compressible fluid

More information

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

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

More information

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

Computational Fluid Dynamics-1(CFDI)

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

More information

Before we look at numerical methods, it is important to understand the types of equations we will be dealing with.

Before we look at numerical methods, it is important to understand the types of equations we will be dealing with. Chapter 1. Partial Differential Equations (PDEs) Required Readings: Chapter of Tannehill et al (text book) Chapter 1 of Lapidus and Pinder (Numerical Solution of Partial Differential Equations in Science

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

arxiv:comp-gas/ v1 28 Apr 1993

arxiv:comp-gas/ v1 28 Apr 1993 Lattice Boltzmann Thermohydrodynamics arxiv:comp-gas/9304006v1 28 Apr 1993 F. J. Alexander, S. Chen and J. D. Sterling Center for Nonlinear Studies and Theoretical Division Los Alamos National Laboratory

More information

CHAPTER 4. Basics of Fluid Dynamics

CHAPTER 4. Basics of Fluid Dynamics CHAPTER 4 Basics of Fluid Dynamics What is a fluid? A fluid is a substance that can flow, has no fixed shape, and offers little resistance to an external stress In a fluid the constituent particles (atoms,

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

Predictor-Corrector Finite-Difference Lattice Boltzmann Schemes

Predictor-Corrector Finite-Difference Lattice Boltzmann Schemes Applied Mathematical Sciences, Vol. 9, 2015, no. 84, 4191-4199 HIKARI Ltd, www.m-hikari.com http://dx.doi.org/10.12988/ams.2015.5138 Predictor-Corrector Finite-Difference Lattice Boltzmann Schemes G. V.

More information

The Lattice Boltzmann method for hyperbolic systems. Benjamin Graille. October 19, 2016

The Lattice Boltzmann method for hyperbolic systems. Benjamin Graille. October 19, 2016 The Lattice Boltzmann method for hyperbolic systems Benjamin Graille October 19, 2016 Framework The Lattice Boltzmann method 1 Description of the lattice Boltzmann method Link with the kinetic theory Classical

More information

Lattice Boltzmann Method

Lattice Boltzmann Method 3 Lattice Boltzmann Method 3.1 Introduction The lattice Boltzmann method is a discrete computational method based upon the lattice gas automata - a simplified, fictitious molecular model. It consists of

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

Pressure corrected SPH for fluid animation

Pressure corrected SPH for fluid animation Pressure corrected SPH for fluid animation Kai Bao, Hui Zhang, Lili Zheng and Enhua Wu Analyzed by Po-Ram Kim 2 March 2010 Abstract We present pressure scheme for the SPH for fluid animation In conventional

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

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

Dedalus: An Open-Source Spectral Magnetohydrodynamics Code

Dedalus: An Open-Source Spectral Magnetohydrodynamics Code Dedalus: An Open-Source Spectral Magnetohydrodynamics Code Keaton Burns University of California Berkeley Jeff Oishi SLAC National Accelerator Laboratory Received ; accepted ABSTRACT We developed the magnetohydrodynamic

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

Partial Differential Equations

Partial Differential Equations Partial Differential Equations Introduction Deng Li Discretization Methods Chunfang Chen, Danny Thorne, Adam Zornes CS521 Feb.,7, 2006 What do You Stand For? A PDE is a Partial Differential Equation This

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

Particle-based Fluids

Particle-based Fluids Particle-based Fluids Particle Fluids Spatial Discretization Fluid is discretized using particles 3 Particles = Molecules? Particle approaches: Molecular Dynamics: relates each particle to one molecule

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

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

An electrokinetic LB based model for ion transport and macromolecular electrophoresis

An electrokinetic LB based model for ion transport and macromolecular electrophoresis An electrokinetic LB based model for ion transport and macromolecular electrophoresis Raffael Pecoroni Supervisor: Michael Kuron July 8, 2016 1 Introduction & Motivation So far an mesoscopic coarse-grained

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

Lecture 5: Kinetic theory of fluids

Lecture 5: Kinetic theory of fluids Lecture 5: Kinetic theory of fluids September 21, 2015 1 Goal 2 From atoms to probabilities Fluid dynamics descrines fluids as continnum media (fields); however under conditions of strong inhomogeneities

More information

LATTICE BOLTZMANN METHOD AND DIFFUSION IN MATERIALS WITH LARGE DIFFUSIVITY RATIOS

LATTICE BOLTZMANN METHOD AND DIFFUSION IN MATERIALS WITH LARGE DIFFUSIVITY RATIOS THERMAL SCIENCE: Year 27, Vol. 2, No. 3, pp. 73-82 73 LATTICE BOLTZMANN METHOD AND DIFFUSION IN MATERIALS WITH LARGE DIFFUSIVITY RATIOS by Edouard WALTHER *, Rachid BENNACER, and Caroline DE SA LMT, ENS

More information

Simulation of T-junction using LBM and VOF ENERGY 224 Final Project Yifan Wang,

Simulation of T-junction using LBM and VOF ENERGY 224 Final Project Yifan Wang, Simulation of T-junction using LBM and VOF ENERGY 224 Final Project Yifan Wang, yfwang09@stanford.edu 1. Problem setting In this project, we present a benchmark simulation for segmented flows, which contain

More information

The lattice Boltzmann method for contact line dynamics

The lattice Boltzmann method for contact line dynamics The lattice Boltzmann method for contact line dynamics Sudhir Srivastava, J.H.M. ten Thije Boonkkamp, Federico Toschi April 13, 2011 Overview 1 Problem description 2 Huh and Scriven model 3 Lattice Boltzmann

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

Length Learning Objectives Learning Objectives Assessment

Length Learning Objectives Learning Objectives Assessment Universidade Federal Fluminense PGMEC Course: Advanced Computational Fluid Dynamics Coordinator: Vassilis Theofilis Academic Year: 2018, 2 nd Semester Length: 60hrs (48hrs classroom and 12hrs tutorials)

More information

A FAST SOLVER FOR ELLIPTIC EQUATIONS WITH HARMONIC COEFFICIENT APPROXIMATIONS

A FAST SOLVER FOR ELLIPTIC EQUATIONS WITH HARMONIC COEFFICIENT APPROXIMATIONS Proceedings of ALGORITMY 2005 pp. 222 229 A FAST SOLVER FOR ELLIPTIC EQUATIONS WITH HARMONIC COEFFICIENT APPROXIMATIONS ELENA BRAVERMAN, MOSHE ISRAELI, AND ALEXANDER SHERMAN Abstract. Based on a fast subtractional

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

Chapter 4. Nonlinear Hyperbolic Problems

Chapter 4. Nonlinear Hyperbolic Problems Chapter 4. Nonlinear Hyperbolic Problems 4.1. Introduction Reading: Durran sections 3.5-3.6. Mesinger and Arakawa (1976) Chapter 3 sections 6-7. Supplementary reading: Tannehill et al sections 4.4 and

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

Solution Methods. Steady State Diffusion Equation. Lecture 04

Solution Methods. Steady State Diffusion Equation. Lecture 04 Solution Methods Steady State Diffusion Equation Lecture 04 1 Solution methods Focus on finite volume method. Background of finite volume method. Discretization example. General solution method. Convergence.

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

Improvements of Unsteady Simulations for Compressible Navier Stokes Based on a RK/Implicit Smoother Scheme

Improvements of Unsteady Simulations for Compressible Navier Stokes Based on a RK/Implicit Smoother Scheme Improvements of Unsteady Simulations for Compressible Navier Stokes Based on a RK/Implicit Smoother Scheme Oren Peles and Eli Turkel Department of Applied Mathematics, Tel-Aviv University In memoriam of

More information

A Central Compact-Reconstruction WENO Method for Hyperbolic Conservation Laws

A Central Compact-Reconstruction WENO Method for Hyperbolic Conservation Laws A Central Compact-Reconstruction WENO Method for Hyperbolic Conservation Laws Kilian Cooley 1 Prof. James Baeder 2 1 Department of Mathematics, University of Maryland - College Park 2 Department of Aerospace

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

First, Second, and Third Order Finite-Volume Schemes for Diffusion

First, Second, and Third Order Finite-Volume Schemes for Diffusion First, Second, and Third Order Finite-Volume Schemes for Diffusion Hiro Nishikawa 51st AIAA Aerospace Sciences Meeting, January 10, 2013 Supported by ARO (PM: Dr. Frederick Ferguson), NASA, Software Cradle.

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

Lattice Boltzmann Method for Fluid Simulations

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

More information

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

19 th INTERNATIONAL CONGRESS ON ACOUSTICS MADRID, 2-7 SEPTEMBER 2007

19 th INTERNATIONAL CONGRESS ON ACOUSTICS MADRID, 2-7 SEPTEMBER 2007 19 th INTERNATIONAL CONGRESS ON ACOUSTICS MADRID, -7 SEPTEMBER 007 INVESTIGATION OF AMPLITUDE DEPENDENCE ON NONLINEAR ACOUSTICS USING THE DIRECT SIMULATION MONTE CARLO METHOD PACS: 43.5.Ed Hanford, Amanda

More information

Computational Analysis of an Imploding Gas:

Computational Analysis of an Imploding Gas: 1/ 31 Direct Numerical Simulation of Navier-Stokes Equations Stephen Voelkel University of Notre Dame October 19, 2011 2/ 31 Acknowledges Christopher M. Romick, Ph.D. Student, U. Notre Dame Dr. Joseph

More information

Numerical Methods for PDEs

Numerical Methods for PDEs Numerical Methods for PDEs Partial Differential Equations (Lecture 1, Week 1) Markus Schmuck Department of Mathematics and Maxwell Institute for Mathematical Sciences Heriot-Watt University, Edinburgh

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 Numerical Methods for Partial Differential Equations Finite Difference Methods

More information

A high order adaptive finite element method for solving nonlinear hyperbolic conservation laws

A high order adaptive finite element method for solving nonlinear hyperbolic conservation laws A high order adaptive finite element method for solving nonlinear hyperbolic conservation laws Zhengfu Xu, Jinchao Xu and Chi-Wang Shu 0th April 010 Abstract In this note, we apply the h-adaptive streamline

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

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

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

TAU Extensions for High Enthalpy Flows. Sebastian Karl AS-RF

TAU Extensions for High Enthalpy Flows. Sebastian Karl AS-RF TAU Extensions for High Enthalpy Flows Sebastian Karl AS-RF Contents Motivation Extensions available in the current release: Numerical schemes for super- and hypersonic flow fields Models for gas mixtures,

More information

Notes. Multi-Dimensional Plasticity. Yielding. Multi-Dimensional Yield criteria. (so rest state includes plastic strain): #=#(!

Notes. Multi-Dimensional Plasticity. Yielding. Multi-Dimensional Yield criteria. (so rest state includes plastic strain): #=#(! Notes Multi-Dimensional Plasticity! I am back, but still catching up! Assignment is due today (or next time I!m in the dept following today)! Final project proposals: I haven!t sorted through my email,

More information

The Orchestra of Partial Differential Equations. Adam Larios

The Orchestra of Partial Differential Equations. Adam Larios The Orchestra of Partial Differential Equations Adam Larios 19 January 2017 Landscape Seminar Outline 1 Fourier Series 2 Some Easy Differential Equations 3 Some Not-So-Easy Differential Equations Outline

More information

An Accurate Fourier-Spectral Solver for Variable Coefficient Elliptic Equations

An Accurate Fourier-Spectral Solver for Variable Coefficient Elliptic Equations An Accurate Fourier-Spectral Solver for Variable Coefficient Elliptic Equations Moshe Israeli Computer Science Department, Technion-Israel Institute of Technology, Technion city, Haifa 32000, ISRAEL Alexander

More information

Coupled double-distribution-function lattice Boltzmann method for the compressible Navier-Stokes equations

Coupled double-distribution-function lattice Boltzmann method for the compressible Navier-Stokes equations PHYSICAL REVIEW E 76, 5675 7 Coupled double-distribution-function lattice Boltzmann method for the compressible Navier-Stokes equations Q. Li, Y. L. He,* Y. Wang, and W. Q. Tao State Key Laboratory of

More information

A hybrid method for hydrodynamic-kinetic flow - Part II - Coupling of hydrodynamic and kinetic models

A hybrid method for hydrodynamic-kinetic flow - Part II - Coupling of hydrodynamic and kinetic models A hybrid method for hydrodynamic-kinetic flow - Part II - Coupling of hydrodynamic and kinetic models Alessandro Alaia, Gabriella Puppo May 31, 2011 Abstract In this work we present a non stationary domain

More information

Chapter 3 Burgers Equation

Chapter 3 Burgers Equation Chapter 3 Burgers Equation One of the major challenges in the field of comple systems is a thorough understanding of the phenomenon of turbulence. Direct numerical simulations (DNS) have substantially

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

Summary We develop an unconditionally stable explicit particle CFD scheme: Boltzmann Particle Hydrodynamics (BPH)

Summary We develop an unconditionally stable explicit particle CFD scheme: Boltzmann Particle Hydrodynamics (BPH) Summary Steps in BPH Space is divided into Cartesian cells Finite number of particles ~10 6-10 7 Particles fly freely between t n and t n+1 Mass, momentum and total energy are conserved Relax into a (LTE)

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

Investigating platelet motion towards vessel walls in the presence of red blood cells

Investigating platelet motion towards vessel walls in the presence of red blood cells Investigating platelet motion towards vessel walls in the presence of red blood cells (Complex Fluids in Biological Systems) Lindsay Crowl and Aaron Fogelson Department of Mathematics University of Utah

More information

Chapter 1. Continuum mechanics review. 1.1 Definitions and nomenclature

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

More information

.u= 0 ρ( u t +(u. )u)= ρ g p+.[µ( u+ t u)]

.u= 0 ρ( u t +(u. )u)= ρ g p+.[µ( u+ t u)] THETIS is a numerical simulation tool developed by University of Bordeaux. It is a versatile code to solve different problems: fluid flows, heat transfers, scalar transports or porous mediums. The potential

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

Scalable Non-Linear Compact Schemes

Scalable Non-Linear Compact Schemes Scalable Non-Linear Compact Schemes Debojyoti Ghosh Emil M. Constantinescu Jed Brown Mathematics Computer Science Argonne National Laboratory International Conference on Spectral and High Order Methods

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

A Scalable, Parallel Implementation of Weighted, Non-Linear Compact Schemes

A Scalable, Parallel Implementation of Weighted, Non-Linear Compact Schemes A Scalable, Parallel Implementation of Weighted, Non-Linear Compact Schemes Debojyoti Ghosh Emil M. Constantinescu Jed Brown Mathematics Computer Science Argonne National Laboratory SIAM Annual Meeting

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

Marching on the BL equations

Marching on the BL equations Marching on the BL equations Harvey S. H. Lam February 10, 2004 Abstract The assumption is that you are competent in Matlab or Mathematica. White s 4-7 starting on page 275 shows us that all generic boundary

More information

Discretization Error Reduction through r Adaptation in CFD

Discretization Error Reduction through r Adaptation in CFD Discretization Error Reduction through r Adaptation in CFD ASME Verification and Validation Symposium May 13 15, 2015 William C. Tyson, Christopher J. Roy, Joseph M. Derlaga, and Charles W. Jackson Aerospace

More information

Computational Fluid Dynamics Prof. Dr. Suman Chakraborty Department of Mechanical Engineering Indian Institute of Technology, Kharagpur

Computational Fluid Dynamics Prof. Dr. Suman Chakraborty Department of Mechanical Engineering Indian Institute of Technology, Kharagpur Computational Fluid Dynamics Prof. Dr. Suman Chakraborty Department of Mechanical Engineering Indian Institute of Technology, Kharagpur Lecture No. #12 Fundamentals of Discretization: Finite Volume Method

More information