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

Size: px
Start display at page:

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

Transcription

1 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 used classes of finite volume weighted essentially non-oscillatory (WENO) schemes in two dimensional Cartesian meshes. We compare them in terms of accuracy, performance for smooth and shocked solutions, and efficiency in CPU timing. For linear systems both schemes are high order accurate, however for nonlinear systems, analysis and numerical simulation results verify that one of them (Class A) is only second order accurate, while the other (Class B) is high order accurate. The WENO scheme in Class A is easier to implement and costs less than that in Class B. Numerical experiments indicate that the resolution for shocked problems is often comparable for schemes in both classes for the same building blocks and meshes, despite of the difference in their formal order of accuracy. The results in this paper may give some guidance in the application of high order finite volume schemes for simulating shocked flows. Key Words: weighted essentially non-oscillatory (WENO) schemes; finite volume schemes; accuracy Dedicated to the memory of Professor David Gottlieb Department of Mathematics, University of Science and Technology of China, Hefei, Anhui 2326, P.R. China. rui@ustc.edu.cn. Research supported in part by NSFC grant 879. Department of Mathematics, University of Science and Technology of China, Hefei, Anhui 2326, P.R. China. mpzhang@ustc.edu.cn. Research supported in part by NSFC grant 679. Division of Applied Mathematics, Brown University, Providence, RI 292, USA. shu@dam.brown.edu. Research supported in part by ARO grant W9NF and NSF grant DMS-8986.

2 Introduction and the setup of the schemes In this paper we are interested in numerically solving two dimensional conservation law systems u t + f(u) x + g(u) y = () with suitable initial and boundary conditions, using the finite volume schemes on Cartesian meshes. For this purpose, the computational domain is decomposed to rectangular cells Ω ij = [x i /2, x i+/2 ] [y j /2, y j+/2 ], and for simplicity we assume the mesh sizes x = x i+/2 x i /2 and y = y j+/2 y j /2 are constants. This assumption is not essential: finite volume schemes in this paper can be defined on arbitrary Cartesian meshes, even those with abrupt changes in mesh sizes, without affecting their conservation, accuracy and stability. In a finite volume scheme we seek approximations to the cell averages ũ i,j = x y yj+/2 xi+/2 y j /2 x i /2 u(x, y)dxdy. (2) We use the notation ū to denote the cell averaging operation in the x-direction (integral in the cell [x i /2, x i+/2 ] divided by the cell size x), and ũ to denote the cell averaging operation in the y-direction. The two dimensional cell average ũ can be obtained by successively performing the cell averaging operators in x and in y. If we integrate the conservation law () over the cell Ω ij and then divide by its area, we obtain d ũ i,j dt where ũ i,j is the cell average (2) and + x ( f i+/2,j f i /2,j ) + y (ḡ i,j+/2 ḡ i,j /2 ) = (3) f i+/2,j = y yj+/2 y j /2 f(u(x i+/2, y))dy (4) ḡ i,j+/2 = xi+/2 g(u(x, y j+/2 ))dx (5) x x i /2 are the physical fluxes, which are cell averages of f(u) in y at x = x i+/2 and of g(u) in x at y = y j+/2 respectively. Although (3) looks like a scheme, we should emphasize that it is actually an equality satisfied by the exact solution of the PDE (). Notice that the equality (3) describes the evolution of the cell averages ũ i,j while requiring the information of point values of the solution u in evaluating the physical fluxes in (4) and (5). In order to convert the equality (3) to a scheme (commonly referred to as a finite volume scheme, since it solves for the cell averages ũ i,j rather than point values of the solution) in the following form d ũ i,j dt + x ( ˆf i+/2,j ˆf i /2,j ) + y (ĝ i,j+/2 ĝ i,j /2 ) =, (6) 2

3 we must use a reconstruction procedure to obtain numerical fluxes ˆf i+/2,j and ĝ i,j+/2 in (6) as accurate approximations to the physical fluxes f i+/2,j and ḡ i,j+/2 in (4) and (5). We consider two classes of finite volume schemes in this paper. Both of them depend crucially on the following one-dimensional reconstruction procedure. One-dimensional reconstruction procedure: Given the cell averages ū i = x xi+/2 x i /2 u(x)dx of a piecewise smooth function u(x), the procedure uses these cell averages in several neighboring cells ū i l,, ū i+k (the collection of these neighboring cells is referred to as the stencil of the reconstruction) to obtain an approximation to the point value u(x i+/2 ) at the cell interface or at another point u(x ) where x is in the cell [x i /2, x i+/2 ]. We require the reconstruction to be high order accurate when u(x) is smooth in the stencil, and to be essentially non-oscillatory near discontinuities. Such reconstruction procedure has been extensively studied in the literature, among high order ones we mention the essentially non-oscillatory (ENO) reconstruction [2] and the weighted ENO (WENO) reconstruction [4, 3]. In the appendix we list the fifth order WENO reconstruction procedure [3] that we use in this paper. More details about WENO reconstruction can be found in, e.g. [7, 8, 5]. For a given physical flux f(u), based on monotonicity in the scalar case and on characteristic information and Riemann solvers in the system case, we can define a numerical flux ˆf(u, u + ) where u and u + approximate the left and right limits of the function u respectively. The numerical flux ˆf(u, u + ) is at least Lipschitz continuous for both arguments, and is consistent with the physical flux in the sense that ˆf(u, u) = f(u). Examples of numerical fluxes for systems of conservation laws in fluid dynamics can be found in, e.g. [, 6]. In this paper we use the Lax-Friedrichs flux and the HLLC flux as representative examples. In the construction of finite volume schemes we often need to use a q-point Gaussian quadrature to approximate line integrals such as those (4) and (5): q q f i+/2,j ω k f(u(x i+/2, yj k )), ḡ i,j+/2 ω k g(u(x k i, y j+/2)) (7) k= where ω k are the Gaussian quadrature weights, and yj k and x k i are the Gaussian quadrature points. In this paper we consider only schemes up to fifth order accuracy, hence q = 3 suffices. We are now ready to define the two classes of finite volume schemes that we will study in this paper. The first class (Class A) of these methods has the following algorithm flowchart: Finite volume scheme, Class A: 3 k=

4 . Using the two dimensional cell averages ũ i,j, perform a one-dimensional reconstruction procedure in y to obtain a high order accurate approximation to the cell average of u in x at y = y j+/2, denoted by ū i,j+/2. For the purpose of upwinding and stability, typically two different approximations, denoted by ū i,j+/2 and ū + i,j+/2, based on stencils biased to the left and to the right respectively, are obtained. 2. Using the two dimensional cell averages ũ i,j, perform a one-dimensional reconstruction procedure in x to obtain a high order accurate approximation to the cell average of u in y at x = x i+/2, denoted by ũ i+/2,j. Again, two different approximations, denoted by ũ i+/2,j and ũ+ i+/2,j, based on stencils biased to the left and to the right respectively, are obtained. 3. Form the numerical fluxes simply as ˆf i+/2,j = ˆf(ũ i+/2,j, ũ+ i+/2,j ), ĝ i,j+/2 = ĝ(ū i,j+/2, ū+ i,j+/2 ). (8) 4. Obtain the finite volume scheme (6), then discretize it in time by the TVD Runge-Kutta time discretization [9]. We use the third order version in the numerical tests performed in this paper. This finite volume scheme is very simple and efficient, and hence is widely used in applications. However, this scheme is only second order accurate for general nonlinear systems (systems in which the physical fluxes f(u) and g(u) are nonlinear functions of u), regardless of the order of accuracy in the one-dimensional reconstruction procedure used in Steps and 2 above. The problem arises in the choice of the numerical fluxes in Step 3 above. We will give a proof of this fact in the Appendix. Numerical experiments in next section clearly demonstrate this second order accuracy. There is however an important exception. If the system is linear (that is, the physical fluxes f(u) = Au and g(u) = Bu where A and B are constant matrices), such as the linear Maxwell equations and linearized Euler equations, the same high order accuracy as in the one-dimensional reconstruction is achieved, see the Appendix for a proof and next section for numerical verification. The second class (Class B) of the finite volume methods that we will study in this paper has the following algorithm flowchart: Finite volume scheme, Class B:. Using the two dimensional cell averages ũ i,j, perform a one-dimensional reconstruction procedure in y to obtain a high order accurate approximation to the cell average of u in x at y = y j+/2, denoted by ū i,j+/2. For the purpose of upwinding and stability, typically two different approximations, denoted by ū i,j+/2 and ū+ i,j+/2, based on stencils biased to the left and to the right respectively, are obtained. This step is the same as the first step for the finite volume scheme in Class A. 4

5 2. Using the one dimensional cell averages ū ± i,j+/2, perform a one-dimensional reconstruction procedure in x to obtain a high order accurate approximation to the point values of u at the Gaussian quadrature points x k i, denoted by u ± i k,j+/2. 3. Using the two dimensional cell averages ũ i,j, perform a one-dimensional reconstruction procedure in x to obtain a high order accurate approximation to the cell average of u in y at x = x i+/2, denoted by ũ i+/2,j. Again, two different approximations, denoted by ũ i+/2,j and ũ+ i+/2,j, based on stencils biased to the left and to the right respectively, are obtained. This step is the same as the second step for the finite volume scheme in Class A. 4. Using the one dimensional cell averages ũ ± i+/2,j, perform a one-dimensional reconstruction procedure in y to obtain a high order accurate approximation to the point values of u at the Gaussian quadrature points yj k, denoted by u ± i+/2,j k. 5. Form the numerical fluxes using the Gaussian quadrature (7): ˆf i+/2,j = q k= ω k ˆf(u i+/2,j k, u + i+/2,j k ), ĝ i,j+/2 = q ω k ĝ(u i k,j+/2, u+ i k,j+/2 ). k= (9) 6. Obtain the finite volume scheme (6), then discretize it in time by the TVD Runge-Kutta time discretization [9]. Comparing with the finite volume scheme in Class A, we can observe that the finite volume scheme in Class B is more complicated and more costly, because of the additional reconstructions in Steps 2 and 4 and the Gaussian quadrature sums in Step 5. However, this scheme is genuinely high order accurate for nonlinear systems. We will give a proof of this fact in the Appendix. Numerical experiments in next section clearly demonstrate the high order accuracy. 2 Numerical experiments We use the two dimensional Euler equations for compressible gas dynamics, namely () with ρ ρv ρw u = ρv ρw, f(u) = ρv 2 + p ρvw, g(u) = ρvw ρw 2 + p, E v(e + p) w(e + p) where ρ is the density, (v, w) is the velocity, E is the total energy, E = + γ 2 ρ(v2 + w 2 ) where p is the pressure, with γ =.4 in our computation. The two classes p 5

6 of finite volume WENO schemes considered in the previous section are compared for accuracy (both linear and nonlinear cases), resolution for shocked solutions, and CPU costs. Time discretization is by the third order TVD Runge-Kutta method [9], with a suitably reduced time step for the accuracy tests so that spatial errors dominate. Example. The initial condition is set to be ρ(x, y, ) = +.5 sin(π(x + y)) v(x, y, ) = w(x, y, ) = p(x, y, ) =. with periodic boundary conditions. The exact solution is ρ(x, y, ) = +.5 sin(π(x + y 2t)) v(x, y, ) = w(x, y, ) = p(x, y, ) =. () () It is easy to check that, in this special case, the Euler equations actually become a linear system. The computational domain is taken as [, ] [, ] with periodic boundary conditions. We use uniform meshes and denote x = y = h, and give the results with both the Lax-Friedrichs and the HLLC fluxes at time t = 2. in Tables and 2. Clearly, for this linear system case both classes of the finite volume schemes are fifth order accurate. Table : Example. L errors and orders of accuracy for density. Class A finite volume scheme. Lax-Friedrichs Flux HLLC Flux h CFL Error Order Error Order 2/ E E-4 2/ E E / E E / E E / E E- 5.3 This example is often used in the literature to test accuracy of schemes. As we can see here, this is not a stringent test case. The Class A finite volume scheme, which is only second order accurate for general nonlinear problems, easily passes this test as a fifth order scheme. The CPU time used for both classes of the finite volume WENO schemes is listed in Table 3. Here and below the CPU time is measured on a.5ghz Itanium 2 Madison 6

7 Table 2: Example. L errors and orders of accuracy for density. Class B finite volume scheme. Lax-Friedrichs Flux HLLC Flux h CFL Error Order Error Order 2/2.9.87E E-4 2/ E E /8.6.94E E / E E / E E bit CPU. We can see that the Class B finite volume WENO scheme uses about 3 to 4 times more CPU time than the Class A scheme on the same mesh. This is consistent with operation counts of these two classes of schemes. Table 3: Example. CPU time (in seconds) for both classes of finite volume schemes. Lax-Friedrichs Flux HLLC Flux h Class A Class B Ratio Class A Class B Ratio 2/ / / / / Example 2 (2D vortex evolution). This example [7] is a nonlinear example, for which we can observe different orders of accuracy for the two classes of finite volume WENO schemes. The setup of the problem is as following. The mean flow is ρ =, p =, (v, w) = (, ), and the computational domain is [, ] [, ]. We add, to the mean flow, an isentropic vortex, which corresponds to perturbations in (v, w) and the temperature T = p ρ and no perturbation in the entropy S = p ρ γ : (δv, δw) = ε (γ )ε2 2π e.5( r2) ( ȳ, x), δt = e r2, δs =, 8γπ 2 where ( x, ȳ) = (x 5, y 5), r 2 = x 2 + ȳ 2, and the vortex strength ε = 5. Periodic boundary condition is used, which has little effect on the solution since the vortex is close to zero at the initial boundary. It is clear that the exact solution is just the passive convection of the vortex with the mean velocity. The errors at time t =.2 calculated by the two classes of finite volume WENO schemes are listed in Tables 4 and 5, respectively. We can observe clearly that the accuracy for the Class A finite 7

8 Table 4: Example 2. L errors and orders of accuracy for density. Class A finite volume scheme. Lax-Friedrichs Flux HLLC Flux h CFL Error Order Error Order / E E-5 / E E / E E / E E / E E-8 2. Table 5: Example 2. L errors and orders of accuracy for density. Class B finite volume scheme. Lax-Friedrichs Flux HLLC Flux h CFL Error Order Error Order / E E-5 / E E / E E / E E /64..3E E- 5.8 volume scheme is only second order, while the accuracy for the Class B scheme is fifth order. Example 3. We add suitable source terms to the right-hand side of the Euler equations such that the following smooth functions are exact solutions of the resulting nonlinear PDE system ρ(x, y, t) = +.5 sin(π(x + y 3t)) v(x, y, t) = cos(π(x + 2y + 2t)) w(x, y, t) =.5 sin(π(2x + y 3t)) p(x, y, t) = +.5 sin(π(x y + 4t)). The computational domain is [, ] [, ] and periodic boundary condition is applied. The error at time t =. calculated by the two classes of finite volume WENO schemes are listed in Tables 6 and 7, respectively. We observe once more that the accuracy for the Class A finite volume scheme is only second order, while the accuracy for the Class B scheme is fifth order. In Figure, we plot the relationship between the L error and CPU time for both classes of finite volume schemes in this example. Even though the Class B finite volume WENO scheme uses about 3 to 4 times more CPU time than the Class A scheme on the same mesh, to reach a given error tolerance below 2. 3, the Class B scheme uses less CPU time. This is consistent with the general conclusions 8

9 Table 6: Example 3. L errors and orders of accuracy for density. Class A finite volume scheme. Lax-Friedrichs Flux HLLC Flux h CFL Error Order Error Order 2/ E-2 3.6E-2 2/ E E /8.5.2E E / E E / E E-5.98 Table 7: Example 3. L errors and orders of accuracy for density. Class B finite volume scheme. Lax-Friedrichs Flux HLLC Flux h CFL Error Order Error Order 2/ E E-2 2/ E E / E E /6.3.43E E / E E about high order schemes: they are more economical when high precision simulation is required. Example 4 (Oblique Lax shock tube). The purpose of this test is to assess the capability of the two classes of WENO schemes in resolving waves that are oblique to the computational mesh. The two dimensional Lax problem is solved where the initial jump makes an angle θ against x-axis ( < θ π/2). If θ = π/2, we have the one-dimensional Lax problem. If < θ < π/2, all the waves produced will be oblique to the rectangular computational mesh. We take our computational domain to be [ 7, 7] [ 7, 7], and θ = π/4. The initial jump starts at (x, y) = ( 7, 7). That is, initially we have { (45,.698 cos( π (ρ, v, w, p) = ),.698 sin( π ), 3.528), if x < y 4 4 (.5,,,.57), otherwise (2) The solution is computed up to t =.3 for the mesh size x = y = /3. We show in Figure 2 the densities at y =. The solid lines are the exact solution. We can observe that both classes of the finite volume WENO scheme give visually similar results on the same meshes, despite of their different formal order of accuracy. Example 5 (A Mach 3 wind tunnel with a step). This model problem has been carefully examined in Woodward and Colella [] and later by many others. The 9

10 . Class A WENO Class B WENO. Class A WENO Class B WENO.... Error. Error. e-5 e-5 e-6 e-6 e-7. CPU time(seconds) e-7. CPU time(seconds) Figure : Example 3. L error versus CPU time for both classes of WENO schemes. Left: Lax-Friedrichs flux; Right: HLLC flux. setup of the problem is the following. The wind tunnel is length unit wide and 3 length units long. The step is.2 length unit high and is located.6 length units from the left-hand end of the tunnel. The problem is initialized by a right going Mach 3 flow. Reflective boundary conditions are applied along the walls of the tunnel and in-flow and out-flow boundary conditions are applied at the entrance (left-hand end) and the exit (right-hand end). For the treatment of the singularity at the corner of the step, we adopt the same technique used in [], which is based on the assumption of a nearly steady flow in the region near the corner. The numerical results are shown in Figure 3, for the mesh sizes x = y = 6 and. We can observe that both 32 classes of the finite volume WENO scheme give visually similar results on the same meshes, despite of their different formal order of accuracy. Example 6 (Double Mach reflection of a strong shock). The computational domain for this problem is chosen to be [, 4] [, ]. The reflecting wall lies at the bottom of the computational domain starting from x = /6. Initially a right-moving Mach shock is positioned at x = /6, y =, and makes a 6 angle with the x-axis. For the bottom boundary, the exact postshock condition is imposed for the part from x = to x = /6 and a reflective boundary condition is used for the rest. At the top boundary of our computational domain, the flow values are set to describe the exact motion of the Mach shock. See [] for a detailed description of the problem. We give the results of both classes of the finite volume WENO schemes in Figure 4 with x = y = /48. The results with x = y = /96 are given in Figure 5. Again, we can observe that both classes of the finite volume WENO scheme give comparable resolutions on the same meshes, despite of their different formal order of accuracy.

11 Figure 2: Oblique Lax shock tube. Density at y =. x = y = /3. Left: Class A WENO; Right: Class B WENO. 3 Concluding remarks Two classes of finite volume WENO schemes are discussed and tested in this paper. We observe numerically and prove theoretically that they are both high order accurate for linear systems, however the Class A schemes are only second order accurate for nonlinear systems, while the Class B schemes are still high order accurate. The operation count and CPU timing for the Class B schemes are about 3 to 4 times of those for the Class A schemes on the same mesh. However, for high precision simulation of smooth flows, Class B schemes could take less CPU time to reach the same error threshold than Class A schemes. For problems with shocks, at least for the test problems that we have experimented in this paper, the two classes of finite volume schemes give comparable resolution on the same meshes, despite of their difference in formal order of accuracy. Results in this paper might shed some light on the popularity of Class A schemes in applications. A Appendix In this appendix we describe briefly the fifth order WENO reconstruction procedure, and prove the orders of accuracy for the two classes of WENO schemes studied in this paper.

12 (a) x = y =, Class A WENO (b) x = y =, Class B WENO (c) x = y =, Class A WENO (d) x = y =, Class B WENO 32 Figure 3: Flow past a forward facing step. 3 contours from. to 6.6, Lax-Friedrichs flux. 2

13 (a) Class A WENO (b) Class B WENO (c) Blow-up regions near the Mach stem for details. Left: Class A WENO; Right: Class B WENO Figure 4: Result for the double Mach reflection. x = y =, Class A WENO 48 (a) and Class B WENO (b), HLLC flux. 3

14 (a) Class A WENO (b) Class B WENO (c) Blow-up regions near the Mach stem for details. Left: Class A WENO; Right: Class B WENO Figure 5: Result for the double Mach reflection. x = y = (a) and Class B WENO (b), HLLC flux. 4, Class A WENO 96

15 A. Fifth order WENO reconstruction We use the fifth-order WENO reconstruction procedure, described in [3]. Lower or higher order reconstructions are also possible, see for example those in [4, ]. For a piecewise smooth function v(x), we denote v i as its cell average. The fifthorder accurate reconstruction with a left-biased stencil is defined as v j+/2 = ω v + ω v + ω 2 v 2 (3) where v k are the reconstructed values obtained from cell averages in the k-th stencil S k = (j k, j k +, j k + 2): v = 6 ( v i v i+ + 2 v i ), v = 6 (2 v i+ + 5 v i v i ), (4) v 2 = 6 ( v i 7 v i + 2 v i 2 ) and ω k, k =, 2, 3 are the nonlinear WENO weights given by ω k = α k 3 l= α, α = l.3 (ε + IS ) 2, α =.6 (ε + IS ) 2, α 2 =. (ε + IS 2 ) 2. (5) Here ε is a small parameter which we take as ε = 6 in our numerical tests. The smoothness indicators IS k are given by [3] IS = 3 2 ( v i 2 v i+ + v i+2 ) (3 v i 4 v i+ + v i+2 ) 2, IS = 3 2 ( v i 2 v i + v i+ ) ( v i + v i+ ) 2, IS 2 = 3 2 ( v i 2 2 v i + v i ) (3 v i 2 4 v i + 3 v i ) 2. (6) The right-biased reconstruction v + i+/2 is obtained by symmetry with respect to the location i+/2. Reconstructions to values v(x ) for x inside the interval [x i /2, x i+/2 ] can be obtained along the same lines, in fact only the formulas for the reconstructed values obtained from the small stencils in (4) and the linear weights (.3,.6 and.) in (5) would change. We refer to, e.g. [5] for more details. For the systems of conservation laws, a local characteristic decomposition is used in the reconstruction. We refer to [3, 7] for more details. A.2 Accuracy for the two classes of finite volume WENO schemes Theorem A.. The Class B finite volume WENO scheme is accurate to the order of accuracy of the reconstruction and quadrature rules. 5

16 Proof: We take as an example the case of a fifth order reconstruction and three point quadrature rules used in this paper. The proof for the general case is the same. The values u ± i+/2,j k at the Gaussian points in (9) are reconstructed by the fifth-order WENO procedure, which yields u ± i+/2,j k = u(x i+/2, y k j ) + O( x5 + y 5 ) (7) where u(x, y) is the exact solution of the PDE (we have suppressed the t variable for simplicity, as we are considering truncation errors in space only). Since the numerical flux ˆf is Lipschitz continuous, we have ˆf(u i+/2,j k, u + i+/2,j k ) f(u(x i+/2, y k j )) = ˆf(u i+/2,j k, u + i+/2,j k ) ˆf(u(x i+/2, y k j ), u(x i+/2, y k j )) ˆf(u i+/2,j k, u + i+/2,j k ) ˆf(u i+/2,j k, u(x i+/2, y k j )) + ˆf(u i+/2,j k, u(x i+/2, y k j )) ˆf(u(x i+/2, y k j ), u(x i+/2, y k j )) L( u + i+/2,j k u(x i+/2, y k j ) + u i+/2,j k u(x i+/2, y k j ) ) = O( x 5 + y 5 ). (8) The error for the 3-point Gaussian integration in (7) is f i+/2,j = 3 ω k f(u(x i+/2, yj k )) + O( y6 ). (9) k= So we can get the error of the flux ˆf i+/2,j in (9) as f i+/2,j = ˆf i+/2,j + O( x 5 + y 5 ) (2) Assuming the leading term in the error O( x 5 + y 5 ) in (2) is smooth, we have x ( f i+/2,j f i /2,j ) x ( ˆf i+/2,j ˆf i /2,j ) = O( x 5 + y 5 ). (2) Similarly, we have y (ḡ i,j+/2 ḡ i,j /2 ) y (ĝ i,j+/2 ĝ i,j /2 ) = O( x 5 + y 5 ). (22) We can see from (2) and (22) that the local truncation error for the Class B WENO scheme is fifth order. Theorem A.2. The Class A finite volume WENO scheme is second order accurate for general nonlinear conservation laws, but it is accurate to the order of the reconstruction and quadrature rules for linear conservation laws with constant coefficients. 6

17 Proof: The values ũ ± i+/2,j in (8) are reconstructed by the fifth order WENO procedure, hence we have ũ ± i+/2,j = ũ i+/2,j + O( x 5 ). (23) By the Lipschitz continuity of the numerical flux ˆf, we have ˆf i+/2,j f(ũ i+/2,j ) = ˆf(ũ i+/2,j, ũ+ i+/2,j ) ˆf(ũ i+/2,j, ũ i+/2,j ) ˆf(ũ i+/2,j, ũ+ i+/2,j ) ˆf(ũ i+/2,j, ũ i+/2,j) + ˆf(ũ i+/2,j, ũ i+/2,j) ˆf(ũ i+/2,j, ũ i+/2,j ) L( ũ i+/2,j ũ i+/2,j + ũ + i+/2,j ũ i+/2,j ) = O( x 5 ). (24) That is ˆf i+/2,j = f(ũ i+/2,j ) + O( x 5 ). (25) Therefore we have ˆf i+/2,j ˆf i /2,j x = f(ũ i+/2,j) f(ũ i /2,j ) x + O( x 5 ). (26) Notice that the cell average of a function agrees with its value at the center of the cell to second order: ũ i+/2,j = u(x i+/2, y j ) + O( y 2 ), (27) and the combination of which gives f i+/2,j = f(u(x i+/2, y j )) + O( y 2 ), (28) f(ũ i+/2,j ) = f(u(x i+/2, y j ) + O( y 2 )) = f(u(x i+/2, y j )) + O( y 2 ). (29) We now have f i+/2,j = f(ũ i+/2,j ) + O( y 2 ), (3) which is the crucial source of second order error regardless of the order of reconstruction. We have, therefore, x ( f i+/2,j f i /2,j ) x ( ˆf i+/2,j ˆf i /2,j ) = x ( f i+/2,j f i /2,j ) x (f(ũ i+/2,j) f(ũ i /2,j )) + O( x 5 ) = x ( f i+/2,j f(ũ i+/2,j )) x ( f i /2,j f(ũ i /2,j )) + O( x 5 ) = O( x 5 ) + O( y 2 ) (3) where ˆf i+/2,j is defined with (8). 7

18 Similarly, y (ḡ i,j+/2 ḡ i,j /2 ) y (ĝ i,j+/2 ĝ i,j /2 ) = O( x 2 ) + O( y 5 ). (32) From (3) and (32) we can see that the scheme is only second order accurate. Now, if f(u) = Au is linear, then ( yj+/2 ) yj+/2 f(u(x i+/2, y))dy = f u(x i+/2, y)dy, (33) y j /2 that is, instead of (3) we now have y j /2 f i+/2,j = f(ũ i+/2,j ), (34) thereby avoiding the crucial second order error. From (3) we can then get x ( f i+/2,j f i /2,j ) x ( ˆf i+/2,j ˆf i /2,j ) = O( x 5 ) (35) which leads to fifth order in the local truncation error for this linear case. References [] D.S. Balsara and C.-W. Shu, Monotonicity preserving weighted essentially nonoscillatory schemes with increasingly high order of accuracy, Journal of Computational Physics, 6 (2), [2] A. Harten, B. Engquist, S. Osher and S. Chakravarthy, Uniformly high order essentially non-oscillatory schemes, III, Journal of Computational Physics, 7 (987), [3] G.-S. Jiang and C.-W. Shu, Efficient implementation of weighted ENO schemes, Journal of Computational Physics, 26 (996), pp [4] X.-D. Liu, S. Osher and T. Chan, Weighted essentially non-oscillatory schemes, Journal of Computational Physics, 5 (994), [5] Y.-Y. Liu, C.-W. Shu and M. Zhang, On the positivity of linear weights in WENO approximations, Acta Mathematicae Applicatae Sinica, 25 (29), [6] J. Qiu, B.C. Khoo and C.-W. Shu, A numerical study for the performance of the Runge-Kutta discontinuous Galerkin method based on different numerical fluxes, Journal of Computational Physics, 22 (26),

19 [7] 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: A. Quarteroni), Lecture Notes in Mathematics, volume 697, Springer, Berlin, 998, [8] C.-W. Shu, High order weighted essentially non-oscillatory schemes for convection dominated problems, SIAM Review, 5 (29), [9] C.-W. Shu and S. Osher, Efficient implementation of essentially non-oscillatory shock-capturing schemes, Journal of Computational Physics, 77 (988), [] E.F. Toro, Riemann Solvers and Numerical Methods for Fluid Dynamics, a Practical Introduction, Springer, Berlin, 997. [] P. Woodward and P. Colella, The numerical simulation of two-dimensional fluid flow with strong shocks, Journal of Computational Physics, 54 (984),

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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

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 third order conservative Lagrangian type scheme on curvilinear meshes for the compressible Euler equations

A third order conservative Lagrangian type scheme on curvilinear meshes for the compressible Euler equations 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)

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

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

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

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

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

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

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

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

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

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

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

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

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

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

Semi-Conservative Schemes for Conservation Laws

Semi-Conservative Schemes for Conservation Laws Semi-Conservative Schemes for Conservation Laws Rosa Maria Pidatella 1 Gabriella Puppo, 2 Giovanni Russo, 1 Pietro Santagati 1 1 Università degli Studi di Catania, Catania, Italy 2 Università dell Insubria,

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

Defense Technical Information Center Compilation Part Notice

Defense Technical Information Center Compilation Part Notice UNCLASSIFIED Defense Technical Information Center Compilation Part Notice ADP013629 TITLE: Recent Development and Applications of WENO Schemes DISTRIBUTION: Approved for public release, distribution unlimited

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

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

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

Nonoscillatory Central Schemes on Unstructured Triangular Grids for Hyperbolic Systems of Conservation Laws

Nonoscillatory Central Schemes on Unstructured Triangular Grids for Hyperbolic Systems of Conservation Laws Nonoscillatory Central Schemes on Unstructured Triangular Grids for Hyperbolic Systems of Conservation Laws Ivan Christov 1,* Bojan Popov 1 Peter Popov 2 1 Department of Mathematics, 2 Institute for Scientific

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

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

Accurate Monotonicity-Preserving Schemes with Runge Kutta Time Stepping

Accurate Monotonicity-Preserving Schemes with Runge Kutta Time Stepping JOURNAL OF COMPUTATIONAL PHYSICS 136, 83 99 (1997) ARTICLE NO. CP975745 Accurate Monotonicity-Preserving Schemes with Runge Kutta Time Stepping A. Suresh*, and H. T. Huynh *NYMA, Inc., Brook Park, Ohio

More information

A Semi-Lagrangian Discontinuous Galerkin (SLDG) Conservative Transport Scheme on the Cubed-Sphere

A Semi-Lagrangian Discontinuous Galerkin (SLDG) Conservative Transport Scheme on the Cubed-Sphere A Semi-Lagrangian Discontinuous Galerkin (SLDG) Conservative Transport Scheme on the Cubed-Sphere Ram Nair Computational and Information Systems Laboratory (CISL) National Center for Atmospheric Research

More information

High order WENO and DG methods for time-dependent convection-dominated. PDEs: a brief survey of several recent developments 1.

High order WENO and DG methods for time-dependent convection-dominated. PDEs: a brief survey of several recent developments 1. High order WENO and DG methods for time-dependent convection-dominated PDEs: a brief survey of several recent developments 1 Chi-Wang Shu Division of Applied Mathematics Brown University Providence, RI

More information

High Order Finite Difference and Finite Volume WENO Schemes and Discontinuous Galerkin Methods for CFD

High Order Finite Difference and Finite Volume WENO Schemes and Discontinuous Galerkin Methods for CFD NASA/CR-200-20865 ICASE Report No. 200- High Order Finite Difference and Finite Volume WENO Schemes and Discontinuous Galerkin Methods for CFD Chi-Wang Shu Brown University, Providence, Rhode Island ICASE

More information

ICASE $-I!1'!l~il '1] NASA Contractor Report , - I r" ICASE Report No AD-A

ICASE $-I!1'!l~il '1] NASA Contractor Report , - I r ICASE Report No AD-A NASA Contractor Report 187542 -, - I r" ICASE Report No. 91-32 AD-A236 842 ICASE THE P L- RKDG METHOD FOR TWO-DIMENSIONAL EULER EQUATIONS OF GAS DYNAMICS Bernardo Cockburn Chi-Wang Shu Contract No. NAS1-18605

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

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

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

Central Runge-Kutta Schemes for Conservation Laws

Central Runge-Kutta Schemes for Conservation Laws Central Runge-Kutta Schemes for Conservation Laws Lorenzo Pareschi Gabriella Puppo Giovanni Russo Abstract In this work, a new formulation for central schemes based on staggered grids is proposed. It is

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

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

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

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

A robust WENO type finite volume solver for steady Euler equations on unstructured grids

A robust WENO type finite volume solver for steady Euler equations on unstructured grids A robust WENO type finite volume solver for steady Euler equations on unstructured grids Guanghui Hu,, Ruo Li 2, Tao Tang Department of Mathematics, Hong Kong Baptist University, Kowloon Tong, Hong Kong.

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

Partial Differential Equations

Partial Differential Equations Simulation in Computer Graphics Partial Differential Equations Matthias Teschner Computer Science Department University of Freiburg Motivation various dynamic effects and physical processes are described

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

Efficient implementation of WENO Scheme on structured meshes

Efficient implementation of WENO Scheme on structured meshes Efficient implementation of WENO Scheme on structured meshes o Xinrong Su, Dept. Aero. Enging, Tohoku Univ, Sendai, E-mail: su@ad.mech.tohoku.ac.jp Daisuke Sasaki, Dept. Aero. Enging, Tohoku Univ, Sendai,

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

Computing Nearly Singular Solutions Using Pseudo-Spectral Methods

Computing Nearly Singular Solutions Using Pseudo-Spectral Methods Computing Nearly Singular Solutions Using Pseudo-Spectral Methods Thomas Y. Hou Ruo Li January 9, 2007 Abstract In this paper, we investigate the performance of pseudo-spectral methods in computing nearly

More information

Computing & Verifying Compressible Fluid Dynamics:! The Good, The Bad and The Ugly!

Computing & Verifying Compressible Fluid Dynamics:! The Good, The Bad and The Ugly! : LA- UR 11-05852 Computing & Verifying Compressible Fluid Dynamics:! The Good, The Bad and The Ugly! Tariq Aslam! Los Alamos National Laboratory! WX-9: Shock and Detonation Physics! Slide 1 Background:!

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

Verification of Moving Mesh Discretizations

Verification of Moving Mesh Discretizations Verification of Moving Mesh Discretizations Krzysztof J. Fidkowski High Order CFD Workshop Kissimmee, Florida January 6, 2018 How can we verify moving mesh results? Goal: Demonstrate accuracy of flow solutions

More information

A Bi Hyperbolic Finite Volume Method on Quadrilateral Meshes

A Bi Hyperbolic Finite Volume Method on Quadrilateral Meshes A Bi Hyperbolic Finite Volume Method on Quadrilateral Meshes H. Joachim Schroll and Fredrik Svensson July 6, 24 preprint Lund University 24 Abstract A non oscillatory, high resolution reconstruction method

More information

An Introduction to Viscosity Solutions: theory, numerics and applications

An Introduction to Viscosity Solutions: theory, numerics and applications An Introduction to Viscosity Solutions: theory, numerics and applications M. Falcone Dipartimento di Matematica OPTPDE-BCAM Summer School Challenges in Applied Control and Optimal Design July 4-8, 2011,

More information

weighted minimal surface model for surface reconstruction from scattered points, curves, and/or pieces of surfaces.

weighted minimal surface model for surface reconstruction from scattered points, curves, and/or pieces of surfaces. weighted minimal surface model for surface reconstruction from scattered points, curves, and/or pieces of surfaces. joint work with (S. Osher, R. Fedkiw and M. Kang) Desired properties for surface reconstruction:

More information

AN ADAPTIVE MESH REDISTRIBUTION ALGORITHM FOR CONVECTION-DOMINATED PROBLEMS. Zheng-Ru Zhang and Tao Tang

AN ADAPTIVE MESH REDISTRIBUTION ALGORITHM FOR CONVECTION-DOMINATED PROBLEMS. Zheng-Ru Zhang and Tao Tang COMMUNICATIONS ON Website: http://aimsciences.org PURE AND APPLIED ANALYSIS Volume, Number 3, september pp. 34 357 AN ADAPTIVE MESH REDISTRIBUTION ALGORITHM FOR CONVECTION-DOMINATED PROBLEMS Zheng-Ru Zhang

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

Numerical Methods for (Time-Dependent) HJ PDEs

Numerical Methods for (Time-Dependent) HJ PDEs Numerical Methods for (Time-Dependent) HJ PDEs Ian Mitchell Department of Computer Science The University of British Columbia research supported by National Science and Engineering Research Council of

More information

1. Introduction. We consider Cauchy problems for Hamilton Jacobi (HJ) equations

1. Introduction. We consider Cauchy problems for Hamilton Jacobi (HJ) equations SIAM J. SCI. COMPUT. Vol. 8, No. 6, pp. 9 47 c 6 Society for Industrial and Applied Mathematics CENTRAL WENO SCHEMES FOR HAMILTON JACOBI EQUATIONS ON TRIANGULAR MESHES DORON LEV, SUHAS NAAK, CHI-WANG SHU,

More information

A limiting strategy for the back and forth error compensation and correction method for solving advection equations

A limiting strategy for the back and forth error compensation and correction method for solving advection equations A limiting strategy for the back and forth error compensation and correction method for solving advection equations Lili Hu, Yao Li, Yingjie Liu April 22, 2014 Abstract We further study the properties

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

High order fast sweeping methods for static Hamilton-Jacobi equations

High order fast sweeping methods for static Hamilton-Jacobi equations High order fast sweeping methods for static Hamilton-Jacobi equations Yong-Tao Zhang, Hong-Kai Zhao and Jianliang Qian 3 ABSTRACT We construct high order fast sweeping numerical methods for computing viscosity

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

Downloaded 10/27/17 to Redistribution subject to SIAM license or copyright; see

Downloaded 10/27/17 to Redistribution subject to SIAM license or copyright; see SIAM J. SCI. COMPUT. Vol. 37, No. 3, pp. C354 C383 c 2015 Society for Industrial and Applied Mathematics EFFICIENT IMPLEMENTATION OF NONLINEAR COMPACT SCHEMES ON MASSIVELY PARALLEL PLATFORMS DEBOJYOTI

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

Unstructured Mesh Generation for Implicit Moving Geometries and Level Set Applications

Unstructured Mesh Generation for Implicit Moving Geometries and Level Set Applications Unstructured Mesh Generation for Implicit Moving Geometries and Level Set Applications Per-Olof Persson (persson@mit.edu) Department of Mathematics Massachusetts Institute of Technology http://www.mit.edu/

More information

CS 450 Numerical Analysis. Chapter 7: Interpolation

CS 450 Numerical Analysis. Chapter 7: Interpolation Lecture slides based on the textbook Scientific Computing: An Introductory Survey by Michael T. Heath, copyright c 2018 by the Society for Industrial and Applied Mathematics. http://www.siam.org/books/cl80

More information

Skåne University Hospital Lund, Lund, Sweden 2 Deparment of Numerical Analysis, Centre for Mathematical Sciences, Lund University, Lund, Sweden

Skåne University Hospital Lund, Lund, Sweden 2 Deparment of Numerical Analysis, Centre for Mathematical Sciences, Lund University, Lund, Sweden Volume Tracking: A New Method for Visualization of Intracardiac Blood Flow from Three-Dimensional, Time-Resolved, Three-Component Magnetic Resonance Velocity Mapping Appendix: Theory and Numerical Implementation

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

FOURTH ORDER COMPACT FORMULATION OF STEADY NAVIER-STOKES EQUATIONS ON NON-UNIFORM GRIDS

FOURTH ORDER COMPACT FORMULATION OF STEADY NAVIER-STOKES EQUATIONS ON NON-UNIFORM GRIDS International Journal of Mechanical Engineering and Technology (IJMET Volume 9 Issue 10 October 2018 pp. 179 189 Article ID: IJMET_09_10_11 Available online at http://www.iaeme.com/ijmet/issues.asp?jtypeijmet&vtype9&itype10

More information

GENUINELY MULTIDIMENSIONAL NON-DISSIPATIVE FINITE VOLUME SCHEMES FOR TRANSPORT

GENUINELY MULTIDIMENSIONAL NON-DISSIPATIVE FINITE VOLUME SCHEMES FOR TRANSPORT GENUINELY MULTIDIMENSIONAL NON-DISSIPATIVE FINITE VOLUME SCHEMES FOR TRANSPORT BRUNO DESPRÉS, FRÉDÉRIC LAGOUTIÈRE Commissariat à l Énergie Atomique, Bruyères-le-Châtel. despres@cmpax.polytechnique.fr e-mail:

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

COMPARISON OF FINITE VOLUME HIGH-ORDER SCHEMES FOR THE TWO-DIMENSIONAL EULER EQUATIONS

COMPARISON OF FINITE VOLUME HIGH-ORDER SCHEMES FOR THE TWO-DIMENSIONAL EULER EQUATIONS ECCOMAS Congress 206 VII European Congress on Computational Methods in Applied Sciences and Engineering M. Papadrakakis, V. Papadopoulos, G. Stefanou, V. Plevris (eds.) Crete Island, Greece, 5 0 June 206

More information

Modeling External Compressible Flow

Modeling External Compressible Flow Tutorial 3. Modeling External Compressible Flow Introduction The purpose of this tutorial is to compute the turbulent flow past a transonic airfoil at a nonzero angle of attack. You will use the Spalart-Allmaras

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

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

Introduction to ANSYS CFX

Introduction to ANSYS CFX Workshop 03 Fluid flow around the NACA0012 Airfoil 16.0 Release Introduction to ANSYS CFX 2015 ANSYS, Inc. March 13, 2015 1 Release 16.0 Workshop Description: The flow simulated is an external aerodynamics

More information

Techniques for Using the Method of Manufactured Solutions for Verification and Uncertainty Quantification of CFD Simulations Having Discontinuities

Techniques for Using the Method of Manufactured Solutions for Verification and Uncertainty Quantification of CFD Simulations Having Discontinuities Techniques for Using the Method of Manufactured Solutions for Verification and Uncertainty Quantification of CFD Simulations Having Discontinuities Ben Grier Clemson University Richard Figliola, Larry

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

A HYBRID SEMI-PRIMITIVE SHOCK CAPTURING SCHEME FOR CONSERVATION LAWS

A HYBRID SEMI-PRIMITIVE SHOCK CAPTURING SCHEME FOR CONSERVATION LAWS Eighth Mississippi State - UAB Conference on Differential Equations and Computational Simulations. Electronic Journal of Differential Equations, Conf. 9 (), pp. 65 73. ISSN: 7-669. URL: http://ejde.math.tstate.edu

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