Discontinuous Galerkin method

In applied mathematics, discontinuous Galerkin methods (DG methods) form a class of numerical methods for solving differential equations. They combine features of the finite element and the finite volume framework and have been successfully applied to hyperbolic, elliptic, parabolic and mixed form problems arising from a wide range of applications. DG methods have in particular received considerable interest for problems with a dominant first-order part, e.g. in electrodynamics, fluid mechanics and plasma physics. Indeed, the solutions of such problems may involve strong gradients (and even discontinuities) so that classical finite element methods fail, while finite volume methods are restricted to low order approximations.

Discontinuous Galerkin methods were first proposed and analyzed in the early 1970s as a technique to numerically solve partial differential equations. In 1973 Reed and Hill introduced a DG method to solve the hyperbolic neutron transport equation.

The origin of the DG method for elliptic problems cannot be traced back to a single publication as features such as jump penalization in the modern sense were developed gradually. However, among the early influential contributors were Babuška, J.-L. Lions, Joachim Nitsche and Miloš Zlámal. DG methods for elliptic problems were already developed in a paper by Garth Baker in the setting of 4th order equations in 1977. A more complete account of the historical development and an introduction to DG methods for elliptic problems is given in a publication by Arnold, Brezzi, Cockburn and Marini. A number of research directions and challenges on DG methods are collected in the proceedings volume edited by Cockburn, Karniadakis and Shu.

Overview

Much like the continuous Galerkin (CG) method, the discontinuous Galerkin (DG) method is a finite element method formulated relative to a weak formulation of a particular model system. Unlike traditional CG methods that are conforming, the DG method works over a trial space of functions that are only piecewise continuous, and thus often comprise more inclusive function spaces than the finite-dimensional inner product subspaces utilized in conforming methods.

As an example, consider the continuity equation for a scalar unknown ρ {\displaystyle \rho } in a spatial domain Ω {\displaystyle \Omega } without "sources" or "sinks" :

ρ t + J = 0 , {\displaystyle {\frac {\partial \rho }{\partial t}}+\nabla \cdot \mathbf {J} =0,}

where J {\displaystyle \mathbf {J} } is the flux of ρ {\displaystyle \rho } .

Now consider the finite-dimensional space of discontinuous piecewise polynomial functions over the spatial domain Ω {\displaystyle \Omega } restricted to a discrete triangulation Ω h {\displaystyle \Omega _{h}} , written as

S h p ( Ω h ) = { v | Ω e i P p ( Ω e i ) ,     Ω e i Ω h } {\displaystyle S_{h}^{p}(\Omega _{h})=\{v_{|\Omega _{e_{i}}}\in P^{p}(\Omega _{e_{i}}),\ \ \forall \Omega _{e_{i}}\in \Omega _{h}\}}

for P p ( Ω e i ) {\displaystyle P^{p}(\Omega _{e_{i}})} the space of polynomials with degrees less than or equal to p {\displaystyle p} over element Ω e i {\displaystyle \Omega _{e_{i}}} indexed by i {\displaystyle i} . Then for finite element shape functions N j P p {\displaystyle N_{j}\in P^{p}} the solution is represented by

ρ h i = j = 1 dofs ρ j i ( t ) N j i ( x ) , x Ω e i . {\displaystyle \rho _{h}^{i}=\sum _{j=1}^{\text{dofs}}\rho _{j}^{i}(t)N_{j}^{i}({\boldsymbol {x}}),\quad \forall {\boldsymbol {x}}\in \Omega _{e_{i}}.}

Then similarly choosing a test function

φ h i ( x ) = j = 1 dofs φ j i N j i ( x ) , x Ω e i , {\displaystyle \varphi _{h}^{i}({\boldsymbol {x}})=\sum _{j=1}^{\text{dofs}}\varphi _{j}^{i}N_{j}^{i}({\boldsymbol {x}}),\quad \forall {\boldsymbol {x}}\in \Omega _{e_{i}},}

multiplying the continuity equation by φ h i {\displaystyle \varphi _{h}^{i}} and integrating by parts in space, the semidiscrete DG formulation becomes:

d d t Ω e i ρ h i φ h i d x + Ω e i φ h i J h n d x = Ω e i J h φ h i d x . {\displaystyle {\frac {d}{dt}}\int _{\Omega _{e_{i}}}\rho _{h}^{i}\varphi _{h}^{i}\,d{\boldsymbol {x}}+\int _{\partial \Omega _{e_{i}}}\varphi _{h}^{i}\mathbf {J} _{h}\cdot {\boldsymbol {n}}\,d{\boldsymbol {x}}=\int _{\Omega _{e_{i}}}\mathbf {J} _{h}\cdot \nabla \varphi _{h}^{i}\,d{\boldsymbol {x}}.}

Scalar hyperbolic conservation law

A scalar hyperbolic conservation law is of the form

t u + x f ( u ) = 0 for t > 0 , x R u ( 0 , x ) = u 0 ( x ) , {\displaystyle {\begin{aligned}\partial _{t}u+\partial _{x}f(u)&=0\quad {\text{for}}\quad t>0,\,x\in \mathbb {R} \\u(0,x)&=u_{0}(x)\,,\end{aligned}}}

where one tries to solve for the unknown scalar function u u ( t , x ) {\displaystyle u\equiv u(t,x)} , and the functions f , u 0 {\displaystyle f,u_{0}} are typically given.

Space discretization

The x {\displaystyle x} -space will be discretized as

R = k I k , I k := ( x k , x k + 1 ) for x k < x k + 1 . {\displaystyle \mathbb {R} =\bigcup _{k}I_{k}\,,\quad I_{k}:=\left(x_{k},x_{k+1}\right)\quad {\text{for}}\quad x_{k}<x_{k+1}\,.}

Furthermore, we need the following definitions

h k := | I k | , h := sup k h k , x ^ k := x k + h k 2 . {\displaystyle h_{k}:=|I_{k}|\,,\quad h:=\sup _{k}h_{k}\,,\quad {\hat {x}}_{k}:=x_{k}+{\frac {h_{k}}{2}}\,.}

Basis for function space

We derive the basis representation for the function space of our solution u {\displaystyle u} . The function space is defined as

S h p := { v L 2 ( R ) : v | I k Π p } for p N 0 , {\displaystyle S_{h}^{p}:=\left\lbrace v\in L^{2}(\mathbb {R} ):v{\Big |}_{I_{k}}\in \Pi _{p}\right\rbrace \quad {\text{for}}\quad p\in \mathbb {N} _{0}\,,}

where v | I k {\displaystyle {v|}_{I_{k}}} denotes the restriction of v {\displaystyle v} onto the interval I k {\displaystyle I_{k}} , and Π p {\displaystyle \Pi _{p}} denotes the space of polynomials of maximal degree p {\displaystyle p} . The index h {\displaystyle h} should show the relation to an underlying discretization given by ( x k ) k {\displaystyle \left(x_{k}\right)_{k}} . Note here that v {\displaystyle v} is not uniquely defined at the intersection points ( x k ) k {\displaystyle (x_{k})_{k}} .

At first we make use of a specific polynomial basis on the interval [ 1 , 1 ] {\displaystyle [-1,1]} , the Legendre polynomials ( P n ) n N 0 {\displaystyle (P_{n})_{n\in \mathbb {N} _{0}}} , i.e.,

P 0 ( x ) = 1 , P 1 ( x ) = x , P 2 ( x ) = 1 2 ( 3 x 2 1 ) , {\displaystyle P_{0}(x)=1\,,\quad P_{1}(x)=x\,,\quad P_{2}(x)={\frac {1}{2}}(3x^{2}-1)\,,\quad \dots }

Note especially the orthogonality relations

P i , P j L 2 ( [ 1 , 1 ] ) = 2 2 i + 1 δ i j i , j N 0 . {\displaystyle \left\langle P_{i},P_{j}\right\rangle _{L^{2}([-1,1])}={\frac {2}{2i+1}}\delta _{ij}\quad \forall \,i,j\in \mathbb {N} _{0}\,.}

Transformation onto the interval [ 0 , 1 ] {\displaystyle [0,1]} , and normalization is achieved by functions ( φ i ) i {\displaystyle (\varphi _{i})_{i}}

φ i ( x ) := 2 i + 1 P i ( 2 x 1 ) for x [ 0 , 1 ] , {\displaystyle \varphi _{i}(x):={\sqrt {2i+1}}P_{i}(2x-1)\quad {\text{for}}\quad x\in [0,1]\,,}

which fulfill the orthonormality relation

φ i , φ j L 2 ( [ 0 , 1 ] ) = δ i j i , j N 0 . {\displaystyle \left\langle \varphi _{i},\varphi _{j}\right\rangle _{L^{2}([0,1])}=\delta _{ij}\quad \forall \,i,j\in \mathbb {N} _{0}\,.}

Transformation onto an interval I k {\displaystyle I_{k}} is given by ( φ ¯ k i ) i {\displaystyle \left({\bar {\varphi }}_{ki}\right)_{i}}

φ ¯ k i := 1 h k φ i ( x x k h k ) for x I k , {\displaystyle {\bar {\varphi }}_{ki}:={\frac {1}{\sqrt {h_{k}}}}\varphi _{i}\left({\frac {x-x_{k}}{h_{k}}}\right)\quad {\text{for}}\quad x\in I_{k}\,,}

which fulfill

φ ¯ k i , φ ¯ k j L 2 ( I k ) = δ i j i , j N 0 k . {\displaystyle \left\langle {\bar {\varphi }}_{ki},{\bar {\varphi }}_{kj}\right\rangle _{L^{2}(I_{k})}=\delta _{ij}\quad \forall \,i,j\in \mathbb {N} _{0}\forall \,k\,.}

For L {\displaystyle L^{\infty }} -normalization we define φ k i := h k φ ¯ k i {\displaystyle \varphi _{ki}:={\sqrt {h_{k}}}{\bar {\varphi }}_{ki}} , and for L 1 {\displaystyle L^{1}} -normalization we define φ ~ k i := 1 h k φ ¯ k i {\displaystyle {\tilde {\varphi }}_{ki}:={\frac {1}{\sqrt {h_{k}}}}{\bar {\varphi }}_{ki}} , s.t.

φ k i L ( I k ) = φ i L ( [ 0 , 1 ] ) =: c i , and φ ~ k i L 1 ( I k ) = φ i L 1 ( [ 0 , 1 ] ) =: c i , 1 . {\displaystyle \|\varphi _{ki}\|_{L^{\infty }(I_{k})}=\|\varphi _{i}\|_{L^{\infty }([0,1])}=:c_{i,\infty }\quad {\text{and}}\quad \|{\tilde {\varphi }}_{ki}\|_{L^{1}(I_{k})}=\|\varphi _{i}\|_{L^{1}([0,1])}=:c_{i,1}\,.}

Finally, we can define the basis representation of our solutions u h {\displaystyle u_{h}}

u h ( t , x ) := i = 0 p u k i ( t ) φ k i ( x ) for x ( x k , x k + 1 ) u k i ( t ) = u h ( t , ) , φ ~ k i L 2 ( I k ) . {\displaystyle {\begin{aligned}u_{h}(t,x):=&\sum _{i=0}^{p}u_{ki}(t)\varphi _{ki}(x)\quad {\text{for}}\quad x\in (x_{k},x_{k+1})\\u_{ki}(t)=&\left\langle u_{h}(t,\cdot ),{\tilde {\varphi }}_{ki}\right\rangle _{L^{2}(I_{k})}\,.\end{aligned}}}

Note here, that u h {\displaystyle u_{h}} is not defined at the interface positions.

Besides, prism bases are employed for planar-like structures, and are capable for 2-D/3-D hybridation.

DG-scheme

The conservation law is transformed into its weak form by multiplying with test functions, and integration over test intervals

t u + x f ( u ) = 0 t u , v L 2 ( I k ) + x f ( u ) , v L 2 ( I k ) = 0 for v S h p t u , φ ~ k i L 2 ( I k ) + x f ( u ) , φ ~ k i L 2 ( I k ) = 0 for k i p . {\displaystyle {\begin{aligned}\partial _{t}u+\partial _{x}f(u)&=0\\\Rightarrow \quad \left\langle \partial _{t}u,v\right\rangle _{L^{2}(I_{k})}+\left\langle \partial _{x}f(u),v\right\rangle _{L^{2}(I_{k})}&=0\quad {\text{for}}\quad \forall \,v\in S_{h}^{p}\\\Leftrightarrow \quad \left\langle \partial _{t}u,{\tilde {\varphi }}_{ki}\right\rangle _{L^{2}(I_{k})}+\left\langle \partial _{x}f(u),{\tilde {\varphi }}_{ki}\right\rangle _{L^{2}(I_{k})}&=0\quad {\text{for}}\quad \forall \,k\;\forall \,i\leq p\,.\end{aligned}}}

By using partial integration one is left with

d d t u k i ( t ) + f ( u ( t , x k + 1 ) ) φ ~ k i ( x k + 1 ) f ( u ( t , x k ) ) φ ~ k i ( x k ) f ( u ( t , ) ) , φ ~ k i L 2 ( I k ) = 0 for k i p . {\displaystyle {\begin{aligned}{\frac {\mathrm {d} }{\mathrm {d} t}}u_{ki}(t)+f(u(t,x_{k+1})){\tilde {\varphi }}_{ki}(x_{k+1})-f(u(t,x_{k})){\tilde {\varphi }}_{ki}(x_{k})-\left\langle f(u(t,\,\cdot \,)),{\tilde {\varphi }}_{ki}'\right\rangle _{L^{2}(I_{k})}=0\quad {\text{for}}\quad \forall \,k\;\forall \,i\leq p\,.\end{aligned}}}

The fluxes at the interfaces are approximated by numerical fluxes g {\displaystyle g} with

g k := g ( u k , u k + ) , u k ± := u ( t , x k ± ) , {\displaystyle g_{k}:=g(u_{k}^{-},u_{k}^{+})\,,\quad u_{k}^{\pm }:=u(t,x_{k}^{\pm })\,,}

where u k ± {\displaystyle u_{k}^{\pm }} denotes the left- and right-hand sided limits. Finally, the DG-Scheme can be written as

d d t u k i ( t ) + g k + 1 φ ~ k i ( x k + 1 ) g k φ ~ k i ( x k ) f ( u ( t , ) ) , φ ~ k i L 2 ( I k ) = 0 for k i p . {\displaystyle {\begin{aligned}{\frac {\mathrm {d} }{\mathrm {d} t}}u_{ki}(t)+g_{k+1}{\tilde {\varphi }}_{ki}(x_{k+1})-g_{k}{\tilde {\varphi }}_{ki}(x_{k})-\left\langle f(u(t,\,\cdot \,)),{\tilde {\varphi }}_{ki}'\right\rangle _{L^{2}(I_{k})}=0\quad {\text{for}}\quad \forall \,k\;\forall \,i\leq p\,.\end{aligned}}}

Scalar elliptic equation

A scalar elliptic equation is of the form

x x u = f ( x ) for x ( a , b ) u ( x ) = g ( x ) for x = a , b {\displaystyle {\begin{aligned}-\partial _{xx}u&=f(x)\quad {\text{for}}\quad x\in (a,b)\\u(x)&=g(x)\,\quad {\text{for}}\,\quad x=a,b\end{aligned}}}

This equation is the steady-state heat equation, where u {\displaystyle u} is the temperature. Space discretization is the same as above. We recall that the interval ( a , b ) {\displaystyle (a,b)} is partitioned into N + 1 {\displaystyle N+1} intervals of length h {\displaystyle h} .

We introduce jump [ ] {\displaystyle [{}\cdot {}]} and average { } {\displaystyle \{{}\cdot {}\}} of functions at the node x k {\displaystyle x_{k}} :

[ v ] | x k = v ( x k + ) v ( x k ) , { v } | x k = 0.5 ( v ( x k + ) + v ( x k ) ) {\displaystyle [v]{\Big |}_{x_{k}}=v(x_{k}^{+})-v(x_{k}^{-}),\quad \{v\}{\Big |}_{x_{k}}=0.5(v(x_{k}^{+})+v(x_{k}^{-}))}

The interior penalty discontinuous Galerkin (IPDG) method is: find u h {\displaystyle u_{h}} satisfying

A ( u h , v h ) + A ( u h , v h ) = ( v h ) + ( v h ) {\displaystyle A(u_{h},v_{h})+A_{\partial }(u_{h},v_{h})=\ell (v_{h})+\ell _{\partial }(v_{h})}

where the bilinear forms A {\displaystyle A} and A {\displaystyle A_{\partial }} are

A ( u h , v h ) = k = 1 N + 1 x k 1 x k x u h x v h k = 1 N { x u h } x k [ v h ] x k + ε k = 1 N { x v h } x k [ u h ] x k + σ h k = 1 N [ u h ] x k [ v h ] x k {\displaystyle A(u_{h},v_{h})=\sum _{k=1}^{N+1}\int _{x_{k-1}}^{x_{k}}\partial _{x}u_{h}\partial _{x}v_{h}-\sum _{k=1}^{N}\{\partial _{x}u_{h}\}_{x_{k}}[v_{h}]_{x_{k}}+\varepsilon \sum _{k=1}^{N}\{\partial _{x}v_{h}\}_{x_{k}}[u_{h}]_{x_{k}}+{\frac {\sigma }{h}}\sum _{k=1}^{N}[u_{h}]_{x_{k}}[v_{h}]_{x_{k}}}

and

A ( u h , v h ) = x u h ( a ) v h ( a ) x u h ( b ) v h ( b ) ε x v h ( a ) u h ( a ) + ε x v h ( b ) u h ( b ) + σ h ( u h ( a ) v h ( a ) + u h ( b ) v h ( b ) ) {\displaystyle A_{\partial }(u_{h},v_{h})=\partial _{x}u_{h}(a)v_{h}(a)-\partial _{x}u_{h}(b)v_{h}(b)-\varepsilon \partial _{x}v_{h}(a)u_{h}(a)+\varepsilon \partial _{x}v_{h}(b)u_{h}(b)+{\frac {\sigma }{h}}{\big (}u_{h}(a)v_{h}(a)+u_{h}(b)v_{h}(b){\big )}}

The linear forms {\displaystyle \ell } and {\displaystyle \ell _{\partial }} are

( v h ) = a b f v h {\displaystyle \ell (v_{h})=\int _{a}^{b}fv_{h}}

and

( v h ) = ε x v h ( a ) g ( a ) + ε x v h ( b ) g ( b ) + σ h ( g ( a ) v h ( a ) + g ( b ) v h ( b ) ) {\displaystyle \ell _{\partial }(v_{h})=-\varepsilon \partial _{x}v_{h}(a)g(a)+\varepsilon \partial _{x}v_{h}(b)g(b)+{\frac {\sigma }{h}}{\big (}g(a)v_{h}(a)+g(b)v_{h}(b){\big )}}

The penalty parameter σ {\displaystyle \sigma } is a positive constant. Increasing its value will reduce the jumps in the discontinuous solution. The term ε {\displaystyle \varepsilon } is chosen to be equal to 1 {\displaystyle -1} for the symmetric interior penalty Galerkin method; it is equal to + 1 {\displaystyle +1} for the non-symmetric interior penalty Galerkin method.

Direct discontinuous Galerkin method

The direct discontinuous Galerkin (DDG) method is a new discontinuous Galerkin method for solving diffusion problems. In 2009, Liu and Yan first proposed the DDG method for solving diffusion equations.[1][2] The advantages of this method compared with Discontinuous Galerkin method is that the direct discontinuous Galerkin method derives the numerical format by directly taking the numerical flux of the function and the first derivative term without introducing intermediate variables. We still can get a reasonable numerical results by using this method, and the derivation process is more simple, the amount of calculation is greatly reduced.

The direct discontinuous finite element method is a branch of the Discontinuous Galerkin methods. It mainly includes transforming the problem into variational form, regional unit splitting, constructing basis functions, forming and solving discontinuous finite element equations, and convergence and error analysis.

For example, consider a nonlinear diffusion equation, which is one-dimensional:

U t ( a ( U ) U x ) x = 0     i n   ( 0 , 1 ) × ( 0 , T ) {\displaystyle U_{t}-{(a(U)\cdot U_{x})}_{x}=0\ \ in\ (0,1)\times (0,T)} , in which U ( x , 0 ) = U 0 ( x )     o n   ( 0 , 1 ) {\displaystyle U(x,0)=U_{0}(x)\ \ on\ (0,1)}

Space discretization

Firstly, define { I j = ( x j 1 2 ,   x j + 1 2 ) , j = 1... N } {\displaystyle \left\{I_{j}=\left(x_{j-{\frac {1}{2}}},\ x_{j+{\frac {1}{2}}}\right),j=1...N\right\}} , and Δ x j = x j + 1 2 x j 1 2 {\displaystyle \Delta x_{j}=x_{j+{\frac {1}{2}}}-x_{j-{\frac {1}{2}}}} . Therefore we have done the space discretization of x {\displaystyle x} . Also, define Δ x = max 1 j < N   Δ x j {\displaystyle \Delta x=\max _{1\leq j<N}\ \Delta x_{j}} .

We want to find an approximation u {\displaystyle u} to U {\displaystyle U} such that t [ 0 , T ] {\displaystyle \forall t\in \left[0,T\right]} , u V Δ x {\displaystyle u\in \mathbb {V} _{\Delta x}} ,

V Δ x := { v L 2 ( 0 , 1 ) : v | I j P k ( I j ) ,   j = 1 , . . . , N } {\displaystyle \mathbb {V} _{\Delta x}:=\left\{v\in L^{2}\left(0,1\right):{v|}_{I_{j}}\in P^{k}\left(I_{j}\right),\ j=1,...,N\right\}} , P k ( I j ) {\displaystyle P^{k}\left(I_{j}\right)} is the polynomials space in I j {\displaystyle I_{j}} with degree at most k {\displaystyle k} .

Formulation of the scheme

Flux: h := h ( U , U x ) = a ( U ) U x {\displaystyle h:=h\left(U,U_{x}\right)=a\left(U\right)U_{x}} .

U {\displaystyle U} : the exact solution of the equation.

Multiply the equation with a smooth function v H 1 ( 0 , 1 ) {\displaystyle v\in H^{1}\left(0,1\right)} so that we obtain the following equations:

I j U t v d x h j + 1 2 v j + 1 2 + h j 1 2 v j 1 2 + a ( U ) U x v x d x = 0 {\displaystyle \int _{I_{j}}U_{t}vdx-h_{j+{\frac {1}{2}}}v_{j+{\frac {1}{2}}}+h_{j-{\frac {1}{2}}}v_{j-{\frac {1}{2}}}+\int a\left(U\right)U_{x}v_{x}dx=0} ,

I j U ( x , 0 ) v ( x ) d x = I j U 0 ( x ) v ( x ) d x {\displaystyle \int _{I_{j}}U\left(x,0\right)v\left(x\right)dx=\int _{I_{j}}U_{0}\left(x\right)v\left(x\right)dx}

Here v {\displaystyle v} is arbitrary, the exact solution U {\displaystyle U} of the equation is replaced by the approximate solution u {\displaystyle u} , that is to say, the numerical solution we need is obtained by solving the differential equations.

The numerical flux

Choosing a proper numerical flux is critical for the accuracy of DDG method.

The numerical flux needs to satisfy the following conditions:

♦ It is consistent with h = b ( u ) x = a ( u ) u x {\displaystyle h={b\left(u\right)}_{x}=a\left(u\right)u_{x}}

♦ The numerical flux is conservative in the single value on x j + 1 2 {\displaystyle x_{j+{\frac {1}{2}}}} .

♦ It has the L 2 {\displaystyle L^{2}} -stability;

♦ It can improve the accuracy of the method.

Thus, a general scheme for numerical flux is given:

h ^ = D x b ( u ) = β 0 [ b ( u ) ] Δ x + b ( u ) x ¯ + m = 1 k 2 β m ( Δ x ) 2 m 1 [ x 2 m b ( u ) ] {\displaystyle {\widehat {h}}=D_{x}b(u)=\beta _{0}{\frac {\left[b\left(u\right)\right]}{\Delta x}}+{\overline {{b\left(u\right)}_{x}}}+\sum _{m=1}^{\frac {k}{2}}\beta _{m}{\left(\Delta x\right)}^{2m-1}\left[\partial _{x}^{2m}b\left(u\right)\right]}

In this flux, k {\displaystyle k} is the maximum order of polynomials in two neighboring computing units. [ ] {\displaystyle \left[\cdot \right]} is the jump of a function. Note that in non-uniform grids, Δ x {\displaystyle \Delta x} should be ( Δ x j + Δ x j + 1 2 ) {\displaystyle \left({\frac {\Delta x_{j}+\Delta x_{j+1}}{2}}\right)} and 1 N {\displaystyle {\frac {1}{N}}} in uniform grids.

Error estimates

Denote that the error between the exact solution U {\displaystyle U} and the numerical solution u {\displaystyle u} is e = u U {\displaystyle e=u-U} .

We measure the error with the following norm:

| | | v ( , t ) | | | = ( 0 1 v 2 d x + ( 1 γ ) 0 t j = 1 N I j v x 2 d x d τ + α 0 t j = 1 N [ v ] 2 / Δ x d τ ) 0.5 {\displaystyle \left|\left|\left|v(\cdot ,t)\right|\right|\right|={\left(\int _{0}^{1}v^{2}dx+\left(1-\gamma \right)\int _{0}^{t}\sum _{j=1}^{N}\int _{I_{j}}v_{x}^{2}dxd\tau +\alpha \int _{0}^{t}\sum _{j=1}^{N}{\left[v\right]}^{2}/\Delta x\cdot d\tau \right)}^{0.5}}

and we have | | | U ( , T ) | | | | | | U ( , 0 ) | | | {\displaystyle \left|\left|\left|U(\cdot ,T)\right|\right|\right|\leq \left|\left|\left|U(\cdot ,0)\right|\right|\right|} , | | | u ( , T ) | | | | | | U ( , 0 ) | | | {\displaystyle \left|\left|\left|u(\cdot ,T)\right|\right|\right|\leq \left|\left|\left|U(\cdot ,0)\right|\right|\right|}

See also

References

  1. ^ Hailiang Liu, Jue Yan, The Direct Discontinuous Galerkin (DDG) Methods For Diffusion Problems,SIAM J. NUMER. ANAL. Vol. 47, No. 1, pp. 675–698.
  2. ^ Hailiang Liu, Jue Yan, The Direct Discontinuous Galerkin (DDG) Method for Diffusion with Interface Corrections, Commun. Comput. Phys. Vol. 8, No. 3, pp. 541-564.
  • D.N. Arnold, F. Brezzi, B. Cockburn and L.D. Marini, Unified analysis of discontinuous Galerkin methods for elliptic problems, SIAM J. Numer. Anal. 39(5):1749–1779, 2002.
  • G. Baker, Finite element methods for elliptic equations using nonconforming elements, Math. Comp. 31 (1977), no. 137, 45–59.
  • A. Cangiani, Z. Dong, E.H. Georgoulis, and P. Houston, hp-Version Discontinuous Galerkin Methods on Polygonal and Polyhedral Meshes, SpringerBriefs in Mathematics, (December 2017).
  • W. Mai, J. Hu, P. Li, and H. Zhao, “An efficient and stable 2-D/3-D hybrid discontinuous Galerkin time-domain analysis with adaptive criterion for arbitrarily shaped antipads in dispersive parallel-plate pair,” IEEE Trans. Microw. Theory Techn., vol. 65, no. 10, pp. 3671–3681, Oct. 2017.
  • W. Mai et al., “A straightforward updating criterion for 2-D/3-D hybrid discontinuous Galerkin time-domain method controlling comparative error,” IEEE Trans. Microw. Theory Techn., vol. 66, no. 4, pp. 1713–1722, Apr. 2018.
  • B. Cockburn, G. E. Karniadakis and C.-W. Shu (eds.), Discontinuous Galerkin methods. Theory, computation and applications, Lecture Notes in Computational Science and Engineering, 11. Springer-Verlag, Berlin, 2000.
  • P. Lesaint, and P. A. Raviart. "On a finite element method for solving the neutron transport equation." Mathematical aspects of finite elements in partial differential equations 33 (1974): 89–123.
  • D.A. Di Pietro and A. Ern, Mathematical Aspects of Discontinuous Galerkin Methods. Mathématiques et Applications, Vol. 69, Springer-Verlag, Berlin, 2011.
  • J.S. Hesthaven and T. Warburton, Nodal Discontinuous Galerkin Methods: Algorithms, Analysis, and Applications. Springer Texts in Applied Mathematics 54. Springer Verlag, New York, 2008.
  • B. Rivière, Discontinuous Galerkin Methods for Solving Elliptic and Parabolic Equations: Theory and Implementation. SIAM Frontiers in Applied Mathematics, 2008.
  • CFD Wiki http://www.cfd-online.com/Wiki/Discontinuous_Galerkin
  • W.H. Reed and T.R. Hill, Triangular mesh methods for the neutron transport equation, Tech. Report LA-UR-73–479, Los Alamos Scientific Laboratory, 1973.
  • v
  • t
  • e
Finite difference
Parabolic
Hyperbolic
Others
Finite volumeFinite element
Meshless/MeshfreeDomain decompositionOthers