Keywords

These keywords were added by machine and not by the authors. This process is experimental and the keywords may be updated as the learning algorithm improves.

1 Introduction

Discontinuous Galerkin (DG) methods offer an enormous flexibility regarding local grid refinement and variation of polynomial degrees rendering such concepts powerful discretization tools which have proven to be well-suited for a variety of different problem classes. While initially the main focus has been on transport problems like hyperbolic conservation laws, interest has meanwhile shifted towards diffusion problems. Specifically, we focus here on the efficient solution of the linear systems of equations that arise from the Symmetric Interior Penalty DG method applied to elliptic boundary value problems. [1] The principal objective is to develop robust preconditioners for the full “DG-flexibility” which means to obtain uniformly bounded condition numbers for locally refined meshes and arbitrarily (subject to mild grading conditions) varying polynomial degrees at the expense of linearly scaling computational work. A first step towards that goal has been made in [3] treating the case of geometrically conforming meshes but arbitrarily large variable polynomial degrees which already exposes major principal obstructions. In this paper we complement this work by detailed studies of several issues arising in [3].

To our knowledge the only concept yielding full robustness with respect to polynomial degrees is based on Legendre-Gauß-Lobatto (LGL) quadrature. Specifically, in the framework of auxiliary space methods low order finite element discretizations on LGL-grids can be used to precondition high order polynomial discretizations. However, when dealing with variable degrees the possible non-matching of such grids at element interfaces turns out to severely obstruct in general the design of efficient preconditioners. To overcome these difficulties we propose in [3] a concatenation of auxiliary space preconditioners. In the first stage the spectral DG formulation (SE-DG) is transferred to a spectral continuous Galerkin formulation (SE-CG). In the second stage we proceed from here to a finite element formulation on a specific dyadic grid (DFE-CG) which is associated with an LGL-grid but belongs to a nested hierarchy. The latter problem can then be tackled by a multilevel wavelet preconditioner presented in forthcoming work. The overall path of our iterated auxiliary space preconditioner therefore is \(\mathbf{SE-DG}\ \rightarrow\ \text{SE-CG}\ \rightarrow\ \mathbf{DFE-CG}\). It should be noted that a natural alternative is to combine the first stage with a domain decomposition substructuring preconditioner as proposed in [6] admitting a mild growth of condition numbers with respect to the polynomial degree.

We are content here for most part of the paper with brief pointers to the detailed analysis in [24] to an extent needed for the present discussion.

Section 2 introduces our model problem, the LGL technique is explained in Sect. 3. The auxiliary space method is detailed in Sect. 4, while Sects. 5 and 6 consider stages 1 and 2 of our preconditioner. Finally in Sect. 7 we give some numerical experiments that shed light on the constants that arise in four basic inequalities used in the second stage.

2 Model Problem and Discontinuous Galerkin Formulation

Given a bounded Lipschitz domain \(\varOmega \subset \mathbb{R}^{d}\) with piecewise smooth boundary we consider as a simple model problem the weak formulation: find \(u \in H_{0}^{1}(\varOmega )\) such that

$$\displaystyle\begin{array}{rcl} a(u,v):=\int _{\varOmega }\nabla u \cdot \nabla v\ \mathrm{d}x = \left \langle f,v\right \rangle,\quad v \in H_{0}^{1}(\varOmega )& & {}\\ \end{array}$$

of Poisson’s equation −Δ u = f on Ω with zero Dirichlet boundary conditions u = 0 on ∂ Ω. For simplicity, we assume that \(\bar{\varOmega }\) is the union of a collection \(\mathcal{R}\) of finitely many (hyper-)rectangles, which at most overlap with their boundaries. More complex geometries can be handled by isoparametric mappings. By \(\mathcal{F}_{l}(R)\) we denote the l-dimensional facets of a (hyper-)rectangle R and by \(\mathcal{F}_{l} = \cup _{R\in \mathcal{R}}\mathcal{F}_{l}(R)\) the union of all these objects. Let H k (R) be the side length of R in the k-th coordinate direction.

The polynomial degrees used in each cell R are defined as \(p = (p_{k})_{k=1}^{d}\), where p k is the polynomial degree in the k-th coordinate direction. We introduce the piecewise constant function δ = (H, p) that collects the hp approximation parameters. On δ we impose mild grading conditions, see [3] for the details.

For the spectral discretization of our model problem, we choose the DG spectral ansatz space \(V _{\delta }:= \left \{v \in L^{2}(\varOmega ): v\vert _{R} \in \mathbb{Q}_{p}(R)\ \text{for all}\ R \in \mathcal{R}\right \}\), where \(\mathbb{Q}_{p}(R)\) is the tensor space of all polynomials of degree at most p on the (hyper-)rectangle R.

We employ the standard notation of DG methods for jumps and averages on the mesh skeleton and on ∂ Ω. The The Symmetric Interior Penalty Discontinuous Galerkin method (SIPG) \(a_{\delta }(u,v) = \left \langle f,v\right \rangle\) for all v ∈ V δ is based on the SIPG bilinear form

$$\displaystyle\begin{array}{rcl} & & a_{\delta }(u_{\delta },v_{\delta }):=\sum _{R\in \mathcal{R}}(\nabla u_{\delta },\nabla v_{\delta })_{R} +\sum _{F\in \mathcal{F}}(-(\left \{\nabla u_{\delta }\right \},\left [v_{\delta }\right ])_{F} - (\left [u_{\delta }\right ],\left \{\nabla v_{\delta }\right \})_{F}) {}\\ & & \qquad \qquad \qquad \qquad \qquad \qquad +\sum _{F\in \mathcal{F}}\gamma \omega _{F}(\left [u_{\delta }\right ],\left [v_{\delta }\right ])_{F} = (f,v_{\delta })_{\varOmega },\quad v_{\delta } \in V _{\delta } {}\\ \end{array}$$

with \(\omega _{F}:=\max \left \{\omega _{F,R^{-}},\omega _{F,R^{+}}\right \}\) for internal faces F and \(\omega _{F,R^{\pm }}:= \frac{p_{k}(R^{\pm })(p_{ k}(R^{\pm })+1)} {H_{k}(R^{\pm })}\). For boundary faces \(F \subset \partial \varOmega\) we set \(\omega _{F,R}:= \frac{p_{k}(R)(p_{k}(R)+1)} {H_{k}(R)}\).

3 Legendre-Gauß-Lobatto (LGL) Grids

Denoting by \((\xi _{i})_{i=1}^{p-1}\) the zeros of the first derivative of the p-th Legendre polynomial L p , in ascending order, and setting ξ 0 = −1 and ξ p  = 1, \(\mathcal{G}_{p} = (\xi _{i})_{0\leq i\leq p}\) is the Legendre-Gauß-Lobatto (LGL) grid of degree p on the reference interval \(\hat{I} = [-1,1]\), see e.g. [5]. In combination with appropriate LGL weights \((w_{i})_{0\leq i\leq p}\) the LGL points of order p can be interpreted as quadrature points of a quadrature rule of exactness 2p − 1. In [4] we prove quasi-uniformity of the LGL-grids \((\mathcal{G}_{p})_{p\in \mathbb{N}}\), i.e., \(\frac{h_{i+1},p} {h_{i},p}\), for 1 ≤ i ≤ p − 1, remains uniformly bounded independent of p, where \(h_{i} = \vert \xi _{i} -\xi _{i-1}\vert \).

The particular relevance of tensor product LGL-grids for preconditioners for spectral element discretizations lies in the two norm equivalences (see [5])

$$\displaystyle\begin{array}{rcl} \big\|\varphi \big\|_{H^{i}(R)} \eqsim \big\| \mathcal{I}_{h,p}^{R}\varphi \big\|_{ H^{i}(R)}\quad \text{for all}\quad \varphi \in \mathbb{Q}_{p}(R),\quad i \in \{ 0,1\},& &{}\end{array}$$
(1)

which hold uniformly for any d-dimensional hypercube \(R =\mathop{ \mbox{ $\times $}}_{k=1}^{d}I_{k}\) where \(\mathcal{I}_{h,p}^{R}\) is the piecewise multi-linear interpolant on the tensor product LGL-grid.

4 Abstract Theory: Auxiliary Space Method

The auxiliary space method (ASM) [911] is a powerful concept for the construction of preconditioners that can be derived from the fictitious space lemma [79].

Given a problem a(u, v) = f(v) for all v ∈ V on the linear space V equipped with a bilinear form \(a(\cdot,\cdot ): V \times V \rightarrow \mathbb{R}\), we seek an auxiliary space \(\tilde{V }\) with an auxiliary form \(\tilde{a}(\cdot,\cdot ):\tilde{ V } \times \tilde{ V } \rightarrow \mathbb{R}\) that is in some sense close to the original one but easier to solve. Note that we neither require \(V \subset \tilde{ V }\) nor \(\tilde{V } \subset V\) which is important in the context of non-conforming discretizations. Therefore on the sum \(\hat{V } = V +\tilde{ V }\) we need in general another version \(\hat{a}(\cdot,\cdot ):\hat{ V } \times \hat{ V } \rightarrow \mathbb{R}\) as well as a second form \(b(\cdot,\cdot ):\hat{ V } \times \hat{ V } \rightarrow \mathbb{R}\) which dominates a on V and plays the role of a smoother. The required closeness of the spaces V and \(\tilde{V }\) is described with the aid of two linear operators \(Q:\tilde{ V } \rightarrow V\) and \(\tilde{Q}: V \rightarrow \tilde{ V }\). Specifically, these operators have to satisfy certain direct estimates involving the above bilinear forms. For the details on the ASM conditions see [9].

Lemma 1 (Stable Splitting [9]).

Under the assumptions of the ASM, we have the following stable splitting

$$\displaystyle\begin{array}{rcl} a(v,v) \sim \inf _{w\in V,\tilde{v}\in \tilde{V }:\ v=w+Q\tilde{v}}\left (b(w,w) +\tilde{ a}(\tilde{v},\tilde{v})\right )\quad \text{for all}\ v \in V.& & {}\\ \end{array}$$

The main result of the ASM is given in the following theorem [9].

Theorem 1 (Auxiliary Space Method).

Let \(\mathbf{C_{B}}\) and \(\mathbf{C_{\tilde{A}}}\) be symmetric preconditioners for B and \(\mathbf{\tilde{A}}\) , respectively. Let S be the representation of \(Q:\tilde{ V } \rightarrow V\) . Then \(\mathbf{C_{A}}:= \mathbf{C_{B}} + \mathbf{S}\mathbf{C_{\tilde{A}}}\mathbf{S}^{T}\) is a symmetric preconditioner for A . Moreover, there exists a uniform constant C such that the spectral condition number of C A A satisfies

$$\displaystyle\begin{array}{rcl} \kappa (\mathbf{C_{A}}\mathbf{A}) \leq C\kappa (\mathbf{C_{B}}\mathbf{B})\kappa (\mathbf{C_{\tilde{A}}}\mathbf{\tilde{A}}).& & {}\\ \end{array}$$

For a given practical application it remains to identify a suitable auxiliary space \(\tilde{V }\), the bilinear forms \(\tilde{a}:\tilde{ V } \times \tilde{ V } \rightarrow \mathbb{R}\) and \(\hat{a},b:\hat{ V } \times \hat{ V } \rightarrow \mathbb{R}\), as well as the two linear operators Q and \(\tilde{Q}\), such that ASM conditions are satisfied. In addition efficient preconditioners for the “easier” auxiliary problems \(\mathbf{C_{\tilde{A}}}\) and C B need to be devised. Of course, the rationale is that the complexity to apply \(\mathbf{C_{\tilde{A}}}\) and C B should be much lower than solving the original problem.

Note that the operator \(\tilde{Q}\) need not be implemented but enters only the analysis.

5 Stage 1: ASM DG-SEM → CG-SEM

In the first stage, we choose the largest conforming subspace \(\tilde{V }:= V _{\delta } \cap H_{0}^{1}(\varOmega )\) of V: = V δ as auxiliary space so that Q can be taken as the canonical injection. The definition of the operator \(\tilde{Q}\) can be found in [3].

The main issue in this stage is the choice of the auxiliary form b(⋅ , ⋅ ). Using LGL-quadrature combined with an inverse estimate for the partial derivatives in the form a(⋅ , ⋅ ) we arrive at

$$\displaystyle\begin{array}{rcl} b(u,v):=\sum _{R\in \mathcal{R}}\sum _{\xi \in \mathcal{G}_{p}(R)}u(\xi )\,v(\xi )\,c_{\xi }W_{\xi },\quad W_{\xi }:= \left (\sum _{k=1}^{d}w_{\xi,k}^{-2}\right )w_{\xi,k}.& & {}\\ \end{array}$$

Here the weights c ξ  ∼ 1 are chosen as

$$\displaystyle\begin{array}{rcl} c_{\xi }:= \left \{\begin{array}{cc} \beta _{1}(c_{1}^{2} +\gamma \rho _{1}\omega _{F}w_{F,R}/W_{\xi }),&\xi \in \mathcal{G}_{p}(F,R),\ F \in \mathcal{F}_{d-1}(R),\ R \in \mathcal{R}, \\ \beta _{1}c_{1}^{2}, & \text{else}, \end{array} \right.& & {}\\ \end{array}$$

where \(w_{F,R^{\pm }}\) is the LGL quadrature weight on F seen as a face of R ± and the parameters β, ρ 1 can be used to “tune” the scheme. The resulting matrix B is diagonal so that the application of \(\mathbf{C_{B}}:= \mathbf{B}^{-1}\) requires only \(\mathcal{O}(N)\) operations. It is shown in [3] that all ASM conditions are satisfied for this choice of b(⋅ , ⋅ ). Numerical experiments show that the parameters β 1 and ρ 1 can by and large be optimized independently of the polynomial degrees.

6 Stage 2: CG-SEM → CG-DFEM

The second stage involves three major ingredients, namely

  1. (1)

    the choice of spaces of piecewise multi-linear finite elements on hierarchies of nested anisotropic dyadic grids, to permit a subsequent application of efficient multilevel preconditioners,

  2. (2)

    the construction of the operators Q and \(\tilde{Q}\), and

  3. (3)

    the construction of the auxiliary bilinear form b(⋅ , ⋅ ).

As for (1), the non-matching of LGL-grids for different degrees p at interfaces prevents us from taking low order finite element spaces as auxiliary space for the high order conforming problem resulting from the first stage. Instead, with each LGL-grid \(\mathcal{G}_{p}\) we associate a dyadic grid \(\mathcal{G}_{D,p}\), which is roughly generated as follows: starting with the boundary points { − 1, 1} as initial guess we adaptively refine the grid. A subinterval in the grid is bisected into two parts of equal size, if the smallest of the overlapping LGL-subintervals is longer than α times its length. The parameter α therefore controls the mesh size of the dyadic grid. However, for input LGL-grids of different polynomial degrees the resulting dyadic grids are not necessarily nested yet. How to ensure nestedness while keeping the grid size under control is shown in [3, 4]. The key quality of the associated dyadic grids \(\mathcal{G}_{D,p}\) is that mutual low order piecewise multi-linear interpolation between the low order finite element spaces on \(\mathcal{G}_{p}(R),\mathcal{G}_{D,p}(R)\) is uniformly H 1-stable, see [3] for the proofs. Denoting by V h, D, p (R) the space of piecewise multi-linear conforming finite elements on \(\mathcal{G}_{D,p}(R)\), we now take \(V:= V _{\delta } \cap H_{0}^{1}(\varOmega )\) and \(\tilde{V }:= V _{h,D} \cap H_{0}^{1}(\varOmega )\), where \(V _{h,D} =\{ v \in C^{0}(\overline{\varOmega })\:\ \forall R \in \mathcal{R}\;,\ v_{\vert R}:= v_{R} \in V _{h,D,p}(R)\}\).

Concerning (2), the operator Q is defined element-wise as follows. For a given element vertex \(z \in \mathcal{F}_{0}(R)\) let p denote the polynomial degree vector whose kth entry is the minimum of the kth entries of all degree vectors associated with elements R sharing z as a vertex. Here a grading of the degrees is important. Let \(\varPhi _{z} \in \mathbb{Q}_{1}(R)\) the multi-linear shape function on R satisfying conditions \(\varPhi _{z}(y) =\delta _{y,z}\) for all \(y \in \mathcal{F}_{0}(R)\). Then, we define

$$\displaystyle\begin{array}{rcl} \tilde{v}_{z}^{{\ast}}:= \mathcal{I}_{ h,D,p_{z}^{{\ast}}}^{R}\left (\varPhi _{ z}\tilde{v}_{R}\right ) \in V _{h,D,p_{z}^{{\ast}}}(R)\qquad \text{and}\qquad v_{z}^{{\ast}} = \mathcal{I}_{ p_{z}^{{\ast}}}^{R}\,\tilde{v}_{ z}^{{\ast}}\in \mathbb{Q}_{ p_{z}^{{\ast}}}(R)\;,\quad & &{}\end{array}$$
(2)

where \(\mathcal{I}_{h,D,p_{z}^{{\ast}}}^{R},\mathcal{I}_{p_{z}^{{\ast}}}^{R}\) are the dyadic piecewise multilinear and high order LGL-interpolants on the respective grids. Summing-up over the vertices of R, we define

$$\displaystyle{ \tilde{v}_{R}^{{\ast}}:=\sum _{ z\in \mathcal{F}_{0}(R)}\tilde{v}_{z}^{{\ast}}\in V _{ h,D,p}(R)\qquad \text{and}\qquad Q_{R}\tilde{v}_{R}:= v_{R}^{{\ast}}:=\sum _{ z\in \mathcal{F}_{0}(R)}v_{z}^{{\ast}}\in \mathbb{Q}_{ p}(R)\;. }$$
(3)

The operator \(\tilde{Q}\) is defined analogously with the roles of dyadic and LGL-grids exchanged, see [3].

To finally address (3), for the structure of the form \(b(\cdot,\cdot )\) from the first stage the direct estimates in the ASM conditions are no longer valid. It has to be suitably relaxed along the following lines. We make an ansatz of the form

$$\displaystyle\begin{array}{rcl} b(v,w):=\sum _{R\in \mathcal{R}}\sum _{k=1}^{d}\Big(\sum _{ S_{\ell}\in \mathcal{T}_{0,k}(R)}b_{R,k,S_{\ell}}^{0}(v,w) +\sum _{ S_{\ell}\in \mathcal{T}_{1,k}(R)}b_{R,k,S_{\ell}}^{1}(v,w)\Big),& &{}\end{array}$$
(4)

where \(\mathcal{T}_{0,k}(R)\) is the collection of those LGL-subcells S , \(\ell\in \mathop{\mbox{ $\times $}}_{k=1}^{d}\{1,\ldots,p_{k}(R)\}\), with side lengths \(h_{l}^{(\ell_{l})}\) in the LGL-grid \(\mathcal{G}_{p}(R)\) that are strongly anisotropic according to \((\max _{l\neq k}h_{l}^{(\ell_{l})})/h_{ k}^{(\ell_{k})} > C_{\text{aspect}}\) for a fixed constant C aspect > 0, while \(\mathcal{T}_{1,k}(R)\) is comprised of the remaining “isotropic” cells. On the isotropic cells in \(\mathcal{T}_{1,k}(R)\) we use an inverse estimate applied to piecewise multi-linear LGL-interpolants of v and w. On the remaining anisotropic cells we retain integrals over the variable involving the partial derivative and use quadrature in the remaining variables. For this auxiliary form b(⋅ , ⋅ ) and the above operators Q and \(\tilde{Q}\) we can verify all ASM conditions, see [3]. Note that the Gramian B is no longer diagonal and we refer to [3] for efficient realizations of C B.

7 Numerical Experiments: Constants in the Basic Interpolation Inequalities

A fundamental role in the proof of the ASM-conditions in the second stage \(\mathbf{SE-CG}\ \rightarrow\ \mathbf{DFE-CG}\ \) is played by four basic interpolation estimates. In particular, knowing the size of the constants arising in these inequalities and their dependence on the polynomial degrees helps understanding the quantitative effects observed in more complex situations later on.

As before, let Φ z denote the affine shape function now on the reference interval \(\hat{I} = [-1,1] \subset \mathbb{R}\) satisfying \(\varPhi _{z}(x) =\delta _{x,z}\) for x, z ∈ {−1, 1}. By \(\mathcal{I}_{q}\) we denote the polynomial interpolation operator on the LGL-grid \(\mathcal{G}_{q}\) for polynomial degree q and by \(\mathcal{I}_{h,D,q}\) the piecewise affine interpolation operator on the dyadic grid \(\mathcal{G}_{D,q}\) associated with \(\mathcal{G}_{q}\).

A major tool for proving the ASM conditions is given by the following theorem.

Theorem 2.

Assume that \(\mathit{cp} \leq q \leq p\) for some fixed constant c > 0. Then we have

$$\displaystyle{ \vert \mathcal{I}_{q}(\varPhi _{z}v)\vert _{H^{m}(\hat{I})} \lesssim \Vert v\Vert _{H^{m}(\hat{I})}\quad \text{for all}\ v \in \mathbb{Q}_{p}(\hat{I}),\ z \in \{-1,1\},\ m \in \{ 0,1\}, }$$
(5)

and

$$\displaystyle{ \vert \mathcal{I}_{h,D,q}(\varPhi _{z}\tilde{v})\vert _{H^{m}(\hat{I})} \lesssim \Vert \tilde{ v}\Vert _{H^{m}(\hat{I})}\quad \text{for all}\ \tilde{v} \in V _{h,D,p}(\hat{I}),\ z \in \{-1,1\},\ m \in \{ 0,1\}. }$$
(6)

We determine next numerically the smallest constants that fulfill the inequalities (5) and (6). This can be obtained by solving generalized eigenvalue problems for the largest generalized eigenvalue. For all dyadic grids we choose the grid generation parameter α = 1. 2, which balances two effects: on the one hand, the generated auxiliary space is rich enough for a good approximation while on the other hand, to keep the solution of the auxiliary space feasible, the dyadic grid does not have too many degrees of freedom. Figure 1 shows the dependence of the smallest possible constants on the polynomial degrees p and q in the range 1 ≤ p, q ≤ 64.

We observe that the constants in (5) and (6) become large for m = 0 when the quotient pq increases, but eventually stay bounded as long as cp ≤ q ≤ p for a fixed c > 0. For m = 1 we find uniform moderate constants in (5) and (6) for arbitrary choices of p and q. While the nodes in the LGL-grids move gradually with increasing degree the associated dyadic grids change more abruptly which explains the jumps in the graph in Fig. 1c.

Fig. 1
figure 1

Dependance of the constants in (5) and (6) on p and q. (a) (5), m = 0, (b) (5), m = 1, (c) (6), m = 0, (d) (6), m = 1

We are particularly interested in the behavior of the constants when the quotient of p and q is fixed, i.e., we restrict ourselves to a cross section through the three-dimensional plots along a line in the pq-plane. As an example, we choose p = 2q representing strongly varying degrees on adjacent elements. The smallest constants in the inequalities for polynomial degrees q up to 128 are displayed in Fig. 2.

Fig. 2
figure 2

Constants in the basic interpolation inequalities for p = 2q (dashed line: (5), solid line: (6)). (a) m = 0, (b) m = 1

While for m = 0 the constants quickly approach an asymptotic value for both (5) and for (6), this is not true for (5) and m = 1. In this case we observe a very slow monotonic convergence to its asymptotic limit. Thus for moderate polynomial degrees one still observes a significant growth. Since this estimate is relevant for the ASM conditions on the operator \(\tilde{Q}\) in the second stage, this leads to some growth of the condition number of the preconditioned problem for moderate polynomial degrees and significant inter-element jumps, although it eventually stays uniformly bounded independent of the polynomial degree q.

8 Summary and Outlook

In this paper we sketch a preconditioner for the spectral symmetric interior penalty discontinuous Galerkin method that, under mild grading conditions, is robust in variably arbitrarily large polynomial degrees, announcing detailed results given in [3]. The concept is based on the LGL-techniques for spectral methods combined with judiciously chosen nested dyadic grids through an iterated application of the auxiliary space method. A detailed exposition of a multiwavelet preconditioner for the dyadic grid problem, an extension to locally refined grids with hanging nodes, strategies for parallel implementations, and the treatment of jumping coefficients will be presented in forthcoming work.