A Bound-Preserving Fourth Order Compact Finite Difference Scheme for Scalar Convection Diffusion Equations

Size: px
Start display at page:

Download "A Bound-Preserving Fourth Order Compact Finite Difference Scheme for Scalar Convection Diffusion Equations"

Transcription

1 A Bound-Preserving Fourth Order Compact Finite Difference Scheme for Scalar Convection Diffusion Equations Hao Li Math Dept, Purdue Univeristy Ocean University of China, December, 2017 Joint work with Shusen Xie (Ocean University of China) and Xiangxiong Zhang (Purdue University) 1 / 42

2 Overview 1 Inroduction Bound Preserving Conservative Scheme Time Discretization Monotone Scheme 2 Compact Finite Difference Weak Monotonicity 3 Further Extension Different Boundary Conditions Higher Order Scheme Non-uniform Grids 4 Numerical Test 2 / 42

3 Stability: Compressible Euler Equations in Gas Dynamics ρ m E t + m ρu 2 + p (E + p)u x = 0, with m = ρu, E = 1 2 ρu2 + ρe, p = (γ 1)ρe The speed of sound is given by c = γp/ρ and the three eigenvalues of the Jacobian are u, u ± c If either ρ < 0 or p < 0, then the sound speed is imaginary and the system is no longer hyperbolic Thus the initial value problem is ill-posed This is why it is computationally unstable 3 / 42

4 Bound Preserving for Scalar Conservation Laws Consider the initial value problem u t + F(u) = 0, u(x, 0) = u 0 (x), x R n for which the unique entropy solution u(x, t) satisfies min x In particular, u(x, t 0 ) u(x, t) max u(x, t 0 ), t t 0 Maximum Principle x min x u 0 (x) = m u(x, t) M = max u 0 (x) x It is also a desired property for numerical solutions due to Bound Preserving 1 Physical meaning: vehicle density (traffic flow), mass percentage (pollutant transport), probability distribution (Boltzmann equation) and etc 2 Stability for systems: positivity of density and pressure (gas dynamics), water height (shallow water equations), particle density for describing electrical discharges (a convection-dominated system) and etc For numerical schemes, this is a completely DIFFERENT problem from discrete maximum principle in solving elliptic equations 4 / 42

5 Scalar Equations IVP: u t + f(u) x = 0, u(x, 0) = u 0 (x) Maximum Principle (Bound Preserving): u(x, t) [m, M] where m = min u 0 (x), M = min u 0 (x) For finite difference, any scheme satisfying min u n j u n+1 j max u n j j j at most first order accurate can be Harten s Counter Example: consider u t + u x = 0, u(x, 0) = sin x Put the grids in a way such that x = π 2 is in the middle of two grid points

6 Scalar Equations IVP: u t + f(u) x = 0, u(x, 0) = u 0 (x) Maximum Principle (Bound Preserving): u(x, t) [m, M] where m = min u 0 (x), M = min u 0 (x) For finite difference, any scheme satisfying min u n j u n+1 j max u n j j j at most first order accurate can be Harten s Counter Example: consider u t + u x = 0, u(x, 0) = sin x Put the grids in a way such that x = π 2 is in the middle of two grid points

7 Scalar Equations IVP: u t + f(u) x = 0, u(x, 0) = u 0 (x) Maximum Principle (Bound Preserving): u(x, t) [m, M] where m = min u 0 (x), M = min u 0 (x) For finite difference, any scheme satisfying min u n j u n+1 j max u n j j j at most first order accurate can be Harten s Counter Example: consider u t + u x = 0, u(x, 0) = sin x Put the grids in a way such that x = π 2 is in the middle of two grid points sin π 2 sin ( π 2 + x 2 ) = 1 8 x2 + O( x 3 ) 7 / 42

8 Bound-Preserving Schemes 1 First order monotone schemes 2 FD/FV schemes satisfying min u n j u n+1 j j max u n j : can have any formal j order of accuracy in the monotone region but are only first order accurate around the extrema Eg, Conventional total-variation-diminishing (TVD) schemes High Resolution schemes such as the MUSCL scheme 3 FV schemes satisfying min x u n (x) u n+1 (x) max u n (x): x R Sanders, 1988: a third order finite volume scheme for 1D XZ and Shu, 2009: higher order (up to 6th) extension of Sanders scheme Liu and Osher, 1996: a third order FV scheme for 1D (can be proven bound-preserving only for linear equations) Noelle, 1998; Kurganov and Petrova, 2001: 2D generalization of Liu and Osher All schemes in this category use the exact time evolution 8 / 42

9 Bound-Preserving Schemes Practical/popular high order schemes are NOT bound-preserving It was unknown previously how to construct a high order bound-preserving scheme for 2D nonlinear equations 9 / 42

10 Conservative Eulerian Schemes Conservative Schemes: The scheme must have the following form: U n+1 j = U n j t [ˆfj+ 1 x j 2 Global Conservation: u n+1 j x j = uj n x j j j We insist on using conservative schemes: ˆf j Lax-Wendroff Theorem: If converging (as mesh sizes go to zero), the converged solution of a conservative scheme is a weak solution 2 The shock location will be wrong if the conservation is violated 3 If a scheme is conservative and positivity preserving, then we have L1-stability: j un+1 j x j = j un+1 j x j = j un j x j = j un j x j In Euler equations, if density and pressure are positive, then we have L1-stability for density and total energy Crude replacement of negative values by positive ones is simply unacceptable and unstable because it destroys the local conservation ] 10 / 42

11 Objective We want to construct a scheme which is 1 genuinely high order accurate (at least third order) 2 conservative 3 positivity/bound preserving 4 Practical concern: cost effective, multi-dimensions, unstructured meshes, parallelizability and etc Why high order schemes? For smooth solutions, the computational cost of higher order schemes is smaller to reach the same accuracy Near shocks, the error in L norm of any scheme will at most half order For a lot of problems: accuracy is still high order away from discontinuities Motivation: nonlinear stability is one of the main reasons why high order schemes have not been widely used for more real world problems 11 / 42

12 Time Discretization: SSP Runge-Kutta or Multi-Step Method High order strong stability preserving (SSP) Runge-Kutta or multi-step method is a convex combination of several forward Euler schemes Eg, the 5 stages 4th order SSP Runge-Kutta method for solving u t = F(u) is given by u (1) = u n tf(u n ) u (2) = u n u (1) tf(u (1) ) u (3) = u n u (2) tf(u (2) ) u (4) = u n u (3) tf(u (3) ) u n+1 = u (2) u (3) tf(u (3) ) u (4) tf(u (4) ) This method was numerically found to be optimal 12 / 42

13 Time Discretization: SSP Runge-Kutta or Multi-Step Method If the forward Euler is bound-preserving, then so is the high order Runge-Kutta/Multi-Step SSP time discretization has been often used to construct positivity preserving schemes 13 / 42

14 First Order Monotone Schemes Let λ = t x, a monotone scheme for u t + f(u) x = 0 is given by ] u n+1 j = u n n j λ [ f(u j, u n j+1) f(u n j 1, u n j ) = H(u n j 1, u n j, u n j+1) where the numerical flux f(, ) is monotonically increasing wrt the first variable and decreasing wrt the second variable Eg, the Lax-Friedrichs flux 1 f(u, v) = (f(u) + f(v) α(v u)), α = max f (u) 2 u If m u n j M for all j, then u n+1 j = H(u n j 1, u n j, u n j+1) = H(,, ) (1) implies m = H(m, m, m) u n+1 j H(M, M, M) = M 14 / 42

15 Fourth Order Compact Finite Difference Standard centered finite difference: u i = u i+1 u i 1 2 x + O( x 2 ), u i Fourth order compact finite difference: = u i+1 2u i + u i 1 x 2 + O( x 2 ) 1 6 u i u i u i 1 = u i+1 u i 1 + O( x 4 ) 2 x 1 12 u i u i u i 1 = u i+1 2u i + u i 1 x 2 + O( x 4 ) A tridiagonal system needs to be solved: u 1 u 2 u 3 u N 1 u N = 1 2 x ie Wu = D x u u 1 u 2 u 3 u N 1 u N, 15 / 42

16 The Weighting Operator for Convection If we regard W as an operator mapping a vector to another vector, then (Wu) j = 1 6 u j u j u j 1, which happens to be the Simpson s rule (or 3-point Gauss-Lobatto Rule) in quadrature x j 1 x j x j+1 Locally, for each interval [x j 1, x j+1 ], there exists a cubic polynomial p j (x), obtained through interpolation at x j 1, x j, x j+1, x j+2 (or x j 2, x j 1, x j, x j+1 )

17 The Weighting Operator for Convection If we regard W as an operator mapping a vector to another vector, then (Wu) j = 1 6 u j u j u j 1, which happens to be the Simpson s rule (or 3-point Gauss-Lobatto Rule) in quadrature x j 1 x j x j+1 x j+2 Locally, for each interval [x j 1, x j+1 ], there exists a cubic polynomial p j (x), obtained through interpolation at x j 1, x j, x j+1, x j+2 (or x j 2, x j 1, x j, x j+1 )

18 The Weighting Operator for Convection If we regard W as an operator mapping a vector to another vector, then (Wu) j = 1 6 u j u j u j 1, which happens to be the Simpson s rule (or 3-point Gauss-Lobatto Rule) in quadrature x j 1 x j x j+1 x j+2 Locally, for each interval [x j 1, x j+1 ], there exists a cubic polynomial p j (x), obtained through interpolation at x j 1, x j, x j+1, x j+2 (or x j 2, x j 1, x j, x j+1 ) 18 / 42

19 The Fourth Order Compact Finite Difference Scheme for Convection Let u i = (Wu) i = 1 6 u i u i u i+1 The fourth order compact finite difference for u t + f(u) x = 0 can be written as u n+1 i = u n i t 1 x 2 [f(un i+1) f(u n i 1)] = u n i t x (ˆf n ˆf n ), i+ 1 i ˆfi+ 1 2 = 1 2 (f(u i+1) + f(u i )) The weak monotonicity holds under the CFL constraint λ max u f (u) 1 3 : u n+1 i = 1 6 un i un i un i λ[f(un i+1) f(u n i 1)] = 1 6 [u i 1 3λf(u n i 1)] [un i+1 + 3λf(u n i+1)] un i = H(u n i 1, u n i, u n i+1) = H(,, ) Thus m u n i M implies m = H(m, m, m) u n+1 i H(M, M, M) = M 19 / 42

20 How to enforce bounds? Consider enforcing the positivity (general lower/upper bounds can be similarly treated) Given point values u i, if 1 6 u i u i u i+1 0 for any i, then the following hold: For any three consecutive points, at least one point value is non-negative If u i < 0, local average is non-negative: 1 3 u i u i u i+1 0 This means that it is possible to eliminate the undershoot without changing 1 3 u i u i u i+1 If u i < 0, then either u i u i+1 0 or u i u i 1 0 So a simple local limiter can enforce the positivity ( or general lower/upper bounds): if u i+1 u i 1, set u i+1 u i+1 + u i, u i 0, if u i+1 < u i 1, set u i 1 u i 1 + u i, u i 0 20 / 42

21 2D Convection Let u i,j denote point values on a 2D uniform grid Define two weighting operators: (W x u) i,j = 1 6 u i 1,j u i,j u i+1,j, (W y u) i,j = 1 6 u i,j u i,j u i,j+1 Let u denote W x W y u The fourth order compact finite difference for u t + f(u) x + g(u) y = 0 can be written as u n+1 i,j = u n i,j + t 1 x 2 W y[f(u n i+1,j) f(u n i 1,j)] + t 1 y 2 W x[g(u n i,j+1) f(u n i,j 1)] has weak monotonicity thus u n i,j A dimension by dimension fashion 2D limiter: u n+1 i,j 0 implies un+1 i,j 0 Introduce a new variable v = W x u So u = W y v Given u 0, apply 1D limiter in y-direction on v to enforce v 0 Given v 0, apply 1D limiter in x-direction on u to enforce u 0 21 / 42

22 Diffusion 1 12 (u i u i + u i 1) = u i+1 2u i + u i 1 x 2 + O( x 4 ) Let ũ i = (Wu) i = 1 12 (u i u i + u i+1 ) The fourth order compact finite difference for u t = g(u) xx can be written as ũ n+1 i = ũ n i + t x 2 [g(un i+1) 2g(u n i ) + g(u n i 1)], Assuming g (u) 0 The weak monotonicity holds under the CFL constraint t x max 2 u f (u) 1 6 The same 1D limiter can be used for enforcing bounds Remarks For approximating the 2D Laplacian, the fourth order compact finite difference scheme is also known as the 9-point discrete Laplacian (the second order centered difference is 5-point Laplacian) For solving heat equation, Crank-Nicolson time discretization and the 9-point Laplacian give an M-matrix, thus it can preserve bounds/positivity However, such a result cannot be easily extended to nonlinear cases 22 / 42

23 Convection-Diffusion For the equation u t + f(u) x = g(u) xx, define two weighting operators: (W 1 u) j = 1 6 (u j+1 + 4u j + u j 1 ), (W 2 u) j = 1 12 (u j u j + u j 1 ) Let ū i = (W 1 W 2 u) i = (W 2 W 1 u) i, then the scheme is ū n+1 j = ū n j λ 1 2 W 2[f(u n j+1) f(u n j 1)] + µw 1 [g(u n j+1) 2g(u n j ) + g(u n j 1)] ū n+1 j has weak monotonicity, thus u n j 0 implies ū n+1 j 0 The same 1D limiter can be applied twice to for enforcing the bound 23 / 42

24 TVB limiter The result is still true if adding the TVB limiter in Bernardo Cockburn and Chi-Wang Shu Nonlinearly stable compact schemes for shock calculations SIAM Journal on Numerical Analysis, 31(3): , 1994 Using both TVB limiter and the simple local bound-preserving limiter can eliminate overshoot/undershoot and oscillations without losing accuracy/conservation 24 / 42

25 2D Incompressible Flow The stream function formulation of 2D incompressible Navier-Stokes equations: ω t + (uω) x + (vω) y = ω u = ψ y, v = ψ x ψ = ω The weak monotonicity holds But to have H(M, M, M) = M, we need a discrete incompressible condition: [ 1 1 x 6 u i+1,j u i+1,j u i+1,j u i 1,j u i 1,j 1 ] 6 u i 1,j [ 1 y 6 v i+1,j v i,j v i 1,j v i+1,j v i,j 1 1 ] 6 v i 1,j 1 = 0 25 / 42

26 Inflow-outflow boundary conditions For the equation u t + f(u) x = 0 on [0, 1] with initial value u(x, 0) = u 0 (x) and inflow boundary condition u(0, t) = g(t) We have the 4th-order compact finite difference d 1 dt u 0 u 1 u 3 u N u N+1 = 1 2 x f 0 f 1 f 2 f N f N+1 26 / 42

27 Inflow-outflow boundary conditions With forward euler time discretization the scheme is ū n+1 i = ū n i t 2 x (f i+1 f i 1 ), 1 i N Since u 0 is known, to solve the previous linear system, we need to find a good approximation of u N+1 A cubic polynomial p j (x), obtained through enforcing its integral equals ū i over interval [x i 1, x i+1 ] for i = N 3, N 2, N 1, N We get A filter u N+1 = 2 3ūN ūn ūn ūN u N+1 = max(min(u N+1, ubound), lbound) should be used to make u N+1 [m, M] Next we can compute u i, 1 i N Apply the previous bound-preserving limiter to u i to make sure u i [m, M] Then we can update the value of ū i, 1 i N and compute the solution at next level 27 / 42

28 Dirichlet boundary conditions Consider u t + f(u) x = g(u) xx on [0, L] with initial value u(x, 0) = u 0 (x) and Dirichlet boundary condition u(0, t) = L(t), u(l, t) = R(t) Define W := W 1 W 2 = W 2 W 1, we will have and d dt (WU) + W 2D x f + W 2 F = W 1 D xx g + W 1 G (2) W 2 F + W 1 G = 1 18 u t, f x, x f x 2 g u t, x f x 2 g u t,n x f N x 2 g N u t,n f x,n x f N x 2 g N+1 (3) 28 / 42

29 Dirichlet boundary conditions We need to approximate f(u) x,0 and f(u) x,n+1 But to have weak monotonicity, only 3rd-order approximation can be made and f(u) x,0 = 1 x ( 11 6 f 0 + 3f f f 3) f(u) x,n+1 = 1 x ( 1 3 f N f N 1 3f N f N+1) Then we plug these approximations in and rearrange (2) Finally we have the space discretization d dt Wũ = D x f + Dxx g 29 / 42

30 D x = 1 24 x W = 1 72 D xx = 1 6 x N (N+2) N (N+2) N (N+2), ũ = u 0 u 1 u N u N+1 f 0 f 1, f =, g = f N f N+1 g 0 g 1 g N g N+1 (N+2) 1 (N+2) 1 (N+2) 1 Weak monotonicity and consistency hold The previous limiter can be applied to preserve the bound 2D case can be treated similarily,(4),(5) (6) 30 / 42

31 6th and 8th Order Scheme 6th order first derivative approximation with the weak monotonicity: βf i 2 + αf i 1 + f i + αf i+1 + βf i+2 = b f i+2 f i 2 4 x + a f i+1 f i 1 2, β = 1 12 ( 1 + 3α), a = 2 1 (8 3α), b = 9 18 ( α), α > 1 3 If we let α = 4 9, β = 1 36, a = 40 27, b = 25 54, we acctually have the 8th order with the weak monotonicity 6th-order second derivative approximation with the weak monotonicity: βf i 2 + αf i 1 + f i + αf i+1 + βf i+2 = b f i+2 2f i + f i 2 4 x 2 + a f i+1 2f i + f i 1 2, a = 78α + 48, b = α 36, α > 0 62 If we let α = , we acctually have the 8th order scheme with the weak monotonicity 31 / 42

32 Non-uniform Grids Consider a mapping for the physical non-uniform grid points x j on the interval [a, b] to uniform reference grid points ξ j on the same interval [a, b] Let ξ(x) denote such a map and dξ(x) dx 0 Then a convection diffusion equation in the form of can be written as: tû + u t + f(u) x = g(u) xx ( ) dξ dx d2 ξ dx 2 ξ f(û) = ( ) dξ 2 2 dx ξ 2 g(û) Therefore, it is equivalent to solve the following equation u t + c(x)f(u) x = d(x)g(u) xx, d(x) > 0 32 / 42

33 Accuracy Test SSP 4th-order multistep for 2D linear convection: Mesh L error order L 1 error order E-5-368E E E E E E E SSP RK4 for 1D linear convection: Mesh L error order L 1 error order E-5-167E E E E E E E / 42

34 SSP 4th-order multistep for 1D convection-diffusion equation: Mesh L error order L 1 error order E-6-992E E E E E E E / 42

35 1D burgers equation when the exact solution has a shock 2 2 Numerical Exact Numerical Exact Left: numerical solutions without bound-preserving limiter Right: numerical solutions with bound-preserving limiter / 42

36 12 4th order Compact FD with limiter Exact solution of u t =(u 8 ) xx Left: degenerate nonlinear parabolic equation u t = (u 8 ) xx, the numerical solution is strictly nonnegative Right: the vortex patch test for 2D incompressible NS equation with Reynolds number 3000, the solution is strictly bounded by 1 and 1 36 / 42

37 2D Incompressible flow with Reynolds number 3000: double shear layer X Y The solution is strictly in the bound 37 / 42

38 8th order scheme for linear convection equation: Mesh L error order L 1 error order E-6-199E E E E E E E th order scheme for burgers equation: Mesh L error order L 1 error order E-3-337E E E E E E E / 42

39 Inflow-outflow Boundary condition: Numerical Exact 14 Numerical Exact Burgers equation u t + ( 1 2 u2 ) xx = 0, when the solution is positive Left: numerical solution without bound-preserving limiter Right: numerical solution with bound-preserving limiter The solution is strictly bounded by 05 and / 42

40 SSP 4th-order multistep for 1D convection diffusion equation with Dirichlet boundary condition: Mesh L error order L 1 error order E-5-203E E E E E E E E E / 42

41 Generalization to Systems? Try to use the idea of FV? 41 / 42

42 The End 42 / 42

30 crete maximum principle, which all imply the bound-preserving property. But most

30 crete maximum principle, which all imply the bound-preserving property. But most 3 4 7 8 9 3 4 7 A HIGH ORDER ACCURATE BOUND-PRESERVING COMPACT FINITE DIFFERENCE SCHEME FOR SCALAR CONVECTION DIFFUSION EQUATIONS HAO LI, SHUSEN XIE, AND XIANGXIONG ZHANG Abstract We show that the classical

More information

Positivity-preserving high order schemes for convection dominated equations

Positivity-preserving high order schemes for convection dominated equations Positivity-preserving high order schemes for convection dominated equations Chi-Wang Shu Division of Applied Mathematics Brown University Joint work with Xiangxiong Zhang; Yinhua Xia; Yulong Xing; Cheng

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

Maximum-principle-satisfying and positivity-preserving high order schemes for conservation laws: Survey and new developments

Maximum-principle-satisfying and positivity-preserving high order schemes for conservation laws: Survey and new developments Maximum-principle-satisfying and positivity-preserving high order schemes for conservation laws: Survey and new developments By Xiangxiong Zhang 1 and Chi-Wang Shu 1 Department of Mathematics, Brown University,

More information

A positivity-preserving high order discontinuous Galerkin scheme for convection-diffusion equations

A positivity-preserving high order discontinuous Galerkin scheme for convection-diffusion equations A positivity-preserving high order discontinuous Galerkin scheme for convection-diffusion equations Sashank Srinivasan a, Jonathan Poggie a, Xiangxiong Zhang b, a School of Aeronautics and Astronautics,

More information

Weighted Essentially Non-Oscillatory limiters for Runge-Kutta Discontinuous Galerkin Methods

Weighted Essentially Non-Oscillatory limiters for Runge-Kutta Discontinuous Galerkin Methods Weighted Essentially Non-Oscillatory limiters for Runge-Kutta Discontinuous Galerkin Methods Jianxian Qiu School of Mathematical Science Xiamen University jxqiu@xmu.edu.cn http://ccam.xmu.edu.cn/teacher/jxqiu

More information

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

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

More information

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

ENO and WENO schemes. Further topics and time Integration

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

More information

A parametrized maximum principle preserving flux limiter for finite difference RK-WENO schemes with applications in incompressible flows.

A parametrized maximum principle preserving flux limiter for finite difference RK-WENO schemes with applications in incompressible flows. A parametrized maximum principle preserving flux limiter for finite difference RK-WENO schemes with applications in incompressible flows Tao Xiong Jing-ei Qiu Zhengfu Xu 3 Abstract In Xu [] a class of

More information

A minimum entropy principle of high order schemes for gas dynamics. equations 1. Abstract

A minimum entropy principle of high order schemes for gas dynamics. equations 1. Abstract A minimum entropy principle of high order schemes for gas dynamics equations iangxiong Zhang and Chi-Wang Shu 3 Abstract The entropy solutions of the compressible Euler equations satisfy a minimum principle

More information

Fourier analysis for discontinuous Galerkin and related methods. Abstract

Fourier analysis for discontinuous Galerkin and related methods. Abstract Fourier analysis for discontinuous Galerkin and related methods Mengping Zhang and Chi-Wang Shu Abstract In this paper we review a series of recent work on using a Fourier analysis technique to study the

More information

Numerische Mathematik

Numerische Mathematik Numer. Math. ) :545 563 DOI.7/s--443-7 Numerische Mathematik A minimum entropy principle of high order schemes for gas dynamics equations iangxiong Zhang Chi-Wang Shu Received: 7 July / Revised: 5 September

More information

ARTICLE IN PRESS Mathematical and Computer Modelling ( )

ARTICLE IN PRESS Mathematical and Computer Modelling ( ) Mathematical and Computer Modelling Contents lists available at ScienceDirect Mathematical and Computer Modelling ournal homepage: wwwelseviercom/locate/mcm Total variation diminishing nonstandard finite

More information

TOTAL VARIATION DIMINISHING RUNGE-KUTTA SCHEMES

TOTAL VARIATION DIMINISHING RUNGE-KUTTA SCHEMES MATHEMATICS OF COMPUTATION Volume 67 Number 221 January 1998 Pages 73 85 S 0025-5718(98)00913-2 TOTAL VARIATION DIMINISHING RUNGE-KUTTA SCHEMES SIGAL GOTTLIEB AND CHI-WANG SHU Abstract. In this paper we

More information

High Order Accurate Runge Kutta Nodal Discontinuous Galerkin Method for Numerical Solution of Linear Convection Equation

High Order Accurate Runge Kutta Nodal Discontinuous Galerkin Method for Numerical Solution of Linear Convection Equation High Order Accurate Runge Kutta Nodal Discontinuous Galerkin Method for Numerical Solution of Linear Convection Equation Faheem Ahmed, Fareed Ahmed, Yongheng Guo, Yong Yang Abstract This paper deals with

More information

Entropy stable high order discontinuous Galerkin methods. for hyperbolic conservation laws

Entropy stable high order discontinuous Galerkin methods. for hyperbolic conservation laws Entropy stable high order discontinuous Galerkin methods for hyperbolic conservation laws Chi-Wang Shu Division of Applied Mathematics Brown University Joint work with Tianheng Chen, and with Yong Liu

More information

Inverse Lax-Wendroff Procedure for Numerical Boundary Conditions of. Conservation Laws 1. Abstract

Inverse Lax-Wendroff Procedure for Numerical Boundary Conditions of. Conservation Laws 1. Abstract Inverse Lax-Wendroff Procedure for Numerical Boundary Conditions of Conservation Laws Sirui Tan and Chi-Wang Shu 3 Abstract We develop a high order finite difference numerical boundary condition for solving

More information

Stable Semi-Discrete Schemes for the 2D Incompressible Euler Equations

Stable Semi-Discrete Schemes for the 2D Incompressible Euler Equations Stable Semi-Discrete Schemes for the D Incompressible Euler Equations Doron Levy Department of Mathematics Stanford University dlevy@math.stanford.edu http://math.stanford.edu/ dlevy Maryland, May 004

More information

Strong Stability-Preserving (SSP) High-Order Time Discretization Methods

Strong Stability-Preserving (SSP) High-Order Time Discretization Methods Strong Stability-Preserving (SSP) High-Order Time Discretization Methods Xinghui Zhong 12/09/ 2009 Outline 1 Introduction Why SSP methods Idea History/main reference 2 Explicit SSP Runge-Kutta Methods

More information

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

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

More information

A numerical study of SSP time integration methods for hyperbolic conservation laws

A numerical study of SSP time integration methods for hyperbolic conservation laws MATHEMATICAL COMMUNICATIONS 613 Math. Commun., Vol. 15, No., pp. 613-633 (010) A numerical study of SSP time integration methods for hyperbolic conservation laws Nelida Črnjarić Žic1,, Bojan Crnković 1

More information

Hierarchical Reconstruction with up to Second Degree Remainder for Solving Nonlinear Conservation Laws

Hierarchical Reconstruction with up to Second Degree Remainder for Solving Nonlinear Conservation Laws Hierarchical Reconstruction with up to Second Degree Remainder for Solving Nonlinear Conservation Laws Dedicated to Todd F. Dupont on the occasion of his 65th birthday Yingjie Liu, Chi-Wang Shu and Zhiliang

More information

A class of the fourth order finite volume Hermite weighted essentially non-oscillatory schemes

A class of the fourth order finite volume Hermite weighted essentially non-oscillatory schemes Science in China Series A: Mathematics Aug., 008, Vol. 51, No. 8, 1549 1560 www.scichina.com math.scichina.com www.springerlink.com A class of the fourth order finite volume Hermite weighted essentially

More information

Hierarchical Reconstruction with up to Second Degree Remainder for Solving Nonlinear Conservation Laws

Hierarchical Reconstruction with up to Second Degree Remainder for Solving Nonlinear Conservation Laws Hierarchical Reconstruction with up to Second Degree Remainder for Solving Nonlinear Conservation Laws Dedicated to Todd F. Dupont on the occasion of his 65th birthday Yingjie Liu, Chi-Wang Shu and Zhiliang

More information

A genuinely high order total variation diminishing scheme for one-dimensional. scalar conservation laws 1. Abstract

A genuinely high order total variation diminishing scheme for one-dimensional. scalar conservation laws 1. Abstract A genuinely high order total variation diminishing scheme for one-dimensional scalar conservation laws Xiangxiong Zhang and Chi-Wang Shu 3 Abstract It is well known that finite difference or finite volume

More information

Improvement of convergence to steady state solutions of Euler equations with. the WENO schemes. Abstract

Improvement of convergence to steady state solutions of Euler equations with. the WENO schemes. Abstract Improvement of convergence to steady state solutions of Euler equations with the WENO schemes Shuhai Zhang, Shufen Jiang and Chi-Wang Shu 3 Abstract The convergence to steady state solutions of the Euler

More information

Runge-Kutta discontinuous Galerkin method with a simple and compact Hermite WENO limiter

Runge-Kutta discontinuous Galerkin method with a simple and compact Hermite WENO limiter Runge-Kutta discontinuous Galerkin method with a simple and compact Hermite WENO limiter Jun Zhu, inghui Zhong, Chi-Wang Shu 3 and Jianxian Qiu 4 Abstract In this paper, we propose a new type of weighted

More information

A Fourth-Order Central Runge-Kutta Scheme for Hyperbolic Conservation Laws

A Fourth-Order Central Runge-Kutta Scheme for Hyperbolic Conservation Laws A Fourth-Order Central Runge-Kutta Scheme for Hyperbolic Conservation Laws Mehdi Dehghan, Rooholah Jazlanian Department of Applied Mathematics, Faculty of Mathematics and Computer Science, Amirkabir University

More information

AN OPTIMALLY ACCURATE SPECTRAL VOLUME FORMULATION WITH SYMMETRY PRESERVATION

AN OPTIMALLY ACCURATE SPECTRAL VOLUME FORMULATION WITH SYMMETRY PRESERVATION AN OPTIMALLY ACCURATE SPECTRAL VOLUME FORMULATION WITH SYMMETRY PRESERVATION Fareed Hussain Mangi*, Umair Ali Khan**, Intesab Hussain Sadhayo**, Rameez Akbar Talani***, Asif Ali Memon* ABSTRACT High order

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

Dedicated to the 70th birthday of Professor Lin Qun

Dedicated to the 70th birthday of Professor Lin Qun Journal of Computational Mathematics, Vol.4, No.3, 6, 39 5. ANTI-DIFFUSIVE FINITE DIFFERENCE WENO METHODS FOR SHALLOW WATER WITH TRANSPORT OF POLLUTANT ) Zhengfu Xu (Department of Mathematics, Pennsylvania

More information

Construction of very high order Residual Distribution Schemes for steady problems

Construction of very high order Residual Distribution Schemes for steady problems Construction of very high order Residual Distribution Schemes for steady problems Rémi Abgrall, Mario Ricchiuto, Cédric Tavé, Nadège Villedieu and Herman Deconinck Mathématiques Appliquées de Bordeaux,

More information

Anti-diffusive finite difference WENO methods for shallow water with. transport of pollutant

Anti-diffusive finite difference WENO methods for shallow water with. transport of pollutant Anti-diffusive finite difference WENO methods for shallow water with transport of pollutant Zhengfu Xu 1 and Chi-Wang Shu 2 Dedicated to Professor Qun Lin on the occasion of his 70th birthday Abstract

More information

An Improved Non-linear Weights for Seventh-Order WENO Scheme

An Improved Non-linear Weights for Seventh-Order WENO Scheme An Improved Non-linear Weights for Seventh-Order WENO Scheme arxiv:6.06755v [math.na] Nov 06 Samala Rathan, G Naga Raju Department of Mathematics, Visvesvaraya National Institute of Technology, Nagpur,

More information

A Fifth Order Flux Implicit WENO Method

A Fifth Order Flux Implicit WENO Method A Fifth Order Flux Implicit WENO Method Sigal Gottlieb and Julia S. Mullen and Steven J. Ruuth April 3, 25 Keywords: implicit, weighted essentially non-oscillatory, time-discretizations. Abstract The weighted

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

Strong Stability Preserving Properties of Runge Kutta Time Discretization Methods for Linear Constant Coefficient Operators

Strong Stability Preserving Properties of Runge Kutta Time Discretization Methods for Linear Constant Coefficient Operators Journal of Scientific Computing, Vol. 8, No., February 3 ( 3) Strong Stability Preserving Properties of Runge Kutta Time Discretization Methods for Linear Constant Coefficient Operators Sigal Gottlieb

More information

Semi-Lagrangian Formulations for Linear Advection Equations and Applications to Kinetic Equations

Semi-Lagrangian Formulations for Linear Advection Equations and Applications to Kinetic Equations Semi-Lagrangian Formulations for Linear Advection and Applications to Kinetic Department of Mathematical and Computer Science Colorado School of Mines joint work w/ Chi-Wang Shu Supported by NSF and AFOSR.

More information

Finite Differences for Differential Equations 28 PART II. Finite Difference Methods for Differential Equations

Finite Differences for Differential Equations 28 PART II. Finite Difference Methods for Differential Equations Finite Differences for Differential Equations 28 PART II Finite Difference Methods for Differential Equations Finite Differences for Differential Equations 29 BOUNDARY VALUE PROBLEMS (I) Solving a TWO

More information

DISCONTINUOUS GALERKIN METHOD FOR TIME DEPENDENT PROBLEMS: SURVEY AND RECENT DEVELOPMENTS

DISCONTINUOUS GALERKIN METHOD FOR TIME DEPENDENT PROBLEMS: SURVEY AND RECENT DEVELOPMENTS DISCONTINUOUS GALERKIN METHOD FOR TIME DEPENDENT PROBLEMS: SURVEY AND RECENT DEVELOPMENTS CHI-WANG SHU Abstract. In these lectures we give a general survey on discontinuous Galerkin methods for solving

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 Dept. of

More information

Strong Stability Preserving Time Discretizations

Strong Stability Preserving Time Discretizations AJ80 Strong Stability Preserving Time Discretizations Sigal Gottlieb University of Massachusetts Dartmouth Center for Scientific Computing and Visualization Research November 20, 2014 November 20, 2014

More information

CENTRAL DISCONTINUOUS GALERKIN METHODS ON OVERLAPPING CELLS WITH A NON-OSCILLATORY HIERARCHICAL RECONSTRUCTION

CENTRAL DISCONTINUOUS GALERKIN METHODS ON OVERLAPPING CELLS WITH A NON-OSCILLATORY HIERARCHICAL RECONSTRUCTION CENTRAL DISCONTINUOUS GALERKIN METHODS ON OVERLAPPING CELLS WITH A NON-OSCILLATORY HIERARCHICAL RECONSTRUCTION YINGJIE LIU, CHI-WANG SHU, EITAN TADMOR, AND MENGPING ZHANG Abstract. The central scheme of

More information

Entropy stable schemes for degenerate convection-diffusion equations

Entropy stable schemes for degenerate convection-diffusion equations Entropy stable schemes for degenerate convection-diffusion equations Silvia Jerez 1 Carlos Parés 2 ModCompShock, Paris 6-8 Decmber 216 1 CIMAT, Guanajuato, Mexico. 2 University of Malaga, Málaga, Spain.

More information

Solving the Euler Equations!

Solving the Euler Equations! http://www.nd.edu/~gtryggva/cfd-course/! Solving the Euler Equations! Grétar Tryggvason! Spring 0! The Euler equations for D flow:! where! Define! Ideal Gas:! ρ ρu ρu + ρu + p = 0 t x ( / ) ρe ρu E + p

More information

Part 1. The diffusion equation

Part 1. The diffusion equation Differential Equations FMNN10 Graded Project #3 c G Söderlind 2016 2017 Published 2017-11-27. Instruction in computer lab 2017-11-30/2017-12-06/07. Project due date: Monday 2017-12-11 at 12:00:00. Goals.

More information

YINGJIE LIU, CHI-WANG SHU, EITAN TADMOR, AND MENGPING ZHANG

YINGJIE LIU, CHI-WANG SHU, EITAN TADMOR, AND MENGPING ZHANG CENTRAL DISCONTINUOUS GALERKIN METHODS ON OVERLAPPING CELLS WITH A NON-OSCILLATORY HIERARCHICAL RECONSTRUCTION YINGJIE LIU, CHI-WANG SHU, EITAN TADMOR, AND MENGPING ZHANG Abstract. The central scheme of

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

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

Convex ENO Schemes for Hamilton-Jacobi Equations

Convex ENO Schemes for Hamilton-Jacobi Equations Convex ENO Schemes for Hamilton-Jacobi Equations Chi-Tien Lin Dedicated to our friend, Xu-Dong Liu, notre Xu-Dong. Abstract. In one dimension, viscosit solutions of Hamilton-Jacobi (HJ equations can be

More information

Received 6 August 2005; Accepted (in revised version) 22 September 2005

Received 6 August 2005; Accepted (in revised version) 22 September 2005 COMMUNICATIONS IN COMPUTATIONAL PHYSICS Vol., No., pp. -34 Commun. Comput. Phys. February 6 A New Approach of High OrderWell-Balanced Finite Volume WENO Schemes and Discontinuous Galerkin Methods for a

More information

FUNDAMENTALS OF LAX-WENDROFF TYPE APPROACH TO HYPERBOLIC PROBLEMS WITH DISCONTINUITIES

FUNDAMENTALS OF LAX-WENDROFF TYPE APPROACH TO HYPERBOLIC PROBLEMS WITH DISCONTINUITIES 6th European Conference on Computational Mechanics (ECCM 6) 7th European Conference on Computational Fluid Dynamics (ECFD 7) 1115 June 018, Glasgow, UK FUNDAMENTALS OF LAX-WENDROFF TYPE APPROACH TO HYPERBOLIC

More information

A central discontinuous Galerkin method for Hamilton-Jacobi equations

A central discontinuous Galerkin method for Hamilton-Jacobi equations A central discontinuous Galerkin method for Hamilton-Jacobi equations Fengyan Li and Sergey Yakovlev Abstract In this paper, a central discontinuous Galerkin method is proposed to solve for the viscosity

More information

Runge Kutta Discontinuous Galerkin Methods for Convection-Dominated Problems

Runge Kutta Discontinuous Galerkin Methods for Convection-Dominated Problems Journal of Scientific Computing, Vol. 16, No. 3, September 2001 ( 2001) Review Article Runge Kutta Discontinuous Galerkin Methods for Convection-Dominated Problems Bernardo Cockburn 1 and Chi-Wang Shu

More information

Index. higher order methods, 52 nonlinear, 36 with variable coefficients, 34 Burgers equation, 234 BVP, see boundary value problems

Index. higher order methods, 52 nonlinear, 36 with variable coefficients, 34 Burgers equation, 234 BVP, see boundary value problems Index A-conjugate directions, 83 A-stability, 171 A( )-stability, 171 absolute error, 243 absolute stability, 149 for systems of equations, 154 absorbing boundary conditions, 228 Adams Bashforth methods,

More information

ALTERNATING EVOLUTION DISCONTINUOUS GALERKIN METHODS FOR HAMILTON-JACOBI EQUATIONS

ALTERNATING EVOLUTION DISCONTINUOUS GALERKIN METHODS FOR HAMILTON-JACOBI EQUATIONS ALTERNATING EVOLUTION DISCONTINUOUS GALERKIN METHODS FOR HAMILTON-JACOBI EQUATIONS HAILIANG LIU AND MICHAEL POLLACK Abstract. In this work, we propose a high resolution Alternating Evolution Discontinuous

More information

FDM for parabolic equations

FDM for parabolic equations FDM for parabolic equations Consider the heat equation where Well-posed problem Existence & Uniqueness Mass & Energy decreasing FDM for parabolic equations CNFD Crank-Nicolson + 2 nd order finite difference

More information

An interface treating technique for compressible multi-medium flow with. Runge-Kutta discontinuous Galerkin method. Abstract

An interface treating technique for compressible multi-medium flow with. Runge-Kutta discontinuous Galerkin method. Abstract An interface treating technique for compressible multi-medium flow with Runge-Kutta discontinuous Galerkin method Chunwu Wang 1 and Chi-Wang Shu 2 Abstract The high-order accurate Runge-Kutta discontinuous

More information

Essentially Non-Oscillatory and Weighted Essentially Non-Oscillatory Schemes for Hyperbolic Conservation Laws

Essentially Non-Oscillatory and Weighted Essentially Non-Oscillatory Schemes for Hyperbolic Conservation Laws NASA/CR-97-0653 ICASE Report No. 97-65 Essentially Non-Oscillatory and Weighted Essentially Non-Oscillatory Schemes for Hyperbolic Conservation Laws Chi-Wang Shu Brown University Institute for Computer

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

In particular, if the initial condition is positive, then the entropy solution should satisfy the following positivity-preserving property

In particular, if the initial condition is positive, then the entropy solution should satisfy the following positivity-preserving property 1 3 4 5 6 7 8 9 1 11 1 13 14 15 16 17 18 19 1 3 4 IMPLICIT POSITIVITY-PRESERVING HIGH ORDER DISCONTINUOUS GALERKIN METHODS FOR CONSERVATION LAWS TONG QIN AND CHI-WANG SHU Abstract. Positivity-preserving

More information

On limiting for higher order discontinuous Galerkin method for 2D Euler equations

On limiting for higher order discontinuous Galerkin method for 2D Euler equations On limiting for higher order discontinuous Galerkin method for 2D Euler equations Juan Pablo Gallego-Valencia, Christian Klingenberg, Praveen Chandrashekar October 6, 205 Abstract We present an implementation

More information

c 2001 Society for Industrial and Applied Mathematics

c 2001 Society for Industrial and Applied Mathematics SIAM J. SCI. COMPUT. Vol. 3, No. 3, pp. 707 740 c 001 Society for Industrial and Applied Mathematics SEMIDISCRETE CENTRAL-UPWIND SCHEMES FOR HYPERBOLIC CONSERVATION LAWS AND HAMILTON JACOBI EQUATIONS ALEXANDER

More information

Application of the Kurganov Levy semi-discrete numerical scheme to hyperbolic problems with nonlinear source terms

Application of the Kurganov Levy semi-discrete numerical scheme to hyperbolic problems with nonlinear source terms Future Generation Computer Systems () 65 7 Application of the Kurganov Levy semi-discrete numerical scheme to hyperbolic problems with nonlinear source terms R. Naidoo a,b, S. Baboolal b, a Department

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

Development and stability analysis of the inverse Lax-Wendroff boundary. treatment for central compact schemes 1

Development and stability analysis of the inverse Lax-Wendroff boundary. treatment for central compact schemes 1 Development and stability analysis of the inverse Lax-Wendroff boundary treatment for central compact schemes François Vilar 2 and Chi-Wang Shu 3 Division of Applied Mathematics, Brown University, Providence,

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

7 Hyperbolic Differential Equations

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

More information

Surprising Computations

Surprising Computations .... Surprising Computations Uri Ascher Department of Computer Science University of British Columbia ascher@cs.ubc.ca www.cs.ubc.ca/ ascher/ Uri Ascher (UBC) Surprising Computations Fall 2012 1 / 67 Motivation.

More information

H. L. Atkins* NASA Langley Research Center. Hampton, VA either limiters or added dissipation when applied to

H. L. Atkins* NASA Langley Research Center. Hampton, VA either limiters or added dissipation when applied to Local Analysis of Shock Capturing Using Discontinuous Galerkin Methodology H. L. Atkins* NASA Langley Research Center Hampton, A 68- Abstract The compact form of the discontinuous Galerkin method allows

More information

Antony Jameson. AIAA 18 th Computational Fluid Dynamics Conference

Antony Jameson. AIAA 18 th Computational Fluid Dynamics Conference Energy Estimates for Nonlinear Conservation Laws with Applications to Solutions of the Burgers Equation and One-Dimensional Viscous Flow in a Shock Tube by Central Difference Schemes Antony Jameson AIAA

More information

On High Order Strong Stability Preserving Runge Kutta and Multi Step Time Discretizations

On High Order Strong Stability Preserving Runge Kutta and Multi Step Time Discretizations Journal of Scientific Computing, Vol. 5, Nos. /, November 005 ( 005) DOI: 0.007/s095-00-65-5 On High Order Strong Stability Preserving Runge Kutta and Multi Step Time Discretizations Sigal Gottlieb Received

More information

A Speed-Up Strategy for Finite Volume WENO Schemes for Hyperbolic Conservation Laws

A Speed-Up Strategy for Finite Volume WENO Schemes for Hyperbolic Conservation Laws J Sci Comput (011) 46: 359 378 DOI 10.1007/s10915-010-9407-9 A Speed-Up Strategy for Finite Volume WENO Schemes for Hyperbolic Conservation Laws Fei Teng Li Yuan Tao Tang Received: 3 February 010 / Revised:

More information

ICES REPORT A Multilevel-WENO Technique for Solving Nonlinear Conservation Laws

ICES REPORT A Multilevel-WENO Technique for Solving Nonlinear Conservation Laws ICES REPORT 7- August 7 A Multilevel-WENO Technique for Solving Nonlinear Conservation Laws by Todd Arbogast, Chieh-Sen Huang, and Xikai Zhao The Institute for Computational Engineering and Sciences The

More information

An adaptive mesh redistribution method for nonlinear Hamilton-Jacobi equations in two- and three-dimensions

An adaptive mesh redistribution method for nonlinear Hamilton-Jacobi equations in two- and three-dimensions An adaptive mesh redistribution method for nonlinear Hamilton-Jacobi equations in two- and three-dimensions H.-Z. Tang, Tao Tang and Pingwen Zhang School of Mathematical Sciences, Peking University, Beijing

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 The Implicit Schemes for the Model Problem The Crank-Nicolson scheme and θ-scheme

More information

Discontinuous Galerkin method for hyperbolic equations with singularities

Discontinuous Galerkin method for hyperbolic equations with singularities Discontinuous Galerkin method for hyperbolic equations with singularities Chi-Wang Shu Division of Applied Mathematics Brown University Joint work with Qiang Zhang, Yang Yang and Dongming Wei Outline Introduction

More information

Superconvergence of discontinuous Galerkin methods for 1-D linear hyperbolic equations with degenerate variable coefficients

Superconvergence of discontinuous Galerkin methods for 1-D linear hyperbolic equations with degenerate variable coefficients Superconvergence of discontinuous Galerkin methods for -D linear hyperbolic equations with degenerate variable coefficients Waixiang Cao Chi-Wang Shu Zhimin Zhang Abstract In this paper, we study the superconvergence

More information

A second-order asymptotic-preserving and positive-preserving discontinuous. Galerkin scheme for the Kerr-Debye model. Abstract

A second-order asymptotic-preserving and positive-preserving discontinuous. Galerkin scheme for the Kerr-Debye model. Abstract A second-order asymptotic-preserving and positive-preserving discontinuous Galerkin scheme for the Kerr-Debye model Juntao Huang 1 and Chi-Wang Shu Abstract In this paper, we develop a second-order asymptotic-preserving

More information

Numerical Simulation for Porous Medium Equation by Local Discontinuous Galerkin Finite Element Method

Numerical Simulation for Porous Medium Equation by Local Discontinuous Galerkin Finite Element Method J Sci Comput (009) 38: 7 48 DOI 0.007/s095-008-93-7 Numerical Simulation for Porous Medium Equation by Local Discontinuous Galerkin Finite Element Method Qiang Zhang Zi-Long Wu Received: April 008 / Revised:

More information

Chapter 1. Introduction and Background. 1.1 Introduction

Chapter 1. Introduction and Background. 1.1 Introduction Chapter 1 Introduction and Background 1.1 Introduction Over the past several years the numerical approximation of partial differential equations (PDEs) has made important progress because of the rapid

More information

A High Order Conservative Semi-Lagrangian Discontinuous Galerkin Method for Two-Dimensional Transport Simulations

A High Order Conservative Semi-Lagrangian Discontinuous Galerkin Method for Two-Dimensional Transport Simulations Motivation Numerical methods Numerical tests Conclusions A High Order Conservative Semi-Lagrangian Discontinuous Galerkin Method for Two-Dimensional Transport Simulations Xiaofeng Cai Department of Mathematics

More information

A re-averaged WENO reconstruction and a third order CWENO scheme for hyperbolic conservation laws

A re-averaged WENO reconstruction and a third order CWENO scheme for hyperbolic conservation laws A re-averaged WENO reconstruction and a third order CWENO scheme for hyperbolic conservation laws Chieh-Sen Huang a,, Todd Arbogast b,, Chen-Hui Hung c,3 a Department of Applied Mathematics and National

More information

arxiv: v1 [math.na] 21 Nov 2017

arxiv: v1 [math.na] 21 Nov 2017 High Order Finite Difference Schemes for the Heat Equation Whose Convergence Rates are Higher Than Their Truncation Errors, A. Ditkowski arxiv:7.0796v [math.na] Nov 07 Abstract Typically when a semi-discrete

More information

Chapter 4. MAC Scheme. The MAC scheme is a numerical method used to solve the incompressible Navier-Stokes. u = 0

Chapter 4. MAC Scheme. The MAC scheme is a numerical method used to solve the incompressible Navier-Stokes. u = 0 Chapter 4. MAC Scheme 4.1. MAC Scheme and the Staggered Grid. The MAC scheme is a numerical method used to solve the incompressible Navier-Stokes equation in the velocity-pressure formulation: (4.1.1)

More information

Weighted ENO Schemes

Weighted ENO Schemes Xiaolei Chen Advisor: Prof. Xiaolin Li Department of Applied Mathematics and Statistics Stony Brook University, The State University of New York February 7, 014 1 3 Mapped WENO-Z Scheme 1D Scalar Hyperbolic

More information

arxiv: v1 [physics.flu-dyn] 13 Oct 2010

arxiv: v1 [physics.flu-dyn] 13 Oct 2010 Observable Divergence Theorem: Evolution Equations for Inviscid Regularization of hocks and Turbulence Kamran Mohseni arxiv:00.262v [physics.flu-dyn] 3 Oct 200 The divergence theorem of Gauss plays a central

More information

Applied Mathematics 205. Unit III: Numerical Calculus. Lecturer: Dr. David Knezevic

Applied Mathematics 205. Unit III: Numerical Calculus. Lecturer: Dr. David Knezevic Applied Mathematics 205 Unit III: Numerical Calculus Lecturer: Dr. David Knezevic Unit III: Numerical Calculus Chapter III.3: Boundary Value Problems and PDEs 2 / 96 ODE Boundary Value Problems 3 / 96

More information

Time stepping methods

Time stepping methods Time stepping methods ATHENS course: Introduction into Finite Elements Delft Institute of Applied Mathematics, TU Delft Matthias Möller (m.moller@tudelft.nl) 19 November 2014 M. Möller (DIAM@TUDelft) Time

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

Sung-Ik Sohn and Jun Yong Shin

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

More information

Lecture Notes on Numerical Schemes for Flow and Transport Problems

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

More information

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

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

More information

Hybrid semi-lagrangian finite element-finite difference methods for the Vlasov equation

Hybrid semi-lagrangian finite element-finite difference methods for the Vlasov equation Numerical Analysis and Scientific Computing Preprint Seria Hybrid semi-lagrangian finite element-finite difference methods for the Vlasov equation W. Guo J. Qiu Preprint #21 Department of Mathematics University

More information

Design of optimal Runge-Kutta methods

Design of optimal Runge-Kutta methods Design of optimal Runge-Kutta methods David I. Ketcheson King Abdullah University of Science & Technology (KAUST) D. Ketcheson (KAUST) 1 / 36 Acknowledgments Some parts of this are joint work with: Aron

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

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

On a class of numerical schemes. for compressible flows

On a class of numerical schemes. for compressible flows On a class of numerical schemes for compressible flows R. Herbin, with T. Gallouët, J.-C. Latché L. Gastaldo, D. Grapsas, W. Kheriji, T.T. N Guyen, N. Therme, C. Zaza. Aix-Marseille Université I.R.S.N.

More information

Shock Capturing for Discontinuous Galerkin Methods using Finite Volume Sub-cells

Shock Capturing for Discontinuous Galerkin Methods using Finite Volume Sub-cells Abstract We present a shock capturing procedure for high order Discontinuous Galerkin methods, by which shock regions are refined in sub-cells and treated by finite volume techniques Hence, our approach

More information