A third order conservative Lagrangian type scheme on curvilinear meshes for the compressible Euler equations

Size: px
Start display at page:

Download "A third order conservative Lagrangian type scheme on curvilinear meshes for the compressible Euler equations"

Transcription

1 A third order conservative Lagrangian type scheme on curvilinear meshes for the compressible Euler equations Juan Cheng and Chi-Wang Shu 2 Abstract Based on the high order essentially non-oscillatory (ENO) Lagrangian type scheme on quadrilateral meshes presented in our earlier work [], in this paper we develop a third order conservative Lagrangian type scheme on curvilinear meshes for solving the Euler equations of compressible gas dynamics. The main purpose of this work is to demonstrate our claim in [] that the accuracy degeneracy phenomenon observed for the high order Lagrangian type scheme is due to the error from the quadrilateral mesh with straight-line edges, which restricts the accuracy of the resulting scheme to at most second order. The accuracy test given in this paper shows that the third order Lagrangian type scheme can actually obtain uniformly third order accuracy even on distorted meshes by using curvilinear meshes. Numerical examples are also presented to verify the performance of the third order scheme on curvilinear meshes in terms of resolution for discontinuities and non-oscillatory properties. Keywords: Lagrangian type scheme; high order accuracy; conservative scheme; curvilinear mesh; WENO reconstruction; compressible Euler equations Institute of Applied Physics and Computational Mathematics, Beijing 000, China. cheng juan@iapcm.ac.cn. Research is supported in part by NSFC grant Additional support is provided by the National Basic Research Program of China under grant 200CB202, by the Foundation of National Key Laboratory of Computational Physics under grant 0C02000 and by the National Hi-Tech Inertial Confinement Fusion Committee of China. 2 Division of Applied Mathematics, Brown University, Providence, RI shu@dam.brown.edu. Research is supported in part by NSF grant DMS-00.

2 Introduction In numerical simulations of multidimensional fluid flow, there are two typical choices: a Lagrangian framework, in which the mesh moves with the local fluid velocity, and an Eulerian framework, in which the fluid flows through a grid fixed in space. More generally, the motion of the grid can also be chosen arbitrarily, this method is called the Arbitrary Lagrangian- Eulerian method (ALE; see, e.g. [,, ]). Lagrangian methods are widely used in many fields for multi-material flow simulations such as astrophysics and computational fluid dynamics (CFD), due to their distinguished advantage of being able to capture the material interface sharply. In the past years, many efforts have been made to develop Lagrangian methods. Some algorithms are developed from the nonconservative form of the Euler equations, see, e.g. [2,, ], while others start from the conservative form of the Euler equations, e.g. those in [,,, 0]. In our previous paper [], we developed a class of Lagrangian type schemes on quadrilateral meshes for solving the Euler equations which are based on the high order essentially non-oscillatory (ENO) reconstruction. Advantages for the schemes in [] include their conservativity for the density, momentum and total energy, their essentially non-oscillatory performance, parameter-free implementation, and their formal high order accuracy both in space and time. However, we also found that our third order Lagrangian type scheme could only achieve second order accuracy on two dimensional distorted Lagrangian meshes. We attributed this phenomenon to a fundamental problem in the formulation of the Lagrangian schemes. Since in a Lagrangian simulation, each cell represents a material particle, its shape may change with the movement of fluid. Therefore, a cell with an initially quadrilateral shape may not keep its shape as a quadrilateral at a later time. It usually becomes a curved quadrilateral. Thus if during our Lagrangian simulation the mesh is always kept as quadrilateral with straight-line edges, this approximation of the mesh will bring second order error into the scheme. Finally we made a conclusion that for a Lagrangian type scheme in multi-dimensions, it can be at most second order accurate if curved meshes are not used. 2

3 Meanwhile, we also predicted that our scheme can be extended to higher than second order accuracy if curvilinear meshes are used. In this paper, we explore curvilinear meshes to demonstrate our claim stated above. We will develop a third order scheme on curved quadrilateral meshes in two space dimensions. The reconstruction is based on the high order WENO procedure [, ] but with simpler linear weights. The accuracy test and some non-oscillatory tests are presented to verify our claim. The scheme can also be extended to higher than third order accuracy if an higher order approximation is used on both the meshes and the discretization of the governing equations. An outline of the rest of this paper is as follows. In Section 2, we describe the individual steps of the third order Lagrangian type scheme on curvilinear meshes in two space dimensions. In Section, numerical examples are given to verify the performance of the new Lagrangian type method. In Section we will give concluding remarks. 2 The third order conservative Lagrangian type scheme on curvilinear meshes 2. The compressible Euler equations in Lagrangian formulation The Euler equations for unsteady compressible flow in the reference frame of a moving control volume can be expressed in integral form in the Cartesian coordinates as d UdΩ+ FdΓ = 0 (2.) dt Ω(t) where Ω(t) is the moving control volume enclosed by its boundary Γ(t). The vector of the conserved variables U and the flux vector F are given by ρ (u ẋ) nρ U = M, F = (u ẋ) nm + p n E (u ẋ) ne + pu n Γ(t) (2.2) where ρ is the density, u is the velocity, M = ρu is the momentum, E is the total energy and p is the pressure, ẋ is the velocity of the control volume boundary Γ(t), n denotes the unit outward normal to Γ(t). The system (2.) represents the conservation of mass, momentum and energy.

4 The set of equations is completed by the addition of an equation of state (EOS) with the following general form p = p(ρ, e) (2.) where e = E ρ 2 u 2 is the specific internal energy. Especially, if we consider the ideal gas, then the equation of state has a simpler form, p =(γ )ρe where γ is a constant representing the ratio of specific heat capacities of the fluid. This paper focuses on solving the governing equations (2.)-(2.2) in a Lagrangian framework, in which it is assumed that ẋ = u, and the vectors U and F then take the simpler form U = ρ M E, F = 0 p n pu n. (2.) 2.2 The third order conservative Lagrangian type scheme on curvilinear meshes in two space dimension The 2D spatial domain Ω is discretized into M N computational cells. I i+/2,j+/2 is a generalized quadrilateral cell, with each edge being a quadratic curve. This curved quadrilateral cell is uniquely identified by its four vertices {(x i,j,y i,j ), (x i+,j,y i+,j ), (x i+,j+,y i+,j+ ), (x,j+,y,j+ )} and the four middle points of its four quadratic edges {(x i+/2,j,y i+/2,j ), (x i+,j+/2,y i+,j+/2 ), (x i+/2,j+,y i+/2,j+ ), (x i,j+/2,y i,j+/2 )}. S i+/2,j+/2 denotes the area of the cell I i+/2,j+/2 with i =,..., M, j =,..., N. For a given cell I i+/2,j+/2, the location of the cell center is denoted by (x i+/2,j+/2,y i+/2,j+/2 ). The fluid velocity (u i,j,v i,j ) is defined at the vertex of the mesh and (u i+/2,j,v i+/2,j ), (u i,j+/2,v i,j+/2 ) define the fluid velocities at the middle points of the curvilinear edges of the cell. We consider only the nonstaggered mesh, with all the variables except velocity stored at the cell center of I i+/2,j+/2 in the form of cell averages. For example, the values of the cell averages for the cell I i+/2,j+/2

5 denoted by ρ i+/2,j+/2, M x i+/2,j+/2, M y i+/2,j+/2 and E i+/2,j+/2 are defined as follows ρ i+/2,j+/2 = M y i+/2,j+/2 = where ρ, M x, M y respectively. S i+/2,j+/2 S i+/2,j+/2 ρdxdy, M x i+/2,j+/2 = M x dxdy, I i+/2,j+/2 S i+/2,j+/2 I i+/2,j+/2 M y dxdy, E i+/2,j+/2 = Edxdy I i+/2,j+/2 S i+/2,j+/2 I i+/2,j+/2 and E are the density, x-momentum, y-momentum and total energy, 2.2. Spatial and time discretizations The conservative semi-discrete scheme for the equations (2.) and (2.) has the following form on the 2D non-staggered mesh ρ i+/2,j+/2 S i+/2,j+/2 d M x i+/2,j+/2s i+/2,j+/2 dt M y i+/2,j+/2 S = ˆFdl i+/2,j+/2 I i+/2,j+/2 E i+/2,j+/2 S i+/2,j+/2 ˆf D (U n, U+ n ) ˆf = Mx (U n, U + n ) I i+/2,j+/2 ˆf My (U n, U+ n ) ˆf E (U n, U + n ) dl. (2.) Here U ± = (ρ ±,M ± x,m ± y,e ± ) are the values of mass, x-momentum, y-momentum and total energy at two sides of the boundary. U ± n =(ρ ±,M n ±,E ± ), where M n ± are the left and right component values of the momentum which is normal to the cell boundary, i.e. M n ± =(M x ±,M± y ) n. ˆfD, ˆfMx, ˆfMy and ˆf E are the numerical fluxes of mass, x-momentum, y-momentum and total energy across the cell boundary respectively. Here in the Lagrangian formulation, we have ˆf D (U n, U n ) = 0, ˆf Mx (U n, U n ) = pn x ˆf My (U n, U n ) = pn y ˆf E (U n, U n ) = pu n (2.) where u n = u n is the normal velocity at the cell boundary. Similar to [], we use the high order WENO reconstruction with Roe-type characteristic decomposition [] to obtain U ± and U ± n at the boundary and also use sufficiently high

6 order quadrature to construct schemes up to the expected third-order spatial accuracy. The Dukowicz flux and the Lax-Friedrichs (L-F) flux are used in this paper for numerical tests. To save space, in the following we will only list the difference in the procedure of constructing the scheme on the curved quadrilateral meshes from that on the straight-line edged quadrilateral meshes. We refer to [] for the other details. Since calculating the integral of the numerical flux and determining the reconstruction polynomials in the scheme (2.) involve the integration on each curved quadrilateral cell, firstly we should know the exact description of each curvilinear cell with quadratically-curved edges by the information of the coordinates of its four vertices and the four middle points of its four edges. We accomplish this procedure by a mapping from a canonical square to a curved quadrilateral cell. For simplicity, here we denote the coordinates of the four vertices of the concerned cell as {(x m,y m ),m =, 2,, } and the middle points of its four edges as (x 2,y 2 ), (x 2,y 2 ), (x,y ), (x,y ) respectively (see Fig. 2.). Then the shape of this curvilinear cell can be determined by the following interpolation function. x = y = ϕ m x m + ϕ mn x mn m= ϕ m y m + n=m+ (mod ) m= n=m+ (mod ) ϕ mn y mn (2.) where ϕ m = ( + ξ mξ)( + η m η)( ξ m ξ η m η), m =, 2,, ϕ mn = 2 ( + ξ mnξ + η mn η)( ξ 2 mn η2 η 2 mn ξ2 ), n = m + (mod ), ξ, η For each boundary edge Γ m of the curved edges in I i+/2,j+/2, the curvilinear integral of the numerical flux ˆF is discretized by a -point Gaussian quadrature, ˆFdl = ˆF ẋ 2 +ẏ 2 dζ ω k ˆF(Un (G k )) ẋ 2 (G k ) + ẏ 2 (G k ), (2.) Γ m k= where ζ = ξ, ẋ = dx dξ, ẏ = dy dξ if the edge Γ m corresponds to a ξ line, ζ = η, ẋ = dx dη, ẏ = dy dη if the edge Γ m corresponds to an η line. G k =, 0, are the Gaussian quadrature (Simpson s

7 (-,) (,) Y X (-,-) (,-) Figure 2.: Mapping from a canonical square to a curved quadrilateral with quadraticallycurved edges. rule) points at this edge. {ω k,k =, } are the weights with the values of /, /, / respectively. The integral of the reconstruction polynomial p(x, y) on the curved quadrilateral cell can be computed in the (ξ, η) coordinates for example by a -point Gaussian integration formula I i+/2,j+/2 p(x, y)dxdy = p(x, y) J dξdη ω k ω l p(g k,l ) J(G k,l ) (2.) where J is the Jacobian matrix, G k,l =(ξ k,η l ) are the Gaussian quadrature points of the cell in the (ξ, η)-plane with ξ = η =, ξ 2 = η 2 =, ξ = η =,ξ = η =, and {ω k,k =, } are the weights which have the values ω =, ω 2 =, ω =, ω =. The procedure of choosing the candidate stencils for a third order WENO reconstruction in our framework is discussed in detail in [2], in the context of remapping. Briefly described, we start from the family of candidate stencils for the second-order approximation, and determine the smoothest stencil for the linear reconstruction in the cell I i+/2,j+/2, for example the smoothest stencil might consist of Cell 0 (i.e. I i+/2,j+/2 ), Cell, and Cell 2, see Fig Extending from these three cells, we can then choose the following three sets of stencils which come from different directions for the third order reconstruction in Cell 0, k,l= {A : 0,, 2,,, }, {B : 0,, 2,,, }, {C : 0,, 2,,, 2} Among these stencils, we can see Stencil A represents a central stencil and the other two are biased stencils.

8 Figure 2.2: The potential cells for the candidate stencils The WENO procedure here is similar to that in [] except that different weights are used. In this procedure, the coefficients of the reconstruction polynomial are chosen as the weighted averages of those determined by the above final three possible stencils. Here we use different weights to make our third order scheme on curved meshes more stable. To be specific, we use density as an example. To determine the coefficients {a mn,m+ n 2} of the quadratic polynomial reconstruction function inside the cell I i+/2,j+/2, ρ i+/2,j+/2 (x, y) = m+n 2 a mn (x x i+/2,j+/2 ) m (y y i+/2,j+/2 ) n, suppose the coefficients of the reconstruction polynomials of the three candidate stencils are a i mn,i=, 2,, then we choose a mn = i= wi a i mn where the weights wi are chosen as w i = w i j= wj, wj = c j m+n 2 (S D) m+n a j mn 2 + ɛ (2.0) where c j are the linear weights, S D is the total area of the computational domain which is introduced to preserve the self-similarity property of the reconstruction, and we typically choose ɛ = 0. In order to improve the linear stability of the scheme, we choose c =2 to increase the linear weight of the central stencil A in the reconstruction and c 2 = c = for the other two stencils. This crude WENO reconstruction, which does not theoretically increase the accuracy of each candidate stencil but is very easy to compute, performs nicely in our numerical experiments. We also use the third order TVD Runge-Kutta method [] for the time discretization of the scheme, see [] for the implementation details.

9 2.2.2 The determination of the velocity The vertex velocity of the mesh is determined in the same way as in []. For the velocity of an edge s middle point, the tangential velocity is defined as the arithmetic average of the tangential velocities from its two sides. As to the normal velocity, for the Dukowicz flux, we obtain it as a by-product of the approximate Riemann solver and for the L-F flux, we obtain it by a Roe average of the normal velocities from its two sides. In our numerical non-oscillatory tests, we found that the velocity at the middle point of an edge should be limited in order to avoid the edge from dramatic curving, which may lead to a degeneracy of the cell (i.e. different sides of the cell intersect each other inside). We perform the limitation on the movement of the middle point as described below, which does not destroy the formal accuracy of the numerical scheme. We first set a reference circular arc for each curvilinear edge which is on the same side of the line connecting the two end-points of the edge. The reference circular arc is determined by the two end-points of the edge and another point which is preset at the normal direction of the above mentioned line from its middle point. The distance between this point and the middle point of the line is as follows, d = c l 2 (2.) where l is the straight-line length of the edge, c is a parameter which can be used to determine the allowed amplitude of the circular arc. For the edge with two fixed end points, if c is larger, then the radius of the reference circular arc (we call it as the reference curvature radius) is smaller, and vice versa. After we obtain the new position of the related points at each Runge-Kutta time step, we check the curvature radius of the curvilinear edge at its middle point. If it is less than its pre-set reference curvature radius, we move this middle point to the location of the middle point of the pre-set reference circular arc. We can control the extent of this modification by choosing an adequate pre-set c. In particular, we remark that any choice of c>0 will not destroy the asymptotic formal accuracy when the solution

10 is smooth, as a Taylor expansion indicates that the actual curvature radius for a smooth solution corresponds to a distance d in (2.) of the size O( l ), which is asymptotically smaller than c l 2 with any c>0, hence the limiter is never enacted for smooth solutions and small enough l. This is verified numerically in our accuracy test in next section. Numerical results in two space dimensions In this section, in the accuracy test we will only show the results obtained by the Dukowicz flux because the results by other fluxes introduced in [] are quite similar. In the nonoscillatory tests, we will show the results obtained by the Dukowicz flux and the L-F flux.. Accuracy test Here we choose the two-dimensional vortex evolution problem [] for our accuracy test. The vortex problem is described as follows: The mean flow is ρ =, p = and (u, v) = (, ) (diagonal flow). We add to this mean flow an isentropic vortex perturbations in (u, v) and the temperature T = p/ρ, no perturbation in the entropy S = p/ρ γ. (δu, δv) = ɛ (γ )ɛ2 2π e0.( r2) ( y, x), δt = e ( r2), δs =0 γπ 2 where ( y, x) = (x,y ), r 2 = x 2 + y 2, and the vortex strength is ɛ =. The computational domain is taken as [0, 0] [0, 0], and periodic boundary conditions are used. In this test, the Courant number is chosen as 0. and the parameter c in (2.) for the limitation on the movement of the middle points at the cell edges is set to be 0.. For comparison, we compute the third order scheme with the Dukowicz flux and the above mentioned WENO reconstruction both on the straight-line edged quadrilateral meshes and the curved quadrilateral meshes. Fig.. shows the local meshes simulated by these two kinds of schemes at t =. The convergence results at t = are listed in Tables.-.2 respectively. In Table., we can only see second order accuracy just as the result in [], while in Table.2 we can see the desired third order accuracy at least in the L norm which verifies our claim. 0

11 Table.: Errors of the third order scheme on 2D straight-line edged quadrilateral meshes for the vortex problem using N x N y initially uniform mesh cells. N x = N y Norm Density order Momentum order Energy order 20 L 0.E-2 0.E-2 0.E- L 0.2E- 0.0E- 0.E+0 0 L 0.E E E L 0.E-2. 0.E-. 0.E-. 0 L 0.E E E- 2.0 L 0.2E E E L 0.E E E- 2.0 L 0.E-. 0.E E-2 2. Table.2: Errors of the third order scheme on 2D curved quadrilateral meshes for the vortex problem using N x N y initially uniform mesh cells. N x = N y Norm Density order Momentum order Energy order 20 L 0.E-2 0.E-2 0.E-2 L 0.2E- 0.2E- 0.0E- 0 L 0.20E E E- 2. L 0.E-2. 0.E E-. 0 L 0.2E E E- 2. L 0.E E E L 0.E E E- 2. L 0.2E E E- 2. y y x x Figure.: The local mesh of the vortex problem at t =. Left: quadrilateral; Right: curved quadrilateral.

12 Remark: In fact, we have also experimented with another type of WENO reconstruction described below: Denote the Cell 0 to be I i+/2,j+/2, then we choose four central stencils and four biased stencils for our WENO reconstruction from the information on the cell 0 and its 2 neighboring cells (see Fig. 2.2). The stencils we use are as follows: Central stencils: { 0,, 2,,, }, { 0,, 2,,, }, { 0,, 2,,, }, { 0,, 2,,, } Biased stencils: { 0,, 2,,, 2}, { 0,,,,, 0}, { 0,,,, 0, }, { 0, 2,,,, 2} We can obtain eight reconstruction polynomials from these eight stencils. Then the final nonlinear WENO reconstruction polynomial is obtained by a combination of these eight polynomials by using similar smoothness indicators and nonlinear weights as those in Hu and Shu []. To be more specific, we define the following smoothness indicator to measure the smoothness. SI = S i+/2,j+/2 α (D α p(x, y)) 2 dxdy (.) I i+/2,j+/2 α 2 where α is a multi-index and D is the derivative operator, for example, when α = (, ) then α = 2 and D α p(x, y) = p 2 (x, y)/ x y. The nonlinear weights are then defined as ω k = ω k l ω, ω l = l c l (ɛ + SI l ) 2 (.2) where {c l,l =, } are the linear weights. Here we set c l = 2 for the central stencils and c l = for the biased stencils. Tables.-. contain the error results of the third order code with this WENO reconstruction on the straight-line edged quadrilateral meshes and the curved quadrilateral meshes respectively. We can see our third order scheme on the curved meshes can yield higher than third order accuracy for all the concerned quantities both in the L norm and in the L norm while the corresponding scheme on the quadrilateral meshes still only achieves second order accuracy. These accuracy results reinforce our claim 2

13 Table.: Errors of the third order scheme in the Remark on 2D straight-line edged quadrilateral meshes for the vortex problem using N x N y initially uniform mesh cells. N x = N y Norm Density order Momentum order Energy order 20 L 0.E-2 0.E-2 0.2E- L 0.0E- 0.E- 0.E+0 0 L 0.E E E L 0.2E-2. 0.E-.0 0.E-. 0 L 0.E E E- 2.0 L 0.E E-2. 0.E L 0.E E E- 2.0 L 0.E E-. 0.2E Table.: Errors of the third order scheme in the Remark on 2D curved quadrilateral meshes for the vortex problem using N x N y initially uniform mesh cells. N x = N y Norm Density order Momentum order Energy order 20 L 0.E-2 0.0E-2 0.E-2 L 0.E- 0.0E- 0.E- 0 L 0.E-. 0.2E-. 0.E-. L 0.E E E L 0.0E-. 0.E E-.2 L 0.E E-. 0.E- 0 L 0.E-. 0.0E-.2 0.E-.02 L 0.E-. 0.E-. 0.E- 2 on the reason of the accuracy degeneracy problem in the Lagrangian type scheme being on the quadrilateral meshes with straight-line edges. Unfortunately, we also find out that the smoothness indicator (.)-(.2), which is developed mainly for the regular Eulerian meshes, does not seem to perform well in the Lagrangian type scheme framework when simulating problems with strong discontinuities which cause meshes to generate severe aspect ratios and distortions. It seems that a new way to measure smoothness taking the mesh distortion and large aspect ratios into account is necessary, however we will not perform such an investigation in this paper. In the following non-oscillatory tests, we apply the WENO reconstruction introduced in the previous section rather than the WENO reconstruction in this remark.

14 .2 Non-oscillatory tests We test our third order scheme on two examples with shocked solutions. The purpose here is to assess the non-oscillatory property of the scheme, rather than to show any advantage of higher order schemes. In fact for such test cases with strong shocks and relatively simple solution structure, high order schemes have very little advantage over a good first or second order scheme. Example. (The Saltzman problem []). The problem consists of a rectangular box whose left end is a piston. The piston moves into the box with a constant velocity of.0. The initial mesh is 00 cells in the x-direction and 0 cells in the y-direction which is defined by x(i, j) = (i ) x + ( j) sin(0.0π(i )) y, y(i, j) = (j ) y where x = y =0.0. The initial mesh is displayed in Figure.2. Notice that the initial mesh is deliberately distorted to set it as a more demanding test case. The working fluid is described by an ideal gas with γ = /. The initial conditions involve a stationary gas with a unity density and an internal energy of 0. Reflective boundary conditions are used on the right, upper and lower boundaries. For this test case, it is necessary to first use a smaller Courant number in order to maintain stability. The Courant number λ is set to be 0.0 initially and returns to be 0. after t =0.0. We perform the limitation on the movement of the middle points at the cell edges by choosing the parameter c =0. in (2.). The analytic post shock density is.0 and the shock speed is.. The purely Lagrangian numerical results for the Dukowicz flux and the L-F flux are shown in Figures.-. for the time t =0. respectively. At this time, the shock is expected to be located at x =0.. We can observe that our high order scheme preserves one-dimensional solution well except for the region near the top and bottom wall boundaries where the result is affected by the boundary conditions. Example.2 (The Sedov blast wave problem in a Cartesian coordinate system []). The

15 X Figure.2: The initial mesh of the Saltzman problem Y X Y X Figure.: The result of the Saltzman problem with the Dukowicz flux at t = 0.. Top: mesh; Bottom: density contour plots from.2 to. with 2 equally spaced contours.

16 Y X 0. Y X Figure.: The result of the Saltzman problem with the L-F flux at t = 0.. Top: mesh; Bottom: density contour plots from.2 to. with 2 equally spaced contours. Sedov blast wave problem models the expanding wave by an intense explosion in a perfect gas. The simulation is performed on a Cartesian grid whose initial uniform grid consists of 0 0 rectangular cells with a total edge length of. in both directions. The initial density is unity and the initial velocity is zero. The specific internal energy is zero except in the first zone where it has a value of 2.0. The analytical solution gives a shock at radius unity at time unity with a peak density of. In this test, the Courant number λ is set to be 0.. The parameter c in (2.) for the limitation on the movement of the middle points at the cell edges is chosen as 0.2. Figures.-. show the results by the purely Lagrangian calculations with the Dukowicz flux and the L-F flux at the time t = respectively. Concluding remarks In this paper we have developed a third order Lagrangian type scheme on the curved quadrilateral meshes for solving Euler equations which are based on high order weighted essentially non-oscillatory (WENO) reconstruction. This work is aimed to demonstrate our claim in

17 y Y ! x X Figure.: The Sedov problem with Dukowicz flux at t =. density contours; Right: density as a function of the radius radius Left: the mesh; Middle: y Y ! x X radius Figure.: The Sedov problem with L-F flux at t =. Left: the mesh; Middle: density contours; Right: density as a function of the radius.

18 [] where we attributed the accuracy degeneracy phenomenon observed in the third order Lagrangian type scheme to the error from the quadrilateral meshes with straight-line edges. Similar to the scheme on the quadrilateral meshes introduced in [], the scheme on the curved quadrilateral meshes is conservative for density, momentum and total energy, are essentially non-oscillatory, and have no parameters to be tuned for individual test cases. Besides, it can actually obtain the desired third order accuracy by using the curvilinear meshes. Some accuracy and non-oscillatory tests are provided to verify that the scheme achieves the designed third order accuracy and can also simulate problems containing discontinuities. In future work we will study new smoothness indicators in the WENO reconstruction, which take the mesh distortion and large aspect ratios into consideration, in order to improve the robustness of the high order Lagrangian type schemes for shock calculations. References [] D.J. Benson, Computational methods in Lagrangian and Eulerian hydrocodes, Computer Methods in Applied Mechanics and Engineering,, 2, 2-. [2] J. Cheng and C.-W. Shu, A high order accurate conservative remapping method on staggered meshes, Applied Numerical Mathematics, in press, doi:0.0/j.apnum [] J. Cheng and C.-W. Shu, A high order ENO conservative Lagrangian type scheme for the compressible Euler equations, Journal of Computational Physics, 22, 200, -. [] B. Després and C. Mazeran, Lagrangian gas dynamics in two dimensions and lagrangian systems, Archive for Rational Mechanics and Analysis,, 200, 2-2. [] J.K. Dukowicz and B.J.A. Meltz, Vorticity errors in multidimensional Lagrangian codes, Journal of Computational Physics,, 2, -.

19 [] C. Hirt, A. Amsden and J. Cook, An arbitrary Lagrangian-Eulerian computing method for all flow speeds, Journal of Computational Physics,,, [] C. Hu and C.-W. Shu, Weighted essentially non-oscillatory schemes on Triangular meshes, Journal of Computational Physics, 0,, -2. [] G. Jiang and C.-W. Shu, Efficient implementation of weighted ENO schemes, Journal of Computational Physics, 2,, [] R. Loubère and M.J. Shashkov, A subcell remapping method on staggered polygonal grids for arbitrary-lagrangian-eulerian methods, Journal of Computational Physics, 20, 200, 0-. [0] P.-H. Maire, R. Abgrall, J. Breil and J. Ovadia, A cell-centered Lagrangian scheme for two-dimensional compressible flow problems, SIAM Journal on Scientific Computing, 2, 200, -2. [] C.D. Munz, On Godunov-type schemes for Lagrangian gas dynamics, SIAM Journal on Numerical Analysis,,, -2. [2] J. von Neumann and R.D. Richtmyer, A method for the calculation of hydrodynamics shocks, Journal of Applied Physics, 2, 0, [] J.S. Peery and D.E. Carroll, Multi-material ALE methods in unstructured grids, Computer Methods in Applied Mechanics and Engineering,, 2000, -. [] L.I. Sedov, Similarity and Dimensional Methods in Mechanics, Academic Press, New York,. [] C.-W. Shu, Essentially non-oscillatory and weighted essentially non-oscillatory schemes for hyperbolic conservation laws, in Advanced Numerical Approximation of Nonlinear Hyperbolic Equations, B. Cockburn, C. Johnson, C.-W. Shu and E. Tadmor (Editor:

20 A. Quarteroni), Lecture Notes in Mathematics, volume, Springer, Berlin,, 2-2. [] C.-W. Shu and S. Osher, Efficient implementation of essentially non-oscillatory shockcapturing schemes, Journal of Computational Physics,,, -. [] C.-W. Shu, T.A. Zang, G. Erlebacher, D. Whitaker and S. Osher, High-order ENO schemes applied to two- and three-dimensional compressible flow, Applied Numerical Mathematics,, 2, -. [] P.R. Woodward and P. Colella, The numerical simulation of two-dimensional fluid flow with strong shocks, Journal of Computational Physics,,, -. 20

On the order of accuracy and numerical performance of two classes of finite volume WENO schemes

On the order of accuracy and numerical performance of two classes of finite volume WENO schemes On the order of accuracy and numerical performance of two classes of finite volume WENO schemes Rui Zhang, Mengping Zhang and Chi-Wang Shu November 29, 29 Abstract In this paper we consider two commonly

More information

Third Order WENO Scheme on Three Dimensional Tetrahedral Meshes

Third Order WENO Scheme on Three Dimensional Tetrahedral Meshes COMMUNICATIONS IN COMPUTATIONAL PHYSICS Vol. 5, No. 2-4, pp. 86-848 Commun. Comput. Phys. February 29 Third Order WENO Scheme on Three Dimensional Tetrahedral Meshes Yong-Tao Zhang 1, and Chi-Wang Shu

More information

Mid-Year Report. Discontinuous Galerkin Euler Equation Solver. Friday, December 14, Andrey Andreyev. Advisor: Dr.

Mid-Year Report. Discontinuous Galerkin Euler Equation Solver. Friday, December 14, Andrey Andreyev. Advisor: Dr. Mid-Year Report Discontinuous Galerkin Euler Equation Solver Friday, December 14, 2012 Andrey Andreyev Advisor: Dr. James Baeder Abstract: The focus of this effort is to produce a two dimensional inviscid,

More information

Hierarchical Reconstruction for Spectral Volume Method on Unstructured Grids

Hierarchical Reconstruction for Spectral Volume Method on Unstructured Grids Hierarchical Reconstruction for Spectral Volume Method on Unstructured Grids Zhiliang Xu, Yingjie Liu and Chi-Wang Shu April 4, 2009 Abstract The hierarchical reconstruction (HR) [, 24] is applied to a

More information

High Order Schemes for CFD: A Review. Juan Cheng 1. Institute of Applied Physics and Computational Mathematics, Beijing , China.

High Order Schemes for CFD: A Review. Juan Cheng 1. Institute of Applied Physics and Computational Mathematics, Beijing , China. High Order Schemes for CFD: A Review Juan Cheng 1 Institute of Applied Physics and Computational Mathematics, Beijing 100088, China and Chi-Wang Shu 2 Division of Applied Mathematics, Brown University,

More information

On the Order of Accuracy and Numerical Performance of Two Classes of Finite Volume WENO Schemes

On the Order of Accuracy and Numerical Performance of Two Classes of Finite Volume WENO Schemes Commun. Comput. Phys. doi: 8/cicp.99.84s Vol. 9, No. 3, pp. 87-87 March On the Order of Accuracy and Numerical Performance of Two Classes of Finite Volume WENO Schemes Rui Zhang, Mengping Zhang and Chi-Wang

More information

Final Report. Discontinuous Galerkin Compressible Euler Equation Solver. May 14, Andrey Andreyev. Adviser: Dr. James Baeder

Final Report. Discontinuous Galerkin Compressible Euler Equation Solver. May 14, Andrey Andreyev. Adviser: Dr. James Baeder Final Report Discontinuous Galerkin Compressible Euler Equation Solver May 14, 2013 Andrey Andreyev Adviser: Dr. James Baeder Abstract: In this work a Discontinuous Galerkin Method is developed for compressible

More information

Lecture 1: Finite Volume WENO Schemes Chi-Wang Shu

Lecture 1: Finite Volume WENO Schemes Chi-Wang Shu Lecture 1: Finite Volume WENO Schemes Chi-Wang Shu Division of Applied Mathematics Brown University Outline of the First Lecture General description of finite volume schemes for conservation laws The WENO

More information

A high order moving boundary treatment for compressible inviscid flows 1. Abstract

A high order moving boundary treatment for compressible inviscid flows 1. Abstract A high order moving boundary treatment for compressible inviscid flows Sirui Tan and Chi-Wang Shu Abstract We develop a high order numerical boundary condition for compressible inviscid flows involving

More information

A cell-centered Arbitrary Lagrangian Eulerian method for two-dimensional multimaterial problems

A cell-centered Arbitrary Lagrangian Eulerian method for two-dimensional multimaterial problems A cell-centered Arbitrary Lagrangian Eulerian method for two-dimensional multimaterial problems Application to Inertial Confinement Fusion modeling in the direct drive context Pierre-Henri Maire, maire@celia.u-bordeaux1.fr

More information

Development of a Maxwell Equation Solver for Application to Two Fluid Plasma Models. C. Aberle, A. Hakim, and U. Shumlak

Development of a Maxwell Equation Solver for Application to Two Fluid Plasma Models. C. Aberle, A. Hakim, and U. Shumlak Development of a Maxwell Equation Solver for Application to Two Fluid Plasma Models C. Aberle, A. Hakim, and U. Shumlak Aerospace and Astronautics University of Washington, Seattle American Physical Society

More information

Runge-Kutta discontinuous Galerkin method using a new type of WENO limiters on unstructured mesh 1

Runge-Kutta discontinuous Galerkin method using a new type of WENO limiters on unstructured mesh 1 Runge-Kutta discontinuous Galerkin method using a new type of WENO limiters on unstructured mesh Jun Zhu, inghui Zhong 3, Chi-Wang Shu 4 and Jianxian Qiu 5 Abstract In this paper we generalize a new type

More information

CS205b/CME306. Lecture 9

CS205b/CME306. Lecture 9 CS205b/CME306 Lecture 9 1 Convection Supplementary Reading: Osher and Fedkiw, Sections 3.3 and 3.5; Leveque, Sections 6.7, 8.3, 10.2, 10.4. For a reference on Newton polynomial interpolation via divided

More information

Debojyoti Ghosh. Adviser: Dr. James Baeder Alfred Gessow Rotorcraft Center Department of Aerospace Engineering

Debojyoti Ghosh. Adviser: Dr. James Baeder Alfred Gessow Rotorcraft Center Department of Aerospace Engineering Debojyoti Ghosh Adviser: Dr. James Baeder Alfred Gessow Rotorcraft Center Department of Aerospace Engineering To study the Dynamic Stalling of rotor blade cross-sections Unsteady Aerodynamics: Time varying

More information

Weighted Essentially Non-oscillatory Schemes on Triangular Meshes 1

Weighted Essentially Non-oscillatory Schemes on Triangular Meshes 1 Journal of Computational Physics 150, 97 127 (1999) Article ID jcph.1998.6165, available online at http://www.idealibrary.com on Weighted Essentially Non-oscillatory Schemes on Triangular Meshes 1 Changqing

More information

On the Construction, Comparison, and Local Characteristic Decomposition for High-Order Central WENO Schemes

On the Construction, Comparison, and Local Characteristic Decomposition for High-Order Central WENO Schemes Journal of Computational Physics 8, 87 09 (00) doi:0.006/jcph.00.79 On the Construction, Comparison, and Local Characteristic Decomposition for High-Order Central WENO Schemes Jianxian Qiu, and Chi-Wang

More information

A New Trouble-Cell Indicator for Discontinuous Galerkin Methods for. Hyperbolic Conservation Laws ABSTRACT

A New Trouble-Cell Indicator for Discontinuous Galerkin Methods for. Hyperbolic Conservation Laws ABSTRACT A New Trouble-Cell Indicator for Discontinuous Galerkin Methods for Hyperbolic Conservation Laws Guosheng Fu and Chi-Wang Shu ABSTRACT We introduce a new troubled-cell indicator for the discontinuous Galerkin

More information

On the high order FV schemes for compressible flows

On the high order FV schemes for compressible flows Applied and Computational Mechanics 1 (2007) 453-460 On the high order FV schemes for compressible flows J. Fürst a, a Faculty of Mechanical Engineering, CTU in Prague, Karlovo nám. 13, 121 35 Praha, Czech

More information

A robust reconstruction for unstructured WENO schemes 1

A robust reconstruction for unstructured WENO schemes 1 A robust reconstruction for unstructured WENO schemes 1 Yuan Liu 2 and Yong-Tao Zhang 3 Corresponding author. Tel.: +1 574 631 6079. E-mail: yzhang10@nd.edu Abstract The weighted essentially non-oscillatory

More information

High Order Weighted Essentially Non-Oscillatory Schemes for Convection. Dominated Problems. Chi-Wang Shu 1

High Order Weighted Essentially Non-Oscillatory Schemes for Convection. Dominated Problems. Chi-Wang Shu 1 High Order Weighted Essentially Non-Oscillatory Schemes for Convection Dominated Problems Chi-Wang Shu Division of Applied Mathematics, Brown University, Providence, Rhode Island 09 ABSTRACT High order

More information

The WENO Method in the Context of Earlier Methods To approximate, in a physically correct way, [3] the solution to a conservation law of the form u t

The WENO Method in the Context of Earlier Methods To approximate, in a physically correct way, [3] the solution to a conservation law of the form u t An implicit WENO scheme for steady-state computation of scalar hyperbolic equations Sigal Gottlieb Mathematics Department University of Massachusetts at Dartmouth 85 Old Westport Road North Dartmouth,

More information

Numerical Analysis of Shock Tube Problem by using TVD and ACM Schemes

Numerical Analysis of Shock Tube Problem by using TVD and ACM Schemes Numerical Analysis of Shock Tube Problem by using TVD and Schemes Dr. Mukkarum Husain, Dr. M. Nauman Qureshi, Syed Zaid Hasany IST Karachi, Email: mrmukkarum@yahoo.com Abstract Computational Fluid Dynamics

More information

Example 13 - Shock Tube

Example 13 - Shock Tube Example 13 - Shock Tube Summary This famous experiment is interesting for observing the shock-wave propagation. Moreover, this case uses the representation of perfect gas and compares the different formulations:

More information

Non-Oscillatory Hierarchical Reconstruction for Central and Finite Volume Schemes

Non-Oscillatory Hierarchical Reconstruction for Central and Finite Volume Schemes COMMUNICATIONS IN COMPUTATIONAL PHYSICS Vol., No., pp. 933-963 Commun. Comput. Phys. October 7 Non-Oscillatory Hierarchical Reconstruction for Central and Finite Volume Schemes Yingjie Liu,, Chi-Wang Shu,

More information

Conservative high order semi-lagrangian finite difference WENO methods for advection in incompressible flow. Abstract

Conservative high order semi-lagrangian finite difference WENO methods for advection in incompressible flow. Abstract Conservative high order semi-lagrangian finite difference WENO methods for advection in incompressible flow Jing-Mei Qiu 1 and Chi-Wang Shu Abstract In this paper, we propose a semi-lagrangian finite difference

More information

NON-OSCILLATORY HIERARCHICAL RECONSTRUCTION FOR CENTRAL AND FINITE VOLUME SCHEMES

NON-OSCILLATORY HIERARCHICAL RECONSTRUCTION FOR CENTRAL AND FINITE VOLUME SCHEMES NON-OSCILLATORY HIERARCHICAL RECONSTRUCTION FOR CENTRAL AND FINITE VOLUME SCHEMES YINGJIE LIU, CHI-WANG SHU, EITAN TADMOR, AND MENGPING ZHANG Abstract. This is the continuation of the paper central discontinuous

More information

This is an author-deposited version published in: Eprints ID: 4362

This is an author-deposited version published in:   Eprints ID: 4362 This is an author-deposited version published in: http://oatao.univ-toulouse.fr/ Eprints ID: 4362 To cite this document: CHIKHAOUI Oussama, GRESSIER Jérémie, GRONDIN Gilles. Assessment of the Spectral

More information

Numerical Methods for Hyperbolic and Kinetic Equations

Numerical Methods for Hyperbolic and Kinetic Equations Numerical Methods for Hyperbolic and Kinetic Equations Organizer: G. Puppo Phenomena characterized by conservation (or balance laws) of physical quantities are modelled by hyperbolic and kinetic equations.

More information

Runge Kutta discontinuous Galerkin method using WENO limiters II: unstructured meshes

Runge Kutta discontinuous Galerkin method using WENO limiters II: unstructured meshes Runge Kutta discontinuous Galerkin method using WENO limiters II: unstructured meshes Jun Zhu, Jianxian Qiu,Chi-WangShu 3 and Michael Dumbser 4 Abstract In [], Qiu and Shu investigated using weighted essentially

More information

Observations on the fifth-order WENO method with non-uniform meshes

Observations on the fifth-order WENO method with non-uniform meshes Observations on the fifth-order WENO method with non-uniform meshes Rong Wang, a, Hui Feng, b, Raymond J. Spiteri a,, a Department of Computer Science, University of Saskatchewan, Saskatoon, SK, S7N 5C9,

More information

A Central Compact-Reconstruction WENO Method for Hyperbolic Conservation Laws

A Central Compact-Reconstruction WENO Method for Hyperbolic Conservation Laws AIAA SciTech Forum 8 January 08, Kissimmee, Florida 08 AIAA Aerospace Sciences Meeting 0.54/6.08-0067 A Central Compact-Reconstruction WENO Method for Hyperbolic Conservation Laws Kilian Cooley and Dr.

More information

A CONSERVATIVE FRONT TRACKING ALGORITHM

A CONSERVATIVE FRONT TRACKING ALGORITHM A CONSERVATIVE FRONT TRACKING ALGORITHM Vinh Tan Nguyen, Khoo Boo Cheong and Jaime Peraire Singapore-MIT Alliance Department of Mechanical Engineering, National University of Singapore Department of Aeronautics

More information

A Technique of Treating Negative Weights in WENO Schemes

A Technique of Treating Negative Weights in WENO Schemes NASA/CR--63 ICASE Report No. -49 A Technique of Treating Negative Weights in WENO Schemes Jing Shi, Changqing Hu, and Chi-Wang Shu Brown University, Providence, Rhode Island ICASE NASA Langley Research

More information

A DETAILED COMPARISON OF WENO AND SFV HIGH-ORDER METHODS FOR INVISCID AERODYNAMIC APPLICATIONS

A DETAILED COMPARISON OF WENO AND SFV HIGH-ORDER METHODS FOR INVISCID AERODYNAMIC APPLICATIONS Blucher Mechanical Engineering Proceedings May 2014, vol. 1, num. 1 www.proceedings.blucher.com.br/evento/10wccm A DETAILED COMPARISON OF WENO AND SFV HIGH-ORDER METHODS FOR INVISCID AERODYNAMIC APPLICATIONS

More information

High-Order CENO Reconstruction Scheme For Three-Dimensional Unstructured Mesh

High-Order CENO Reconstruction Scheme For Three-Dimensional Unstructured Mesh High-Order CENO Reconstruction Scheme For Three-Dimensional Unstructured Mesh by Al-Amin Aziz A thesis submitted in conformity with the requirements for the degree of Masters of Applied Science Graduate

More information

Robust and Efficient Adaptive Moving Mesh Solution of the 2-D Euler equations

Robust and Efficient Adaptive Moving Mesh Solution of the 2-D Euler equations Contemporary Mathematics Robust and Efficient Adaptive Moving Mesh Solution of the -D Euler equations P. A. Zegeling, W. D. de Boer, and H. Z. Tang Abstract. In this paper we describe an adaptive moving

More information

A new Eulerian computational method for the propagation of short acoustic and electromagnetic pulses

A new Eulerian computational method for the propagation of short acoustic and electromagnetic pulses A new Eulerian computational method for the propagation of short acoustic and electromagnetic pulses J. Steinhoff, M. Fan & L. Wang. Abstract A new method is described to compute short acoustic or electromagnetic

More information

TVD and ENO Schemes for Multidimensional Steady and Unsteady Flows A Comparative Analysis

TVD and ENO Schemes for Multidimensional Steady and Unsteady Flows A Comparative Analysis TVD and ENO Schemes for Multidimensional Steady and Unsteady Flows A Comparative Analysis Philippe Angot IRPHE équipe MNM, UMR CNRS 38, Universit Aix-Marseille I. & II., 2, Av. Général Leclerc, 30 03 Marseille,

More information

Nonoscillatory Central Schemes on Unstructured Triangulations for Hyperbolic Systems of Conservation Laws

Nonoscillatory Central Schemes on Unstructured Triangulations for Hyperbolic Systems of Conservation Laws Nonoscillatory Central Schemes on Unstructured Triangulations for Hyperbolic Systems of Conservation Laws Ivan Christov Bojan Popov Department of Mathematics, Texas A&M University, College Station, Texas

More information

Numerical study on the convergence to steady state solutions of a new class of finite volume WENO schemes: triangular meshes

Numerical study on the convergence to steady state solutions of a new class of finite volume WENO schemes: triangular meshes Numerical study on the convergence to steady state solutions of a new class of finite volume WENO schemes: triangular meshes Jun Zhu and Chi-Wang Shu Abstract In this paper we continue our research on

More information

Weno Scheme for Transport Equation on Unstructured Grids with a DDFV Approach

Weno Scheme for Transport Equation on Unstructured Grids with a DDFV Approach Weno Scheme for Transport Equation on Unstructured Grids with a DDFV Approach Florence Hubert and Rémi Tesson Abstract In this paper we develop a DDFV approach for WENO scheme on unstructred grids for

More information

1.2 Numerical Solutions of Flow Problems

1.2 Numerical Solutions of Flow Problems 1.2 Numerical Solutions of Flow Problems DIFFERENTIAL EQUATIONS OF MOTION FOR A SIMPLIFIED FLOW PROBLEM Continuity equation for incompressible flow: 0 Momentum (Navier-Stokes) equations for a Newtonian

More information

The gas-kinetic methods have become popular for the simulation of compressible fluid flows in the last

The gas-kinetic methods have become popular for the simulation of compressible fluid flows in the last Parallel Implementation of Gas-Kinetic BGK Scheme on Unstructured Hybrid Grids Murat Ilgaz Defense Industries Research and Development Institute, Ankara, 626, Turkey and Ismail H. Tuncer Middle East Technical

More information

Challenges and recent progress in developing numerical methods for multi-material ALE Hydrocodes

Challenges and recent progress in developing numerical methods for multi-material ALE Hydrocodes Challenges and recent progress in developing numerical methods for multi-material ALE Hydrocodes ICFD 25 year Anniversary Conference 15-16 th September 2008 Oxford University Andrew Barlow AWE Introduction

More information

A new multidimensional-type reconstruction and limiting procedure for unstructured (cell-centered) FVs solving hyperbolic conservation laws

A new multidimensional-type reconstruction and limiting procedure for unstructured (cell-centered) FVs solving hyperbolic conservation laws HYP 2012, Padova A new multidimensional-type reconstruction and limiting procedure for unstructured (cell-centered) FVs solving hyperbolic conservation laws Argiris I. Delis & Ioannis K. Nikolos (TUC)

More information

A MULTI-DOMAIN ALE ALGORITHM FOR SIMULATING FLOWS INSIDE FREE-PISTON DRIVEN HYPERSONIC TEST FACILITIES

A MULTI-DOMAIN ALE ALGORITHM FOR SIMULATING FLOWS INSIDE FREE-PISTON DRIVEN HYPERSONIC TEST FACILITIES A MULTI-DOMAIN ALE ALGORITHM FOR SIMULATING FLOWS INSIDE FREE-PISTON DRIVEN HYPERSONIC TEST FACILITIES Khalil Bensassi, and Herman Deconinck Von Karman Institute for Fluid Dynamics Aeronautics & Aerospace

More information

A new type of multi-resolution WENO schemes with increasingly higher order of accuracy

A new type of multi-resolution WENO schemes with increasingly higher order of accuracy A new type of multi-resolution WENO schemes with increasingly higher order of accuracy Jun Zhu and Chi-Wang Shu Abstract In this paper, a new type of high-order finite difference and finite volume multi-resolution

More information

Faculty of Mechanical and Manufacturing Engineering, University Tun Hussein Onn Malaysia (UTHM), Parit Raja, Batu Pahat, Johor, Malaysia

Faculty of Mechanical and Manufacturing Engineering, University Tun Hussein Onn Malaysia (UTHM), Parit Raja, Batu Pahat, Johor, Malaysia Applied Mechanics and Materials Vol. 393 (2013) pp 305-310 (2013) Trans Tech Publications, Switzerland doi:10.4028/www.scientific.net/amm.393.305 The Implementation of Cell-Centred Finite Volume Method

More information

A-posteriori Diffusion Analysis of Numerical Schemes in Wavenumber Domain

A-posteriori Diffusion Analysis of Numerical Schemes in Wavenumber Domain 2th Annual CFD Symposium, August 9-1, 218, Bangalore A-posteriori Diffusion Analysis of Numerical Schemes in Wavenumber Domain S. M. Joshi & A. Chatterjee Department of Aerospace Engineering Indian Institute

More information

Central-Upwind Schemes on Triangular Grids for Hyperbolic Systems of Conservation Laws

Central-Upwind Schemes on Triangular Grids for Hyperbolic Systems of Conservation Laws Central-Upwind Schemes on Triangular Grids for Hyperbolic Systems of Conservation Laws Alexander Kurganov, 1 Guergana Petrova 2 1 Department of Mathematics, Tulane University, New Orleans, Louisiana 70118

More information

High-Order Numerical Algorithms for Steady and Unsteady Simulation of Viscous Compressible Flow with Shocks (Grant FA )

High-Order Numerical Algorithms for Steady and Unsteady Simulation of Viscous Compressible Flow with Shocks (Grant FA ) High-Order Numerical Algorithms for Steady and Unsteady Simulation of Viscous Compressible Flow with Shocks (Grant FA9550-07-0195) Sachin Premasuthan, Kui Ou, Patrice Castonguay, Lala Li, Yves Allaneau,

More information

A higher-order finite volume method with collocated grid arrangement for incompressible flows

A higher-order finite volume method with collocated grid arrangement for incompressible flows Computational Methods and Experimental Measurements XVII 109 A higher-order finite volume method with collocated grid arrangement for incompressible flows L. Ramirez 1, X. Nogueira 1, S. Khelladi 2, J.

More information

FEMLAB Exercise 1 for ChE366

FEMLAB Exercise 1 for ChE366 FEMLAB Exercise 1 for ChE366 Problem statement Consider a spherical particle of radius r s moving with constant velocity U in an infinitely long cylinder of radius R that contains a Newtonian fluid. Let

More information

High-Order Navier-Stokes Simulations using a Sparse Line-Based Discontinuous Galerkin Method

High-Order Navier-Stokes Simulations using a Sparse Line-Based Discontinuous Galerkin Method High-Order Navier-Stokes Simulations using a Sparse Line-Based Discontinuous Galerkin Method Per-Olof Persson University of California, Berkeley, Berkeley, CA 9472-384, U.S.A. We study some of the properties

More information

A Novel Multi-Dimensional Limiter for High-Order Finite Volume Methods on Unstructured Grids

A Novel Multi-Dimensional Limiter for High-Order Finite Volume Methods on Unstructured Grids Commun. Comput. Phys. doi:.428/cicp.oa-27-39 Vol. xx, No. x, pp. -28 xxx 2x A Novel Multi-Dimensional Limiter for High-Order Finite Volume Methods on Unstructured Grids Yilang Liu, Weiwei Zhang, and Chunna

More information

A high order stable conservative method for solving hyperbolic conservation. laws on arbitrarily distributed point clouds.

A high order stable conservative method for solving hyperbolic conservation. laws on arbitrarily distributed point clouds. A high order stable conservative method for solving hyperbolic conservation laws on arbitrarily distributed point clouds Jie Du and Chi-Wang Shu Abstract In this paper, we aim to solve one and two dimensional

More information

A cell by cell anisotropic adaptive mesh Arbitrary Lagrangian Eulerian method for the numerical solution of the Euler equations. J. M.

A cell by cell anisotropic adaptive mesh Arbitrary Lagrangian Eulerian method for the numerical solution of the Euler equations. J. M. THE UNIVERSITY OF READING DEPARTMENT OF MATHEMATICS A cell by cell anisotropic adaptive mesh Arbitrary Lagrangian Eulerian method for the numerical solution of the Euler equations. J. M. Morrell Thesis

More information

Math 690N - Final Report

Math 690N - Final Report Math 690N - Final Report Yuanhong Li May 05, 008 Accurate tracking of a discontinuous, thin and evolving turbulent flame front has been a challenging subject in modelling a premixed turbulent combustion.

More information

Chapter 6. Semi-Lagrangian Methods

Chapter 6. Semi-Lagrangian Methods Chapter 6. Semi-Lagrangian Methods References: Durran Chapter 6. Review article by Staniford and Cote (1991) MWR, 119, 2206-2223. 6.1. Introduction Semi-Lagrangian (S-L for short) methods, also called

More information

High Order Fixed-Point Sweeping WENO Methods for Steady State of Hyperbolic Conservation Laws and Its Convergence Study

High Order Fixed-Point Sweeping WENO Methods for Steady State of Hyperbolic Conservation Laws and Its Convergence Study Commun. Comput. Phys. doi:.48/cicp.375.6a Vol., No. 4, pp. 835-869 October 6 High Order Fixed-Point Sweeping WENO Methods for Steady State of Hyperbolic Conservation Laws and Its Convergence Study Liang

More information

21. Efficient and fast numerical methods to compute fluid flows in the geophysical β plane

21. Efficient and fast numerical methods to compute fluid flows in the geophysical β plane 12th International Conference on Domain Decomposition Methods Editors: Tony Chan, Takashi Kako, Hideo Kawarada, Olivier Pironneau, c 2001 DDM.org 21. Efficient and fast numerical methods to compute fluid

More information

On the convergence to steady state solutions of a new class of high order WENO schemes

On the convergence to steady state solutions of a new class of high order WENO schemes On the convergence to steady state solutions of a new class of high order WENO schemes Jun Zhu and Chi-Wang Shu Abstract A new class of high order weighted essentially non-oscillatory (WENO) schemes [J.

More information

A Review on the Numerical Solution of the 1D Euler Equations. Hudson, Justin. MIMS EPrint:

A Review on the Numerical Solution of the 1D Euler Equations. Hudson, Justin. MIMS EPrint: A Review on the Numerical Solution of the D Euler Equations Hudson, Justin 6 MIMS EPrint: 6.9 Manchester Institute for Mathematical Sciences School of Mathematics The University of Manchester Reports available

More information

DDFV Schemes for the Euler Equations

DDFV Schemes for the Euler Equations DDFV Schemes for the Euler Equations Christophe Berthon, Yves Coudière, Vivien Desveaux Journées du GDR Calcul, 5 juillet 2011 Introduction Hyperbolic system of conservation laws in 2D t W + x f(w)+ y

More information

Computation of Fictitious Gas Flow with Euler Equations

Computation of Fictitious Gas Flow with Euler Equations 1 Computation of Fictitious Gas Flow with Euler Equations Pei Li and Helmut Sobieczky DLR Göttingen, Germany Abstract The Fictitious Gas Concept supports some computational design methods to construct

More information

Local-structure-preserving discontinuous Galerkin methods with Lax-Wendroff type time discretizations for Hamilton-Jacobi equations

Local-structure-preserving discontinuous Galerkin methods with Lax-Wendroff type time discretizations for Hamilton-Jacobi equations Local-structure-preserving discontinuous Galerkin methods with Lax-Wendroff type time discretizations for Hamilton-Jacobi equations Wei Guo, Fengyan Li and Jianxian Qiu 3 Abstract: In this paper, a family

More information

A SIMPLE EULERIAN FINITE-VOLUME METHOD FOR COMPRESSIBLE FLUIDS IN DOMAINS WITH MOVING BOUNDARIES

A SIMPLE EULERIAN FINITE-VOLUME METHOD FOR COMPRESSIBLE FLUIDS IN DOMAINS WITH MOVING BOUNDARIES A SIMPLE EULERIAN FINITE-VOLUME METHOD FOR COMPRESSIBLE FLUIDS IN DOMAINS WITH MOVING BOUNDARIES ALINA CHERTOCK AND ALEXANDER KURGANOV Abstract. We introduce a new simple Eulerian method for treatment

More information

Partition Design and Optimization for High-Order Spectral Volume Schemes on Tetrahedral Grids

Partition Design and Optimization for High-Order Spectral Volume Schemes on Tetrahedral Grids 48th AIAA Aerospace Sciences Meeting Including the New Horizons Forum and Aerospace Exposition 4-7 January 200, Orlando, Florida AIAA 200-720 Partition Design and Optimization for High-Order Spectral Volume

More information

Edge Detection Free Postprocessing for Pseudospectral Approximations

Edge Detection Free Postprocessing for Pseudospectral Approximations Edge Detection Free Postprocessing for Pseudospectral Approximations Scott A. Sarra March 4, 29 Abstract Pseudospectral Methods based on global polynomial approximation yield exponential accuracy when

More information

A new class of central compact schemes with spectral-like resolution II: Hybrid weighted nonlinear schemes. Abstract

A new class of central compact schemes with spectral-like resolution II: Hybrid weighted nonlinear schemes. Abstract A new class of central compact schemes with spectral-like resolution II: Hybrid weighted nonlinear schemes Xuliang Liu 1, Shuhai Zhang, Hanxin Zhang 3 and Chi-Wang Shu 4 Abstract In this paper, we develop

More information

Carl Leake Embry-Riddle Aeronautical University,

Carl Leake Embry-Riddle Aeronautical University, College of Engineering Honors Program 8-11-2016 Testing the Accuracy of Commercial Computational Fluid Dynamics Codes: Vortex Transport by Uniform Flow and Transonic Ringleb Flow Problems Using ANSYS Fluent

More information

Solving a Two Dimensional Unsteady-State. Flow Problem by Meshless Method

Solving a Two Dimensional Unsteady-State. Flow Problem by Meshless Method Applied Mathematical Sciences, Vol. 7, 203, no. 49, 242-2428 HIKARI Ltd, www.m-hikari.com Solving a Two Dimensional Unsteady-State Flow Problem by Meshless Method A. Koomsubsiri * and D. Sukawat Department

More information

HONOM EUROPEAN WORKSHOP on High Order Nonlinear Numerical Methods for Evolutionary PDEs, Bordeaux, March 18-22, 2013

HONOM EUROPEAN WORKSHOP on High Order Nonlinear Numerical Methods for Evolutionary PDEs, Bordeaux, March 18-22, 2013 HONOM 2013 EUROPEAN WORKSHOP on High Order Nonlinear Numerical Methods for Evolutionary PDEs, Bordeaux, March 18-22, 2013 A priori-based mesh adaptation for third-order accurate Euler simulation Alexandre

More information

BACK AND FORTH ERROR COMPENSATION AND CORRECTION METHODS FOR REMOVING ERRORS INDUCED BY UNEVEN GRADIENTS OF THE LEVEL SET FUNCTION

BACK AND FORTH ERROR COMPENSATION AND CORRECTION METHODS FOR REMOVING ERRORS INDUCED BY UNEVEN GRADIENTS OF THE LEVEL SET FUNCTION BACK AND FORTH ERROR COMPENSATION AND CORRECTION METHODS FOR REMOVING ERRORS INDUCED BY UNEVEN GRADIENTS OF THE LEVEL SET FUNCTION TODD F. DUPONT AND YINGJIE LIU Abstract. We propose a method that significantly

More information

Parallelization study of a VOF/Navier-Stokes model for 3D unstructured staggered meshes

Parallelization study of a VOF/Navier-Stokes model for 3D unstructured staggered meshes Parallelization study of a VOF/Navier-Stokes model for 3D unstructured staggered meshes L. Jofre, O. Lehmkuhl, R. Borrell, J. Castro and A. Oliva Corresponding author: cttc@cttc.upc.edu Centre Tecnològic

More information

AMR Multi-Moment FVM Scheme

AMR Multi-Moment FVM Scheme Chapter 4 AMR Multi-Moment FVM Scheme 4.1 Berger s AMR scheme An AMR grid with the hierarchy of Berger s AMR scheme proposed in [13] for CFD simulations is given in Fig.4.1 as a simple example for following

More information

ALE Seamless Immersed Boundary Method with Overset Grid System for Multiple Moving Objects

ALE Seamless Immersed Boundary Method with Overset Grid System for Multiple Moving Objects Tenth International Conference on Computational Fluid Dynamics (ICCFD10), Barcelona,Spain, July 9-13, 2018 ICCFD10-047 ALE Seamless Immersed Boundary Method with Overset Grid System for Multiple Moving

More information

Introduction to C omputational F luid Dynamics. D. Murrin

Introduction to C omputational F luid Dynamics. D. Murrin Introduction to C omputational F luid Dynamics D. Murrin Computational fluid dynamics (CFD) is the science of predicting fluid flow, heat transfer, mass transfer, chemical reactions, and related phenomena

More information

Spectral(Finite) Volume Method for Conservation Laws on Unstructured Grids

Spectral(Finite) Volume Method for Conservation Laws on Unstructured Grids Journal of Computational Physics 179, 665 697 (2002) doi:10.1006/jcph.2002.7082 Spectral(Finite) Volume Method for Conservation Laws on Unstructured Grids II. Extension to Two-Dimensional Scalar Equation

More information

Introduction to Computational Fluid Dynamics Mech 122 D. Fabris, K. Lynch, D. Rich

Introduction to Computational Fluid Dynamics Mech 122 D. Fabris, K. Lynch, D. Rich Introduction to Computational Fluid Dynamics Mech 122 D. Fabris, K. Lynch, D. Rich 1 Computational Fluid dynamics Computational fluid dynamics (CFD) is the analysis of systems involving fluid flow, heat

More information

CONSERVATIVE AND NON-CONSERVATIVE METHODS BASED ON HERMITE WEIGHTED ESSENTIALLY-NON-OSCILLATORY RECONSTRUCTION FOR VLASOV EQUATIONS

CONSERVATIVE AND NON-CONSERVATIVE METHODS BASED ON HERMITE WEIGHTED ESSENTIALLY-NON-OSCILLATORY RECONSTRUCTION FOR VLASOV EQUATIONS CONSERVATIVE AND NON-CONSERVATIVE METHODS BASED ON HERMITE WEIGHTED ESSENTIALLY-NON-OSCILLATORY RECONSTRUCTION FOR VLASOV EQUATIONS CHANG YANG AND FRANCIS FILBET Abstract. We develop weighted essentially

More information

WENO scheme with subcell resolution for computing nonconservative Euler. equations with applications to one-dimensional compressible two-medium flows

WENO scheme with subcell resolution for computing nonconservative Euler. equations with applications to one-dimensional compressible two-medium flows WENO scheme with subcell resolution for computing nonconservative Euler equations with applications to one-dimensional compressible two-medium flows Tao Xiong, Chi-Wang Shu and Mengping Zhang 3 Abstract

More information

Implementing third order compressible flow solver for hexahedral meshes in OpenFoam

Implementing third order compressible flow solver for hexahedral meshes in OpenFoam Tutorial/Report in OpenFoam Course 8 Implementing third order compressible flow solver for hexahedral meshes in OpenFoam Martin Olausson, Chalmers University of Technology, SE-1 9 Gothenburg, Sweden Abstract

More information

Computational Astrophysics 5 Higher-order and AMR schemes

Computational Astrophysics 5 Higher-order and AMR schemes Computational Astrophysics 5 Higher-order and AMR schemes Oscar Agertz Outline - The Godunov Method - Second-order scheme with MUSCL - Slope limiters and TVD schemes - Characteristics tracing and 2D slopes.

More information

An explicit and conservative remapping strategy for semi-lagrangian advection

An explicit and conservative remapping strategy for semi-lagrangian advection An explicit and conservative remapping strategy for semi-lagrangian advection Sebastian Reich Universität Potsdam, Potsdam, Germany January 17, 2007 Abstract A conservative semi-lagrangian advection scheme

More information

Extension of the spectral volume method to high-order boundary representation

Extension of the spectral volume method to high-order boundary representation Journal of Computational Physics 211 (2006) 154 178 www.elsevier.com/locate/jcp Extension of the spectral volume method to high-order boundary representation Z.J. Wang a, *, Yen Liu b,1 a Department of

More information

Solving Partial Differential Equations on Overlapping Grids

Solving Partial Differential Equations on Overlapping Grids **FULL TITLE** ASP Conference Series, Vol. **VOLUME**, **YEAR OF PUBLICATION** **NAMES OF EDITORS** Solving Partial Differential Equations on Overlapping Grids William D. Henshaw Centre for Applied Scientific

More information

Numerical and theoretical analysis of shock waves interaction and reflection

Numerical and theoretical analysis of shock waves interaction and reflection Fluid Structure Interaction and Moving Boundary Problems IV 299 Numerical and theoretical analysis of shock waves interaction and reflection K. Alhussan Space Research Institute, King Abdulaziz City for

More information

Application of ENO technique to semi-lagrangian interpolations. RC LACE stay report Scientific supervisors: Petra Smolíková and Ján Mašek

Application of ENO technique to semi-lagrangian interpolations. RC LACE stay report Scientific supervisors: Petra Smolíková and Ján Mašek Application of ENO technique to semi-lagrangian interpolations RC LACE stay report Scientific supervisors: Petra Smolíková and Ján Mašek Alexandra Crăciun NMA, Romania CHMI, Prague 09.05-03.06.2016 1 Introduction

More information

ANALYSIS AND IMPLEMENTATION OF A HIGH-ORDER RECONSTRUCTION ALGORITHM FOR AN UNSTRUCTURED FINITE VOLUME FLOW SOLVER. Shane Edmond Sawyer

ANALYSIS AND IMPLEMENTATION OF A HIGH-ORDER RECONSTRUCTION ALGORITHM FOR AN UNSTRUCTURED FINITE VOLUME FLOW SOLVER. Shane Edmond Sawyer ANALYSIS AND IMPLEMENTATION OF A HIGH-ORDER RECONSTRUCTION ALGORITHM FOR AN UNSTRUCTURED FINITE VOLUME FLOW SOLVER By Shane Edmond Sawyer Approved: Kidambi Sreenivas Research Professor of Computational

More information

Numerical Methods for PDEs. SSC Workgroup Meetings Juan J. Alonso October 8, SSC Working Group Meetings, JJA 1

Numerical Methods for PDEs. SSC Workgroup Meetings Juan J. Alonso October 8, SSC Working Group Meetings, JJA 1 Numerical Methods for PDEs SSC Workgroup Meetings Juan J. Alonso October 8, 2001 SSC Working Group Meetings, JJA 1 Overview These notes are meant to be an overview of the various memory access patterns

More information

A new 8-node quadrilateral spline finite element

A new 8-node quadrilateral spline finite element Journal of Computational and Applied Mathematics 195 (2006) 54 65 www.elsevier.com/locate/cam A new 8-node quadrilateral spline finite element Chong-Jun Li, Ren-Hong Wang Institute of Mathematical Sciences,

More information

High-Order Central ENO Finite-Volume Scheme with Adaptive Mesh Refinement

High-Order Central ENO Finite-Volume Scheme with Adaptive Mesh Refinement 18th AIAA Computational Fluid Dynamics Conference 25-28 June 2007, Miami, FL AIAA 2007-4323 High-Order Central ENO Finite-Volume Scheme with Adaptive Mesh Refinement L. Ivan and C.P.T. Groth University

More information

A Hybrid Cartesian Grid and Gridless Method for Compressible Flows

A Hybrid Cartesian Grid and Gridless Method for Compressible Flows rd AIAA Aerospace Sciences Meeting and Exhibit,, January 5, Reno, Nevada A Hybrid Cartesian Grid and Gridless Method for Compressible Flows Hong Luo and Joseph D. Baum Science Applications International

More information

Module 1: Introduction to Finite Difference Method and Fundamentals of CFD Lecture 13: The Lecture deals with:

Module 1: Introduction to Finite Difference Method and Fundamentals of CFD Lecture 13: The Lecture deals with: The Lecture deals with: Some more Suggestions for Improvement of Discretization Schemes Some Non-Trivial Problems with Discretized Equations file:///d /chitra/nptel_phase2/mechanical/cfd/lecture13/13_1.htm[6/20/2012

More information

A Jiang Tadmor Scheme on Unstructured Triangulations

A Jiang Tadmor Scheme on Unstructured Triangulations A Jiang Tadmor Scheme on Unstructured Triangulations Ivan Christov, Bojan Popov Department of Mathematics, Texas A&M University, College Station, TX 77843-3368, USA Abstract Nonoscillatory central schemes

More information

The Development of a Navier-Stokes Flow Solver with Preconditioning Method on Unstructured Grids

The Development of a Navier-Stokes Flow Solver with Preconditioning Method on Unstructured Grids Proceedings of the International MultiConference of Engineers and Computer Scientists 213 Vol II, IMECS 213, March 13-15, 213, Hong Kong The Development of a Navier-Stokes Flow Solver with Preconditioning

More information

Well-balanced schemes for the Euler equations with gravitation

Well-balanced schemes for the Euler equations with gravitation Well-balanced schemes for the Euler equations with gravitation Roger Käppeli Joint work with S. Mishra Outline Introduction Well-balanced scheme for HydroStatic Equilibrium (HSE) First order Second order

More information

Outline. Level Set Methods. For Inverse Obstacle Problems 4. Introduction. Introduction. Martin Burger

Outline. Level Set Methods. For Inverse Obstacle Problems 4. Introduction. Introduction. Martin Burger For Inverse Obstacle Problems Martin Burger Outline Introduction Optimal Geometries Inverse Obstacle Problems & Shape Optimization Sensitivity Analysis based on Gradient Flows Numerical Methods University

More information

The Level Set Method. Lecture Notes, MIT J / 2.097J / 6.339J Numerical Methods for Partial Differential Equations

The Level Set Method. Lecture Notes, MIT J / 2.097J / 6.339J Numerical Methods for Partial Differential Equations The Level Set Method Lecture Notes, MIT 16.920J / 2.097J / 6.339J Numerical Methods for Partial Differential Equations Per-Olof Persson persson@mit.edu March 7, 2005 1 Evolving Curves and Surfaces Evolving

More information