Abstract
In this work, we consider the general family of the so called ADER \(P_NP_M\) schemes for the numerical solution of hyperbolic partial differential equations with arbitrary high order of accuracy in space and time. The family of one-step \(P_NP_M\) schemes was introduced in Dumbser (J Comput Phys 227:8209–8253, 2008) and represents a unified framework for classical high order Finite Volume (FV) schemes (\(N=0\)), the usual Discontinuous Galerkin (DG) methods (\(N=M\)), as well as a new class of intermediate hybrid schemes for which a reconstruction operator of degree M is applied over piecewise polynomial data of degree N with \(M>N\). In all cases with \(M \ge N > 0 \) the \(P_NP_M\) schemes are linear in the sense of Godunov (Math. USSR Sbornik 47:271–306, 1959), thus when considering phenomena characterized by discontinuities, spurious oscillations may appear and even destroy the simulation. Therefore, in this paper we present a new simple, robust and accurate a posteriori subcell finite volume limiting strategy that is valid for the entire class of \(P_NP_M\) schemes. The subcell FV limiter is activated only where it is needed, i.e. in the neighborhood of shocks or other discontinuities, and is able to maintain the resolution of the underlying high order \(P_NP_M\) schemes, due to the use of a rather fine subgrid of \(2N+1\) subcells per space dimension. The paper contains a wide set of test cases for different hyperbolic PDE systems, solved on adaptive Cartesian meshes that show the capabilities of the proposed method both on smooth and discontinuous problems, as well as the broad range of its applicability. The tests range from compressible gasdynamics over classical MHD to relativistic magnetohydrodynamics.
Similar content being viewed by others
Avoid common mistakes on your manuscript.
1 Introduction
In this work we want to improve the family of high order accurate ADER \(P_NP_M\) schemes first introduced in [37, 40] for the solution of hyperbolic partial differential equations. In this family of schemes the discrete solution is represented in space through high order piecewise polynomials of degree N at each timestep; the data are then evolved in time through a space-time reconstruction procedure of order M. The reconstruction procedure is divided into two steps: concerning the spatial reconstruction, we employ a classical WENO reconstruction in the case of pure finite volume schemes (\(N=0\)), a reconstruction procedure based on \(L^2\) projection that is linear in the sense of Godunov for \(N>0\) and \(M>N\), and in the case or pure DG schemes (\(N=M\)) the reconstruction reduces to the identity operator; concerning the reconstruction in time, we employ a novel variant of the ADER approach of Toro and Titarev, see [26, 109, 110, 113, 114], based on an element-local space-time Galerkin predictor, see [40]. In practice, we can see the Finite Volume (FV) schemes of order M as a particular case of \(P_NP_M\) methods when \(N=0\), and also the Discontinous Galerkin (DG) methods are included in this family when choosing \(N=M\).
Furthermore, this family contains another important class of hybrid or reconstructed DG schemes when taking \(N>0, M>N\), which are the main object of study of this paper. Indeed, they offer many advantages, in particular their good compromise between cost and resolution. In fact, data are represented with polynomials of order N, so more accurately with respect to FV methods, but without the expensive cost of a full DG representation of approximation degree M; also the CFL stability constraint that limits the timestep size of any explicit scheme, only depends on N and not on M, allowing for larger timesteps once the desired order of accuracy has been fixed, see [40]. Last but not least, for \(N>0\) the \(P_NP_M\) schemes require a much smaller reconstruction stencil than comparable finite volume schemes of degree M. The nominal order of accuracy of the scheme is given by \(M+1\) so it can be at least in principle arbitrary high.
The family of reconstructed DG schemes, which is similar to the \(P_NP_M\) framework, was forwarded independently by Luo et al. in a series of papers, see e.g. [68, 87, 88, 116, 117, 119] and references therein. At this point we also highlight that the use of reconstruction and filtering operators as a post-processor for improving the accuracy of DG schemes goes back to work of Ryan et al., see [72, 77, 90, 99, 100]. Other related work on reconstruction-based DG schemes can be found in [17, 28, 82, 118].
Moreover, the ADER \(P_NP_M\) family provides a useful framework for code developers because it allows to include in a unique code both types of standard discretization methods for hyperbolic PDE (FV and DG schemes), together with the new class of intermediate hybrid schemes for \(M>N>0\). It is then possible to let it up to the user to decide whether for a particular application the use of a robust finite volume approach (\(N=0\)), a very accurate DG scheme (\(N=M\)), or a less expensive but still very accurate intermediate \(P_NP_M\) method with \(M>N>0\), is the most appropriate.
The main drawback so far of the intermediate \(P_NP_M\) schemes with \(M>N>0\), as presented in [40], is that they are linear in the sense of Godunov [64], hence not well suited for dealing with discontinuous problems. For this reason, here we propose a new simple, robust and accurate limiting strategy that is able to stabilize the entire class of \(P_NP_M\) schemes in such a way that they can be employed for the numerical solution of hyperbolic equations with discontinuous solutions, which may arise even when starting with smooth initial conditions. Moreover, the new limiter does not substantially deteriorate the benefits of \(P_NP_M\) schemes in terms of computational cost and accuracy of the original unlimited schemes. To the best knowledge of the authors, this is the first time that an a posteriori subcell finite volume limiter is proposed for general \(P_NP_M\) schemes with \(M>N>0\). So far, only the cases \(N=0\) and \(M=N\) were covered in [40] and [52], respectively.
Our limiter is based on the MOOD approach [29, 35, 36], which has already been successfully applied in the framework of ADER finite volume schemes [21, 22, 85] and Discontinous Galerkin finite element schemes, see [25, 47, 52, 75, 97, 124]. Specifically, the numerical solution is checked a posteriori for nonphysical values and spurious oscillations, and if it does not satisfy all admissibility detection criteria, given by both physical and numerical requirements, in a certain cell, that cell is marked as troubled. Then, instead of applying a limiter to the already computed solution, the solution is locally recomputed with a more robust scheme in the troubled cells, relying either on a second order TVD scheme, as proposed for pure DG schemes in [19, 47, 106], or on a higher order ADER-WENO finite volume method as employed in [23, 32, 52, 95, 124]. Moreover, this second computation is performed on a finer subgrid generated within each troubled cell; the subcell approach is employed in order to maintain the high resolution of the initial \(P_NP_M\) scheme even when passing to a less accurate (but more robust) FV scheme. For the given reasons our limiter is called a posteriori subcell finite volume limiter.
Finally, for a complete review of ADER \(P_NP_M\) schemes we refer to the recent paper [25], where a complete introduction traces the historical developments of these methods up to its latest evolutions.
The rest of the paper is organized as follows. After an introduction of the class of physical phenomena that can be discretized with the proposed numerical method and the structure of our data representation, we present the family of ADER \(P_NP_M\) schemes in Sect. 2. In particular, we describe the reconstruction procedure in space, see Sect. 2.3, and in time see Sect. 2.4; these procedures provide a high order reconstructed polynomial of degree M in space and time that will be used in the final one-step update formula given in Sect. 2.5. Then, Sect. 2.6 is dedicated to our a posteriori subcell FV limiter, which in addition can be combined with mesh adaptation techniques as described in Sect. 2.7.
Next, in Sect. 3 we present a large set of numerical results that shows the order of convergence of our scheme for smooth solutions and their capability of dealing with discontinuities, i.e. their robustness and resolution. We also compare the hybrid reconstructed schemes with pure DG schemes in order to show the resulting gain in terms of computational cost. Finally, we close the paper with some remarks and an outlook to future works in Sect. 4.
2 Numerical Method
In this Section we carefully describe the a posteriori subcell finite volume limiter for general \(P_NP_M\) schemes, showing its simplicity, accuracy, robustness and versatility thanks to the following key ingredients:
-
the use of the unified \(P_NP_M\) framework for finite volume (FV), discontinous Galerkin (DG) and hybrid reconstructed DG schemes allows the user to decide freely which combination of N and M is the better choice for a particular application;
-
the ADER space-time predictor-corrector formalism allows the implementation of a truly arbitrary high order accurate fully discrete one-step scheme that needs only one MPI communication per time step within a parallel HPC implementation, see Sect. 2.4;
-
the a posteriori subcell finite volume limiter avoids spurious oscillations of high order \(P_NP_M\) schemes without affecting the resolution of the underlying method, see Sect. 2.6;
-
the adaptive mesh refinement (AMR) technique allows to use a fine grid only where necessary, resorting to cheaper coarse grids in smooth regions of the solution, see Sect. 2.7.
2.1 Governing PDE System
We consider a very general formulation of the governing equations in order to model a wide class of physical phenomena, namely all those which are described by hyperbolic systems of conservation laws that can be cast into the following form,
where \(\mathbf {x}= (x,y,z)\) is the spatial position vector, d is the number of space dimensions, t represents the time, \(\mathbf {Q}= (q_1,q_2, \dots , q_{m})^T\) is the vector of conserved variables defined in the space of the admissible states \(\varOmega _{\mathbf {Q}} \subset \mathbb {R}^{m}\) and \( \mathbf {F}(\mathbf {Q}) = (\,\mathbf {f}(\mathbf {Q}), \mathbf {g}(\mathbf {Q}), \mathbf {h}(\mathbf {Q})\,) = \mathbf {f}^i (\mathbf {Q})\) (\(i=1,2,3\)) is the non-linear flux tensor. This kind of system (1) is said to be hyperbolic if for all directions \(\mathbf {n} \ne \mathbf {0}\) the matrix
has m real eigenvalues and a full set of m linearly independent eigenvectors. Examples of hyperbolic equations are the Euler equations of gasdynamics, the Shallow Water equations [27, 108] and many multiphase models [4, 38, 62] used in fluid mechanics, the magnetohydrodynamics system (MHD) for plasma flow [6, 9], the unified first order hyperbolic formulation of continuum mechanics by Godunov, Peshkov and Romenski (GPR) [43, 48, 49, 65, 66, 93] as well as the special and general relativistic formulations of MHD, see e.g. [3, 5, 10, 33, 41, 56, 122], or for the Einstein field equations (CCZ4) [1, 2, 42, 44]. We will test the method proposed in this paper on some of those systems in order to verify its applicability in different physical domains.
2.2 Domain Discretization and High Order Data Representation (Order N)
On grid level \(\ell =0\) the computational domain \(\varOmega \) is discretized with a uniform Cartesian grid, called main grid or the level zero grid, composed of \(N_E =N_x \times N_y\times N_z\) conforming elements (quadrilaterals if \(d=2\), or hexahedra if \(d=3\)) denoted by \(\varOmega _{\mathbf {i}}= \varOmega _{ijk}, \mathbf {i} =(i,j,k)\) with \(i = 1, \dots , N_x\), \(j=1, \dots , N_y\), \(k=1, \dots , N_z\), with volume \(|\varOmega _{ijk}| = \int _{\varOmega _{ijk}} d\mathbf {x}\) and such that
For each element we define a reference frame of coordinates \(\varvec{\xi }=(\xi , \eta , \zeta )\) linked to the Cartesian coordinates \(\mathbf {x}=(x,y,z)\) of \(\varOmega _{ijk}\) by
Then, we represent the conserved variables \(\mathbf {Q}\) of (1) in each cell \(\varOmega _{\mathbf {i}}\) by a \(d-\)dimensional tensor product of piecewise polynomials of degree N
where \(\varphi _\ell (\varvec{\xi })\) are nodal spatial basis functions given by the tensor product of a set of Lagrange interpolation polynomials of maximum degree N such that
where \(\varvec{\xi }_{\text {GL}}^m\) are the set of \((N+1)^d\) Gauss-Legendre (GL) quadrature points obtained by the tensor product of the GL quadrature points \(\xi _{\text {GL}}^m, \eta _{\text {GL}}^m, \zeta _{\text {GL}}^m\) in the unit interval [0, 1], see [107].
The discontinuous finite element data representation in (4) leads naturally to i) a Discontinuous Galerkin (DG) scheme if \(N>0\) and \(N=M\), where the desired order of accuracy M already coincides with the degree N of the polynomial approximating the data (\(M=N\)), so that high order of accuracy in space can be obtained without the use of any spatial reconstruction operator, and to ii) a Finite Volume (FV) scheme in the case \(N=0\). This indeed means that for \(N=0\) we have \(\varphi _\ell (\varvec{\xi }) = 1\) with \(\ell =0\), and (4) reduces to the classical piecewise constant data representation that is typical of finite volume schemes, where the only degree of freedom per element is the usual cell average \(\hat{\mathbf {u}}_{0}\). In this case the order of accuracy M in space will be obtained through the reconstruction procedure described in next Sect. 2.3. However, iii) also a family of hybrid reconstructed Discontinuous Galerkin methods is included in this representation, where a Hermite-type reconstruction of degree \(M > N\) is performed on cell data represented by polynomials of degree N, see the next Sect. 2.3.
Thus, within the general \(P_NP_M\) formalism one can simultaneously deal with arbitrary high order FV and DG schemes and reconstructed hybrid methods inside a unified framework, with only very few differences between the different schemes (substantially the reconstruction procedure and the type of limiter).
2.3 High Order Spatial Reconstruction (Order M)
In the framework of \(P_NP_M\) schemes, M indicates the highest polynomial approximation degree used for the representation of the discrete solution within the method. Hence, in this Section we describe the reconstruction procedure that is needed to obtain approximation degree M in space from an underlying data representation \(\mathbf {u}_h(\mathbf {x},t^n)\) of lower or equal degree \(N \le M\), i.e. the procedure that generates a spatially high order accurate reconstruction polynomial \(\mathbf {w}_h(\mathbf {x},t^n)\) of degree M
where we formally employ the same nodal basis functions for the reconstruction and for the data representation, see (4). However, note that when \(M \ne N\) of course \(\psi _l(\mathbf {x},t^n)\) does not coincide with \(\varphi _l(\mathbf {x},t^n)\), since the polynomial degree and the positions of the GL points are not the same.
For the sake of a uniform notation, when \(M=N\), we trivially impose that the reconstruction polynomial is given by the DG polynomial, i.e. \(\mathbf {w}_h(\mathbf {x},t^n)=\mathbf {u}_h(\mathbf {x},t^n)\), which automatically implies that in the case \(N=M\) the reconstruction operator is simply the identity.
In the other cases, we employ a polynomial reconstruction procedure implemented in a dimension by dimension fashion in order to compute the coefficients \(\hat{\mathbf {w}}_{\ell ,\mathbf {i}}\) in (6). To better follow the following reasoning we refer the reader also to the Figs. 1, 2 and 3. Focusing on the reconstruction procedure along the x-direction, given an element \(\varOmega _{\mathbf {i}}=\varOmega _{ijk}\), we write the reconstruction polynomial in x-direction \(\mathbf {w}_h^x\) in terms of one dimensional basis functions as
Then, we integrate on a set \(\mathcal {S}^x\) of neighbors of \(\varOmega _{\mathbf {i}}\) in x-direction, obtaining an algebraic system for the polynomial coefficients \( \hat{\mathbf {w}}_{\ell _{1},r_2,r_3,\mathbf {i}}\) (one for each horizontal section of \(\varOmega _{\mathbf {i}}\))
where \(\mathcal {S}^x\) contains the neighbors along the x axis, i.e \(\varOmega _{\mathbf {m}}=\varOmega _{mjk}\) such that \(m \in \left\{ i-1, i, i+1\right\} \). Note that we are using a stencil made always of only 3 elements in each direction, thus a very compact one. Indeed, a stencil composed of 3 elements is enough for any \(P_NP_M\) scheme with \(M\le 3N+2\), because any \(P_N\) cell contains \(N+1\) degrees of freedom, thus 3 cells provide \(3N+3\) degrees of freedom, which are sufficient for a polynomial reconstruction of degree up to \(3N+2\). Moreover, when the provided information are more than the minimum required, the system (9) results to be overdetermined; so, to solve it, we employ a constrained least-squares technique (CLSQ) [46], i.e. we impose that the reconstructed polynomial satisfies
exactly. In other words, all moments of the reconstructed solution \(\mathbf {w}_h\) and the original solution \(\mathbf {u}_h\) up to degree N must coincide exactly within cell \(\varOmega _{\mathbf {i}}\) and match on the remaining stencil elements in the least-square sense.
To complete the reconstruction polynomial, we now repeat the above procedure in the y-direction, so we write the reconstruction polynomial in terms of one-dimensional basis functions as
and we solve the algebraic system
with \(\mathcal {S}^y\) being the set of the neighbors along the y axis, i.e \(\varOmega _{\mathbf {n}}=\varOmega _{ink}\) such that \(n \in \left\{ j-1, j, j+1 \right\} \). Again, for overdetermined systems we impose that the reconstruction exactly satisfies
And then the same procedure can be repeated along the z axis by looking for the unknown coefficients \(\hat{\mathbf {w}}_{\ell _{1},\ell _{2},\ell _{3},\mathbf {i}}\) of
and solving the algebraic system
\(\mathcal {S}^z\) being the set of the neighbors along the z axis, i.e \(\varOmega _{\mathbf {p}}=\varOmega _{ijp}\) such that \(p \in \left[ k-1, k, k+1\right] \). For overdetermined systems, the constraint reads
Finally, the coefficients \(\hat{\mathbf {w}}_{\ell _{1},\ell _{2},\ell _{3},\mathbf {i}}\) represent the \(\hat{\mathbf {w}}_{\ell ,\mathbf {i}}\) of (6) that give us the desired polynomial representation of order M in space.
We would like to emphasize that the reconstructed \(P_NP_M\) schemes with \(N>0\) are very compact because for the reconstruction they need a much smaller stencils than classical finite volume schemes and that for regular Cartesian meshes, the coefficients of the above constraint least squares systems depend only on the choice of the basis functions, hence the integrals can be precomputed once and for all on the reference element before starting the simulation.
Furthermore, in the specific case \(N=0\), i.e. when the \(P_NP_M\) reduces to a FV scheme, the above polynomial reconstruction procedure must be made nonlinear; this can be easily done, for example, by adopting the WENO strategy specifically described in the context of \(P_NP_M\) type schemes (thus with the same notation adopted here) on Cartesian meshes in [25, 51]. We recall that the nonlinearity introduced through ENO/WENO type procedures essentially avoids the spurious oscillations typical of high order linear schemes modeling discontinuous processes see [64], and was already introduced in the 80s and subsequently largely developed [8, 69, 70, 73, 103, 105, 125]. Due to the already exhaustive literature available on FV schemes, here, for what concerns the strategies that guarantee robustness on discontinuities, we focus on \(P_NP_M\) schemes only with \(N>0\): indeed, it is for those schemes that we propose in this work a new strategy, i.e. the new a posteriori subcell FV limiter described in Sect. 2.6.
2.4 High Order in Time via a Local Space-Time Galerkin Predictor
We recall that high order of accuracy in space is provided by the piecewise polynomial data representation \(\mathbf {w}_h\) of (6), obtained in the previous Sect. 2.3.
Now, in order to achieve also high order of accuracy in time, relying on the ADER predictor-corrector approach, we need to compute the so-called space-time Galerkin predictor, i.e. a space-time polynomial \(\mathbf {q}_h\) of degree M in \((d+1)\)-dimensions (d for the space plus 1 for the time) which takes the following form
where again \(\theta _\ell (\varvec{\xi }, \tau )\) is given by the tensor product of Lagrange interpolation polynomials \(\varphi _{\ell }\left( \varvec{\xi }(\mathbf {x}) \right) \varphi _{\ell _\tau }\left( \tau \right) \), with \(\varvec{\xi }(\mathbf {x})\) given by (3) and the mapping for the time coordinate given by \(t = t^n + \tau \varDelta t, \tau \in [0,1]\). This high order polynomial in space and time will serve as a predictor solution, only valid inside \(\varOmega _{\mathbf {i}}\times [t^n,t^{n+1}]\), to be used for evaluating the numerical fluxes and the sources when integrating the PDE in the final corrector step of the ADER scheme, see Sect. 2.5.
In order to determine the unknown coefficients \(\hat{\mathbf {q}}_\ell \) of (16) we search \(\mathbf {q}_h\) such that it satisfies a weak form of the governing PDE (1) integrated in space and time locally inside each \(\varOmega _{\mathbf {i}}\) (with \(\varOmega _{\mathbf {i}}^{\circ } = \varOmega _{\mathbf {i}}\backslash \partial \varOmega _{\mathbf {i}}\) being the interior of \(\varOmega _{\mathbf {i}}\))
where the first term is integrated in time by parts exploiting the causality principle (upwinding in time)
and \(\mathbf {w}_h(\mathbf {x},t^{n})\) is the known initial condition at time \(t^n\).
Now, the system (18), which contains only volume integrals to be calculated inside \(\varOmega _{\mathbf {i}}\) and no surface integrals, can be solved via a simple discrete Picard iteration for each element \(\varOmega _{\mathbf {i}}\), and there is no need of any communication with neighbor elements. Indeed, the so-called predictor step consists in a local solution of the governing PDE (1) in the small, see [69], inside each space-time element \(\varOmega _{\mathbf {i}}\times [t^n,t^{n+1}]\). It is called local because it is obtained by only considering cell \(\varOmega _{\mathbf {i}}\) with initial data \(\mathbf {w}_h\), the governing equations (1) and the geometry, without taking into account any interaction between \(\varOmega _{\mathbf {i}}\) and its neighbors. We also want to emphasize that this procedure is exactly the same whatever N and M are.
We recall that this procedure has been introduced for the first time in [40] for unstructured meshes, it has been extended for example to moving meshes in [18] and to degenerate space time elements in [60]; finally, its convergence has been formally proved in [25].
2.5 High Order Fully-Discrete One-Step ADER \(P_NP_M\) Scheme
Last, the update formula of our ADER \(P_NP_M\) scheme is recovered starting from the weak formulation of the governing equations (1) (where the test functions \(\varphi _k\) coincide with the basis functions \(\varphi _\ell \) of (5))
we then substitute \(\mathbf {Q}\) with (4) at time \(t=t^n\) (the known initial condition) and at \(t=t^{n+1}\) (to represent the unknown evolved conserved variables), and with the high order predictor \(\mathbf {q}_h\) previously computed for \(t\in [t^n, t^{n+1}]\), obtaining
The use of \(\mathbf {q}_h\) allows to compute the integrals appearing in (20) with high order of accuracy in both space and time.
The boundary fluxes \(\mathcal {F}\cdot \mathbf {n}\) are obtained by a Riemann solver, thus providing the coupling between neighbors, which was neglected in the predictor step. In particular, in this work we will employ three types of standard fluxes, namely the Rusanov flux and the HLL flux, whose description can be found in [112], and the HLLEM flux for which we refer to [39, 53]. For the sake of completness, we report here the expression of the Rusanov flux that reads as follows
where \(s_{\max }\) is the maximum eigenvalue of the system matrices \(\mathbf {A}(\mathbf {q}_h^{+})\) and \(\mathbf {A}(\mathbf {q}_h^{-})\) being \(\mathbf {A}(\mathbf {Q})=\frac{\partial \mathbf {F}}{\partial \mathbf {Q}}\). We remark also that due to the discontinuous character of \(\mathbf {q}_h\) at the interfaces \(\partial \varOmega _{\mathbf {i}}\), \(\mathcal {F}\cdot \mathbf {n}\) is computed through a numerical flux function evaluated over the boundary-extrapolated data \(\mathbf {q}_h^{-}\) and \(\mathbf {q}_h^{+}\) (i.e the predictors \(\mathbf {q}_h\) of two neighbors elements evaluated at the common interface).
Finally, we stress again that the update procedure in (20) is the same whatever N and M are, and allows the contemporary evolution of all the \((N+1)^d\) degrees of freedom of \(\mathbf {u}_h\).
2.5.1 CFL Stability Constraint
A very important feature of \(P_NP_M\) schemes is linked to the CFL stability constraint. Since this family of scheme is explicit, the time step \(\varDelta t\) has to be computed according to a (global) Courant-Friedrichs-Levy (CFL) stability condition given by
where \(h_{\text {min}}\) is the minimum characteristic mesh-size, \(|\lambda _{\max }|\) is the spectral radius of the system matrix \(\mathbf {A}\) and the maximum admissible \(\text {CFL}_{P_NP_M}\) number is given in Table 1. In the above formula we wanted also to recall the classical CFL condition of Runge-Kutta DG schemes (the one written on the right, with \(\text {CFL}<1\)) which is just a bit less restrictive than the one needed for ADER \(P_NP_M\) schemes, but easier to remember and helpful in justifying the stability of our subcell limiter, see formula (29).
Furthermore, we would like to emphasize that it is the degree N of the data representation that governs the stability of the method and not the polynomial degree M of the reconstruction operator. Hence, the reconstructed hybrid methods with \(N>0\) and \(M>N\) allow for larger time steps than the pure DG methods (\(N=M\)) of the same order always maintaining a superior resolution with respect to FV schemes (\(N=0\)), fact that further justifies the interest in their development.
2.6 A Posteriori Subcell Finite Volume Limiter
Up to now, the presented \(P_NP_M\) scheme is high order accurate in space and time and, formally, the differences between the FV case (\(N=0\)) the pure DG case (\(N=M\)) and the hybrid reconstructed case (\(N>0, M>N\)) are basically only due to the procedure for achieving high order of accuracy in space, which is obtained through a WENO reconstruction in the FV case, a linear reconstruction in the hybrid case and is automatic by construction for DG, see Sect. 2.3. But this is actually a major difference, because the WENO operator provides a non-linear stabilization of the FV scheme, while the \(P_NP_M\) schemes with \(N>0\) presented so far are unlimited and, as such, they are affected by the so-called Gibbs phenomenon, i.e. oscillations are likely to appear in presence of shock waves or other discontinuities. These oscillations can be explained by the Godunov theorem [64], because in this case the scheme is linear in the sense of Godunov.
As a consequence, a limiting technique is required. Our strategy is described in detail below and it will be applied whenever \(N>0\).
First, we need to consider the numerical solution computed so far \(\mathbf {u}_h^{n+1}\) only as a candidate solution: we denote it with \(\mathbf {u}^{n+1,*}_{h}(\mathbf {x},t^{n+1})\).
Then, following [25, 52, 57, 75, 123, 124], each element \(\varOmega _\mathbf {i}\) is divided into \(N_\omega =(2N+1)^d\) equal non-overlapping subgrid cells \(\omega _{\mathbf {i},\alpha }\) whose volume is denoted by \(|\omega _{\mathbf {i},\alpha }|\); for any cell we define the corresponding subcell average of the \(P_NP_M\) solution at time \(t^n\)
and the candidate subcell averages at time \(t^{n+1}\)
where \(\mathcal {P}(\mathbf {u}_h)\) is the \(L_2\) projection operator into the space of piecewise constant cell averages.
Now, we have to mark the troubled cells, i.e. we have to identify those cells where the solution found through the \(P_NP_M\) scheme cannot be accepted because it may lead to spurious oscillations. Thus, the candidate solution \(\mathbf {v}^{n+1,*}_h\) is checked against a set of detection criteria. Here we follow the criteria described in [19], however also other specific physical bounds or more elaborate choices as those of invariant domain preserving methods [67] could be considered.
First, we require that the computed solution is physically acceptable, i.e. that it belongs to the phase space of the conservation law being solved. For instance, if the compressible Euler equations for gas dynamics are considered, density and pressure should be positive and in practice we require that they are greater than a prescribed tolerance \(\varepsilon =10^{-12}\). Then, the solution should verify a relaxed discrete maximum principle (DMP)
where \(\mathcal{{V}}(\varOmega _{\mathbf {i}})\) is the set containing all the neighbors of \(\varOmega _{\mathbf {i}}\) sharing a common node with \(\varOmega _{\mathbf {i}}\), and \(\delta \) is a parameter which, according to [19, 52, 124], reads
with \(\delta _0=10^{-5}\) and \(\varepsilon =10^{-4}\). If a cell does not fulfill the detection criteria in all its subcells, then it is marked as troubled. It is possible that some false positive activations of the limiter occur; however these local effects do not reduce the overall quality of the simulation thanks to the highly accurate limiter procedure adopted on troubled cells.
Then only on these troubled cells we apply either a second-order accurate MUSCL-Hancock TVD finite volume scheme with minmod slope limiter [112] (in particular in presence of strong shock waves or low density atmospheres), or a more accurate ADER-WENO FV scheme [51, 52] that better captures local extrema. In this way we can re-compute the solution in order to evolve the cell averages \(\mathbf {v}_{\mathbf {i},\alpha }^n\) in time and obtain \(\mathbf {v}_{\mathbf {i},\alpha }^{n+1}\).
Note that, due to the fact of applying a high order scheme and to do so on a subgrid instead that on the main grid, the subcell average representation given by \(\mathbf {v}_{\mathbf {i},\alpha }^{n+1}\) maintains the high resolution of the underling \(P_NP_M\) scheme. Indeed now, we can recover from these cell averages a polynomial \(\mathbf {u}_{h}^{n+1}\) of degree N; this is done by applying a reconstruction operator \(\mathcal {R}\) such that
which is conservative on the main cell \(\varOmega _{\mathbf {i}}\) thanks to the additional linear constraint
Moreover, the projection operator \(\mathcal {P}\) in (23) and the reconstruction operator \(\mathcal {R}\) in (27) satisfy the property \(\mathcal {P} \cdot \mathcal {R}=\mathcal {I}\), with \(\mathcal {I}\) being the identity operator.
However, we have to remark that the reconstruction operator (27), (28) might still lead to an oscillatory solution, since it is based on a linear unlimited least squares technique. If this is the case, the cell \(\varOmega _{\mathbf {i}}\) will be marked again automatically as troubled during the next timestep \(t^{n+2}\), therefore the same finite volume subcell limiter will be used again in that cell and in particular the subcell averages from which to start as initial data at time \(t^{n+1}\) will be the \(\mathbf {v}_{i,\alpha }^{n+1}\) kept in memory from the previous limited step.
Furthermore, if a cell \(\varOmega _{\mathbf {i}}\) is acceptable but has at least one troubled neighbor in \(\mathcal {V}(\varOmega _{\mathbf {i}})\), then we cannot accept its candidate solution \(\mathbf {u}^{n+1,*}_{h}(\mathbf {x},t^{n+1})\) as it is because the scheme would be nonconservative, since the numerical flux \(\mathcal {F}\cdot \mathbf {n}\) at the common interface would have been computed in two different ways in \(\varOmega _{\mathbf {i}}\) and its neighbor and by using a \(\mathbf {q}_h\) that may already be non acceptable. Thus, the final \(P_NP_M\) solution in these cells, neighbors of troubled ones, is rearranged as follows: we keep the already computed values of the volume integral and of the surface integrals interacting with non-troubled cells, while the numerical flux across the troubled faces is substituted with the one computed through the limiter procedure.
Finally, note that for the subcell FV scheme we have a different CFL stability condition
with \(\text {CFL}_\text {FV}<1\) and \(h_{\min }\) the minimum cell size referred to \(\varOmega _{\mathbf {i}}\). Condition (29) guides us in choosing the number of employed subcells \(N_\omega \). In particular, our choice \(N_\omega = (2N + 1)^d\) respects the stability condition (29) maintaining the original timestep size fixed for the current timestep [see (22)] but also taking into account the maximum possible number of subgrid elements allowed by that timestep size.
We would like to stress again that our interest for \(P_NP_M\) schemes is motivated by the high resolution that they are able to provide and the reduced cost offered by the possibility of representing data with lower order polynomials of degree N and to achieve, however, an order of accuracy M, with \(M>N\), using a very compact stencil and a simple reconstruction procedure.
The presented a posteriori subcell FV limiter is applied only where it is needed by detecting spurious oscillations a posteriori and it is based on strong stability preserving FV schemes developed precisely for dealing with discontinuous solutions. Since FV schemes are less accurate than \(P_NP_M\) schemes with \(N>0\), the limiter is applied on a finer subgrid than the original main grid in order to avoid a loss of useful information.
2.7 Adaptive Cartesian Mesh Refinement
The last ingredient that further increases the resolution of the proposed approach is the possibility of activating an Adaptive Mesh Refinement (AMR) technique based on a cell-by-cell refinement approach; indeed, the combined action of our subcell limiter and of AMR allows a sharp detection of all discontinuities. For details we refer to [14, 15, 24, 45, 51, 55,56,57, 76, 96, 120, 124] and we recall here just the main features. Our algorithm basically consists in, starting from the main grid (2), introducing successive refinement levels, in regions of particular interest according to a prescribed refinement criterion. In particular, we have to fix the following parameters:
-
the maximum level of refinement \(\ell _\mathrm{max}\), typically chosen equal to 2 or 3 in our tests;
-
the refinement factor \(\mathfrak {r}\), governing the number of subcells that are generated according to
$$\begin{aligned} \begin{aligned} \varDelta x_{\ell } = \mathfrak {r} \varDelta x_{\ell +1}, \quad \varDelta y_{\ell } = \mathfrak {r} \varDelta y_{\ell +1}, \quad \varDelta z_{\ell } = \mathfrak {r} \varDelta z_{\ell +1}, \end{aligned} \end{aligned}$$(30)where \(\varDelta x_{\ell }\) is the size of the cell at refinement level number \(\ell \) along the x-direction, and similarly for the other directions;
-
the refinement criterion that we base on oscillations of second derivatives, see [84]. In practice, we have to compute
$$\begin{aligned} \chi _\mathbf {i}=\sqrt{\frac{\sum _{k,l} (\partial ^2 \varPhi /\partial x_k \partial x_l)^2 }{\sum _{k,l}[(|\partial \varPhi /\partial x_k|_{i+1}+|\partial \varPhi /\partial x_k|_i)/\varDelta x_l+\varepsilon |(\partial ^2 /\partial x_k \partial x_l )||\varPhi |]^2} }, \end{aligned}$$(31)where the summation \(\sum _{k,l}\) is taken over the number of space dimension of the problem in order to include the cross term derivatives, the parameter \(\varepsilon = 0.01\) acts as a filter preventing refinement in regions of small ripples, and the function \(\varPhi =\varPhi (\mathbf {Q})\), that could be any suitable indicator function of the conserved variables \(\mathbf {Q}\), in our test is chosen to be simply \(\varPhi (\mathbf {Q})=\rho \). Next, a cell \(\varOmega _{\mathbf {i}}\) is marked for refinement if \(\chi _\mathbf {i}>\chi _\mathrm{ref}\), while it is marked for re-coarsening if \(\chi _\mathbf {i}<\chi _\mathrm{rec}\). In our tests we have chosen \(\chi _\mathrm{ref}\) in the range [0.2, 0.25] and \(\chi _\mathrm{rec}\) in [0.05, 0.15].
Finally, the numerical solution at the subcell level during a refinement step is obtained by a standard \(L_2\) projection, while a reconstruction operator is employed to recover the solution on the main grid starting from the subcell level. Moreover, in order to simplify the reconstruction procedure, the grid is treated as locally uniform for each cell independent of its grid level \(\ell \), because the neighbors cells at a coarser level \(\ell -1\) can be virtually refined in order to allow for the reconstruction procedure on locally uniform meshes detailed in Sect. 2.3. We also note that our AMR algorithm is endowed with a time-accurate local time stepping (LTS) feature, see [51] for details.
3 Numerical Results
In this Section we present a large set of numerical test cases in order to show the accuracy, robustness and efficiency of the presented \(P_NP_M\) family of schemes equipped with the a posteriori subcell finite volume limiter.
In order to cover a wide variety of physical phenomena we have applied our schemes to three sets of equations of relevance in fluid-dynamical applications, namely the Euler equations of compressible hydrodynamics (HD), the magnetohydrodynamics equations (MHD), and the special relativistic magnetohydrodynamics equations (RMHD).
In particular, for any set of equations we have selected both a smooth test case, to show the order of convergence of our schemes (up to order six), and some problems containing strong discontinuities going from logically one-dimensional Riemann problems to classical challenging two-dimensional benchmarks, such as the Sedov explosion problem, the Double Mach Reflection problem, the MHD rotor problem, the RMHD blast wave, as well as the MHD & RMHD Orszag–Tang vortex problems. The presence of discontinuities allows to prove the robustness and resolution of our a posteriori subcell limiting strategy.
Moreover, the results obtained with the intermediate \(P_NP_M\) schemes (i.e. \(N\ne 0\) and \(M> N\)) are compared with the pure DG approach (i.e. \(N=M\)) in order to show their gain in terms of computational efficiency, while maintaining a similar resolution. We also compare numerical results on AMR meshes against results obtained on fine uniform Cartesian meshes, demonstrating both the robustness of our schemes on adaptive meshes and the obtained savings in computational time.
3.1 Euler Equations of Gasdynamics
The first set of hyperbolic equations that we consider is given by the homogeneous Euler equations of compressible gasdynamics that can be cast in form (1) by choosing
The vector of conserved variables \(\mathbf {Q}\) involves the fluid density \(\rho \), the momentum density vector \(\rho \mathbf {v}=(\rho u, \rho v)\) and the total energy density \(\rho E\). The fluid pressure p is related to the conserved quantities \(\mathbf {Q}\) using the equation of state for an ideal gas
where \(\gamma \) is the ratio of specific heats so that the speed of sound takes the form \(c=\sqrt{\frac{\gamma p}{\rho }}\).
3.1.1 Isentropic Vortex
First of all, in order to verify the order of convergence of the proposed \(P_NP_M\) schemes, we consider a smooth isentropic vortex flow according to [71]. The computational domain is given by the square \(\varOmega =[0,10]\times [0,10]\) with periodic boundary conditions set everywhere. For the initial conditions we consider a homogeneous background field \(\mathbf {Q}_0=(\rho ,u,v,p)=(1,1,1,1)\) traveling with a constant velocity \(\mathbf {v}_c = (1,1)\) and we superimpose on this field some perturbations for density and pressure of the following form
with the temperature fluctuation
and the vortex strength \(\varepsilon =5\). The velocity field is also affected by the following perturbations
The initial condition is thus given by \(\mathbf {Q}= \mathbf {Q}_0 + \mathbf {\delta } \mathbf {Q}\). The exact solution \(\mathbf {Q}_e\) at the final time \(t_f\) can be simply computed as the time-shifted initial condition, i.e. \(\mathbf {Q}_e(x, t_f) = \mathbf {Q}(x - \mathbf {v}_c t_f, 0)\).
In Table 2, we report the convergence rates from second up to sixth order of accuracy for the smooth vortex test problem run on a sequence of successively refined meshes up to the final time \(t_f=1.0\). The optimal order of accuracy is achieved for the hybrid schemes \(P_NP_M\) with \(M>N\) and for the pure DG schemes with \(N=M\).
3.1.2 The Sod Shock Tube Problem
The Sod shock tube problem in 2D can be seen as a multidimensional extension of the classical Sod test case in 1D [112], which allows to verify the robustness and the resolution capacity of the employed numerical method on a rarefaction wave, a contact discontinuity and a shock at the same time, indeed the three waves are originated by the discontinuous initial condition.
Here, we consider as computational domain a square of dimension \([-1,1]\times [-1,1]\) covered with a uniform mesh of \(50\times 10\) control volumes, and the initial condition is composed of two different states, separated by a discontinuity at \(x_d=0\)
The final time is chosen to be \(t_f=0.4\), so that the shock wave does not cross the external boundary of the domain, where wall boundary conditions are set. The algorithm for the calculation of the exact solution of this Riemann problem is given in [111].
We have run this problem with two fourth order methods, namely the \(P_2P_3\) and the \(P_3P_3\) schemes, and two sixth order methods, namely the \(P_3P_5\) and the \(P_5P_5\) schemes, equipped with the a posteriori subcell TVD FV limiter and employing the Rusanov flux both in the main \(P_NP_M\) scheme and at the limiter stage. The agreement of our numerical results with the exact solution is perfect and the hybrid schemes (i.e. \(M<N\)) are faster than the pure DG schemes (N=M), see Fig. 4.
Moreover, in Fig. 5, one can see that the limiter activates exactly where the shock discontinuity is located also when the adaptive mesh refinement technique is employed.
3.1.3 The Lax Shock Tube Problem
The Lax shock tube problem, introduced for the first time in [81], is another classical benchmark for high order methods for the solution of the Euler equations. The computational domain is the square \([-1,1]\times [-1,1]\) and the initial condition is composed of two different states, separated by a discontinuity located at \(x_d=0\)
In this case, we have covered our computational domain with a very coarse mesh of \(20\times 10\) elements activating the AMR procedure with \(\ell _{\max }=2\) levels of refinement and \(\mathfrak {r}=3\). In Fig. 6, we present the results obtained with two sixth order methods, namely the \(P_3P_5\) and the \(P_5P_5\) schemes, used together with the HLLEM [39, 53] numerical flux. Both the numerical results perfectly agree with the reference solution and the hybrid scheme is 2.5 times faster than the pure DG scheme. Also the limiter activates exactly only at the shock location and, due to the subcell resolution, it does not affect the quality of the profile which is sharply captured even on a very coarse mesh.
3.1.4 The Shu-Osher Shock Tube Problem
The Shu-Osher problem was first introduced in [104] and it allows to check the capability of our new scheme to deal simultaneously with physical oscillations and shock waves appearing at the same time during the simulation. It consists of a one-dimensional Mach 3 shock front interacting with a sinusoidal density disturbance that generates a combination of discontinuities and smooth structures, whose entropy fluctuations are amplified when passing through the shock.
We discretize our computational domain \(\varOmega = [-5,5]\times [0,1]\) with an AMR grid with \(64\times 4\) elements on the coarsest level and a maximum refinement level \(\ell _{\max }=2\) with \(\mathfrak {r}=3\). The initial conditions are given by
and the simulations run up to the final time \(t_f=1.8\). For this test case, we employ the HLL Riemann solver, and the TVD a posteriori subcell finite volume limiter.
We then compare the results obtained with two pure DG schemes \(P_3P_3\) and \(P_5P_5\), and the hybrid schemes \(P_2P_3\) and \(P_3P_5\) which have, respectively, the same order of accuracy. As shown in Fig. 7, the methods are accurate, and robust thanks to the employed limiter strategy, and the intermediate schemes \(P_NP_M\) with \(M>N\) are computational more efficient than pure DG schemes.
3.1.5 Sedov Problem
This test problem is widespread in literature [60, 74, 86] and it describes the evolution of a blast wave that is generated at the origin \(\mathbf {O}=(x,y)=(0,0)\) of the computational domain \(\varOmega (0)=[0,1.2]\times [0,1.2]\). An exact solution based on self-similarity arguments is available from [101] and the fluid is assumed to be an ideal gas with \(\gamma =1.4\), which is initially at rest and assigned with a uniform density \(\rho _0=1\). The initial pressure is \(p_0=10^{-6}\) everywhere except in the cell \(V_{or}\) containing the origin \(\mathbf {O}\) where it is given by
being \(E_\text {tot}=0.244816\) the the total energy concentrated at \(\mathbf {x}=\mathbf {0}\) and \(|V_\text {or}|\) the total volume of \(V_{or}\).
We solve this numerical test with a selection of high order methods going from fourth to eighth order of accuracy on a mesh of \(50\times 50\) elements with and without AMR. When the adaptive mesh refinement is activated, we take \(\ell _{\max }=2\) and \(\mathfrak {r}=3\). For all these test cases we employ the Rusanov flux, \(CFL=0.9\), and the WENO a posteriori subcell finite volume limiter.
We show the results on the activation of the limiter in Fig. 9, and the obtained density profiles in Fig. 8. Finally, we compare the performances of a selection of methods in Table 3, in particular we highlight the needed computational times versus their capability of capturing the high density peak. We can remark that the hybrid schemes (as the \(P_2P_3\) and the \(P_3P_5\)) have accurate and robust results at a lower computational cost; also the combination with adaptive mesh refinement helps in increasing the accuracy keeping the computational cost low.
3.1.6 Double Mach Reflection
The double Mach reflection problem was first studied by Woodward and Colella [121] from which we take the setup also for our test.
We consider a computational domain \(\varOmega = [0,4] \times [0,1]\) covered with a coarse mesh of \(72\times 24\) elements where we activate the adaptive mesh refinement with \(\ell _{\max }=2\) and \(\mathfrak {r}=3\), and we compare the behavior of two fifth order schemes, namely the hybrid \(P_2P_4\) scheme and the \(P_4P_4\) pure DG scheme. For all the simulations, we employ the Rusanov flux and the second order TVD a posteriori subcell finite volume limiter.
At the beginning of the computation a shock wave moving at Mach number 10 is positioned at \((x,y) = (1/6,0)\) with an angle of \(60^\circ \) with respect to the x-axis and the initial pre-shock conditions (on the left of the shock) are given by a constant density equal to 1.4 and a constant pressure \(p=1\). At the bottom boundary we employ reflective boundary conditions for \(x>1/6\) where we suppose the presence of a wall, and the exact post-shock conditions for \(0 \le x \le 1/6\) to mimic an angled wedge. At the top boundary, the flow variables are set to describe the exact motion of the Mach 10 shock. Finally at the left and right boundaries we set inflow and outflow boundaries.
The obtained numerical results are shown in Fig. 10 for the entire domain; we also plot a zoom in Fig. 11 where, one can notice the roll up of the Mach stem due to Kelvin-Helmholtz instabilities.
3.2 Ideal MHD Equations
Next, we consider the equations of ideal classical magnetohydrodynamics (MHD) which, with respect to the previous set of equations, take also into account the evolution of the magnetic field \(\mathbf {B}\). The vector of the conserved variables \(\mathbf {Q}\) and the flux tensor \(\mathbf {F}\) of the general form (1) are given by
Here, \(\mathbf {B}=(B_x,B_y,B_z)\) represents the magnetic field and \(p_t=p+\frac{1}{8\pi }\mathbf {B}^2\) is the total pressure. The hydrodynamic pressure is given by the equation of state used to close the system, thus
System (39) requires an additional constraint on the divergence of the magnetic field to be satisfied, that is
Here, (39) includes one additional scalar PDE for the evolution of the variable \(\psi \), which is needed to transport divergence errors outside the computational domain with an artificial divergence cleaning speed \(c_h\), see [31, 91]. A similar approach is adopted in [16, 20, 57]. A more recent and more sophisticated methodology to fulfill this condition exactly at the discrete level also in the context of high order ADER WENO finite volume schemes on unstructured simplex meshes can be found in [7].
3.2.1 MHD Vortex
First, for the numerical convergence studies, we solve the vortex test problem proposed by Balsara in [6]. The computational domain is given by the box \(\varOmega =[0,10]\times [0,10]\) with wall boundary conditions imposed everywhere. The initial condition can be written in terms of the vector of primitive variables \(\mathbf {V} = ( \rho , u, v, w, p, B_x, B_y, B_z, \varPsi )^T\) as
with \(\delta \mathbf {v} = (\delta u, \delta v, 0)^T\), \(\ \delta \mathbf {B} = ( \delta B_x, \delta B_y, 0 )^T\) and
where \(\mathbf {e}_z = (0,0,1)\), \(\mathbf {r} = (x-5,y-5,0)\) and \(r = \left\| \mathbf {r} \right\| = \sqrt{ (x-5)^2 + (y-5)^2 }\). The divergence cleaning speed is chosen as \(c_h=2\). The other parameters are \(q=\frac{1}{2}\), \(\kappa =1\) and \(\mu =\sqrt{4 \pi }\), according to [6].
In Table 4, we report the convergence rates from second up to sixth order of accuracy for the MHD vortex test problem run on a sequence of successively refined meshes up to the final time \(t_f=1.0\). The optimal order of accuracy is achieved both in space and time both for the hybrid schemes \(P_NP_M\) with \(M>N\) and for the pure DG schemes with \(N=M\).
3.2.2 MHD Rotor Problem
The MHD rotor problem is a classical benchmark for MHD that was first proposed by Balsara and Spicer in [9]. It consists of a rapidly rotating fluid of high density embedded in a fluid at rest with low density. Both fluids are subject to an initially constant magnetic field.
The rotor produces torsional Alfvén waves that are launched into the outer fluid at rest, resulting in a decrease of angular momentum of the spinning rotor. We consider as computational domain the square \(\varOmega =[-0.5, 0.5]\times [-0.5, 0.5]\) and as initial condition we take the density inside a circle of radius \(r \le 0.1\) equal to \(\rho =10\), while the density of the ambient fluid at rest is set to \(\rho =1\). The rotor has an angular velocity of \(\omega =10\). The pressure is \(p=1\) and the magnetic field vector is set to \(\mathbf {B}= (2.5, 0, 0)^T\) in the entire domain. As proposed by Balsara and Spicer we apply a linear taper to the velocity and to the density in the range from \(0.1 \le r \le 0.105\) so that density and velocity match those of the ambient fluid at rest at a radius of \(r=0.105\). The speed for the hyperbolic divergence cleaning is set to \(c_h=8\) and \(\gamma =1.4\) is used. Wall boundary conditions are applied everywhere.
We run this problem on a coarse mesh made of \(45\times 45\) elements activating the AMR procedure with \(\ell _{\max }=2\) levels of refinement and \(\mathfrak {r}=3\), and for comparison we also employ a finer uniform mesh of \(405\times 405\) elements corresponding to the finest AMR grid level. In particular, we have employed the \(P_2P_4\) fifth order scheme and the \(P_4P_5\) sixth order scheme with the Rusanov numerical flux and our a posteriori subcell WENO FV limiter. In all the cases, we can observe a good agreement between the obtained numerical results and those available in the literature, see Figs. 12 and 13.
3.3 MHD Orszag–Tang Vortex
We consider now the the vortex system of Orszag and Tang [30, 92, 94] for the ideal MHD equations. We choose as computational domain the square \(\varOmega =[0,2\pi ]\times [0,2\pi ]\) with periodic boundary conditions set everywhere; we cover it with a uniform grid of \(128\times 128\) elements.
The initial condition written in terms of primitive variables are the following
with \(\gamma =5/3\). The divergence cleaning speed is set to \(c_h=2\) and the final time of the simulation is taken to be \(t_f=3\) as in [40].
We solve this test by employing three different fifth order schemes, namely the hybrid \(P_2P_4\) and \(P_3P_4\) schemes and the pure DG \(P_4P_4\) scheme, with the Rusanov numerical flux and equipped with our a posteriori subcell TVD finite volume limiter. The obtained numerical results and the cells on which the limiter is activated are presented in Fig. 14. One can notice that the three methods produce similar results with a good qualitative agreement compared to the solutions provided in [7, 40, 124]; moreover, the hybrid schemes are computationally more efficient than the pure DG scheme.
3.4 Special Relativistic MHD Equations
The system of equations of special relativistic magnetohydrodynamics (RMHD) is supposed to provide a sufficiently accurate description of the dynamics of those astrophysical plasma that move close to the speed of light and which are subject to electromagnetic forces that dominate over the gravitational forces. For example this is the case of high energy astrophysical phenomena like extragalactic jets [13], gamma-ray bursts [80] or magnetospheres of neutron stars [89].
For a more detailed description of this model and a review of the numerical methods used in its approximation we refer to [123] and the reference therein. Here we briefly recall only the main terms appearing in the equations, which indeed can be written under the general hyperbolic form (1) by choosing
where we have employed the classical tensor index notation based on the Einstein summation convention, which implies summation over two equal indices.
The conserved variables \((D,S_j,U,B^j)\) are related to the rest-mass density \(\rho \), to the thermal pressure p, to the fluid velocity \(v_i\) and to the magnetic field \(B^i\) by
where \(\varepsilon _{ijk}\) is the spatial Levi–Civita tensor and \(\delta _{ij}\) is the Kronecker symbol. As usual in ideal MHD, the electric field is given by \(\mathbf {E} = -\mathbf {v} \times \mathbf {B}\). The spatial tensor \(W^i_j\) in (45), representing the momentum flux density, is
where \(\delta _{ij}\) is the Kronecker delta.
The above equations include the divergence free condition \(\mathbf {\nabla }\cdot \mathbf {B}=0\) for the magnetic field, which, although is guaranteed by the Maxwell equations at a continuous level, is not automatically satisfied from a numerical point of view. Different strategies can be adopted in order to solve this problem (see [115] for a review). Here, as for the MHD case of Sect. 3.2, we have adopted the so called divergence-cleaning approach presented in [31, 91], which considers an augmented system with an additional equation for a scalar field \(\varPhi \), in order to propagate away the deviations from \(\mathbf {\nabla }\cdot \mathbf {B}=0\)
while the fluxes for the evolution of the magnetic field are also modified, namely \(\mathbf{f}^i(B^j)\rightarrow \varepsilon ^{jik}E^k + \varPhi \delta ^{ij}\).
3.4.1 Alfvén Wave
As for the previous set of equations we first of all check the convergence of our new numerical scheme. In the case of RMHD we can consider the propagation of a circularly polarized Alfven wave, for which an analytic solution can be computed, see [33, 78].
As initial condition we impose the following profile for the magnetic field and the velocity field
where \(B_0\) is the uniform magnetic field along x, \(\rho =p=B_0=\eta =1\), k is the wave number, while \(v_A\) is the Alfven speed at which the wave propagates
and \(\gamma =5/3\).
For the computational domain, we consider the 2D square \(\varOmega =[0, 2\pi ]\times [0, 2\pi ]\) with periodic boundary conditions set everywhere, and we run our simulation up to the final time \(t_f=L/v_A=2\pi /v_A\) corresponding to one period.
In Table 5, we report the \(L_2\) norm of the errors between our numerical results and the analytical solution for the variable \(\rho \). The convergence rates from second up to sixth order of accuracy are confirmed both for the hybrid schemes \(P_NP_M\) with \(M>N\) and for the pure DG schemes with \(N=M\).
3.4.2 Riemann Problems
Now, in order to check the robustness and accuracy of our a posteriori subcell FV limiter for the general class of the \(P_NP_M\) schemes, we solve two classical Riemann problems of RHD (i.e. RMHD with \(\mathbf {B}=\mathbf {0}\)) for which also an exact solution is available.
We consider the computational domain \(\varOmega =[-0.5,0.5]\times [0,1]\) and as initial condition we impose the discontinuous values given in Table 6. We solve these two test cases with a fifth order \(P_3P_5\) scheme and the HLLEM numerical flux, over a mesh of \(20\times 10\) elements with \(\ell _{\max }=2\) levels of refinement and \(\mathfrak {r}=3\).
The obtained numerical results, see Fig. 15, show once again that our limiter procedure preserves the resolution of the underlying \(P_NP_M\) scheme even on a coarse mesh.
3.4.3 Cylindrical Blast Wave
We now take into account a truly two dimensional test in RMHD, i.e. the cylindrical expansion of a blast wave in a plasma with an initially uniform magnetic field. This is a severe test proposed in [79], and subsequently also solved in [33, 50, 83, 123].
For the initial condition we set the rest-mass density and the pressure equal to \(\rho =0.01\) and \(p=1\) within a cylinder of radius \(r=1.0\), and \(\rho =10^{-4}\) and \(p=5\times 10^{-4}\) outside. Like in [79] and in [33], the inner and outer values are joined through a smooth ramp function between \(r=0.8\) and \(r=1\), to avoid a sharp discontinuity in the initial conditions. The plasma is initially at rest and subject to a constant magnetic field along the x-direction, i.e. \(B_x=0.1, B_y=0, B_z=0\).
We have solved this problem on the computational domain \(\varOmega = [-6,6]\times [-6,6]\), with a uniform mesh of \(160\times 160\) elements. We have used the Rusanov numerical flux and two sixth order schemes, namely the \(P_3P_5\) and the \(P_5P_5\) schemes, equipped with the robust a posteriori subcell second-order TVD FV limiter. The obtained numerical results, which agree with those available in the literature, are reported in Fig. 16.
3.4.4 RMHD Orszag–Tang Vortex
Finally, we have chosen the relativistic version of the well known Orszag–Tang vortex problem, proposed by [92], and adapted to the relativistic case in [50, 123]. The computational domain is \(\varOmega = [0,2\pi ]\times [0,2\pi ]\) and the initial conditions are given by
with \(\gamma =4/3\).
To solve this system we employ the sixth order hybrid scheme \(P_3P_5\) over a level zero mesh of \(45\times 45\) elements, activating the AMR feature with \(\ell _{\max }=2\) levels of refinement and \(\mathfrak {r}=3\). The obtained numerical results are reported in Fig. 17: once again we can notice that the two schemes have a similar resolution but the hybrid scheme is 2.62 times faster than a pure DG scheme, of the same order. Furthermore, we can observe that the proposed a posteriori subcell limiter procedure is robust and maintains the high resolution of the underlying \(P_NP_M\) scheme even on coarse meshes.
4 Conclusion
In this paper we have proposed a new simple, robust, accurate and computationally efficient limiting strategy for the general family of ADER \(P_NP_M\) schemes, allowing, for the first time in literature, the use of hybrid reconstructed methods (\(N>0, M>N\)) in the modeling of discontinuous phenomena. The key ideas behind our limiter are: i) its local activation only where the linear schemes introduces oscillations through an a posteriori detector, ii) its robustness due to the use of strong stability preserving TVD or WENO FV schemes as limiter, iii) its resolution due to the use of the limiter on \(2N+1\) subcells. Thus, we have been able to apply this new approach to many different systems of hyperbolic conservation laws, providing highly accurate numerical results in all cases. Moreover, we had the possibility to compare the performance of the class of intermediate \(P_NP_M\) schemes with \(M>N>0\) with pure DG schemes (\(M=N\)). We have observed that in most cases the intermediate \(P_NP_M\) schemes offer a similar resolution compared to pure DG methods, but at a reduced computational cost.
Future work will consider the extension of \(P_NP_M\) scheme with \(N~>~0\), \(M~>~N\) to unstructured moving meshes [18, 63], in particular for regenerating Voronoi tessellations [59, 60], and to the three-dimensional case. Finally, due to their low memory consumption and their gain in computational efficiency compared to DG schemes, they will be also considered for astrophysical applications [42, 44, 61] and the unified first order hyperbolic model of continuum mechanics proposed in [25, 48, 49, 93, 98], where a large number of conserved variables has to be discretized. Due to their accuracy and compact stencil in the future we also plan to use \(P_NP_M\) schemes with a posteriori subcell finite volume limiter in the context of hyperbolic reformulations of nonlinear dispersive systems and wave propagation problems, see e.g. [11, 12, 34, 54, 58].
References
Alic, D., Bona, C., Bona-Casas, C.: Towards a gauge-polyvalent numerical relativity code. Phys. Rev. D 79(4), 044026 (2009)
Alic, D., Bona-Casas, C., Bona, C., Rezzolla, L., Palenzuela, C.: Conformal and covariant formulation of the Z4 system with constraint-violation damping. Phys. Rev. D 85(6), 064040 (2012)
Aloy, M.A., Ibáñez, J.M., Martí, J.M., Müller, E.: GENESIS: a high-resolution code for three-dimensional relativistic hydrodynamics. Astrohys. J. Suppl. 122, 151–166 (1999)
Baer, M., Nunziato, J.: A two-phase mixture theory for the deflagration-to-detonation transition (DDT) in reactive granular materials. J. Multiphase Flow 12, 861–889 (1986)
Balsara, D.: Total variation diminishing scheme for relativistic magnetohydrodynamics. Astrophys. J. Suppl. Ser. 132, 83–101 (2001)
Balsara, D.: Second-order accurate schemes for magnetohydrodynamics with divergence-free reconstruction. Astrophys. J. Suppl. Ser. 151, 149–184 (2004)
Balsara, D., Dumbser, M.: Divergence-free MHD on unstructured meshes using high order finite volume schemes based on multidimensional Riemann solvers. J. Comput. Phys. 299, 687–715 (2015)
Balsara, D., Shu, C.: Monotonicity preserving weighted essentially non-oscillatory schemes with increasingly high order of accuracy. J. Comput. Phys. 160, 405–452 (2000)
Balsara, D., Spicer, D.: A staggered mesh algorithm using high order Godunov fluxes to ensure solenoidal magnetic fields in magnetohydrodynamic simulations. J. Comput. Phys. 149, 270–292 (1999)
Banyuls, F., Font, J.A., Ibáñez, J.M., Martí, J.M., Miralles, J.A.: Numerical 3 + 1 general-relativistic hydrodynamics: a local characteristic approach. Astrophys. J. 476, 221 (1997)
Bassi, C., Bonaventura, L., Busto, S., Dumbser, M.: A hyperbolic reformulation of the Serre–Green–Naghdi model for general bottom topographies. Comput. Fluids 212, 104716 (2020)
Bassi, C., Busto, S., Dumbser, M.: High order ADER-DG schemes for the simulation of linear seismic waves induced by nonlinear dispersive free-surface water waves. Appl. Numer. Math. 158, 236–263 (2020)
Begelman, M.C., Blandford, R.D., Rees, M.J.: Theory of extragalactic radio sources. Rev. Mod. Phys. 56, 255–351 (1984)
Berger, M.J., Colella, P.: Local adaptive mesh refinement for shock hydrodynamics. J. Comput. Phys. 82, 64–84 (1989)
Berger, M.J., Oliger, J.: Adaptive mesh refinement for hyperbolic partial differential equations. J. Comput. Phys. 53, 484 (1984)
Boscheri, W.: An efficient high order direct ALE ADER finite volume scheme with a posteriori limiting for hydrodynamics and magnetohydrodynamics. Int. J. Numer. Methods Fluids 84(2), 76–106 (2017)
Boscheri, W., Balsara, D.: High order direct Arbitrary-Lagrangian–Eulerian (ALE) PNPM schemes with WENO adaptive-order reconstruction on unstructured meshes. J. Comput. Phys. 398, 108899 (2019)
Boscheri, W., Dumbser, M.: Arbitrary-Lagrangian–Eulerian one-step WENO finite volume schemes on unstructured triangular meshes. Commun. Comput. Phys. 14, 1174–1206 (2013)
Boscheri, W., Dumbser, M.: Arbitrary-Lagrangian–Eulerian discontinuous Galerkin schemes with a posteriori subcell finite volume limiting on moving unstructured meshes. J. Comput. Phys. 346, 449–479 (2017)
Boscheri, W., Dumbser, M., Balsara, D.: High-order ADER-WENO ALE schemes on unstructured triangular meshes-application of several node solvers to hydrodynamics and magnetohydrodynamics. Int. J. Numer. Methods Fluids 76(10), 737–778 (2014)
Boscheri, W., Loubère, R.: High order accurate direct Arbitrary-Lagrangian–Eulerian ADER-MOOD finite volume schemes for non-conservative hyperbolic systems with stiff source terms. Commun. Comput. Phys. 21, 271–312 (2017)
Boscheri, W., Loubère, R., Dumbser, M.: Direct Arbitrary-Lagrangian–Eulerian ADER-MOOD finite volume schemes for multidimensional hyperbolic conservation laws. J. Comput. Phys. 292, 56–87 (2015)
Boscheri, W., Semplice, M., Dumbser, M.: Central WENO subcell finite volume limiters for ADER discontinuous Galerkin schemes on fixed and moving unstructured meshes. Commun. Comput. Phys. 25, 311–346 (2019)
Bungartz, H., Mehl, M., Neckel, T., Weinzierl, T.: The PDE framework Peano applied to fluid dynamics: an efficient implementation of a parallel multiscale fluid dynamics solver on octree-like adaptive Cartesian grids. Comput. Mech. 46, 103–114 (2010)
Busto, S., Chiocchetti, S., Dumbser, M., Gaburro, E., Peshkov, I.: High order ADER schemes for continuum mechanics. Front. Phys. 8, 32 (2020)
Busto, S., Toro, E., Vázquez-Cendón, E.: Design and analysis of ADER-type schemes for model advection–diffusion–reaction equations. J. Comput. Phys. 327, 553–575 (2016)
Casulli, V.: Semi-implicit finite difference methods for the two-dimensional shallow water equations. J. Comput. Phys. 86, 56–74 (1990)
Chiravalle, V., Morgan, N.: A 3D Lagrangian cell-centered hydrodynamic method with higher-order reconstructions for gas and solid dynamics. Comput. Math. Appl. 78(2), 298–317 (2019)
Clain, S., Diot, S., Loubère, R.: A high-order finite volume method for systems of conservation laws-multi-dimensional optimal order detection (MOOD). J. Comput. Phys. 230(10), 4028–4050 (2011)
Dahlburg, R.B., Picone, J.M.: Evolution of the Orszag–Tang vortex system in a compressible medium. I. Initial average subsonic flow. Phys. Fluids B 1, 2153–2171 (1989)
Dedner, A., Kemm, F., Kröner, D., Munz, C.D., Schnitzer, T., Wesenberg, M.: Hyperbolic divergence cleaning for the MHD equations. J. Comput. Phys. 175, 645–673 (2002)
de la Rosa, J.N., Munz, C.D.: Hybrid DG/FV schemes for magnetohydrodynamics and relativistic hydrodynamics. Comput. Phys. Commun. 222, 113–135 (2018)
Del Zanna, L., Zanotti, O., Bucciantini, N., Londrillo, P.: ECHO: a Eulerian conservative high-order scheme for general relativistic magnetohydrodynamics and magnetodynamics. Astron. Astrophys. 473, 11–30 (2007)
Dhaouadi, F., Favrie, N., Gavrilyuk, S.: Extended Lagrangian approach for the defocusing nonlinear Schrödinger equation. In: Studies in Applied Mathematics, pp. 1–20 (2018)
Diot, S., Clain, S., Loubère, R.: Improved detection criteria for the multi-dimensional optimal order detection (MOOD) on unstructured meshes with very high-order polynomials. Comput. Fluids 64, 43–63 (2012)
Diot, S., Loubère, R., Clain, S.: The MOOD method in the three-dimensional case: very-high-order finite volume method for hyperbolic systems. Int. J. Numer. Methods Fluids 73, 362–392 (2013)
Dumbser, M.: Arbitrary high order PNPM schemes on unstructured meshes for the compressible Navier–Stokes equations. Comput. Fluids 39, 60–76 (2010)
Dumbser, M.: A diffuse interface method for complex three-dimensional free surface flows. Comput. Methods Appl. Mech. Eng. 257, 47–64 (2013)
Dumbser, M., Balsara, D.: A new, efficient formulation of the HLLEM Riemann solver for general conservative and non-conservative hyperbolic systems. J. Comput. Phys. 304, 275–319 (2016)
Dumbser, M., Balsara, D., Toro, E., Munz, C.: A unified framework for the construction of one-step finite-volume and discontinuous Galerkin schemes. J. Comput. Phys. 227, 8209–8253 (2008)
Dumbser, M., Balsara, D.S., Tavelli, M., Fambri, F.: A divergence-free semi-implicit finite volume scheme for ideal, viscous, and resistive magnetohydrodynamics. Int. J. Numer. Methods Fluids 89(1–2), 16–42 (2019)
Dumbser, M., Fambri, F., Gaburro, E., Reinarz, A.: On GLM curl cleaning for a first order reduction of the CCZ4 formulation of the Einstein field equations. J. Comput. Phys. 404, 109088 (2020)
Dumbser, M., Fambri, F., Tavelli, M., Bader, M., Weinzierl, T.: Efficient implementation of ADER discontinuous Galerkin schemes for a scalable hyperbolic PDE engine. Axioms 7(3), 63 (2018)
Dumbser, M., Guercilena, F., Köppel, S., Rezzolla, L., Zanotti, O.: Conformal and covariant Z4 formulation of the Einstein equations: strongly hyperbolic first-order reduction and solution with discontinuous Galerkin schemes. Phys. Rev. D 97, 084053 (2018)
Dumbser, M., Hidalgo, A., Zanotti, O.: High order space-time adaptive ADER-WENO finite volume schemes for non-conservative hyperbolic systems. Comput. Methods Appl. Mech. Eng. 268, 359–387 (2014)
Dumbser, M., Käser, M.: Arbitrary high order non-oscillatory finite volume schemes on unstructured meshes for linear hyperbolic systems. J. Comput. Phys. 221, 693–723 (2007)
Dumbser, M., Loubère, R.: A simple robust and accurate a posteriori sub-cell finite volume limiter for the discontinuous Galerkin method on unstructured meshes. J. Comput. Phys. 319, 163–199 (2016)
Dumbser, M., Peshkov, I., Romenski, E., Zanotti, O.: High order ADER schemes for a unified first order hyperbolic formulation of continuum mechanics: viscous heat-conducting fluids and elastic solids. J. Comput. Phys. 314, 824–862 (2016)
Dumbser, M., Peshkov, I., Romenski, E., Zanotti, O.: High order ADER schemes for a unified first order hyperbolic formulation of Newtonian continuum mechanics coupled with electro-dynamics. J. Comput. Phys. 348, 298–342 (2017)
Dumbser, M., Zanotti, O.: Very high order PNPM schemes on unstructured meshes for the resistive relativistic MHD equations. J. Comput. Phys. 228, 6991–7006 (2009)
Dumbser, M., Zanotti, O., Hidalgo, A., Balsara, D.: ADER-WENO finite volume schemes with space-time adaptive mesh refinement. J. Comput. Phys. 248, 257–286 (2013)
Dumbser, M., Zanotti, O., Loubère, R., Diot, S.: A posteriori subcell limiting of the discontinuous Galerkin finite element method for hyperbolic conservation laws. J. Comput. Phys. 278, 47–75 (2014)
Einfeldt, B., Munz, C.D., Roe, P.L., Sjögreen, B.: On Godunov-type methods near low densities. J. Comput. Phys. 92(2), 273–295 (1991)
Escalante, C., Morales, T.: A general non-hydrostatic hyperbolic formulation for Boussinesq dispersive shallow flows and its numerical approximation. J. Sci. Comput. 83, 62 (2020)
Fambri, F.: Discontinuous Galerkin methods for compressible and incompressible flows on space-time adaptive meshes: toward a novel family of efficient numerical methods for fluid dynamics. Arch. Comput. Methods Eng. 27(1), 199–283 (2020)
Fambri, F., Dumbser, M., Köppel, S., Rezzolla, L., Zanotti, O.: ADER discontinuous Galerkin schemes for general-relativistic ideal magnetohydrodynamics. Mon. Notices R. Astron. Soc. (MNRAS) 477, 4543–4564 (2018)
Fambri, F., Dumbser, M., Zanotti, O.: Space-time adaptive ADER-DG schemes for dissipative flows: compressible Navier–Stokes and resistive MHD equations. Comput. Phys. Commun. 220, 297–318 (2017)
Favrie, N., Gavrilyuk, S.: A rapid numerical method for solving Serre–Green–Naghdi equations describing long free surface gravity waves. Nonlinearity 30, 2718–2736 (2017)
Gaburro, E.: A unified framework for the solution of hyperbolic PDE systems using high order direct Arbitrary-Lagrangian–Eulerian schemes on moving unstructured meshes with topology change. Arch. Comput. Methods Eng. (2020). https://doi.org/10.1007/s11831-020-09411-7
Gaburro, E., Boscheri, W., Chiocchetti, S., Klingenberg, C., Springel, V., Dumbser, M.: High order direct Arbitrary-Lagrangian–Eulerian schemes on moving Voronoi meshes with topology changes. J. Comput. Phys. 407, 109167 (2020)
Gaburro, E., Castro, M.J., Dumbser, M.: Well-balanced Arbitrary-Lagrangian–Eulerian finite volume schemes on moving nonconforming meshes for the Euler equations of gas dynamics with gravity. Mon. Not. R. Astron. Soc. 477(2), 2251–2275 (2018)
Gaburro, E., Castro, M.J., Dumbser, M.: A well balanced diffuse interface method for complex nonhydrostatic free surface flows. Comput. Fluids 175, 180–198 (2018)
Gaburro, E., Dumbser, M., Castro, M.: Direct Arbitrary-Lagrangian–Eulerian finite volume schemes on moving nonconforming unstructured meshes. Comput. Fluids 159, 254–275 (2017)
Godunov, S.: Finite difference methods for the computation of discontinuous solutions of the equations of fluid dynamics. Math. USSR Sbornik 47, 271–306 (1959)
Godunov, S., Romenski, E.: Elements of Continuum Mechanics and Conservation Laws. Kluwer Academic, Dordrecht (2003)
Godunov, S.K., Romenskii, E.I.: Nonstationary equations of nonlinear elasticity theory in Eulerian coordinates. J. Appl. Mech. Tech. Phys. 13(6), 868–884 (1972)
Guermond, J.L., Nazarov, M., Popov, B., Tomas, I.: Second-order invariant domain preserving approximation of the Euler equations using convex limiting. SIAM J. Sci. Comput. 40(5), A3211–A3239 (2018)
Halashi, B., Luo, H.: A reconstructed discontinuous Galerkin method for magnetohydrodynamics on arbitrary grids. J. Comput. Phys. 326, 258–277 (2016)
Harten, A., Engquist, B., Osher, S., Chakravarthy, S.: Uniformly high order essentially non-oscillatory schemes. III. J. Comput. Phys. 71, 231–303 (1987)
Harten, A., Osher, S.: Uniformly high-order accurate nonoscillatory schemes I. SIAM J. Numer. Anal. 24, 279–309 (1987)
Hu, C., Shu, C.: A high-order WENO finite difference scheme for the equations of ideal magnetohydrodynamics. J. Comput. Phys. 150, 561–594 (1999)
Ji, L., Xu, Y., Ryan, J.: Accuracy enhancement of the linear convection–diffusion equation in multiple dimensions. Math. Comput. 81, 1929–1950 (2012)
Jiang, G., Shu, C.: Efficient implementation of weighted ENO schemes. J. Comput. Phys. 126(1), 202–228 (1996)
Kamm, J., Timmes, F.: On efficient generation of numerically robust Sedov solutions. Technical Report LA-UR-07-2849, LANL (2007)
Kemm, F., Gaburro, E., Thein, F., Dumbser, M.: A simple diffuse interface approach for compressible flows around moving solids of arbitrary shape based on a reduced baer-nunziato model. Comput. Fluids 204, 104536 (2020)
Khokhlov, A.: Fully threaded tree algorithms for adaptive refinement fluid dynamics simulations. J. Comput. Phys. 143(2), 519–543 (1998)
King, J., Mirzaee, H., Ryan, J., Kirby, R.: Smoothness-increasing accuracy-conserving SIAC) filtering for discontinuous Galerkin solutions: improved errors versus higher-order accuracy. J. Sci. Comput. 53, 129–149 (2012)
Komissarov, S.S.: On the properties of Alfvén waves in relativistic magnetohydrodynamics. Phys. Lett. A 232, 435–442 (1997)
Komissarov, S.S.: A Godunov-type scheme for relativistic magnetohydrodynamics. Mon. Not. R. Astron. Soc. 303, 343–366 (1999)
Kouveliotou, C., Meegan, C.A., Fishman, G.J., Bhat, N.P., Briggs, M.S., Koshut, T.M., Paciesas, W.S., Pendleton, G.N.: Identification of two classes of gamma-ray bursts. Astrophys. J. 413, L101–L104 (1993)
Lax, P.: Weak solutions of nonlinear hyperbolic equations and their numerical approximation. Commun. Pure Appl. Math. 7, 159–193 (1954)
van Leer, B., Nomura, S.: Discontinuous Galerkin for diffusion. In: Proceedings of 17th AIAA Computational Fluid Dynamics Conference, 6–9 June 2005, AIAA-2005-5108 (2005)
Leismann, T., Antón, L., Aloy, M.A., Müller, E., Martí, J.M., Miralles, J.A., Ibáñez, J.M.: Relativistic MHD simulations of extragalactic jets. Astron. Astrophys. 436, 503–526 (2005)
Löhner, R.: An adaptive finite element scheme for transient problems in CFD. Comput. Methods Appl. Mech. Eng. 61, 323–338 (1987)
Loubere, R., Dumbser, M., Diot, S.: A new family of high order unstructured MOOD and ADER finite volume schemes for multidimensional systems of hyperbolic conservation laws. Commun. Comput. Phys. 16(3), 718–763 (2014)
Loubère, R., Maire, P., Váchal, P.: 3D staggered Lagrangian hydrodynamics scheme with cell-centered Riemann solver-based artificial viscosity. Int. J. Numer. Methods Fluids 72, 22–42 (2013)
Luo, H., Luo, L., Nourgaliev, R., Mousseau, V., Dinh, N.: A reconstructed discontinuous Galerkin method for the compressible Navier–Stokes equations on arbitrary grids. J. Comput. Phys. 229, 6961–6978 (2010)
Luo, H., Xia, Y., Spiegel, S., Nourgaliev, R., Jiang, Z.: A reconstructed discontinuous Galerkin method based on a Hierarchical WENO reconstruction for compressible flows on tetrahedral grids. J. Comput. Phys. 236, 477–492 (2013)
Michel, F.C.: Theory of neutron star magnetospheres (1991)
Mirzaee, H., King, J., Ryan, J., Kirby, R.: Smoothness-increasing accuracy-conserving (SIAC) filters for discontinuous Galerkin solutions over unstructured triangular meshes. SIAM J. Sci. Comput. 35, A212–A230 (2013)
Munz, C., Omnes, P., Schneider, R., Sonnendrücker, E., Voss, U.: Divergence correction techniques for Maxwell solvers based on a hyperbolic model. J. Comput. Phys. 161, 484–511 (2000)
Orszag, S.A., Tang, C.M.: Small-scale structure of two-dimensional magnetohydrodynamic turbulence. J. Fluid Mech. 90, 129 (1979)
Peshkov, I., Romenski, E.: A hyperbolic model for viscous Newtonian flows. Contin. Mech. Thermodyn. 28, 85–104 (2016)
Picone, J.M., Dahlburg, R.B.: Evolution of the Orszag–Tang vortex system in a compressible medium. II. Supersonic flow. Phys. Fluids B 3, 29–44 (1991)
Rannabauer, L., Dumbser, M., Bader, M.: ADER-DG with a-posteriori finite-volume limiting to simulate tsunamis in a parallel adaptive mesh refinement framework. Comput. Fluids 173, 299–306 (2018)
Reinarz, A., et al.: Exahype: an engine for parallel dynamically adaptive simulations of wave problems. Comput. Phys. Commun. 107251 (2020)
Reinarz, A., Gallard, J.M., Bader, M.: Influence of a-posteriori subcell limiting on fault frequency in higher-order DG schemes. In: 2018 IEEE/ACM 8th Workshop on Fault Tolerance for HPC at eXtreme Scale (FTXS), pp. 79–86. IEEE (2018)
Romenski, E., Peshkov, I., Dumbser, M., Fambri, F.: A new continuum model for general relativistic viscous heat-conducting media. Philos. Trans. R. Soc. A 378(2170), 20190175 (2020)
Ryan, J., Cockburn, B.: Local derivative post-processing for the discontinuous Galerkin method. J. Comput. Phys. 228, 8642–8664 (2009)
Ryan, J., Shu, C., Atkins, H.: Extension of a post-processing technique for the discontinuous Galerkin method for hyperbolic equations with applications to an aeroacoustic problem. SIAM J. Sci. Comput. 26, 821–843 (2005)
Sedov, L.: Similarity and Dimensional Methods in Mechanics. Academic Press, New York (1959)
Shi, J., Zhang, Y.T., Shu, C.W.: Resolution of high order WENO schemes for complicated flow structures. J. Comput. Phys. 186(2), 690–696 (2003)
Shu, C.: Essentially non-oscillatory and weighted essentially non-oscillatory schemes for hyperbolic Conservation Laws. NASA/CR-97-206253 ICASE Report No. 97-65 (1997)
Shu, C., Osher, S.: Efficient implementation of essentially non-oscillatory shock capturing schemes. J. Comput. Phys. 77, 439–471 (1988)
Shu, C.W.: High order WENO and DG methods for time-dependent convection-dominated PDEs: a brief survey of several recent developments. J. Comput. Phys. 316, 598–613 (2016)
Sonntag, M., Munz, C.: Shock capturing for discontinuous Galerkin methods using finite volume subcells. In: Fuhrmann, J., Ohlberger, M., Rohde, C. (eds.) Finite Volumes for Complex Applications VII, pp. 945–953. Springer, Berlin (2014)
Stroud, A.: Approximate Calculation of Multiple Integrals. Prentice-Hall Inc., Englewood Cliffs (1971)
Tavelli, M., Dumbser, M.: A high order semi-implicit discontinuous Galerkin method for the two dimensional shallow water equations on staggered unstructured meshes. Appl. Math. Comput. 234, 623–644 (2014)
Titarev, V., Toro, E.: ADER: arbitrary high order Godunov approach. J. Sci. Comput. 17(1–4), 609–618 (2002)
Titarev, V., Toro, E.: ADER schemes for three-dimensional nonlinear hyperbolic systems. J. Comput. Phys. 204, 715–736 (2005)
Toro, E.: Riemann Solvers and Numerical Methods for Fluid Dynamics, 2nd edn. Springer, Berlin (1999)
Toro, E.: Riemann Solvers and Numerical Methods for Fluid Dynamics: A Practical Introduction. Springer, Berlin (2009)
Toro, E., Titarev, V.: Solution of the generalized Riemann problem for advection-reaction equations. Proc. R. Soc. Lond. 458, 271–281 (2002)
Toro, E.F., Titarev, V.A.: Derivative Riemann solvers for systems of conservation laws and ADER methods. J. Comput. Phys. 212(1), 150–165 (2006)
Toth, G.: The div B = 0 constraint in shock-capturing magnetohydrodynamics codes. J. Comput. Phys. 161(2), 605–652 (2000)
Wang, C., Cheng, J., Berndt, M., Carlson, N., Luo, H.: Application of nonlinear Krylov acceleration to a reconstructed discontinuous Galerkin method for compressible flows. Comput. Fluids 163, 32–49 (2018)
Wang, C., Luo, H., Shashkov, M.: A reconstructed discontinuous Galerkin method for compressible flows in Lagrangian formulation. Comput. Fluids 202, 104522 (2020)
Wang, C., Luo, H., Shashkov, M.: A reconstructed discontinuous Galerkin method for compressible flows in Lagrangian formulation. Comput. Fluids 202, 104522 (2020)
Wang, X., Cheng, C., Luo, H., Zhao, Q.: A reconstructed direct discontinuous Galerkin method for simulating the compressible laminar and turbulent flows on hybrid grids. Comput. Fluids 168, 216–231 (2018)
Weinzierl, T., Mehl, M.: Peano—a traversal and storage scheme for octree-like adaptive Cartesian multiscale grids. SIAM J. Sci. Comput. 33, 2732–2760 (2011)
Woodward, P., Colella, P.: The numerical simulation of two-dimensional fluid flow with strong shocks. J. Comput. Phys. 54, 115–173 (1984)
Zanna, L.D., Bucciantini, N., Londrillo, P.: An efficient shock-capturing central-type scheme for multidimensional relativistic flows II. Magnetohydrodynamics. Astron. Astrophys. 400, 397–413 (2003)
Zanotti, O., Fambri, F., Dumbser, M.: Solving the relativistic magnetohydrodynamics equations with ADER discontinuous Galerkin methods, a posteriori subcell limiting and adaptive mesh refinement. Mon. Not. R. Astron. Soc. 452, 3010–3029 (2015)
Zanotti, O., Fambri, F., Dumbser, M., Hidalgo, A.: Space-time adaptive ADER discontinuous Galerkin finite element schemes with a posteriori sub-cell finite volume limiting. Comput. Fluids 118, 204–224 (2015)
Zhang, Y., Shu, C.: Third order WENO scheme on three dimensional tetrahedral meshes. Commun. Comput. Phys. 5, 836–848 (2009)
Acknowledgements
The research presented in this paper has been partially financed by the European Research Council (ERC) under the European Union’s Seventh Framework Programme (FP7/2007-2013) with the research project STiMulUs, ERC Grant Agreement No. 278267. E. G. has been supported by a national mobility grant for young researchers in Italy, funded by GNCS-INdAM. E. G. has also received funding from the University of Trento via the Strategic Initiative Starting Grant Giovani Ricercatori 2019. M. D. has been funded by the European Union’s Horizon 2020 Research and Innovation Programme under the project ExaHyPE, Grant No. 671698 (call FETHPC-1-2014). M. D. also acknowledges the financial support received from the Italian Ministry of Education, University and Research (MIUR) in the frame of the Departments of Excellence Initiative 2018–2022 attributed to DICAM of the University of Trento (Grant L. 232/2016) and in the frame of the PRIN 2017 project Innovative numerical methods for evolutionary partial differential equations and applications. Furthermore, M. D. has also received funding from the University of Trento via the Strategic Initiative Modeling and Simulation.
Funding
Open Access funding provided by Universitá degli Studi di Trento
Author information
Authors and Affiliations
Corresponding author
Additional information
Publisher's Note
Springer Nature remains neutral with regard to jurisdictional claims in published maps and institutional affiliations.
Rights and permissions
Open Access This article is licensed under a Creative Commons Attribution 4.0 International License, which permits use, sharing, adaptation, distribution and reproduction in any medium or format, as long as you give appropriate credit to the original author(s) and the source, provide a link to the Creative Commons licence, and indicate if changes were made. The images or other third party material in this article are included in the article’s Creative Commons licence, unless indicated otherwise in a credit line to the material. If material is not included in the article’s Creative Commons licence and your intended use is not permitted by statutory regulation or exceeds the permitted use, you will need to obtain permission directly from the copyright holder. To view a copy of this licence, visit http://creativecommons.org/licenses/by/4.0/.
About this article
Cite this article
Gaburro, E., Dumbser, M. A Posteriori Subcell Finite Volume Limiter for General \(P_NP_M\) Schemes: Applications from Gasdynamics to Relativistic Magnetohydrodynamics. J Sci Comput 86, 37 (2021). https://doi.org/10.1007/s10915-020-01405-8
Received:
Revised:
Accepted:
Published:
DOI: https://doi.org/10.1007/s10915-020-01405-8