HIGH ORDER FINITE VOLUME SCHEMES

Size: px
Start display at page:

Download "HIGH ORDER FINITE VOLUME SCHEMES"

Transcription

1 HIGH ORDER FINITE VOLUME SCHEMES Jean-Pierre Croisille Laboratoire de mathématiques, UMR CNRS Univ. Paul Verlaine-Metz LMD, Jan. 26, 2011

2 Joint work with B. Courbet, F. Haider, ONERA, DSNA (Numerical Simulation of Fluid Flows: Aerodynamics & Aeroacoustics, Châtillon-sous-Bagneux, France

3 Scientific context High order numerical methods in Computational Fluid Dynamics Today, finite volume methods are commonly used in many areas of CFD: aerodynamics (external flows), aerothermochemistry(internal flows), porous media flows (petroleum industry, water resource), magnetohydrodynamics (cosmology). Main reasons: versatility of the method, good properties (treatment of convective/diffusive flows, nonlinear waves, conservativity,) strong support in the mathematical applied community. Strong support in physics AND mathematics. Strong interest for this kind of approach in the community in climatology. General context: development of the dynamical core of the GCM equations. Main model: the SW equations on the rotating spherical earth, 2D or 3D. Since several years: strong interest for this problem in the mathematical/cfd community.

4 Outline 1 A finite volume code - The package CEDRE (ONERA- DSNA): aerothermochemistry and energetics. 2 The MUSCL scheme for conservation laws 3 High order finite volumes methods 4 Perspectives: The MUSCL scheme on a spherical grid

5 The package CEDRE: Aerothermochemistry for complex fluid flows Problems to solve Full 3D Navier-Stokes equations + chemical reactions + turbulence modeling (RANS or LES) in complex geometries. 8 < : ρ t + (ρv) = 0 (ρv) t + (ρv v) + p τ) = 0 (ρe tot) t + (ρve tot + pv τ v + q th ) = 0 Fluid models Pressure law: p = p(ρ, ε). Viscous strain tensor τ(x, t) = λ L v(x, t)δ (2) + 2µ L v(x, t) (1) λ L, µ L are the Lamé coefficients, denotes the symmetric tensor product, δ (2) is the unit tensor. Large scale turbulence modeling: LES or RANS. Many other models: chemistry, diphasic flows, particles (eulerian or lagrangian), advected passive scalars.

6 The package CEDRE: Aerothermochemistry for complex fluid flows Problems to solve Full 3D Navier-Stokes equations + chemical reactions + turbulence modeling (RANS or LES) in complex geometries. 8 < : ρ t + (ρv) = 0 (ρv) t + (ρv v) + p τ) = 0 (ρe tot) t + (ρve tot + pv τ v + q th ) = 0 Fluid models Pressure law: p = p(ρ, ε). Viscous strain tensor τ(x, t) = λ L v(x, t)δ (2) + 2µ L v(x, t) (1) λ L, µ L are the Lamé coefficients, denotes the symmetric tensor product, δ (2) is the unit tensor. Large scale turbulence modeling: LES or RANS. Many other models: chemistry, diphasic flows, particles (eulerian or lagrangian), advected passive scalars.

7 Main features of CEDRE Spatial approximation General polyhedral grid Cell-centered FV method: one unknown by cell. Multidomain with parallelism Many pysical models available: single phase flows, multiphasic flows, real gas flows, chemistry, particles (eulerian or lagrangian).

8 Typical set of conservative variables Conservative variables 2 3 ρ 1 ρ nesp ρv 1 ρv 2 q = ρv 3 ρe t ρz ρz nsca physical variables 2 3 p T y 1 2 y nesp u = v 1 = v 2 v ρz ρz nsca thermo. state Velocity Scalar values: Passive scalars RANS scalars (2) 3 7 5

9 Spatial approximation: average on the cells Semi-discrete scheme Form of the semi-discrete dynamical system V i q i = X A i,j f n,i j X A ij ϕ n,i j + V i σ i (3) j V j V Upwinded Euler flux f n,i j = f n(u lim K i, u lim K j ) = 8 < : Roe Flux Low Mach (Turkel) AUSM (4) Navier-Stokes diffusive flux ϕ n,i j = ϕ n(u K, u K ) Sources σ i = σ i (u i, u i ).

10 Specificities in CEDRE (B. Courbet,DSNA-ONERA) Specificities 1 Notion of boundary cells supporting a differential equation. Plays the same role than an internal cell. Useful for multidomains. Useful for boundary conditions. The boundary conditions using relaxation differential equations supported in boundary cells. 2 A geometric domain is multisolver. Coupling of different systems of equations inside a single geometric domain.

11 Time algorithms Explicit time-schemes Runge-Kutta time schemes. Order 2,3,4. Implicit time-schemes Implicit linearized Euler scheme to compute asymptotic stationary states. Linear solvers: GMRES with digonal preconditionning. Implicit time-dependent schemes 2 or 3 implicit steps. Use of the approximate Jacobian operator based on the first order spatial scheme. Low Mach number flows: CFL hydro = 1 for the advective waves (shocks), CFL acc = for the acoustic waves.

12 Time algorithms Explicit time-schemes Runge-Kutta time schemes. Order 2,3,4. Implicit time-schemes Implicit linearized Euler scheme to compute asymptotic stationary states. Linear solvers: GMRES with digonal preconditionning. Implicit time-dependent schemes 2 or 3 implicit steps. Use of the approximate Jacobian operator based on the first order spatial scheme. Low Mach number flows: CFL hydro = 1 for the advective waves (shocks), CFL acc = for the acoustic waves.

13 Main steps of the algorithm Basic scheme The scheme reads U n+1 i = U n i t T i X A ij F(Ũi n, Ũn j ) (5) Given the values q i in the cells, interpolate the gradient q i in each cells. Compute the value of the piecewise linear function ij U n j (x) = Un j + Un j (x x j) (6) Evaluate the numerical flux-function F(Ũi n, Ũn j ). (Slope limiters are used). Assemble the contribution of each interface A ij to the cells T i and the cell T j. Update U n i by U n+1 i. Additional features The computing algorithm is much more complicated than expected at first glance! Loop on the faces, indirection problems, efficiency problems, interdomain problems. Accuracy of quadrature formulas on cell interfaces.

14 Main steps of the algorithm Basic scheme The scheme reads U n+1 i = U n i t T i X A ij F(Ũi n, Ũn j ) (5) Given the values q i in the cells, interpolate the gradient q i in each cells. Compute the value of the piecewise linear function ij U n j (x) = Un j + Un j (x x j) (6) Evaluate the numerical flux-function F(Ũi n, Ũn j ). (Slope limiters are used). Assemble the contribution of each interface A ij to the cells T i and the cell T j. Update U n i by U n+1 i. Additional features The computing algorithm is much more complicated than expected at first glance! Loop on the faces, indirection problems, efficiency problems, interdomain problems. Accuracy of quadrature formulas on cell interfaces.

15 Simulations in aerothermochemistry with CEDRE

16 Local geometry of a cell in CEDRE

17 The MUSCL method in space Conservation law tu (x, t) + f (u(x, t)) = 0 (7) Local geometry The cell with number α is denoted T α, with barycenter x α and d-volume T α. The face A αβ, with barycenter x αβ, has a normal vector n αβ oriented from cell T α to T β and of length nαβ equal to the surface Aαβ. The oriented normal unit vector of the face A αβ is ν αβ. Geometric notational convention The following convention simplifies the notation of sums over cells. Whenever two cells have no common interface, n αβ = 0 and k αβ = 0 and the face A αβ is defined to be empty so that any surface integral over A αβ is automatically zero. In addition, n αα, k αα and h αα are defined to be zero.

18 The MUSCL method in space Conservation law tu (x, t) + f (u(x, t)) = 0 (7) Local geometry The cell with number α is denoted T α, with barycenter x α and d-volume T α. The face A αβ, with barycenter x αβ, has a normal vector n αβ oriented from cell T α to T β and of length nαβ equal to the surface Aαβ. The oriented normal unit vector of the face A αβ is ν αβ. Geometric notational convention The following convention simplifies the notation of sums over cells. Whenever two cells have no common interface, n αβ = 0 and k αβ = 0 and the face A αβ is defined to be empty so that any surface integral over A αβ is automatically zero. In addition, n αα, k αα and h αα are defined to be zero.

19 The MUSCL method in space Conservation law tu (x, t) + f (u(x, t)) = 0 (7) Local geometry The cell with number α is denoted T α, with barycenter x α and d-volume T α. The face A αβ, with barycenter x αβ, has a normal vector n αβ oriented from cell T α to T β and of length nαβ equal to the surface Aαβ. The oriented normal unit vector of the face A αβ is ν αβ. Geometric notational convention The following convention simplifies the notation of sums over cells. Whenever two cells have no common interface, n αβ = 0 and k αβ = 0 and the face A αβ is defined to be empty so that any surface integral over A αβ is automatically zero. In addition, n αα, k αα and h αα are defined to be zero.

20 The MUSCL method in space, (cont.) MUSCL with Method Of Lines The simplest finite-volume scheme consists in evolving the quantities u α (t) approximating the exact averages ū α (t) with the dynamical system du α (t) = 1 X Z fαβ `uα (t), u β (t) dσ (8) dt T α β A αβ MUSCL dynamical system The numerical flux function f αβ (w int, w ext) depends on the two states w int and w ext on each side of the cell interface. Conservation is translates as f αβ (w int, w ext) = f βα (w ext, w int ) (9)

21 The MUSCL method in space, (cont.) MUSCL with Method Of Lines The simplest finite-volume scheme consists in evolving the quantities u α (t) approximating the exact averages ū α (t) with the dynamical system du α (t) = 1 X Z fαβ `uα (t), u β (t) dσ (8) dt T α β A αβ MUSCL dynamical system The numerical flux function f αβ (w int, w ext) depends on the two states w int and w ext on each side of the cell interface. Conservation is translates as f αβ (w int, w ext) = f βα (w ext, w int ) (9)

22 The MUSCL method in space, (cont.) Final form of the MUSCL scheme du α (t) = dt 1 X X ω q f αβ `wα [u(t)] `x αβ;q, wβ [u(t)] `x αβ;q. T α β q (10) Accuracy In equation (10), the x αβ;q are the quadrature points on A αβ and the ω q are the quadrature weights. If the expression under the integral on the right hand side of (8) is a polynomial of degree p in x and if the quadrature formula integrates exactly such polynomials, this step does not introduce any new discretization errors.

23 The MUSCL method in space, (cont.) Final form of the MUSCL scheme du α (t) = dt 1 X X ω q f αβ `wα [u(t)] `x αβ;q, wβ [u(t)] `x αβ;q. T α β q (10) Accuracy In equation (10), the x αβ;q are the quadrature points on A αβ and the ω q are the quadrature weights. If the expression under the integral on the right hand side of (8) is a polynomial of degree p in x and if the quadrature formula integrates exactly such polynomials, this step does not introduce any new discretization errors.

24 Cell-centered gradient reconstruction Interpolation theory: cell-centered gradient reconstruction on general grids A general theory of the gradient reconstruction is available (F. Haider). This theory is used in practice in CEDRE. Consistency of the slope Suppose given a function u(x) given by the (exact) averages u α on a given grid made of VF cells T α. Suppose given a linear slope reconstruction operator u σ α [u] = X β s αβ `uβ u α. (11) The first order consistency is equivalent to the tensor equation σ = X s αβ `hαβ σ for all σ R d. (12) β or equivalently X s αβ h αβ = I d d. (13) β

25 Cell-centered gradient reconstruction Interpolation theory: cell-centered gradient reconstruction on general grids A general theory of the gradient reconstruction is available (F. Haider). This theory is used in practice in CEDRE. Consistency of the slope Suppose given a function u(x) given by the (exact) averages u α on a given grid made of VF cells T α. Suppose given a linear slope reconstruction operator u σ α [u] = X β s αβ `uβ u α. (11) The first order consistency is equivalent to the tensor equation σ = X s αβ `hαβ σ for all σ R d. (12) β or equivalently X s αβ h αβ = I d d. (13) β

26 Least-square gradient reconstruction Proposition Let the matrix H α have rank d and let σ α R d be the solution of the least-squares problem 8 9 < X = min `uβ u α h σ R d : αβ σ 2 ;. (14) β W α Then σ α is unique and given by coefficients s αβ that are the columns of the minimum Frobenius norm solution to equation S αh α = I d d. (15)

27 Linear spectral analysis Asymptotic stability The stability property relevant for practical applications keeps to be the linear asymptotic stability. The semi-discrete MUSCL discrete form of the linear advection equation tu (x, t) + c u (x, t) = 0, (x, t) R d R +. (16) gives a dynamical system du α (t) dt = X β J αβ u β (t) ; 1 α N. (17)

28 Stability of the MUSCL scheme Matrix of the MUSCL scheme The operator J of the MUSCL scheme (17) is 8 < X J αβ = T α 1 (c n αγ) : + δ αβ + `c n αβ γ (18) + X γ X γ (n αγ c) + k αγ s αβ X (n αγ c) + k αγ s α δ αβ γ 9 (n γα c) + k γα s γβ + `n = βα c + k βα s β ;.

29 Stability of the MUSCL scheme, (cont.) Proposition (1) [ Stability of Linear Systems]The system (17) is stable in the sense that if and only if all eigenvalues λ of J satisfy 1 Re(λ) 0 where Re(λ) is the real part of λ. C = sup exp(tj) < (19) t 0 2 if Re(λ) = 0 then the Jordan index ı(λ) = 1 where ı(λ) is the maximal dimension of the Jordan blocks of J containing λ. Definition ( Stable finite-volume operator ) The spatial discretization operator J in (18) are called stable if all their eigenvalues satisfy properties (i)-(ii) of Proposition (1) for all advection velocities c R d.

30 Stability of the MUSCL scheme, (cont.) Proposition (1) [ Stability of Linear Systems]The system (17) is stable in the sense that if and only if all eigenvalues λ of J satisfy 1 Re(λ) 0 where Re(λ) is the real part of λ. C = sup exp(tj) < (19) t 0 2 if Re(λ) = 0 then the Jordan index ı(λ) = 1 where ı(λ) is the maximal dimension of the Jordan blocks of J containing λ. Definition ( Stable finite-volume operator ) The spatial discretization operator J in (18) are called stable if all their eigenvalues satisfy properties (i)-(ii) of Proposition (1) for all advection velocities c R d.

31 Localization of the eigenvalues of the MUSCL scheme Problem As usual in physics, we must solve the question of the localization of the eigenvalues of a linear problem. Here the matrix to analyze contains: The physics of the hyperbolic equation to solve The upwinding (numerical flux) The reconstruction operator The most difficult: the geometry of the grid. The shape of the grid influences the shape of the spectrum!

32 Localization of the eigenvalues of the MUSCL scheme (cont.) Classical tools Fourier analysis. Not possible on irregular grids. Direct algebraic eigenvalues analysis. Gerschgörin discs, field of values analysis: too weak. Energy methods, Lyapunov theorems.

33 Extended Lyapunov Theorem Theorem ( Extended Lyapunov Theorem) Let J M N (C). The following properties are equivalent 1 J satisfies the conditions of Proposition 0.2, that is all eigenvalues λ of J have Re(λ) 0 and if Re(λ) = 0 then the Jordan index ı(λ) = 1. 2 There exists a positive definite matrix G such that the matrix Q = GJ + J G is negative semidefinite.

34 Stability of the MUSCL scheme, (cont.) Corollaire Consider the initial value problem du(t) dt Then there is a constant C such that = Ju(t), u(0) = u 0, u(t) C N, J M N (C). (20) u(t) C u 0 for all t 0 if and only if there exists a positive definite matrix G such that the matrix Q = GJ + J G is negative semidefinite. Practical spectral analysis It turns out to be very difficult to find a matrix G that could give a rigorous proof of eigenvalue stability for the MUSCL operator J.

35 Stability of the MUSCL scheme, (cont.) Corollaire Consider the initial value problem du(t) dt Then there is a constant C such that = Ju(t), u(0) = u 0, u(t) C N, J M N (C). (20) u(t) C u 0 for all t 0 if and only if there exists a positive definite matrix G such that the matrix Q = GJ + J G is negative semidefinite. Practical spectral analysis It turns out to be very difficult to find a matrix G that could give a rigorous proof of eigenvalue stability for the MUSCL operator J.

36 Stability of the MUSCL scheme, (cont.) Table: Least-Squares Reconstruction on the First Neighborhood in 3D: spectral abscissa ω J and statistics of R α L(2, ) grid spectral abscissa average maximum 90th percentile tetrahedral tetrahedral e tetrahedral tetrahedral hybrid hybrid hybrid hybrid deformed cartesian e deformed cartesian e deformed cartesian e deformed cartesian e

37 Numerical experiment Figure: Tetrahedral grid. Unstable spectrum. Convection equation.

38 Numerical experiment Figure: Tetrahedral grid of a channel. The flow is along direction x.

39 Numerical experiment (cont.) log10(residuals) ρ ρ v x 4 6 ρ v y ρ v z ρ E time d Figure: Residuals history of [ρ, ρux, ρuy, ρuz, ρe], 800 time iterations, first dt neighborhood interpolation of the gradient, no slope limiters.

40 Numerical experiment (cont.) log10(residuals) ρ ρ v x ρ v y ρ v z ρ E time d Figure: Residuals history of [ρ, ρux, ρuy, ρuz, ρe], 4000 time iterations, dt second neighborhood interpolation of the gradient, no slope limiters.

41 High order finite volume MUSCL schemes Observation The MUSCL scheme with piecewise linear reconstruction is second order. This is sufficient for accurate computation of non linear waves such as shocks. This is dramatically insufficient for the computation of the fundamental characteritics of diffusive turbulent flows. The conclusion is that we need to have higher order spatial approximations. Question Is it possible to switch from a piecewise linear reconstruction to a higher order reconstruction within the MUSCL framework? Or should we give up the MUSCL approach (one unknown per cell) and switch to alternative high order schemes like the spectral element (Patera, Deville), the spectral difference (Wang,Liu,Vinokur) or the Discontinuous Galerkin schemes (Cockburn, Shu),... which all use more than one unknown per cell. The question to build higher order MUSCL schemes on irregular grids was already studied in the 90 (Harten, Osher, Abgrall,...). This keeps to be a question of fundamental practical importance!

42 High order finite volume MUSCL schemes Observation The MUSCL scheme with piecewise linear reconstruction is second order. This is sufficient for accurate computation of non linear waves such as shocks. This is dramatically insufficient for the computation of the fundamental characteritics of diffusive turbulent flows. The conclusion is that we need to have higher order spatial approximations. Question Is it possible to switch from a piecewise linear reconstruction to a higher order reconstruction within the MUSCL framework? Or should we give up the MUSCL approach (one unknown per cell) and switch to alternative high order schemes like the spectral element (Patera, Deville), the spectral difference (Wang,Liu,Vinokur) or the Discontinuous Galerkin schemes (Cockburn, Shu),... which all use more than one unknown per cell. The question to build higher order MUSCL schemes on irregular grids was already studied in the 90 (Harten, Osher, Abgrall,...). This keeps to be a question of fundamental practical importance!

43 High order MUSCL method Interpolation on irregular grids Basic methodology: interpolate the first, second and third order derivatives in a cell. The mathematical problem belongs therefore to the interpolation theory on unstructured grids. General theory of conservative interpolation on unstructured finite volume grids can be found in the thesis of F. Haider (2009, Univ. Paris 6). Fourth order MUSCL schemes The reconstructed function ũ i (x) is We have ũ i (x) = ū i + σ i (x x i ) θ i(x x i ) ψ i(x x i ) 3 (21) The scheme is as before: σ i u (x i ), θ i u (x i ), ψ i u (x i ) (22) U n+1 i = U n i t T i X A ij F(Ũi n, Ũn j ) (23) ij

44 High order MUSCL method Interpolation on irregular grids Basic methodology: interpolate the first, second and third order derivatives in a cell. The mathematical problem belongs therefore to the interpolation theory on unstructured grids. General theory of conservative interpolation on unstructured finite volume grids can be found in the thesis of F. Haider (2009, Univ. Paris 6). Fourth order MUSCL schemes The reconstructed function ũ i (x) is We have ũ i (x) = ū i + σ i (x x i ) θ i(x x i ) ψ i(x x i ) 3 (21) The scheme is as before: σ i u (x i ), θ i u (x i ), ψ i u (x i ) (22) U n+1 i = U n i t T i X A ij F(Ũi n, Ũn j ) (23) ij

45 Computation of the reconstruction Least square approximation The least-square slope is 8 >< >: σ α LS = P β V α c αβ (ū β ū α), (a) θα LS = P β V α c αβ (σ β σ α), (b) ψα LS = P β V α c αβ (θ β θ α), (c) (24) where the coefficients a α, b α and ā α depend only of the local shape of the grid. Approximate derivatives Suppose that σ α = u (x α), θ α = u (x α), ψ α = u (x α), Then approximations of σ α, θ α, ψ α of order 3, 2, 1 are given by the explicit formulas are given by 8 >< ψ α = P! β c αβ Pγ V β c βγ`σls γ σβ LS P δ V α c αδ (σδ LS σα LS ), (a) >: θ α = ã α ψα + P β c αβ(σβ LS σ α = ā α θα b α ψα + σ LS σ LS α ), (b) α, (c) (25)

46 Computation of the reconstruction Least square approximation The least-square slope is 8 >< >: σ α LS = P β V α c αβ (ū β ū α), (a) θα LS = P β V α c αβ (σ β σ α), (b) ψα LS = P β V α c αβ (θ β θ α), (c) (24) where the coefficients a α, b α and ā α depend only of the local shape of the grid. Approximate derivatives Suppose that σ α = u (x α), θ α = u (x α), ψ α = u (x α), Then approximations of σ α, θ α, ψ α of order 3, 2, 1 are given by the explicit formulas are given by 8 >< ψ α = P! β c αβ Pγ V β c βγ`σls γ σβ LS P δ V α c αδ (σδ LS σα LS ), (a) >: θ α = ã α ψα + P β c αβ(σβ LS σ α = ā α θα b α ψα + σ LS σ LS α ), (b) α, (c) (25)

47 Computational algorithm ALGORITHM 1 1 Compute σ LS α 2 Compute P β V α c αβ (σ LS β in all T α.this involves the stencil V α only. σα LS ) in all cells Tα. 3 Compute the third order derivative ψ α by (25)(a). 4 Compute the second order derivative θ α by (25)(b). 5 Compute the first order derivative σ α by (25)(c). Order of the interpolating polynomial The polynomial! p α(x) = ū α + σ α(x x α) + θ 1 α 2 (x xα) Tα ψ α(x x α) 3 (26) 6 is a fourth order reconstruction of u(x) in the cell T α.

48 Computational algorithm ALGORITHM 1 1 Compute σ LS α 2 Compute P β V α c αβ (σ LS β in all T α.this involves the stencil V α only. σα LS ) in all cells Tα. 3 Compute the third order derivative ψ α by (25)(a). 4 Compute the second order derivative θ α by (25)(b). 5 Compute the first order derivative σ α by (25)(c). Order of the interpolating polynomial The polynomial! p α(x) = ū α + σ α(x x α) + θ 1 α 2 (x xα) Tα ψ α(x x α) 3 (26) 6 is a fourth order reconstruction of u(x) in the cell T α.

49 Full discrete fourth order MUSCL scheme 4th order scheme Use the ordinary RK4 scheme. 8 k 0 = JU n k 1 = J(U n >< t k 0) k 2 = J(U n t k 1) k 3 = J(U n + t k 2 )! >: U n+1 = U n 1 + t 6 k k k k 3 (27) Observation: this scheme is stable on highly irregular random one-dimensional grid with random size. On a smooth varying grid the measured convergence rates are shown on the following table

50 Assessing the fourth order accuracy of the MUSCL scheme Rate of convergence of the 4th order MUSCL scheme - Sinusoidal grid. Period N=32 rate N=64 rate N=128 rate N=256 rate N= (-4) (-5) (-6) (-8) (-9) (-3) (-5) (-6) (-7) (-8) (-3) (-4) (-5) (-7) (-8)

51 The cubed sphere grid The cubed sphere grid Spherical grid made of 6 squares patches. The 6 patches are the projection of a cube on an (internal) sphere. Nonequiangular grid. Very interesting to discretize the SW system. First attempt recently done (Ulrich, Jablonowski, van Leer, JCP, 2010). Good results with some 4th order MUSCL scheme. Classical test-case (Williamson) are tested.

52 The cubed sphere grid (cont.) 1 N 0.5 E F B W 1 1 S N F E W 0 B S Figure: Cubed sphere grids, C8 and C32

53 Implementation so far CEDRE Second order MUSCL scheme in CEDRE (aerothermochemistry for internal flows). Various options of turbulence modling Various options of time-stepping Irregular general grids Multisolver/multidomain solver Fourth order accuracy Methodology of higher order accurate MUSCL scheme assessed on tetrahedral grids (F. Haider). Keeps the standard MUSCL framework,one unknown per cell. Extension to flows on the spherical earth Methodology seems possible on any kind of spherical grids: latitude/longitude, web grid, icosahedral grid, etc. A specifically interesting grid seems to be the cubed sphere grid.

54 Implementation so far CEDRE Second order MUSCL scheme in CEDRE (aerothermochemistry for internal flows). Various options of turbulence modling Various options of time-stepping Irregular general grids Multisolver/multidomain solver Fourth order accuracy Methodology of higher order accurate MUSCL scheme assessed on tetrahedral grids (F. Haider). Keeps the standard MUSCL framework,one unknown per cell. Extension to flows on the spherical earth Methodology seems possible on any kind of spherical grids: latitude/longitude, web grid, icosahedral grid, etc. A specifically interesting grid seems to be the cubed sphere grid.

55 Implementation so far CEDRE Second order MUSCL scheme in CEDRE (aerothermochemistry for internal flows). Various options of turbulence modling Various options of time-stepping Irregular general grids Multisolver/multidomain solver Fourth order accuracy Methodology of higher order accurate MUSCL scheme assessed on tetrahedral grids (F. Haider). Keeps the standard MUSCL framework,one unknown per cell. Extension to flows on the spherical earth Methodology seems possible on any kind of spherical grids: latitude/longitude, web grid, icosahedral grid, etc. A specifically interesting grid seems to be the cubed sphere grid.

56 In progress At ONERA Implementation of the fourth order MUSCL scheme for 3D gas dynamics problems (ONERA, F. Haider, B. Courbet). Cubed sphere grid High order Hermitian interpolation on the cubed sphere grid; Fast solver (FFT)

57 In progress At ONERA Implementation of the fourth order MUSCL scheme for 3D gas dynamics problems (ONERA, F. Haider, B. Courbet). Cubed sphere grid High order Hermitian interpolation on the cubed sphere grid; Fast solver (FFT)

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

A Bound-Preserving Fourth Order Compact Finite Difference Scheme for Scalar Convection Diffusion Equations 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

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

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

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

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

Space-time Discontinuous Galerkin Methods for Compressible Flows

Space-time Discontinuous Galerkin Methods for Compressible Flows Space-time Discontinuous Galerkin Methods for Compressible Flows Jaap van der Vegt Numerical Analysis and Computational Mechanics Group Department of Applied Mathematics University of Twente Joint Work

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

A high-order discontinuous Galerkin solver for 3D aerodynamic turbulent flows

A high-order discontinuous Galerkin solver for 3D aerodynamic turbulent flows A high-order discontinuous Galerkin solver for 3D aerodynamic turbulent flows F. Bassi, A. Crivellini, D. A. Di Pietro, S. Rebay Dipartimento di Ingegneria Industriale, Università di Bergamo CERMICS-ENPC

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

Active Flux for Advection Diffusion

Active Flux for Advection Diffusion Active Flux for Advection Diffusion A Miracle in CFD Hiroaki Nishikawa National Institute of Aerospace! NIA CFD Seminar! August 25, 2015 In collaboration with the University of Michigan Supported by NASA

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

A STUDY OF MULTIGRID SMOOTHERS USED IN COMPRESSIBLE CFD BASED ON THE CONVECTION DIFFUSION EQUATION

A STUDY OF MULTIGRID SMOOTHERS USED IN COMPRESSIBLE CFD BASED ON THE CONVECTION DIFFUSION EQUATION ECCOMAS Congress 2016 VII European Congress on Computational Methods in Applied Sciences and Engineering M. Papadrakakis, V. Papadopoulos, G. Stefanou, V. Plevris (eds.) Crete Island, Greece, 5 10 June

More information

An Introduction to the Discontinuous Galerkin Method

An Introduction to the Discontinuous Galerkin Method An Introduction to the Discontinuous Galerkin Method Krzysztof J. Fidkowski Aerospace Computational Design Lab Massachusetts Institute of Technology March 16, 2005 Computational Prototyping Group Seminar

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

Divergence Formulation of Source Term

Divergence Formulation of Source Term Preprint accepted for publication in Journal of Computational Physics, 2012 http://dx.doi.org/10.1016/j.jcp.2012.05.032 Divergence Formulation of Source Term Hiroaki Nishikawa National Institute of Aerospace,

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

A Multi-Dimensional Limiter for Hybrid Grid

A Multi-Dimensional Limiter for Hybrid Grid APCOM & ISCM 11-14 th December, 2013, Singapore A Multi-Dimensional Limiter for Hybrid Grid * H. W. Zheng ¹ 1 State Key Laboratory of High Temperature Gas Dynamics, Institute of Mechanics, Chinese Academy

More information

A Stable Spectral Difference Method for Triangles

A Stable Spectral Difference Method for Triangles A Stable Spectral Difference Method for Triangles Aravind Balan 1, Georg May 1, and Joachim Schöberl 2 1 AICES Graduate School, RWTH Aachen, Germany 2 Institute for Analysis and Scientific Computing, Vienna

More information

AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS

AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS 1 / 59 AA214B: NUMERICAL METHODS FOR COMPRESSIBLE FLOWS The Finite Volume Method These slides are partially based on the recommended textbook: Culbert B.

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

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

On two fractional step finite volume and finite element schemes for reactive low Mach number flows

On two fractional step finite volume and finite element schemes for reactive low Mach number flows Fourth International Symposium on Finite Volumes for Complex Applications - Problems and Perspectives - July 4-8, 2005 / Marrakech, Morocco On two fractional step finite volume and finite element schemes

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

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

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

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

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

NUMERICAL SOLUTION OF HYPERBOLIC PARTIAL DIFFERENTIAL EQUATIONS

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

More information

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

Extension to moving grids

Extension to moving grids Extension to moving grids P. Lafon 1, F. Crouzet 2 & F. Daude 1 1 LaMSID - UMR EDF/CNRS 2832 2 EDF R&D, AMA April 3, 2008 1 Governing equations Physical coordinates Generalized coordinates Geometrical

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

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

A Finite Volume Code for 1D Gas Dynamics

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

More information

Implicit Solution of Viscous Aerodynamic Flows using the Discontinuous Galerkin Method

Implicit Solution of Viscous Aerodynamic Flows using the Discontinuous Galerkin Method Implicit Solution of Viscous Aerodynamic Flows using the Discontinuous Galerkin Method Per-Olof Persson and Jaime Peraire Massachusetts Institute of Technology 7th World Congress on Computational Mechanics

More information

Optimizing Runge-Kutta smoothers for unsteady flow problems

Optimizing Runge-Kutta smoothers for unsteady flow problems Optimizing Runge-Kutta smoothers for unsteady flow problems Philipp Birken 1 November 24, 2011 1 Institute of Mathematics, University of Kassel, Heinrich-Plett-Str. 40, D-34132 Kassel, Germany. email:

More information

Getting started: CFD notation

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

More information

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

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

Introduction to Finite Volume projection methods. On Interfaces with non-zero mass flux

Introduction to Finite Volume projection methods. On Interfaces with non-zero mass flux Introduction to Finite Volume projection methods On Interfaces with non-zero mass flux Rupert Klein Mathematik & Informatik, Freie Universität Berlin Summerschool SPP 1506 Darmstadt, July 09, 2010 Introduction

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

Zonal modelling approach in aerodynamic simulation

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

More information

ALGEBRAIC FLUX CORRECTION FOR FINITE ELEMENT DISCRETIZATIONS OF COUPLED SYSTEMS

ALGEBRAIC FLUX CORRECTION FOR FINITE ELEMENT DISCRETIZATIONS OF COUPLED SYSTEMS Int. Conf. on Computational Methods for Coupled Problems in Science and Engineering COUPLED PROBLEMS 2007 M. Papadrakakis, E. Oñate and B. Schrefler (Eds) c CIMNE, Barcelona, 2007 ALGEBRAIC FLUX CORRECTION

More information

An Added-Mass Partition Algorithm for Fluid-Structure Interactions of Compressible Fluids and Nonlinear Solids

An Added-Mass Partition Algorithm for Fluid-Structure Interactions of Compressible Fluids and Nonlinear Solids An Added-Mass Partition Algorithm for Fluid-Structure Interactions of Compressible Fluids and Nonlinear Solids J. W. Banks a,,2, W. D. Henshaw a,,3,, A. K. Kapila a,4, D. W. Schwendeman a,,3,4 a Department

More information

Numerical Oscillations and how to avoid them

Numerical Oscillations and how to avoid them Numerical Oscillations and how to avoid them Willem Hundsdorfer Talk for CWI Scientific Meeting, based on work with Anna Mozartova (CWI, RBS) & Marc Spijker (Leiden Univ.) For details: see thesis of A.

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

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

Assessment of Implicit Implementation of the AUSM + Method and the SST Model for Viscous High Speed Flow

Assessment of Implicit Implementation of the AUSM + Method and the SST Model for Viscous High Speed Flow Assessment of Implicit Implementation of the AUSM + Method and the SST Model for Viscous High Speed Flow Simone Colonia, René Steijl and George N. Barakos CFD Laboratory - School of Engineering - University

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

Extremum-Preserving Limiters for MUSCL and PPM

Extremum-Preserving Limiters for MUSCL and PPM arxiv:0903.400v [physics.comp-ph] 7 Mar 009 Extremum-Preserving Limiters for MUSCL and PPM Michael Sekora Program in Applied and Computational Mathematics, Princeton University Princeton, NJ 08540, USA

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

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

CFD in Industrial Applications and a Mesh Improvement Shock-Filter for Multiple Discontinuities Capturing. Lakhdar Remaki

CFD in Industrial Applications and a Mesh Improvement Shock-Filter for Multiple Discontinuities Capturing. Lakhdar Remaki CFD in Industrial Applications and a Mesh Improvement Shock-Filter for Multiple Discontinuities Capturing Lakhdar Remaki Outline What we doing in CFD? CFD in Industry Shock-filter model for mesh adaptation

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

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

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

More information

A 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

Finite volume method on unstructured grids

Finite volume method on unstructured grids Finite volume method on unstructured grids Praveen. C praveen@math.tifrbng.res.in Tata Institute of Fundamental Research Center for Applicable Mathematics Bangalore 560065 http://math.tifrbng.res.in/~praveen

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

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 Finite-Element based Navier-Stokes Solver for LES

A Finite-Element based Navier-Stokes Solver for LES A Finite-Element based Navier-Stokes Solver for LES W. Wienken a, J. Stiller b and U. Fladrich c. a Technische Universität Dresden, Institute of Fluid Mechanics (ISM) b Technische Universität Dresden,

More information

Compact finite difference schemes: an overview

Compact finite difference schemes: an overview Compact finite difference schemes: an overview Jean-Pierre Croisille Département de mathématiques IECL - Univ. de Lorraine - Metz, France Colloque in honor of Gilles Lebeau, Nice, June 214 Jean-Pierre

More information

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

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

More information

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

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

HYPERSONIC AERO-THERMO-DYNAMIC HEATING PREDICTION WITH HIGH-ORDER DISCONTINOUS GALERKIN SPECTRAL ELEMENT METHODS

HYPERSONIC AERO-THERMO-DYNAMIC HEATING PREDICTION WITH HIGH-ORDER DISCONTINOUS GALERKIN SPECTRAL ELEMENT METHODS 1 / 36 HYPERSONIC AERO-THERMO-DYNAMIC HEATING PREDICTION WITH HIGH-ORDER DISCONTINOUS GALERKIN SPECTRAL ELEMENT METHODS Jesús Garicano Mena, E. Valero Sánchez, G. Rubio Calzado, E. Ferrer Vaccarezza Universidad

More information

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

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

More information

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

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

More information

Numerical Solution Techniques in Mechanical and Aerospace Engineering

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

More information

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

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

More information

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

Filtered scheme and error estimate for first order Hamilton-Jacobi equations

Filtered scheme and error estimate for first order Hamilton-Jacobi equations and error estimate for first order Hamilton-Jacobi equations Olivier Bokanowski 1 Maurizio Falcone 2 2 1 Laboratoire Jacques-Louis Lions, Université Paris-Diderot (Paris 7) 2 SAPIENZA - Università di Roma

More information

A High-Order Discontinuous Galerkin Method for the Unsteady Incompressible Navier-Stokes Equations

A High-Order Discontinuous Galerkin Method for the Unsteady Incompressible Navier-Stokes Equations A High-Order Discontinuous Galerkin Method for the Unsteady Incompressible Navier-Stokes Equations Khosro Shahbazi 1, Paul F. Fischer 2 and C. Ross Ethier 1 1 University of Toronto and 2 Argonne National

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

Application of Dual Time Stepping to Fully Implicit Runge Kutta Schemes for Unsteady Flow Calculations

Application of Dual Time Stepping to Fully Implicit Runge Kutta Schemes for Unsteady Flow Calculations Application of Dual Time Stepping to Fully Implicit Runge Kutta Schemes for Unsteady Flow Calculations Antony Jameson Department of Aeronautics and Astronautics, Stanford University, Stanford, CA, 94305

More information

Interior penalty tensor-product preconditioners for high-order discontinuous Galerkin discretizations

Interior penalty tensor-product preconditioners for high-order discontinuous Galerkin discretizations Interior penalty tensor-product preconditioners for high-order discontinuous Galerkin discretizations Will Pazner Brown University, 8 George St., Providence, RI, 9, U.S.A. Per-Olof Persson University of

More information

Additive Manufacturing Module 8

Additive Manufacturing Module 8 Additive Manufacturing Module 8 Spring 2015 Wenchao Zhou zhouw@uark.edu (479) 575-7250 The Department of Mechanical Engineering University of Arkansas, Fayetteville 1 Evaluating design https://www.youtube.com/watch?v=p

More information

NUMERICAL METHODS FOR ENGINEERING APPLICATION

NUMERICAL METHODS FOR ENGINEERING APPLICATION NUMERICAL METHODS FOR ENGINEERING APPLICATION Second Edition JOEL H. FERZIGER A Wiley-Interscience Publication JOHN WILEY & SONS, INC. New York / Chichester / Weinheim / Brisbane / Singapore / Toronto

More information

QUELQUES APPLICATIONS D UN SCHEMA SCHEMA MIXTE-ELEMENT-VOLUME A LA LES, A L ACOUSTIQUE, AUX INTERFACES

QUELQUES APPLICATIONS D UN SCHEMA SCHEMA MIXTE-ELEMENT-VOLUME A LA LES, A L ACOUSTIQUE, AUX INTERFACES 1 QUELQUES APPLICATIONS D UN SCHEMA SCHEMA MIXTE-ELEMENT-VOLUME A LA LES, A L ACOUSTIQUE, AUX INTERFACES O. ALLAIN(*), A. DERVIEUX(**), I. ABALAKIN(***), S. CAMARRI(****), H. GUILLARD(**), B. KOOBUS(*****),

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

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

CapSel Roe Roe solver.

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

More information

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

CFD in COMSOL Multiphysics

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

More information

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

ON THE BENEFIT OF THE SUMMATION-BY-PARTS PROPERTY ON INTERIOR NODAL SETS

ON THE BENEFIT OF THE SUMMATION-BY-PARTS PROPERTY ON INTERIOR NODAL SETS 6th European Conference on Computational Mechanics (ECCM 6 7th European Conference on Computational Fluid Dynamics (ECFD 7 11 15 June 018, Glasgow, UK ON THE BENEFIT OF THE SUMMATION-BY-PARTS PROPERTY

More information

Deforming Composite Grids for Fluid Structure Interactions

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

More information

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

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

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

More information

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

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

Multigrid solvers for equations arising in implicit MHD simulations

Multigrid solvers for equations arising in implicit MHD simulations Multigrid solvers for equations arising in implicit MHD simulations smoothing Finest Grid Mark F. Adams Department of Applied Physics & Applied Mathematics Columbia University Ravi Samtaney PPPL Achi Brandt

More information

Transport equation cavitation models in an unstructured flow solver. Kilian Claramunt, Charles Hirsch

Transport equation cavitation models in an unstructured flow solver. Kilian Claramunt, Charles Hirsch Transport equation cavitation models in an unstructured flow solver Kilian Claramunt, Charles Hirsch SHF Conference on hydraulic machines and cavitation / air in water pipes June 5-6, 2013, Grenoble, France

More information

Hyperbolic Systems of Conservation Laws. in One Space Dimension. II - Solutions to the Cauchy problem. Alberto Bressan

Hyperbolic Systems of Conservation Laws. in One Space Dimension. II - Solutions to the Cauchy problem. Alberto Bressan Hyperbolic Systems of Conservation Laws in One Space Dimension II - Solutions to the Cauchy problem Alberto Bressan Department of Mathematics, Penn State University http://www.math.psu.edu/bressan/ 1 Global

More information

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

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

More information

AProofoftheStabilityoftheSpectral Difference Method For All Orders of Accuracy

AProofoftheStabilityoftheSpectral Difference Method For All Orders of Accuracy AProofoftheStabilityoftheSpectral Difference Method For All Orders of Accuracy Antony Jameson 1 1 Thomas V. Jones Professor of Engineering Department of Aeronautics and Astronautics Stanford University

More information

Numerical methods for the Navier- Stokes equations

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

More information

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

Final abstract for ONERA Taylor-Green DG participation

Final abstract for ONERA Taylor-Green DG participation 1st International Workshop On High-Order CFD Methods January 7-8, 2012 at the 50th AIAA Aerospace Sciences Meeting, Nashville, Tennessee Final abstract for ONERA Taylor-Green DG participation JB Chapelier,

More information

Finite Element methods for hyperbolic systems

Finite Element methods for hyperbolic systems Finite Element methods for hyperbolic systems Eric Sonnendrücker Max-Planck-Institut für Plasmaphysik und Zentrum Mathematik, TU München Lecture notes Wintersemester 14-15 January 19, 15 Contents 1 Introduction

More information