[email protected] (J. Mu), [email protected] (C. Zhuo), [email protected] (Q. Zhang), [email protected] (S. Liu), [email protected] (C. Zhong)
An efficient high-order gas-kinetic scheme with hybrid WENO-AO method for the Euler and Navier-Stokes solutions
Abstract
The high-order gas-kinetic scheme (HGKS) features good robustness, high efficiency and satisfactory accuracy,the performaence of which can be further improved combined with WENO-AO (WENO with adaptive order) scheme for reconstruction. To reduce computational costs in the reconstruction procedure, this paper proposes to combine HGKS with a hybrid WENO-AO scheme. The hybrid WENO-AO scheme reconstructs target variables using upwind linear approximation directly if all extreme points of the reconstruction polynomials for these variables are outside the large stencil. Otherwise, the WENO-AO scheme is used. Unlike combining the hybrid WENO scheme with traditional Riemann solvers, the troubled cell indicator of the hybrid WENO-AO method is fully utilized in the spatial reconstruction process of HGKS. During normal and tangential reconstruction, the gas-kinetic scheme flux not only needs to reconstruct the conservative variables on the left and right interfaces but also to reconstruct the derivative terms of the conservative variables. By reducing the number of times that the WENO-AO scheme is used, the calculation cost is reduced. The high-order gas-kinetic scheme with the hybrid WENO-AO method retains original robustness and accuracy of the WENO5-AO GKS, while exhibits higher computational efficiency.
keywords:
Gas-kinetic scheme, Hybrid WENO-AO scheme, High-order finite volume scheme, Extreme point.52B10, 65D18, 68U05, 68U07
1 Introduction
The development of aerospace technology has accentuated the need to describe complex and detailed flow fields around high-speed aircrafts efficiently. The research focus in computational fluid dynamics (CFD) [1] has shifted towards high-resolution and high-order schemes. In recent years, emphasis has been placed on high-order finite volume methods [2], discontinuous Galerkin (DG) methods, and correction procedures via reconstruction (CPR) for numerical simulations involving complex geometric meshes. The gas-kinetic scheme is a numerical method that provides solutions to the Euler and Navier-Stokes equations within the finite volume framework. The high-order gas-kinetic scheme (HGKS) has demonstrated excellent performance in compressible flows [3, 4]. It has also been successfully extended into DG [5] methods and CPR [6] frameworks.
The gas-kinetic scheme employs a time-evolving gas distribution function to reveal the multi-scale physical flow mechanism, encompassing kinetic particle transport to hydrodynamic wave propagation [7]. A one-stage third-order high-order gas-kinetic scheme was applied for subsonic to supersonic flow tests under the three-dimensional hybrid unstructured grid [8]. To solve the Euler equations, the efficient high-order gas-kinetic scheme (EHGKS) uses both HGKS and Lax-Wendroff method and can be generalized to arbitrary accuracy [9]. A two-stage fourth-order HGKS scheme was proposed by Pan et al. [11] based on the two-stage fourth-order generalized Riemann problem (GRP) scheme [10], becoming increasingly popular. The combination of multi-stage multi-derivative method (MSMD) and HGKS using second-order and third-order gas distribution functions resulted in two-stage fifth-order and three-stage fifth-order HGKS [12], with higher efficiency than the traditional Riemann solver [13] with Runge-Kutta (RK) time stepping method. Fifth-order WENO scheme was proposed by Jiang and Shu [14], providing a general framework for designing smoothness indicators and nonlinear weights. For spatial reconstruction, the classic HGKS with WENO reconstruction [7] is similar to the traditional high-order finite volume method (FVM) [15]. But the classic HGKS with WENO reconstruction [7] better captures shear instability due to the multidimensional properties of the gas distribution function [16]. Using fifth-order WENO-JS or WENO-Z reconstruction, non-equilibrium state and equilibrium state in the gas distribution function were generally reconstructed separately. The WENO adaptive order (WENO-AO) method proposed by Balsara [18] recently was for HGKS spatial reconstruction, overcoming shortcomings of the classic HGKS [7]. Compared to the classic WENO5-GKS scheme, HGKS with WENO-AO reconstruction has shown significant improvements in performance and no false overshoots or undershoots in certain test cases [7]. In addition, the high-order gas-kinetic scheme and high-order gas-kinetic compact schemes [19, 20, 21] are preferred on unstructured meshes due to their higher resolution and stability.
A fundamental concept of WENO schemes is to use a linear combination of lower order numerical fluxes or reconstructions to obtain a higher order approximation. For systems, WENO schemes employ a local characteristic decomposition method to avoid spurious oscillations. However, computing the nonlinear weights and local characteristic decompositions is computationally expensive. Pirozzoli [22] developed an efficient hybrid scheme that combines the WENO scheme for discontinuous regions with a compact upwind scheme for smooth regions. Hill and Pullin [23] proposed a scheme that integrates the tuned center difference method with the WENO scheme to automatically implement nonlinear weights in smooth regions away from shocks. Li and Qiu [25] designed a hybrid WENO scheme using switching principles and Runge-Kutta time discretization. Huang and Qiu [24] proposed a hybrid WENO scheme using the Lax-Wendroff time discretization program. However, different troubled cell indicators may have varying effects on hybrid WENO schemes, and these indicators need to adjust parameters based on different problems to better maintain non-oscillation near discontinuities and reduce computational costs. Zhu and Qiu [26] addressed this issue by proposing a new simple switching principle that uses different reconstruction methods by identifying the positions of all extreme points of a large reconstructed polynomial with numerical fluxes. Chen and Huang [27] improved upon the troubled cell indicator, eliminating the difficulty of finding extreme points of fourth-degree polynomials that can be extended to higher-order hybrid WENO schemes. This study focuses on the hybrid WENO-AO method proposed by Chen and Huang.
This paper applies the hybrid WENO-AO scheme presented in [27] to further reduce computation costs and increase calculation speed while maintaining the robustness and high accuracy of the existing HGKS with WENO-AO method. The benefits of the hybrid WENO-AO scheme for HGKS are as follows. First, the HGKS with the hybrid WENO-AO method retains all the advantages of the HGKS with WENO-AO method [7]. Second, computing characteristic decompositions and nonlinear weights in the WENO scheme is expensive. The hybrid WENO-AO scheme employs upwind linear reconstruction in smooth regions, which avoids the need for characteristic decompositions and calculations of nonlinear weights. Third, the WENO-AO scheme requires high-order smoothness indicators of large stencils to obtain nonlinear weights. Therefore, it is meaningful to replace WENO-AO reconstruction with linear upwind reconstruction in smooth regions to reduce the calculation cost of smoothness indicators. Additionally, for the WENO5-AO GKS method, calculating nonlinear weights is computationally expensive due to the multiple uses of the WENO-AO scheme during normal and tangential reconstruction for interface flux. For the HGKS with the hybrid WENO method, the new scheme utilizes upwind linear approximation in smooth regions, which reduces the computation of smoothness indicators, nonlinear weights, and local characteristic decompositions, saving CPU time. In brief, the HGKS with hybrid WENO scheme maintains the robustness of the HGKS with WENO-AO scheme [7] and demonstrates high efficiency and practicality.
This paper is organized as follows. The second section presents the classic two-stage fourth-order temporal discretization and GKS flux solver. Then, the HGKS with hybrid WENO-AO scheme is introduced, along with a reconstruction procedure for obtaining the non-equilibrium and equilibrium states of the gas distribution function in 1D and 2D. In the third section, numerical tests are conducted to evaluate the accuracy, efficiency, robustness, and shock capture capabilities of the HGKS with hybrid WENO method. Finally, the last section provides a summary of the high-order gas-kinetic scheme with hybrid WENO-AO method.
2 High-order gas-kinetic scheme with hybrid WENO-AO
In this section, we first provide a brief introduction to the gas-kinetic flux solver and the two-stage fourth-order temporal discretization [11]. Next, we describe the HGKS with hybrid WENO-AO spatial reconstruction in detail. Additionally, we conduct a simple analysis of the accuracy and computational costs of the hybrid WENO-AO reconstruction compared to the original WENO-AO reconstruction within the framework of HGKS.
As the finite volume scheme, the conservation laws can be written as
where is the conservative variables and is the corresponding flux. With the spatial discretization and appropriate evaluation . The original partial differential equation (PDE) became the ordinary differential equation (ODE).
(1) |
where is the spatial operator of flux.
2.1 Gas-kinetic flux solver
The two-dimensional Boltzmann-BGK equation is written as
(2) |
where is the particle velocity, is the collision time. is the gas distribution function and is the equilibrium state [28].
The equilibrium state is a Maxwellian distribution,
(3) |
where is the density and , where is the molecular mass, is the Boltzmann constant, and is the temperature. and are the macroscopic velocities in the x-direction and y-direction. For a 2D flow, the internal variable include the random particle motion in the z-direction, and the total number of degrees of freedom . is the specific heat ratio. In the equilibrium state, the internal variable . The relation between the conservative variables and the distribution function is
(4) |
where , . The collision term satisfies the following compatibility condition
(5) |
Based on the Chapman-Enskog expansion for Boltzmann-BGK equation [29, 30], the gas distribution function in the continuum regime can be expanded as
where . By truncating on different orders of , the corresponding macroscopic equations can be derived [31]. For the Euler equations, the zeroth order truncation is taken, i.e. . For the Navier-Stokes equations, when the first order truncation is used, the distribution function is
The solution of the Boltzmann-BGK equation at a cell interface is
(6) |
where and are the particle trajectory, is the location of the cell interface. is the initial gas distribution function at the beginning of each time step . The integral solution simulates the physical process from the free transport of particles in the kinetic scale physics to the evolution of hydrodynamic flow in the integral of term. The flow behavior at the cell interface depends on the ratio of the time step to the local particle collision time .
The initial gas distribution function with considering the first order non-equilibrium part is expressed as follows:
(7) |
The relation between the terms of the and macroscopic variables is
(8) |
where and are the moments of the equilibrium and defined by
The coefficients can be determined by the spatial derivatives of macroscopic flow variables and the compatibility condition as follows
(9) |
where , After obtaining all the required terms, substitute these terms into Eq. (6) and solve it can obtain the gas distribution function on the interface [2].
(10) | ||||
where is the Heaviside function. Derivations related to gas kinetic scheme can be found in [2].
Finally, the gas-kinetic numerical fluxes in the x-direction on the cell interface can be computed as
(11) |
By integrating the above equation in the time interval , the total mass, momentum, and energy transport can be written as
(12) |
More details can be found in [2].
2.2 Two-stage fourth-order temporal discretization
There are many ways to solve ODE Eq. (1). Here we define
The two-stage fourth-order time marching scheme is used to solve the initial value problem Eq. (1) and is written as
(13) | ||||
where is the time derivative of the spatial operator. If the time derivatives of up to can be given, a th-order time marching scheme can be constructed directly. Usually only a few low-order derivative is used to solve nonlinear system problems, such as for approximating the Riemann solver. For hyperbolic conservation law, the two-stage fourth-order temporal discretization is derived in [10] and for the generalized Riemann problem (GRP) solver. In the establishment of high-order gas-kinetic schemes, and are often used by HGKS for 2nd-order GKS flux functions and 3rd-order GKS flux functions respectively [32, 33, 34]. However, higher-order derivatives are prohibited due to the complexity of the HGKS flux function. Another multi-stage multi-derivative method (MSMD) was proposed with HGKS and continues to be used. Similar to the Runge-Kutta (RK) time marching scheme, the MSMD introduce middle stages. The update at becomes a linear combination of and their derivatives in multiple stages. Because of the use of and their derivatives, MSMD can achieve the required time accuracy with fewer middle stages than RK method. This paper mainly focuses on the two-stage fourth-order temporal discretization scheme (S2O4), and more HGKS with MSMD method is detailed and analyzed in [12].
Eq. (10) provides a time-dependent gas distribution function. And the flux for the macroscopic flow variables can be calculated by Eq. (12). The flux of the two-stage fourth-order GKS in the time interval needs the and at both and . The followings mainly introduce the two-stage algorithm.
(1) With the reconstruction at , the x-direction flux , and y-direction flux and in the time interval can be evaluated by Eq. (12).
(2) In the time interval , the flux is expanded as the linear form as
(14) |
The terms and can be determined as
(15) |
(16) |
The terms and can be computed by solving this linear system as
(17) |
(18) |
Similar to and , the and can be computed from and .
(3) Update at by
(19) | ||||
Again through the step (1) and step (2) to compute the middle stage value, we can get and in the time interval .
(4) The numerical fluxes and can be computed by
(20) |
(21) |
Update by
(22) |
In summary, for most of the tests in the third section, the flux function from the distribution function Eq. (10) is typically used. As analyzed in [11], in smooth region the Euler equation with leading error is solved in the S2O4 scheme, and the NS equations with the error . Normally, the condition is satisfied for many flow computations.
2.3 Hybrid WENO-AO method for spatial reconstruction
In this following, we present the main idea about the hybrid WENO scheme. We describe how to determine the point-wise values and derivatives required on the interface in the present hybrid WENO scheme. Next, we extend the HKGS with hybrid WENO method to the two-dimensional case (the process for extending to the three-dimensional case is straightforward). Finally, we provide a detailed analysis of why the improved HGKS can reduce computational costs.
2.3.1 Reconstruction of non-equilibrium states by hybrid WENO-AO
The Hybrid WENO-AO scheme extends the WENO-AO scheme by introducing a troubled cell indicator. When reconstructing the target variables on large stencils, we first use the troubled cell indicator to determine whether the solution is smooth on the large stencils. If the troubled cell indicator indicates the presence of discontinuities or shocks, we use the WENO-AO reconstruction method after transforming the conservative variables into the characteristic variables. Otherwise, we use the upwind linear reconstruction method directly. The detailed process is described as follows:
Step 1. A quadratic polynomial is constructed by using least-square method to approximate target variables on the large stencil . The quadratic polynomial
(23) |
is constructed by requiring
and .
The explicit formulas for and are
(24) |
If second-order derivative , the cell is judged as a non-troubled cell, otherwise, go to Step 2. is usually used for fifth-order method.
Step 2. The extreme point of is calculated as . If , the cell is judged as a non-troubled cell, otherwise, go to Step 3.
Step 3. A new quadratic polynomial is constructed in a conservative way to approximate target variables on the large stencil which is
(25) |
A point is determined as , where is just used to avid the denominator being zero. If where is usually used for fifth-order method, the cell is judged as a non-troubled cell, otherwise it is judged as a troubled cell, go to Step 4.
Step 4. If is judged as a troubled cell, the cells are also judged as troubled cells for the fifth order method. More details about the troubled cell indicator of the hybrid WENO-AO method are presented in [27].
Step 5. If isn’t judged as a troubled cell, the upwind linear reconstruction will be applied to the target variables in the way of component by component. On the large stencil , the point values and derivatives can at cell interface can be written as
(26) |
(27) |
The point values and derivatives can at cell interface can be written as
(28) |
(29) |
Therefore, the upwind linear reconstruction procedure is effective and concise in the smooth region.
If is judged as a troubled cell, the reconstruction performed for the characteristic variables to eliminate the spurious oscillation and improve the stability. The are defined as conservative variables. The are defined as characteristic variables, where is the right eigenmatrix of Jacobian matrix . Here approximately are the averaged conservative variables from both sides of the cell interface. With the reconstructed values, the conservative variables can be obtained by the inverse projection. And then the WENO-AO method is adopted in the reconstruction procedure. The detail formulation of fifth order WENO-AO method is the following.
Three sub-stencils
(30) |
are selected to reconstruct the left interface value and derivative at the cell interface and the right interface value and derivative at the cell interface . The three quadratic polynomials corresponding to the sub-stencils are constructed by requiring
(31) |
where represents the cell-averaged value. Each sub-stencil can achieve a third-order spatial accuracy in smooth case. For the reconstructed polynomials, the point values at the cell interface and is given in terms of the cell-averaged value as follows
(32) | ||||
On the large stencil , a fourth-order polynomial can be constructed by requiring
(33) |
The can be written by Balsara as
(34) |
where are defined linear weights. The linear weights for the large stencil and the sub-stencils , and are given by
(35) |
which satisfy . Typically, and . These linear weights are more flexible than WENO-Z type linear weights. And when the smoothness indicators shows that the large stencil is smooth, the 5th order accuracy can be guaranteed. The smoothness indicators shows that the third-order accuracy can be guaranteed even when it is not smooth. The point value at the cell interface and can be given as
(36) | ||||
To deal with discontinuities and avoid the loss of order of accuracy at inflection points, the non-normalized WENO-Z type nonlinear weights [41] are introduced as follows
(37) |
where the global smooth indicator is designed as
(38) |
The smoothness indicators are defined as
(39) |
where is the order of . For ; for . is taken in current work.
The normalized weights are given by
(40) |
Then the final form of the reconstructed polynomial is
(41) |
The desired values at the cell interfaces can be fully written as
(42) |
The WENO-AO reconstruction procedure is over because it is applied to schemes with Riemann solvers where only point-wise values are needed. In order to calculate the GKS flux, we supplement the derivatives at the cell interfaces on the large stencil and sub-stencils as follows
(43) | ||||
(44) | ||||
The desired derivatives at the cell interfaces can be fully determined as
(45) |
Remark 1. In the HGKS with the hybrid WENO-AO method described above, both upwind linear reconstruction and WENO-AO reconstruction ensure fifth-order accuracy of the non-equilibrium state. However, WENO-AO reconstruction is more computationally intensive than upwind linear reconstruction due to its higher complexity. This is because the computational cost of the nonlinear weights and high order smooth indicators of the WENO-AO method is already greater than that of WENO-Z or WENO-JS. To reduce computational costs, a troubled cell indicator is employed to identify extreme points on the large stencils that require WENO-AO reconstruction. By doing so, the proportion of WENO-AO reconstruction can be reduced, while maintaining the same level of accuracy.
2.3.2 Reconstruction of equilibrium states
The non-equilibrium states are obtained by either the upwind linear reconstruction or the WENO-AO reconstruction, and the equilibrium states can be obtained by the following simple method.
(46) |
(47) |
where are the equilibrium states and are the non-equilibrium states. This is a kinetic-based weighting of the values and derivatives on the left and right sides of the cell interface, while introducing the upwind mechanics. Arithmetic averaging can also be used for smooth flow. In classic WENO5-GKS [11], an extra linear polynomial reconstruction for the equilibrium states is required. This method requires no additional process and achieves a 5th-order spatial accuracy for the equilibrium states. In the above way, all components of the microscopic slopes across the interface have been obtained.
2.3.3 Two-dimensional Reconstruction procedure
Similar to the HGKS with WENO-AO shown in [7]. In fact, every step in the reconstruction process is to replace the WENO-AO method with the hybrid WENO-AO method in the new scheme.
In the two-dimensional case, the values of each Gaussian point which need to be obtained by reconstruction are
The scheme for obtaining the values of Gaussian points is as follows through dimension-by-dimensional reconstruction as follows. The time level is omitted here.
Step 1. According to the one-dimensional Hybrid WENO-AO reconstruction in Section 2.3.1, the line averaged reconstructed values and slopes
can be obtained along the normal direction by using the cell averaged values and ,.
Step 2. Again with the one-dimensional Hybrid WENO-AO reconstruction in Section2.3.1, the values at each Gaussian point
with can be obtained by using the line averaged values constructed above. In the same way, the point-wise derivatives at Gaussian point can be constructed by using the above line averaged derivatives with the hybrid WENO-AO method in Section2.3.1. The details about tangential reconstruction are described in [7].
Step 3. The quantities related to the non-equilibrium states at each Gaussian point are all obtained. And then the quantities related to the equilibrium states can be obtained by the unified weighting Eq. (46) and Eq. (47).
Remark 2. In 1D, the GKS flux on a cell interface can be reconstructed using WENO-AO only twice. But in 2D, the GKS flux on a cell interface should be reconstructed using WENO-AO up to six times, including two processes in Step 1 and four processes in Step 2. The WENO-AO reconstruction is used many times for flow variables and slopes in high dimensional tangential reconstruction. Therefore, replacing WENO-AO reconstruction with upwind linear reconstruction without local characteristic decompositions when allowed can save computing costs. Minimizing the use of WENO-AO reconstruction and using more upwind linear reconstruction helps reduce computational costs.
3 Numerical tests
In this section, 1-D and 2-D numerical tests will be presented to validate the HGKS with hybrid WENO-AO reconstruction. The CPU time for the WENO-AO reconstruction procedure and the hybrid WENO-AO reconstruction procedure are obtained with Intel Core i5-9400 CPU @ 2.90GHz. For the parameters of the HGKS in the follow tests, the ratio of specific heats takes . For the inviscid flow, the collision time is
where and denote the pressure on the left and right cell interface. Usually and are chosen in the classic HGKS. But, can be safely selected for WENO5-AO GKS and hybrid WENO5-AO GKS in most test cases. Without additional explanation, take and here. The pressure jump term in can add artificial dissipation to enlarge the shock thickness to the scale of numerical cell size in the discontinuous region. Besides, it can keep the non-equilibrium dynamics in the shock layer through the kinetic particle transport to mimic the real physical mechanism inside the shock structure.
For the viscous flow [11] [31], the collision time term related to the viscosity coefficient is defined as
where is the dynamic viscous coefficient and is the pressure at the cell interface. In smooth viscous flow region, it reduces to . The time step is determined by
where is the magnitude of velocities, is the CFL number, is the sound speed and is the kinematic viscosity coefficient.
3.1 Accuracy test in 1-D
The advection of density perturbation is tested whose initial condition is set as follows
Both the left and right sides of the test case are periodic boundary conditions. The analytic solution of the advection of density perturbation is
In the computation, a uniform mesh with points are used. The time step is fixed. The collision time is set since the flow is smooth and inviscid. Based on the two-stage fourth-order time-marching method, the HGKS with hybrid WENO-AO method is expected to achieve the same fifth-order spatial accuracy and fourth-order temporal accuracy as analyzed in [11]. The and errors and corresponding orders at are given in the follow tables. WENO-AO reconstruction is used near the two extreme points of a sine wave, as judged by the troubled cell indicator. The remaining region is reconstructed using upwind linear reconstruction. With the mesh refinement in Table 1 and Table 2, the expected orders of accuracy are obtained and the numerical errors are identical.
mesh length | error | Order | error | Order | error | Order |
---|---|---|---|---|---|---|
1/5 | 9.0941825e-04 | 1.0207546e-03 | 1.4309840e-03 | |||
1/10 | 2.8778750e-05 | 4.98 | 3.1964978e-05 | 5.00 | 4.7027062e-05 | 4.93 |
1/20 | 9.0471847e-07 | 4.99 | 1.0020469e-06 | 5.00 | 1.4850604e-06 | 4.98 |
1/40 | 2.8269469e-08 | 5.00 | 3.1333382e-08 | 5.00 | 4.6521236e-08 | 5.00 |
1/80 | 8.8554643e-10 | 5.00 | 9.8172632e-10 | 5.00 | 1.4546295e-09 | 5.00 |
mesh length | error | Order | error | Order | error | Order |
---|---|---|---|---|---|---|
1/5 | 8.8190167e-04 | 9.9663892e-04 | 1.4171754e-03 | |||
1/10 | 2.8712310e-05 | 4.94 | 3.1905636e-05 | 4.97 | 4.7018003e-05 | 4.91 |
1/20 | 9.0460559e-07 | 4.99 | 1.0019354e-06 | 4.99 | 1.4850249e-06 | 4.98 |
1/40 | 2.8269469e-08 | 5.00 | 3.1333382e-08 | 5.00 | 4.6521236e-08 | 5.00 |
1/80 | 8.8554523e-10 | 5.00 | 9.8172512e-10 | 5.00 | 1.4546323e-09 | 5.00 |
3.2 One-dimensional Riemann problems
The reference solutions for the following 1-D Riemann problems were obtained using classic WENO5-GKS with 10,000 uniform mesh points. A comparison of the CPU times for spatial reconstruction demonstrates the advantages of the hybrid WENO-AO method for HGKS. For the same test case, the CPU time for the remaining program components is identical between HGKS with WENO-AO and HGKS with hybrid WENO-AO. For instance, in the SOD problem, the CPU time for the rest of the program is approximately 0.196 seconds for both methods. However, the CPU time for the reconstruction procedure differs, as shown in Table 3.
Numerical example | Grid points | CPU time of hybrid WENO-AO (s) | CPU time of WENO-AO (s) | Ratio |
---|---|---|---|---|
Sod problem | 100 | 0.016 | 0.049 | 32.65% |
Shu-Osher problem | 400 | 0.245 | 1.937 | 12.65% |
Blast wave problem | 400 | 0.773 | 3.176 | 23.34% |
(a) Sod problem
The computational domain for the Sod problem is with 100 uniform mesh points. The solutions of the Sod problem are presented at with non-reflecting boundary condition on both ends. The initial condition is given by
In Fig. 1, a comparison is made between the results of the class WENO5-Z GKS, WENO5-AO GKS and the hybrid WENO5-AO GKS. Overall, the results of the three reconstruction methods are in good agreement with the reference solutions. From the local enlargements in Fig. 1, it is observed that the solutions from the classic HGKS with WENO-Z show undershoot or overshoot around the corner of the rarefaction wave. The results obtained using the HGKS with both WENO-AO and the hybrid WENO-AO are almost identical due to the kinetic-weighting method, which is analyzed in Section2.3.2. It can be seen from Table 3 that the hybrid WENO-AO reconstruction can save 67.35% of CPU time compared to WENO-AO reconstruction for the CPU time of the reconstruction procedure of the HGKS in the Sod problem.






(b) Shu-Osher problem
The Shu-Osher shock acoustic interaction [35] is computed in with 400 mesh points. The non-reflecting boundary condition is given on the left, and the fixed wave profile is extended on the right. The initial conditions are
The Fig. 2 presents density profiles and enlargements at . The values of density computed by the HGKS with WENO-AO reconstruction and hybrid WENO-AO reconstruction are nearly identical with each other. But for the reconstruction procedure, the HGKS with hybrid WENO-AO method requires approximately 87.35% less cpu time compared to the HGKS with WENO-AO method.


(c) Blast wave problem
The third case is the Woodward-Colella blast [36] wave problem. The initial conditions for the blast wave problem are given as follows
The computation is conducted with , employing 400 equally spaced grid points while applying reflection boundary conditions at both ends. Fig. 3 displays the computed profiles of density, velocity and pressure at t=0.038. The results of HGKS with hybrid WENO-AO reconstruction and HGKS with WENO-AO reconstruction show identical wave profiles and correspond well with the reference solutions. The HGKS with hybrid WENO-AO reconstruction exhibits a 75.66% reduction in CPU time for the reconstruction procedure. This test case contains strong discontinuities requiring high-order schemes to be robust. These results indicate that the hybrid WENO5-AO GKS is as robust as the WENO5-AO GKS.



3.3 Accuracy test in 2-D
Similar to 1-D case, we choose the advection of density perturbation for accuracy test. The collision time is set for this inviscid flow. The initial conditions are
The compute domain is . uniform mesh is used and the boundary conditions in both directions are periodic. The analytic solution of the 2-D advection of density perturbation is
The CFL number of the time steps are 0.5. HGKS with both WENO-AO reconstruction and hybrid WENO-AO reconstruction are tested and presented in the Table 4 and Table 5 respectively. The HGKS with hybrid WENO-AO reconstruction can achieve expected accuracy as the HGKS with WENO reconstruction.
mesh length | error | Order | error | Order | error | Order |
---|---|---|---|---|---|---|
1/5 | 1.3573113e-03 | 1.4897997e-03 | 2.1046216e-03 | |||
1/10 | 4.1633737e-05 | 5.03 | 4.6328748e-05 | 5.01 | 6.7573520e-05 | 4.96 |
1/20 | 1.3564842e-06 | 4.94 | 1.5063088e-06 | 4.94 | 2.1917062e-06 | 4.95 |
1/40 | 4.8651945e-08 | 4.80 | 5.4154814e-08 | 4.80 | 7.7820892e-08 | 4.82 |
1/80 | 1.7467843e-09 | 4.80 | 1.9404552e-09 | 4.80 | 2.8182315e-09 | 4.79 |
mesh length | error | Order | error | Order | error | Order |
---|---|---|---|---|---|---|
1/5 | 1.8574494e-03 | 2.0349011e-03 | 2.9200462e-03 | |||
1/10 | 5.8628718e-05 | 4.99 | 6.5166053e-05 | 4.96 | 9.4883564e-05 | 4.94 |
1/20 | 1.8571539e-06 | 4.98 | 2.0587183e-06 | 4.98 | 3.0099476e-06 | 4.98 |
1/40 | 6.0991328e-08 | 4.93 | 6.7640692e-08 | 4.93 | 9.8766773e-08 | 4.93 |
1/80 | 2.0681312e-09 | 4.88 | 2.2970915e-09 | 4.88 | 3.6052416e-09 | 4.78 |
For the following 2-D Numerical examples, the CPU time of the HGKS with different reconstruction procedure is presented in Table 6, in which only the CPU time of the spatial reconstructor is counted. Similarly, in the double Mach reflection problem with the same initial conditions, the CPU time of the remaining programs for the two schemes is 45235.455s and 45478.215s, respectively. So we still show the effect of the hybrid WENO-AO method on HGKS by comparing the CPU time of spatial reconstruction.
Numerical example | Grid points | CPU time of hybrid WENO-AO (s) | CPU time of WENO-AO (s) | Ratio |
---|---|---|---|---|
Riemann problem (configuration 1) | 706.471 | 6100.513 | 11.58% | |
Riemann problem (configuration 6) | 5546.881 | 9628.309 | 57.61% | |
Double Mach reflection problem | 5334.322 | 13596.93 | 39.23% | |
Viscous shock tubes problem | 12148.766 | 46394.377 | 26.91% |
3.4 Two-dimensional Riemann problems
(a) Configuration 1
The initial conditions of the Configuration 1 are four 1-D rarefaction waves and given as [37]
The results of the Configuration 1 at for the HGKS with WENO-AO method and hybrid WENO-AO method are presented in Fig. 4. In comparison to the HGKS with WENO-AO method [7], the original HGKS scheme yields tangential reconstructions without negative temperature due to the separated smooth tangential reconstructions for the equilibrium state . Although the HGKS with hybrid WENO-AO method also introduces linear reconstruction in tangential reconstructions. The HGKS with hybrid WENO-AO method has also no negative temperature in this case. So it has the same stability as the HGKS with the WENO-AO reconstruction, but is more efficient.


(b) Configuration 6
For compressible flow, the shear layer flow is one of the most distinguishable flow patterns. For the case of Configuration 6 [37], the initial conditions with four planar contact discontinuities are given as
These discontinuities trigger the K-H instabilities due to the numerical viscosities. It is commonly believed that the less numerical dissipation corresponds to larger amplitude shear instabilities [38]. It can be observed in Fig. 5 that the HGKS with hybrid WENO-AO method predicts less numerical dissipation and more details of vortices than the HGKS with WENO-AO method. This is mainly due to the fact that in a few cases, direct upwind linear reconstruction has better performance than WENO-AO reconstruction. Also as shown in Table 6, the HGKS with hybrid WENO-AO method can save about 50% CPU of the reconstruction procedure.
The HGKS with hybrid WENO-AO reconstruction can save 46.03% more CPU time reduction in Configuration 1 than in Configuration 6. Because the flow of the Configuration 6 is more complex than Configuration 1. The proportion of WENO-AO reconstruction increases in the Configuration 6 during the reconstruction of the conservative variables and its derivatives in their normal and tangential directions. What is the same is that their initial conditions are all four parts of different flow region, but the computational cost reduction is somewhat different.


3.5 Double Mach reflection problem
The double Mach reflection problem is a inviscid test case designed by Woodward and Colella [36]. The computational domain is with a slip boundary condition applied on the bottom of the domain starting from . The post -shock condition is set for the rest of bottom boundary. At the top boundary, the flow variables are set to describe the exact motion of the Mach 10 shock. The initial pre-shock and post-shock conditions are
Initially, a right-moving Mach 10 shock with a angle against the x-axis is positioned at . The density distributions and local enlargements at for the new HGKS with hybrid WENO-AO scheme and the HGKS with WENO-AO scheme are plotted in Fig.6 and Fig.7, respectively. The HGKS with hybrid WENO-AO method and the HGKS with WENO-AO method are robust and well validated with increasing the CFL number up to 0.8. But the classic WENO5 GKS scheme is With validated with . The HGKS with hybrid WENO-AO method can save 60% CPU time of the reconstruction procedure. Besides the new HGKS with hybrid WENO-AO scheme also resolves the flow structure under the triple Mach stem clearly as the WENO5-AO GKS.




.
3.6 Viscous shock tubes problem
This viscous shock tube problem [22, 39, 40] was investigated to valid the capability of the present two HGKS schemes for low Reynolds number viscous flow with strong shocks. In a two-dimensional unit box , a membrane located at separates two different states of the gas and the dimensionless initial states are
where , Prandtl number and Reynolds number . The computational domain is with a symmetric boundary condition imposed on the top , and non-slip adiabatic conditions applied on the other three solid wall boundaries.
At , the membrane is removed and a wave interaction occurs. A shock wave with Mach number moves to the right side. Then the shock wave followed by a contact discontinuity reflects at the right wall. After the reflection, the shock interacts with the contact discontinuity. During their propagation, both of them interact with the horizontal wall and create a thin boundary layer. The solution will develop complex two-dimensional shock/shear/boundary-layer interactions and the dramatic changes for velocities above the bottom wall introduce strong shear stress.
The density distributions of viscous shock tube at for the HGKS with WENO-AO method is plotted in Fig. 8. And the density distributions of viscous shock tube at for the HGKS with hybrid WENO-AO method is plotted in Fig. 9. The density profiles along the bottom wall are shown in Fig. 10. The classic HGKS replaces WENO-Z type weights with WENO-JS weights to pass this test case. However, both the HGKS with WENO-AO in [7] and the new HGKS with hybrid WENO-AO method can pass and the obtain the following results. Compared with the HGKS with WENO-AO method, the new HGKS with hybrid WENO-AO method can save about 75% of CPU time for reconstruction procedure. In Fig. 10, the density profiles of HGKS with WENO-AO and hybrid WENO-AO are almost same and agree well with the density profiles of classic WENO5-GKS with .



4 Conclusion
The two-stage fourth-order gas-kinetic scheme (HGKS) based on the hybrid WENO-AO method retains the high accuracy and robustness of the original WENO5-AO GKS. The troubled cell indicator in the hybrid WENO-AO method provides a reliable way to determine if all extreme points of the fourth-degree polynomial reconstructed in the cell or interface are within the large stencils. Moreover, the slopes of the flow variables are derived from the reconstructed nonlinear or linear polynomials. HGKS with the hybrid WENO-AO method reduces spurious oscillations at weak discontinuities and exhibits good shear instability resolution, as verified by various inviscid and viscid numerical tests. Importantly, compared to the HGKS with the WENO-AO method, the computation time of the HGKS spatial reconstruction procedure with the hybrid WENO-AO method is reduced by 80% in 1D and 60% in 2D, while maintaining similar robustness and accuracy. Futhermore, the computational cost of the three-dimensional spatial reconstruction procedure of HGKS is substantially higher than that of two-dimensional spatial reconstruction. Therefore, future work will continue to verify whether the HGKS with hybrid WENO-AO method can ensure high accuracy and robustness while enhancing computational efficiency. Our goal is to employ HGKS with hybrid WENO-AO method in numerical simulations of three-dimensional complex flow.
Acknowledgments
The authors would like to thank Yining Yang, Hao Jin for helpful discussion. This work is sponsored by the National Natural Science Foundation of China [grant numbers 11902264, 12072283, 12172301] and the 111 Project of China (B17037).
References
- [1] Zhijian Wang, Krzysztof Fidkowski, Rémi Abgrall, Francesco Bassi, Doru Caraeni, Andrew Cary, Herman Deconinck, Ralf Hartmann, Koen Hillewaert, H. T. Huynh, Norbert Kroll, GeorgMay, Per-Olof Persson, Bram van Leer and Miguel Visbal. High-Order CFD Methods: Current Status and Perspective. International Journal for Numerical Methods in Fluids, 72:811 - 845, 2013.
- [2] Kun Xu. A Gas-Kinetic BGK Scheme for the Navier–Stokes Equations and Its Connection with Artificial Dissipation and Godunov Method. Journal of Computational Physics, 289 – 335, 2009.
- [3] Qibing Li and Song Fu. A High-Order Accurate Gas-Kinetic BGK Scheme. Computational Fluid Dynamics 2008, 372:515-520, 2018.
- [4] Qibing Li, Kun Xu and Song Fu. A high-order gas-kinetic Navier–Stokes flow solver. Journal of Computational Physics, 229(19):6715-6731, 2010.
- [5] Xiaodong Ren, Kun Xu, Wei Shyy and Chunwei Gu. A multi-dimensional high-order discontinuous Galerkin method based on gas kinetic theory for viscous flow computations. Journal of Computational Physics, 292:176-193, 2015.
- [6] Chao Zhang, Qibing Li, Song Fu and Zhijian Wang. A third-order gas-kinetic CPR method for the Euler and Navier–Stokes equations on triangular meshes. Journal of Computational Physics, 363:329-353, 2018.
- [7] Xing Ji and Kun Xu. Performance Enhancement for High-Order Gas-Kinetic Scheme Based on WENO-Adaptive-Order Reconstruction. Communications in Computational Physics, (2), 2020.
- [8] Liang Pan and Kun Xu. A third-order gas-kinetic scheme for three-dimensional inviscid and viscous flow computations. Computers & Fluids, 2015, 119:250-260.
- [9] Shiyi Li,Yibing Chen and Song jiang. An Efficient High-Order Gas-Kinetic Scheme (I): Euler Equations. Journal of Computational Physics, 2020, 415:109488.
- [10] Zhifang Du and Jiequan Li. A Two-Stage Fourth Order Time-Accurate Discretization for Lax–Wendroff Type Flow Solvers I. Hyperbolic Conservation Laws[J]. SIAM Journal on Scientific Computing, 2016(5).
- [11] Liang Pan, Kun Xu, Qibing Li, and Jiequan Li. An efficient and accurate two-stage fourth-order gas-kinetic scheme for the Euler and Navier–Stokes equations. Journal of Computational Physics, 326:197 – 221, 2016.
- [12] Xing Ji, Fengxiang Zhao, Wei Shyy and Kun Xu. A Family of High-order Gas-kinetic Schemes and Its Comparison with Riemann Solver Based High-order Methods. Journal of Computational Physics, 356:150 – 173, 2018.
- [13] Eleuterio F Toro. Riemann solvers and numerical methods for fluid dynamics: a practical introduction. Springer Science & Business Media, 2013.
- [14] Guang-Shan Jiang and Chi-Wang Shu. Efficient implementation of weighted ENO schemes. Journal of computational physics, 126(1):202–228, 1996.
- [15] Titarev Vladimir and Toro Eleuterio. Finite-volume WENO schemes for 3-D conservation laws. Journal of Computational Physics, 201, 2004.
- [16] Kun Xu, Meiliang Mao and Lei Tang. A multidimensional gas-kinetic BGK scheme for hypersonic viscous flow. Journal of Computational Physics, 203(5):405–421, 2005.
- [17] Marcos Castro, Bruno Costa and Wai Sun Don. High order weighted essentially non-oscillatory WENO-Z schemes for hyperbolic conservation laws. Journal of Computational Physics, 230(5):1766–1792, 2011.
- [18] Balsara Dinshaw, Garain Sudip, Florinski Vladimir and Boscheri, Walter. An efficient class of WENO schemes with adaptive order for unstructured meshes. Journal of computational physics, 404:109062, 2019.
- [19] Xing Ji, Fengxiang Zhao, Wei Shyy and Kun Xu. Compact High-Order Gas-Kinetic Scheme for Three-Dimensional Flow Simulations. AIAA Journal, 59(8):2979–2996, 2021.
- [20] Fengxiang Zhao, Xing Ji, Wei Shyy and Kun Xu. A compact high-order gas-kinetic scheme on unstructured mesh for acoustic and shock wave computations. Journal of computational physics, 449:110812, 2022.
- [21] Xing Ji, Fengxiang Zhao, Wei Shyy and Kun Xu. A HWENO reconstruction based high-order compact gas-kinetic scheme on unstructured mesh. Journal of computational physics, 410:109367, 2022.
- [22] Sergio Pirozzoli. Conservative Hybrid Compact-WENO Schemes for Shock-Turbulence Interaction. Journal of computational physics, 178:81–117, 2002.
- [23] David Hill and Dale I Pullin. Hybrid Tuned Center Difference - WENO Method for Large Eddy Simulations in the Presence of Strong Shocks. Journal of computational physics, 194:435–450, 2004.
- [24] Buyue Huang and Jianxian Qiu. Hybrid WENO Schemes with Lax-Wendroff Type Time Discretization. Journal of Mathematical Study, 50:242–267, 2017.
- [25] Jianxian Qiu and Chi-Wang Shu. A Comparison of Troubled-Cell Indicators for Runge–Kutta Discontinuous Galerkin Methods Using Weighted Essentially Nonoscillatory Limiters. SIAM Journal on Scientific Computing, 27(3):995–1013, 2005.
- [26] Zhuang Zhao, Jun Zhu and Yibing Chen and Jianxian Qiu. A new hybrid WENO scheme for hyperbolic conservation laws. Computers & Fluids, 179:422–436, 2019.
- [27] Lili Chen and Cong Huang. One dimensional hybrid WENO-AO method using improved troubled cell indicator based on extreme point. Computers & Fluids, 225:104976, 2021.
- [28] Prabhu Lal Bhatnagar, Eugene P Gross, and Max Krook. A model for collision processes in gases. I. Small amplitude processes in charged and neutral one-component systems. Physical Review, 94(3):511, 1954.
- [29] S.Y. Chou and Donald Baganoff. Kinetic Flux–Vector Splitting for the Navier–Stokes Equations. Journal of Computational Physics, 130(2):217-230, 1997.
- [30] Michael Junk and S.V Raghurama Raok. A New Discrete Velocity Method for Navier–Stokes Equations. Journal of Computational Physics, 155(1):178-198, 1999.
- [31] Dongxin Pan, Rui Zhang, Congshan Zhuo, Sha Liu and Chengwen Zhong. A multi-degree-of-freedom gas kinetic multi-prediction implicit scheme. Journal of Computational Physics, 475:111871, 2023.
- [32] Guiyu Cao, Hualin Liu and Kun Xu. Physical modeling and numerical studies of three-dimensional non-equilibrium multi-temperature flows. Physics of Fluids, 30(12):126104, 2018.
- [33] Xing Ji, Liang Pan, Wei Shyy and Kun Xu. A compact fourth-order gas-kinetic scheme for the Euler and Navier–Stokes equations. Journal of Computational Physics, 372:446-472, 2018.
- [34] Dongxin Pan, Chengwen Zhong, Congshan Zhuo and Sha Liu. A two-stage fourth-order gas-kinetic scheme on unstructured hybrid mesh. Computer Physics Communications, 235:75-87, 2019.
- [35] Chi-Wang Shu and Stanley Osher. Efficient implementation of essentially non-oscillatory shock-capturing schemes, II. In Upwind and High-Resolution Schemes. Springer, 328-374, 1989.
- [36] Paul Woodward and Phillip Colella. The numerical simulation of two-dimensional fluid flow with strong shocks. Journal of computational physics, 54(1):115–173, 1984.
- [37] Peter D Lax and Xu-Dong Liu. Solution of two-dimensional Riemann problems of gas dynamics by positive schemes. SIAM Journal on Scientific Computing, 19(2):319–340, 1998.
- [38] Omer San and Kursat Kara. Evaluation of Riemann flux solvers for WENO reconstruction schemes: Kelvin–Helmholtz instability. Computers & Fluids, 117:24–41, 2015.
- [39] Kyu Hong Kim and Chongam Kim. Accurate, efficient and monotonic numerical methods for multi-dimensional compressible flows: Part II: Multi-dimensional limiting process. Journal of computational physics, 208(2):570–615, 2005.
- [40] Virginie Daru and Christian Tenaud. Numerical simulation of the viscous shock tube problem by using a high resolution monotonicity-preserving scheme. Computers & Fluids, 38:664–676, 2009.
- [41] Rafael Borges, Monique Carmona, Bruno Costa, and Wai Sun Don. An improved weighted essentially non-oscillatory scheme for hyperbolic conservation laws. Journal of Computational Physics, 227(6):3191–3211, 2008.