Numpde
Numpde
Joachim Schöberl
1 Introduction 7
1.1 Classification of PDEs . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 7
1.2 Weak formulation of the Poisson Equation . . . . . . . . . . . . . . . . . . 8
1.3 The Finite Element Method . . . . . . . . . . . . . . . . . . . . . . . . . . 10
3 Sobolev Spaces 27
3.1 Generalized derivatives . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 27
3.2 Sobolev spaces . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 29
3.3 Trace theorems and their applications . . . . . . . . . . . . . . . . . . . . . 30
3.3.1 The trace space H 1/2 . . . . . . . . . . . . . . . . . . . . . . . . . 36
3.4 Equivalent norms on H 1 and on sub-spaces . . . . . . . . . . . . . . . . . . 39
3.5 Interpolation Spaces . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 43
3.5.1 Hilbert space interpolation . . . . . . . . . . . . . . . . . . . . . . . 43
3.5.2 Banach space interpolation . . . . . . . . . . . . . . . . . . . . . . . 43
3.5.3 Operator interpolation . . . . . . . . . . . . . . . . . . . . . . . . . 45
3.5.4 Interpolation of Sobolev Spaces . . . . . . . . . . . . . . . . . . . . 46
3.6 The weak formulation of the Poisson equation . . . . . . . . . . . . . . . . 47
3.6.1 Shift theorems . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 48
3
4 CONTENTS
8 Applications 153
8.1 The Navier Stokes equation . . . . . . . . . . . . . . . . . . . . . . . . . . 153
8.1.1 Proving LBB for the Stokes Equation . . . . . . . . . . . . . . . . . 155
8.1.2 Discrete LBB . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 156
8.2 Elasticity . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 159
8.3 Maxwell equations . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 166
Introduction
Differential equations are equations for an unknown function involving differential opera-
tors. An ordinary differential equation (ODE) requires differentiation with respect to one
variable. A partial differential equation (PDE) involves partial differentiation with respect
to two or more variables.
The coefficients ai,j (x), bi (x), c(x) and the right hand side f (x) are given functions. In
addition, certain type of boundary conditions are required. The behavior of the PDE
depends on the type of the differential operator
d d
X ∂ ∂ X ∂
L := ai,j + bi + c.
i,j=1
∂x i ∂x j i=1
∂x i
∂
Replace ∂xi
by si . Then
d
X d
X
si ai,j sj + b i si + c = 0
i,j=1 i=1
7
8 CHAPTER 1. INTRODUCTION
Often, the distinguished direction corresponds to time. This type of equation requires
boundary conditiosn on the d − 1-dimensional boundary, and initial conditions in the
different direction.
3. If the matrix a has d − 1 positive, and one negative (or vise versa) eigenvalues, then
the shape is a hyperbola. The PDE is called hyperbolic. The simplest one is
d−1 2
X ∂ u ∂ 2u
− + = f.
i=1
∂x2i ∂x2d
Again, the distinguished direction often corresponds to time. Now, two initial con-
ditions are needed.
4. If the matrix a is zero, then the PDE degenerates to the first order PDE
∂u
bi + cu = f.
∂xi
Boundary conditions are needed at a part of the boundary.
These cases behave very differently. We will establish theories for the individual cases.
A more general classicfication, for more positive or negative eigenvalues, and systems of
PDEs is possible. The type of the PDE may also change for different points x.
−∆u = f in Ω, (1.2)
u = uD on ΓD ,
∂u
∂n
= g on ΓN , (1.3)
∂u
∂n
+ αu = g on ΓR .
The domain Ω is an open and bounded subset of Rd , where the problem dimension d is
usually 1, 2 or 3. For d = 1, the equation is not a PDE, but an ODE. The boundary
1.2. WEAK FORMULATION OF THE POISSON EQUATION 9
Exactly one boundary condition must be specified on each part of the boundary.
We transform equation (1.2) together with the boundary conditions (1.3) into its weak
form. For this, we multiply (1.2) by smooth functions (called test functions) and integrate
over the domain: Z Z
− ∆uv dx = f v dx (1.4)
Ω Ω
We do so for sufficiently
R manyRtest functions v in a proper function space. Next, we apply
Gauss’ theorem Ω div p dx = Γ p · n ds to the function p := ∇u v to obtain
Z Z
div(∇u v) dx = ∇u · n v ds
Ω Γ
From the product rule there follows div(∇uv) = ∆uv + ∇u · ∇v. Together we obtain
Z Z Z
∂u
∇u · ∇v dx − v ds = f v dx.
Ω Γ ∂n Ω
Up to now, we only used the differential equation in the domain. Next, we incorporate
the boundary conditions. The Neumann and Robin b.c. are very natural (and thus are
∂u
called natural boundary conditions). We simply replace ∂n by g and −αu + g on ΓN and
ΓR , respectively. Putting unknown terms to the left, and known terms to the right hand
side, we obtain
Z Z Z Z Z
∂u
∇u · ∇v dx + αuv ds − v ds = f v dx + gv ds.
Ω ΓR ΓD ∂n ΓN +ΓR
Finally, we use the information of the Dirichlet boundary condition. We work brute force
and simple keep the Dirichlet condition in strong sense. At the same time, we only allow
test functions v fulfilling v = 0 on ΓD . We obtain the
10 CHAPTER 1. INTRODUCTION
∀ v such that v = 0 on ΓD .
We still did not define the function space in which we search for the solution u. A proper
choice is
V := {v ∈ L2 (Ω) : ∇u ∈ [L2 (Ω)]d and u|Γ ∈ L2 (∂Ω)}.
It is a complete space, and, together with the inner product
(u, v)V := (u, v)L2 (Ω) + (∇u, ∇v)L2 (Ω) + (u, v)L2 (Γ)
it is a Hilbert space. Now, we see that f ∈ L2 (Ω) and g ∈ L2 (Γ) is useful. The Dirichlet
b.c. uD must be chosen such that there exists an u ∈ V with u = uD on ΓD . By definition
of the space, all terms are well defined. We will see later, that the problem indeed has a
unique solution in V .
This is a sub-space of V . The derivatives (in weak sense, see below) are piecewise constant,
and thus, belong to [L2 (Ω)]2 . The function vh ∈ Vh is uniquely defined by its values v(xj )
in the nodes xj ∈ N . We decompose the set of nodes as
N = ND ∪ Nf ,
where ND are the nodes on the Dirichlet boundary, and Nf are all others (f as free). The
finite element approximation is defined as
Now it is time to choose a basis for Vh . The most convenient one is the nodal basis
{ϕi } characterized as
ϕi (xj ) = δi,j . (1.7)
The Kronecker-δ is defined to be 1 for i = j, and 0 else. These are the popular hat
functions. We represent the finite element solution with respect to this basis:
X
uh (x) = ui ϕi (x) (1.8)
P
By the nodal-basis property (1.7) there holds uh (xj ) = i ui ϕi (xj ) = uj . We have to
N
determine the coefficients ui ∈ R , with N = |N |. The ND := |ND | values according to
nodes on ΓD are given explicitely:
uj = uh (xj ) = uD (xj ) ∀ xj ∈ ΓD
The others have to be determined from the variational equation (1.6). It is equivalent to
fulfill (1.6) for the whole space {vh ∈ Vh : vh (xj ) = 0 ∀ xj ∈ ND }, or just for its basis
{ϕi : xi ∈ Nf } associated to the free nodes:
XnZ Z o Z Z
∇ϕi · ∇ϕj dx + αϕi ϕj ds ui = f ϕj dx + gϕj ds (1.9)
i Ω ΓR ΓN +ΓR
∀ ϕj such that xj ∈ Nf
We have inserted the basis expansion (1.8). We define the matrix A = (Aji ) ∈ RN ×N and
the vector f = (fj ) ∈ RN as
Z Z
Aji := ∇ϕi · ∇ϕj dx + αϕi ϕj ds,
Ω ΓR
Z Z
fj := f ϕj dx + gϕj ds.
ΓN +ΓR
• u+v =v+u
• (u + v) + w = u + (v + w)
• λ · (u + v) = λ · u + λ · v, (λ + µ) · u = λ · u + µ · u
Definition 2. A normed vector space (V, k · k) is a vector space with the operation k.k :
V → R being a norm, i.e., for u, v ∈ V and λ ∈ R there holds
• ku + vk ≤ kuk + kvk
• kλ uk = |λ| kuk
• kuk = 0 ⇔ u = 0
Examples of Banach spaces are (L2 , k · kL2 ), (C 0 , k · ksup ), but not (C 0 , k · kL2 ).
k·kV
Definition 4. The closure of a normed vector-space (W, k · kV ), denoted as W is the
smallest complete space containing W .
13
14 CHAPTER 2. THE ABSTRACT THEORY
k·kL2
Example: C = L2 .
Definition 5. A functional or a linear form l(·) on V is a linear mapping l(·) : V → R.
The canonical norm for linear forms is the dual norm
l(v)
klkV ∗ := sup .
06=v∈V kvk
A linear form l is called bounded if the norm is finite. The vector space of all bounded
linear forms on V is called the dual space V ∗ .
R
An example for a bounded linear form is l(·) : L2 → R : v → v dx.
Definition 6. A bilinear form A(·, ·) on V is a mapping A : V × V → R which is linear
in u and in v. It is called symmetric if A(u, v) = A(v, u) for all u, v ∈ V .
R
Examples are the bilinear form A(u, v) = uv dx on L2 , or A(u, v) := uT Av on Rn , where
A is a (symmetric) matrix.
Definition 7. A symmetric bilinear form A(·, ·) is called an inner product if it satisfies
• A(v, v) ≥ 0 ∀ v ∈ V
• A(v, v) = 0 ⇔ v = 0
Often, is is denoted as (·, ·)A , (·, ·)V , or simply (·, ·).
An example on Rn is uT Av, where A is a symmetric and positive definite matrix.
Definition 8. An inner product space is a vector space V together with an inner product
(·, ·)V .
Lemma 9. Cauchy Schwarz inequality. If A(·, ·) is a symmetric bilinear form such
that A(v, v) ≥ 0 for all v ∈ V , then there holds
If A(v, v) = 0, then A(u, u) − 2tA(u, v) ≥ 0 for all t ∈ R, which forces A(u, v) = 0, and the
inequality holds trivially. Else, if A(v, v) 6= 0, set t = A(u, v)/A(v, v), and obtain
Definition 11. An inner product space (V, (·, ·)V ) which is complete with respect to k · kV
is called a Hilbert space.
Lemma 13. Let T be a continuous linear operator from the Hilbert space V to the Hilbert
space W . The kernel of T , ker T := {v ∈ V : T v = 0} is a closed subspace of V .
Proof: First we observe that ker T is a vector space. Now, let (un ) ∈ ker T N converge
to u ∈ V . Since T is continuous, T un → T u, and thus T u = 0 and u ∈ ker T . 2
S ⊥ := {v ∈ V : (v, w) = 0 ∀ w ∈ S}
is a closed subspace.
kT vkW
kT kV →W := sup
06=v∈V kvkV
is finite.
d
An example is the differential operator on the according space dx
: (C 1 (0, 1), k · ksup +
d
k dx · ksup ) → (C(0, 1), k · ksup ).
Definition 17. A dense subspace S of V is such that every element of V can be ap-
proximated by elements of S, i.e.
Lemma 18 (extension principle). Let S be a dense subspace of the normed space V , and
let W be a complete space. Let T : S → W be a bounded linear operator with respect to the
norm kT kV →W . Then, the operator can be uniquely extended onto V .
16 CHAPTER 2. THE ABSTRACT THEORY
ku − u0 k ≤ ku − vk ∀v ∈ S
There holds
u − u0 ⊥ S
Proof: Let d := inf v∈S ku−vk, and let (vn ) be a minimizing sequence such that ku−vn k → d.
We first check that there holds
Since 1/2(vn +vm ) ∈ S, there holds k1/2(vn +vm )−uk ≥ d. We proof that (vn ) is a Cauchy
sequence: Fix ε > 0, choose N ∈ N such that for n > N there holds ku − vn k2 ≤ d2 + ε2 .
Thus for all n, m > N there holds
dϕ(t)
0= |t=0 = {2(u − u0 , w) − 2t(w, w)}|t=0 = 2(u − u0 , w)
dt
We obtained u − u0 ⊥S. If there were two minimizers u0 6= u1 , then u0 − u1 = (u0 − u) −
(u1 − u)⊥S and u0 − u1 ∈ S, which implies u0 − u1 = 0, a contradiction. 2
u = u0 + u1 , u0 ∈ S u1 ∈ S ⊥
PS u := u0 PS⊥ u := (I − PS )u = u1
Lemma 24. The operators PS and PS⊥ are both orthogonal projectors.
With the same argument there holds (u, PS v) = (PS u, PS v). The co-projector PS⊥ = I − PS
is a projector since
(I − PS )2 = I − 2PS + PS2 = I − PS .
It is orthogonal since ((I − PS )u, v) = (u, v) − (PS u, v) = (u, v) − (u, PS v) = (u, (I − PS )v)
2
klkV ∗ = kul kV .
Proof: First, we show uniqueness. Assume that u1 6= u2 both fulfill (2.1). This leads to
the contradiction
0 = l(u1 − u2 ) − l(u1 − u2 )
= (u1 , u1 − u2) − (u2 , u1 − u2 ) = ku1 − u2 k2 .
Next, we construct the ul . For this, define S := ker l. This is a closed subspace.
Case 1: S ⊥ = {0}. Then, S = V , i.e., l = 0. So take ul = 0.
Case 2: S ⊥ 6= {0}. Pick some 0 6= z ∈ S ⊥ . There holds l(z) 6= 0 (otherwise, z ∈ S ∩ S ⊥ =
{0}). Now define
l(z)
ul := 2
z ∈ S⊥
kzk
Then
and
l(z) l(z)
kul k = 2
kzk = ≤ klkV ∗ .
kzk kzk
The bilinear form is non-negative, and A(u, u) = 0 implies u = 0. Thus A(·, ·) is an inner
product, and provides the norm kvkA := A(v, v)1/2 . The normed vector space (C 1 , k.kA ) is
not complete. Define
k.kA
V := C 1 (Ω) ,
which is a Hilbert space per definition. If we can show that there exists a constant c such
that Z
f (v) = f v dx ≤ ckvkA ∀v ∈ V
Ω
then f (.) is a continuous linear functional on V . We will prove this later. In this case, the
Riesz representation theorem tells that there exists an unique u ∈ V such that
A(u, v) = f (v).
A(uh , vh ) = f (vh ) ∀ vh ∈ Vh ,
This means
A(u − uh , vh ) = A(u, vh ) − A(uh , vh ) = f (vh ) − f (vh ) = 0
uh is the projection of u onto Vh , i.e.,
ku − uh kA ≤ ku − vh kA ∀ vh ∈ Vh
• and continuous
A(u, v) ≤ α2 kukV kvkV ∀ u, v ∈ V, (2.3)
20 CHAPTER 2. THE ABSTRACT THEORY
f (v) ≤ kf kV ∗ kvkV .
A(u, v) = f (v) ∀ v ∈ V.
Assume that the coefficients a(x) and c(x) fulfill a(x) ∈ Rd×d , a(x) symmetric and λ1 ≤
λmin (a(x)) ≤ λmax (a(x)) ≤ λ2 , and c(x) such that γ1 ≤ c(x) ≤ γ2 almost everywhere. Then
A(·, ·) is coercive with constant α1 = min{λ1 , γ1 } and α2 = max{λ2 , γ2 }.
−∆u + b · ∇u + u = f in Ω
If div b ≤ 0, what is an important case arising from incompressible flow fields (div b = 0),
then A(·, ·) is coercive and continuous w.r.t. the same norm as above.
Instead of the linear form f (·), we will often write f ∈ V ∗ . The evaluation is written
as the duality product
hf, viV ∗ ×V = f (v).
hAu, vi = A(u, v) ∀ u, v ∈ V.
The operator norm kAkV →V ∗ is bounded by the continuity bound α2 of A(·, ·).
2.5. COERCIVE VARIATIONAL PROBLEMS 21
Thus, we can define the operator A : u ∈ V → A(u, ·) ∈ V ∗ . It is linear, and its operator
norm is bounded by
2
Using this notation, we can write the variational problem as operator equation: find
u ∈ V such that
Au = f (in V ∗ ).
Theorem 29 (Banach’s contraction mapping theorem). Given a Banach space V and a
mapping T : V → V , satisfying the Lipschitz condition
for a fixed L ∈ [0, 1). Then there exists a unique u ∈ V such that
u = T (u),
i.e. the mapping T has a unique fixed point u. The iteration u1 ∈ V given, compute
uk+1 := T (uk )
ku − uk+1 k ≤ Lku − uk k
Theorem 30 (Lax Milgram). Given a Hilbert space V , a coercive and continuous bilinear
form A(·, ·), and a continuous linear form f (.). Then there exists a unique u ∈ V solving
A(u, v) = f (v) ∀ v ∈ V.
There holds
kukV ≤ α1−1 kf kV ∗ (2.4)
Proof: Start from the operator equation Au = f . Let JV : V ∗ → V be the Riesz
isomorphism defined by
JV Au = JV f (in V ),
u = u − τ JV (Au − f ). (2.5)
Banach’s contraction mapping theorem state that (2.5) has a unique fixed point. Finally,
we obtain the bound (2.4) from
ku − uh kV ≤ α2 /α1 inf ku − vh kV
v∈Vh
2.6. INF-SUP STABLE VARIATIONAL PROBLEMS 23
Divide one factor ku − uh k. Since vh ∈ Vh was arbitrary, the estimation holds true also for
the infimum in Vh . 2
If A(·, ·) is additionally symmetric, then it is an inner product. In this case, the coer-
civity and continuity properties are equivalent to
The generated norm k.kA is an equivalent norm to k.kV . In the symmetric case, we can
use the orthogonal projection with respect to (., .)A to improve the bounds to
The factor in the quasi-optimality estimate is now the square root of the general, non-
symmetric case.
B(u, v)
inf sup ≥ β1 . (2.8)
u∈V v∈W
u6=0 v6=0
kukV kvkW
24 CHAPTER 2. THE ABSTRACT THEORY
Define the linear operator B : V → W ∗ by hBu, viW ∗ ×W = B(u, v). The inf-sup
condition can be reformulated as
hBu, vi
sup ≥ β1 kukV , ∀u ∈ V
v∈W kvkW
and, using the definition of the dual norm,
Bu = 0 ⇒ u = 0
Lemma 32. Assume that the continuous bilinear form B(·, ·) fulfills the inf-sup condition
(2.8). Then the according operator B has closed range.
Proof: Let Bun be a Cauchy sequence in W ∗ . From (2.9) we conclude that also un is
Cauchy in V . Since V is complete, un converges to some u ∈ V . By continuity of B, the
sequence Bun converges to Bu ∈ W ∗ . 2
∗
The inf-sup condition (2.8) does not imply that B is onto W . To insure that, we can
pose an inf-sup condition the other way around:
B(u, v)
inf sup ≥ β1 . (2.10)
v∈W u∈V
v6=0 u6=0
kukV kvkW
Theorem 33. Assume that the continuous bilinear form B(·, ·) fulfills the inf-sup condition
(2.8) and condition (2.11). Then, the variational problem: find u ∈ V such that
has a unique solution. The solution depends continuously on the right hand side:
kukV ≤ β1−1 kf kW ∗
Proof: We have to show that the range R(B) = W ∗ . The Hilbert space W ∗ can be split
into the orthogonal, closed subspaces
W ∗ = R(B) ⊕ R(B)⊥ .
(Bu, g)W ∗ = 0 ∀ u ∈ V.
2.6. INF-SUP STABLE VARIATIONAL PROBLEMS 25
Let vg ∈ W be the Riesz representation of g, i.e., (vg , w)W = g(w) for all w ∈ W . This vg
is in contradiction to the assumption (2.11)
B(u, vg ) (Bu, g)W ∗
sup = sup = 0.
u∈V kukV u∈V kukV
Thus, R(B)⊥ = {0} and R(B) = W ∗ . 2
Example 34. A coercive bilinear form is inf-sup stable.
Example 35. A complex symmetric variational problem:
Consider the complex valued PDE
−∆u + iu = f,
√
with Dirichlet boundary conditions, f ∈ L2 , and i = −1. The weak form for the real
system u = (ur , ui ) ∈ V 2 is
(∇ur , ∇vr )L2 + (ui , vr )L2 = (f, vr ) ∀ vr ∈ V
(2.13)
(ur , vi )L2 − (∇ui , ∇vi )L2 = −(f, vi ) ∀ vi ∈ V
We can add up both lines, and define the large bilinear form B(·, ·) : V 2 × V 2 → R by
B((ur , ui ), (vr , vi )) = (∇ur , ∇vr ) + (ui , vr ) + (ur , vi ) − (∇ui , ∇vi )
With respect to the norm kvkV = (kvk2L2 +k∇vk2L2 )1/2 , the bilinear form is continuous, and
fulfills the inf-sup conditions (exercises !) Thus, the variational formulation: find u ∈ V 2
such that
B(u, v) = (f, vr ) − (f, vi ) ∀v ∈ V 2
is stable solvable.
On a finite dimensional space, one to one is equivalent to onto, and we can skip the second
condition.
26 CHAPTER 2. THE ABSTRACT THEORY
Theorem 36. Assume that B(·, ·) is continuous with bound β2 , and B(·, ·) fulfills the
discrete inf-sup condition with bound β1h . Then there holds the quasi-optimal error estimate
Proof: Again, there holds the Galerkin orthogonality B(u, wh ) = B(uh , wh ) for all wh ∈ Vh .
Again, choose an arbitrary vh ∈ Vh :
ku − uh kV ≤ ku − vh kV + kvh − uh kV
−1 B(vh − uh , wh )
≤ ku − vh kV + β1h sup
wh ∈Wh kwh kV
−1 B(vh − u, wh )
= ku − vh kV + β1h sup
wh ∈Wh kwh kV
−1 β2 kvh − ukV kwh kW
≤ ku − vh kV + β1h sup
wh ∈Wh kwh kW
= (1 + β2 /β1h )ku − vh kV .
Chapter 3
Sobolev Spaces
This is a compact set if and only if it is bounded. We say u has compact support in Ω, if
supp u ⊂ Ω. If Ω is a bounded domain, then u has compact support in Ω if and only if u
vanishes in a neighbourhood of ∂Ω.
The space of smooth functions with compact support is denoted as
For a smooth function u ∈ C |α| (Ω), there holds the formula of integration by parts
Z Z
α |α|
D uϕ dx = (−1) uDα ϕ dx ∀ ϕ ∈ D(Ω). (3.2)
Ω Ω
The L2 inner product with a function u in C(Ω) defines the linear functional on D
Z
u(ϕ) := hu, ϕiD0 ×D := uϕ dx.
Ω
27
28 CHAPTER 3. SOBOLEV SPACES
Lloc
1 (Ω) = {u : uK ∈ L1 (K) ∀ compact K ⊂ Ω}.
1/x
It contains functions which can behave very badly near ∂Ω. E.g., ee is in L1loc (0, 1). If Ω
is unbounded, then the constant function 1 is in Lloc
1 , but not in L1 .
The weak derivative is more general than the classical derivative, but more restrictive
than the generalized derivative.
Then,
1 x≤0
g(x) =
−1 x>0
is the first generalized derivative Dg1 of u, which is also a weak derivative. The second
generalized derivative h is
hh, ϕi = −2ϕ(0) ∀ϕ ∈ D
In the following, we will focus on weak derivatives. Unless it is essential we will skip
the sub-scripts w and g.
3.2. SOBOLEV SPACES 29
for k ∈ N0 we set
α
k (Ω) := max kD ukL∞ .
kukW∞
|α|≤k
In the previous chapter we have seen the importance of complete spaces. This is the
case for Sobolev spaces:
Theorem 40. The Sobolev space Wpk (Ω) is a Banach space.
Proof: Let vj be a Cauchy sequence with respect to k · kWpk . This implies that Dα vj is a
Cauchy sequence in Lp , and thus converges
R to some v α Rin k.kLp .
We verify that Dα vj → v α implies Ω Dα vj ϕ dx → Ω v α ϕ dx for all ϕ ∈ D. Let K be
the compact support of ϕ. There holds
Z Z
α α
(D vj − v )ϕ dx = (Dα vj − v α )ϕ dx
Ω K
≤ kDα vj − v α kL1 (K) kϕkL∞
≤ kDα vj − v α kLp (K) kϕkL∞ → 0
Finally, we have to check that v α is the weak derivative of v:
Z Z
α
v ϕ dx = lim Dα vj ϕ dx
j→∞ Ω
Z
|α|
= lim (−1) vj Dα ϕ dx =
j→∞ Ω
Z
= (−1)α vDα ϕ dx.
Ω
2
An alternative definition of Sobolev spaces were to take the closure of smooth functions
in the domain, i.e.,
f k := {C ∞ (Ω) : k.kW k ≤ ∞}k.kWpk .
W p p
fk = W k .
Theorem 41. Let 1 ≤ p < ∞. Then W p p
Definition 42. The domain Ω has a Lipschitz boundary, ∂Ω, if there exists a collection
of open sets Oi , a positive parameter ε, an integer N and a finite number L, such that for
all x ∈ ∂Ω the ball of radius ε centered at x is contained in some Oi , no more than N of
the sets Oi intersect non-trivially, and each part of the boundary Oi ∩ Ω is a graph of a
Lipschitz function ϕi : Rd−1 → R with Lipschitz norm bounded by L.
Theorem 43. Assume that Ω has a Lipschitz boundary, and let 1 ≤ p < ∞. Then
ck = W k .
Wp p
In the following, we will prove most theorems for the Hilbert spaces H k , and state the
general results for Wpk .
tr : H 1 ((0, h)) → R
u → u(0).
Proof: Use that C 1 ([0, h]) is dense in H 1 (0, h). Take a sequence uj in C 1 ([0, h]) con-
verging to u in H 1 -norm. The values uj (0) are Cauchy, and thus converge to an u0 . The
limit is independent of the choice of the sequence uj . This allows to define tr u := u0 . 2
Now, we extend this 1D result to domains in more dimensions. Let Ω be bounded, ∂Ω
be Lipschitz, and consists of M pieces Γi of smoothness C 1 .
We can construct the following covering of a neighbourhood of ∂Ω in Ω: Let Q = (0, 1)2 .
For 1 ≤ i ≤ M , let si ∈ C 1 (Q, Ω) be invertible and such that ks0i kL∞ ≤ c, k(s0i )−1 kL∞ ≤ c,
and det s0i > 0. The domains Si := si (Q) are such that si ((0, 1) × {0}) = Γi , and the
parameterizations match on si ({0, 1} × (0, 1)).
tr : H 1 (Ω) → L2 (∂Ω)
is a bounded operator w.r.t. the norms k.kH 1 and L2 , and conclude by density. We use
the partitioning of ∂Ω into the pieces Γi , and transform to the simple square domain
Q = (0, 1)2 . Define the functions ui on Q = (0, 1)2 as
To transform the H 1 -norm, we differentiate with respect to x̃ by applying the chain rule
dũi du dsi
(x̃) = (si (x̃)) (x̃).
dx̃ dx dx̃
du
Solving for dx
is
−1
du dũi ds
(si (x̃)) = (x̃) (x̃)
dx dx̃ dx̃
The bounds onto s0 and (s0 )−1 imply that
We got a lower bound for det(s0 ) = (det(s0 )−1 )−1 from the upper bound for (s0 )−1 .
It remains to prove the trace estimate on Q. Here, we apply the previous one dimen-
sional result
Z 1( 2 )
∂u(ξ, η)
|u(ξ, 0)|2 ≤ c u(ξ, η)2 + dη ∀ ξ ∈ (0, 1)
0 ∂η
Considering the trace operator from H 1 (Ω) to L2 (∂Ω) is not sharp with respect to the
norms. We will improve the embedding later.
It is a true sub-space, since u = 1 does belong to H 1 , but not to H01 . It is a closed sub-space,
since it is the kernel of a continuous operator.
By means of the trace inequality, one verifies that the linear functional
Z
g(v) := g tr v dx
ΓN
is bounded on H 1 .
Integration by parts
The definition of the trace allows us to perform integration by parts in H 1 :
Z Z Z
∇uϕ dx = − u div ϕ dx + tr u ϕ · n dx ∀ ϕ ∈ [C 1 (Ω)]2
Ω Ω ∂Ω
The definition of the weak derivative (e.g. the weak gradient) looks similar. It allows only
test functions ϕ with compact support in Ω, i.e., having zero boundary values. Only by
choosing a normed space, for which the trace operator is well defined, we can state and
prove integration by parts. Again, the short proof is based on the density of C 1 (Ω) in H 1 .
• Ω = ∪M
i=1 Ωi
• Ωi ∩ Ωj = ∅ if i 6= j
trγij ui = trγij uj
Proof: We have to verify that g ∈ L2 (Ω)d , defined by g|Ωi = gi , is the weak gradient of
u, i.e., Z Z
g · ϕ dx = − u div ϕ dx ∀ ϕ ∈ [C0∞ (Ω)]d
Ω Ω
34 CHAPTER 3. SOBOLEV SPACES
XM Z Z
= − ui div ϕ dx + tr ui ϕ · ni ds
i=1 Ωi ∂Ωi
Z XZ
= − u div ϕ dx + trγij ui ϕ · ni + trγij uj ϕ · nj ds
Ω γij γij
Z
= − u div ϕ dx
Ω
We have used that ϕ = 0 on ∂Ω, and ni = −nj on γij . 2
Applications of this theorem are (conforming nodal) finite element spaces. The parti-
tioning Ωi is the mesh. On each sub-domain, i.e., on each element T , the functions are
polynomials and thus in H 1 (T ). The finite element functions are constructed to be contin-
uous, i.e., the traces match on the interfaces. Thus, the finite element space is a sub-space
of H 1 .
Extension operators
Some estimates are elementary to verify on simple domains such as squares Q. One tech-
nique to transfer these results to general domains is to extend a function u ∈ H 1 (Ω) onto
a larger square Q, apply the result for the square, and restrict the result onto the general
domain Ω. This is now the motivation to study extension operators.
We construct a non-overlapping covering {Si } of a neighbourhood of ∂Ω on both sides.
Let ∂Ω = ∪Γi consist of smooth parts. Let s : (0, 1) × (−1, 1) → Si : (ξ, η) → x be an
invertible function such that
si ((0, 1) × (0, 1)) = Si ∩ Ω
si ((0, 1) × {0}) = Γi
si ((0, 1) × (−1, 0)) = Si \ Ω
−1
Assume that k ds i
k
dx L∞
and k dsdx
i
kL∞ are bounded.
This defines an invertible mapping x → x̂(x) from the inside to the outside by
x̂(x) = si (ξ(x), −η(x)).
The mapping preserve the boundary Γi . The transformations si should be such that x → x̂
is consistent at the interfaces between Si and Sj .
With the flipping operator f : (ξ, η) → (ξ, −η), the mapping is the composite x̂(x) =
si (f (s−1
i )). From that, we obtain the bound
−1
dx̂ ds ds
≤ .
dx dx dx
3.3. TRACE THEOREMS AND THEIR APPLICATIONS 35
e = Ω ∪ S1 ∪ . . . ∪ SM .
Define the domain Ω
We define the extension operator by
(Eu)(x̂) = u(x) ∀ x ∈ ∪Si
(3.3)
(Eu)(x) = u(x) ∀x ∈ Ω
and
k∇EukL2 (Ω)
e ≤ c k∇ukL2 (Ω)
Proof: Let u ∈ C 1 (Ω). First, we prove the estimates for the individual pieces Si :
Z Z
2 2 dx̂
Eu(x̂) dx̂ = u(x) det dx ≤ ckuk2L2 (Si ∩Ω)
Si \Ω Si ∩Ω dx
For the derivatives we use
dEu(x̂) du(x(x̂)) du dx
= = .
dx̂ dx̂ dx dx̂
Since dx
dx̂
and ( dx
dx̂
)−1 = dx̂
dx
are bounded, one obtains
|∇x̂ Eu(x̂)| ' |∇x u(x)|,
and Z Z
2
|∇x̂ Eu| dx̂ ≤ c |∇u|2 dx
Si \Ω Si ∩Ω
By density, we get the result for H 1 (Ω). Let uj ∈ C 1 (Ω) → u, than uj is Cauchy, Euj is
Cauchy in H 1 (Ω),
e and thus converges to u ∈ H 1 (Ω).
e
The extension of functions from H01 (Ω) onto larger domains is trivial: Extension by 0
is a bounded operator. One can extend functions from H 1 (Ω) into H01 (Ω),
e and further, to
an arbitrary domain by extension by 0.
For x̂ = si (ξ, −η), ξ, η ∈ (0, 1)2 , define the extension
E0 u(x̂) = (1 − η) u(x)
Proof: Exercises
In this case, it is not possible to bound the gradient term only by gradients. To see this,
take the constant function on Ω. The gradient vanishes, but the extension is not constant.
W = {tr u : u ∈ H 1 (Ω)}
This is indeed a norm on W . The trace operator is continuous from V → W with norm 1.
Lemma 49. The space (W, k.kW ) is a Banach space. For all g ∈ W there exists an u ∈ V
such that tr u = g and kukV = kgkW
Now, let gn = tr un ∈ W be a Cauchy sequence. This does not imply that un is Cauchy,
but PV0⊥ un is Cauchy in V :
This means that u is the solution of the weak form of the Dirichlet problem
−∆u + u = 0 in Ω
u = g on ∂Ω.
3.3. TRACE THEOREMS AND THEIR APPLICATIONS 37
The converse is also true. If zk is a basis for V0 , and the eigenvalues λk → ∞, then the
embedding V1 ⊂ V0 is compact.
If u ∈ V1 , then
X X X X X
kuk2V1 = ( uk zk , ul zl )V1 = uk ul (zk , zl )V1 = uk ul λk (zk , zl )V0 = u2k λk
k l k,l k,l k
In our case, we apply Hilbert space interpolation to H 1 (0, 1) ⊂ L2 (0, 1). The eigen-value
problem is to find zk ∈ H 1 and λk ∈ R such that
By definition of the weak derivative, there holds (zk0 )0 = (1 − λk )zk , i.e., z k ∈ H 2 . Since
H 2 ⊂ C 0 , there holds also z ∈ C 2 , and a weak solution is also a solution of the strong form
zk − zk00 = λk zk on (0, 1)
(3.5)
zk0 (0) = zk0 (1) = 0
z0 = 1 λ0 = 1
and, for k ∈ N, √
zk (x) = 2 cos(kπx)λk = 1 + k 2 π 2 .
√
Indeed, expanding u ∈ L2 in the cos-basis u = u0 + ∞
P
k=1 uk 2 cos(kπx), one has
∞
X
kuk2L2 = (u, zk )2L2
k=0
and
∞
X
kuk2H 1 = (1 + k 2 π 2 )(u, zk )2L2
k=0
Differentiation adds a factor kπ. Hilbert space interpolation allows to define the fractional
order Sobolev norm (s ∈ (0, 1))
∞
X
kuk2H s (0,1) = (1 + k 2 π 2 )s (u, zk )2L2
k=0
We consider the trace tr |E of H 1 ((0, 1)2 ) onto one edge E = (0, 1) × {0}. For g ∈
WE := tr H 1 ((0, 1)2 ), the norm kgkW is defined by
kgkW = kug kH 1 .
Here, ug solves the Dirichlet problem ug |E = g, and (ug , v)H 1 = 0 ∀ v ∈ H 1 such that
trE v = 0.
Since W ⊂ L2 (E), we can expand g in the L2 -orthonormal cosine basis zk
X
g(x) = gn zk (x)
−∆uk + uk = 0 in Ω
uk = zk on E
∂uk
∂n
= 0 on ∂Ω \ E,
3.4. EQUIVALENT NORMS ON H 1 AND ON SUB-SPACES 39
the k∇ · kL2 -semi-norm is the dominating part up to the constant functions. The L2 norm
is necessary to obtain a norm. We want to replace the L2 norm by some different term
(e.g., the L2 -norm on a part of Ω, or the L2 -norm on ∂Ω), and want to obtain an equivalent
norm.
We formulate an abstract theorem relating a norm k.kV to a semi-norm k.kA . An
equivalent theorem was proven by Tartar.
Theorem 50 (Tartar). Let (V, (., .)V ) and (W, (., .)W ) be Hilbert spaces, such that the
embedding id : V → W is compact. Let A(., .) be a non-negative, symmetric and V -
continuous bilinear form with kernel V0 = {v : A(v, v) = 0}. Assume that
1. The kernel V0 is finite dimensional. On the factor space V /V0 , A(., .) is an equivalent
norm to the quotient norm
Proof: 1. Assume that V0 is not finite dimensional. Then there exists an (., .)V -orthonormal
sequence uk ∈ V0 . Since the embedding id : V → W is compact, it has a sub-sequence
converging in k.kW . But, since
The quotient norm is equal to kPV0⊥ uk. We have to prove that kPV0⊥ ukV ≤ kPV0⊥ ukA for
all u ∈ V . This follows after proving kukV ≤ kukA for all u ∈ V0⊥ . Assume that this is not
true. I.e., there exists a V -orthogonal sequence (uk ) such that kuk kA ≤ k −1 kuk kV . Extract
a sub-sequence converging in k.kW , and call it uk again. From the norm equivalence (3.6)
there follows
2 = kuk − ul k2V kuk − ul kW + kuk − ul kA → 0
Now, we bound
kuk2V = kPV0 uk2V + kPV0⊥ uk2V
1
≤ k PV0 u k2B + kPV0⊥ k2V
c1 |{z}
u−PV ⊥ u
0
2
≤ kukB + c2 kPV0⊥ ukV + kPV0⊥ uk2V
2 2
c1
2 2 1 2c2
= kukB + 1+ kPV0⊥ uk2A
c1 c2 c1
2 2
kukB + kukA
3. Define B(u, v) = (PV⊥1 u, PV⊥1 u)V . Then A(., .) + B(., .) is an inner product: A(u, u) +
B(u, u) = 0 implies that u ∈ V0 and u ∈ V1 , thus u = {0}. From 2. there follows that
A(., .) + B(., .) is equivalent to (., .)V . The result follows from reducing the equivalence to
V1 .
2
1
We want to apply Tartar’s theorem to the case V = H , W = L2 , and kvkA = k∇vkL2 .
The theorem requires that the embedding id : H 1 → L2 is compact. This is indeed true
for bounded domains Ω:
Theorem 51. The embedding of H k → H l for k > l is compact.
We sketch a proof for the embedding H 1 ⊂ L2 . First, prove the compact embedding
H01 (Q) → L2 (Q) for a
square Q, w.l.o.g. set Q = (0, 1)2 . The eigen-value problem: Find
z ∈ H01 (Q) and λ suchthat
(z, v)L2 + (∇z, ∇v)L2 = λ(u, v)L2 ∀ v ∈ H01 (Q)
has eigen-vectors zk,l = sin(kπx)sin(lπy), and eigen-values 1 + k 2 π 2 + l2 π 2 → ∞. The
eigen-vectors are dense in L2 . Thus, the embedding is compact.
On a general domain Ω ⊂ Q, we can extend H 1 (Ω) into H01 (Q), embed H01 (Q) into
L2 (Q), and restrict L2 (Q) onto L2 (Ω). This is the composite of two continuous and a
compact mapping, and thus is compact. 2
There holds
X
kuk20 = u2k
X
kuk21 = λ2k u2k < ∞ for u ∈ V1 .
There holds
V1 ⊂ Vs ⊂ V0 .
Example: Let V0 = L2 (0, 1) and V1 = H01 (0, 1). Then
√
zk = 2 sin(kπx) and λk = k
Let V1 ⊂ V0 be Banach spaces with dense and continuous embedding. We define the
K-functional K : R+ × V0 → R as
q
K(t, u) := inf ku − v1 k20 + t2 kv1 k21 .
v1 ∈V1
Note that
K(t, u) ≤ kuk0 ,
K(t, u) ≤ t kuk1 for u ∈ V1 .
The decay in t measures the smoothness of u. For s ∈ (0, 1) we define the interpolation
norm as Z ∞ 1/2
−2s 2
kuks := t K(t, u) dt/t (3.9)
0
kuks = Cs kuks̃ ,
R∞ τ 1−2s
where Cs2 = 0 1+τ 2
dτ .
P
Proof. For u = uk zk we calculate the K-functional as
and
∞ ∞
t2 λ2k
Z Z X
−2s
kuk2s = t 2
K(t, u) dt/t = u2 dt/t
0 0 k
1 + t2 λ2k k
∞
XZ t2 λ2k
= t−2s 2
u2
2 k
dt/t
k 0 1 + t λk
Substitution τ = λk t gives
XZ ∞
τ −2s τ 2
kuk2s = u2 dτ /τ
2 k
k 0 λ k 1 + τ
∞
τ 1−2s
X Z
= λ2s
k ku 2
2
dτ
k 0 1 + τ
= Cs2 kuk2s̃
Proof: Excercise
Then
T : [V0 , V1 ]s → [W0 , W1 ]s
with norm
kT k[V0 ,V1 ]s →[W0 ,W1 ]s ≤ c01−s cs1
Proof. We use the definition of the interpolation norm, T V1 ⊂ W1 , operator norms and
46 CHAPTER 3. SOBOLEV SPACES
substitution τ = c1 t/c0
Z ∞
kT uk[W0 ,W1 ]s = t−2s KW (t, T u)2 dt/t
Z0 ∞
= t−2s inf {kT u − w1 kW0 + t2 kw1 k2W1 } dt/t
w1 ∈W1
Z0 ∞
≤ t−2s inf {kT u − T v1 kW0 + t2 kT v1 k2W1 } dt/t
v1 ∈V1
Z0 ∞
≤ t−2s inf {c20 ku − v1 kV0 + t2 c21 kv1 k2V1 } dt/t
v1 ∈V1
Z0 ∞
c0 τ −2s
≤ inf {c20 ku − v1 k2V0 + c20 τ 2 kv1 k2V1 } dτ /τ
0 c 1 v 1 ∈V1
Z ∞
= c2−2s
0 c2s
1 τ −2s KV (t, u)2 dτ /τ
0
= c2−2s
0 c2s
1 kuk2[V0 ,V1 ]s
Proof. Let Q be a square containing Ω, w.l.o.g. Q = (0, 2π)2 , and zk,l = eikx eily be the
m
trigonometric basis for (complex-valued) periodic Sobolev Spaces Hper (Q). Then
X
kuk2H m ' (k 2 + l2 )m |uk,l |2 ,
k,l
1 0 2
and thus Hper (Q) = [Hper (Q), Hper (Q)]1/2 by Hilbert space interpolation.
Now let E : L2 (Ω) → L2 (Q) be an extension operator such that
E : H m (Ω) → Hper
m
(Q)
Proof. Exercise
Literature:
• uD ∈ H 1/2 (ΓD ),
• f ∈ L2 (Ω),
• g ∈ L2 (ΓN ∪ ΓR ),
• α ∈ L∞ (ΓD ), α ≥ 0.
Proof: The bilinear-form A(., .) and the linear-form f (.) are continuous on V . Tartar’s
theorem of equivalent norms proves that A(., .) is coercive on V0 .
Since uD is in the closed range of trΓD , there exists an ũD ∈ VD such that
The right hand side is the evaluation of the continuous linear form f (.) − A(e
uD , .) on
V0 . Due to Lax-Milgram, there exists a unique solution z. Then, u := ueD + z solves (3.10).
The choice of ueD is not unique, but, the constructed u is unique. 2
A(u, v) = f (v) ∀ v ∈ V0
3.6. THE WEAK FORMULATION OF THE POISSON EQUATION 49
is well defined for all f ∈ V0∗ , and, due to Lax-Milgram there holds
Vice versa, the bilinear-form defines the linear functional A(u, .) with norm
H −1 := [H01 (Ω)]∗
Since H01 ⊂ L2 , there is L2 ⊂ H −1 (Ω). All negative spaces are defined as H −s (Ω) :=
[H0s ]∗ (Ω), for s ∈ R+ . There holds
. . . H02 ⊂ H01 ⊂ L2 ⊂ H −1 ⊂ H −2 . . .
The solution operator of the weak formulation is smoothing twice. The statements of
shift theorem are that for s > 0, the solution operator maps also
f ∈ H −1+s → u ∈ H 1+s
We give a proof of (a) for the square (0, π)2 by Fourier series. Let
VN = span{sin(kx) sin(ly) : 1 ≤ k, l ≤ N }
PN
For an u = k,l=1 ukl sin(kx) sin(ly) ∈ VN , there holds
kuk2H 2 = kuk2L2 + k∂x uk2L2 + k∂y uk2L2 + k∂x2 uk2L2 + k∂x ∂y uk2L2 + k∂y2 uk2
N
X
' (1 + k 2 + l2 + k 4 + k 2 l2 + l4 )u2kl
k,l=1
N
X
' (k 4 + l4 )u2kl ,
k,l=1
50 CHAPTER 3. SOBOLEV SPACES
Thus we have kukH 2 ' k∆ukL2 = kf kL2 for u ∈ VN . The rest requires a closure argument:
There is {−∆v : v ∈ VN } = VN , and VN is dense in L2 . 2
2
Indeed, on non-smooth non-convex domains, the H -regularity is not true. Take the
sector of the unit-disc
u = (1 − r2 )rβ sin(φβ)
is in H01 , and fulfills ∆u = −(4β + 4)rβ sin(φβ) ∈ L2 . Thus u is the solution of a Dirichlet
problem. But u 6∈ H 2 .
On non-convex domains one can specify the regularity in terms of weighted Sobolev
spaces. Let Ω be a polygonal domain containing M vertices Vi . Let ωi be the interior angle
at Vi . If the vertex belongs to a non-convex corner (ωi > π), then choose some
π
βi ∈ (1 − , 1)
ω
Define Y
w(x) = |x − Vi |βi
non-convex
Vertices Vi
P p := span{xi y j : 0 ≤ i, 0 ≤ j, i + j ≤ p}
Qp := span{xi y j : 0 ≤ i ≤ p, 0 ≤ j ≤ p}
• A constant triangle
• A linear triangle
• A non-conforming triangle
51
52 CHAPTER 4. FINITE ELEMENT METHOD
• A Morley triangle
• A Raviart-Thomas triangle
It is a projection.
Two finite elements (T, VT , ΨT ) and (Tb, VTb , ΨTb ) are called equivalent if there exists an
invertible function F such that
• T = F (Tb)
• VT = {v̂ ◦ F −1 : v̂ ∈ VTb }
• ΨT = {ψiT : VT → R : v → ψiT̂ (v ◦ F )}
IT (v) ◦ F = ITb (v ◦ F )
• either empty
• or Ti = Tj in the case i = j.
In a wider sense, a triangulation may consist of different element shapes such as segments,
triangles, quadrilaterals, tetrahedra, hexhedra, prisms, pyramids.
A finite element complex {(T, VT , ΨT )} is a set of finite elements defined on the geo-
metric elements of the triangulation T .
It is convenient to construct finite element complexes such that all its finite elements
are affine equivalent to one reference finite element (Tb, V̂T , Ψ̂T ). The transformation FT is
such that T = FT (Tb).
Examples: linear reference line segment on (0, 1).
4.1. FINITE ELEMENT SYSTEM ASSEMBLING 53
The finite element complex allows the definition of the global interpolation operator for
m
C -smooth functions by
IT v|T = IT vT ∀T ∈ T
The finite element space is
VT := {v = IT w : w ∈ C m (Ω)}
For smooth functions, functionals ψT,α and ψTe,α̃ sitting in the same location are equiv-
alent. The set of global functionals Ψ = {ψ1 , . . . , ψN } is the linearly independent set of
functionals containing all (equivalence classes of) local functionals.
The connectivity matrix CT ∈ RN ×NT is defined such that the local functionals are
derived from the global ones by
ΨT (u) = CTt Ψ(u)
Examples in 1D and 2D
The nodal basis for the global finite element space is the basis in VT dual to the global
functionals ψj , i.e.,
ψj (ϕi ) = δij
There holds
NT
X
ϕi |T = IT ϕi = ψTα (ϕi )ϕαT
α=1
NT
X
= (CTt ψ(ϕi ))α ϕαT
α=1
NT
X NT
X
= (CTt ei )α ϕαT = CT,iα ϕαT
α=1 α=1
The nodal basis and the dual functionals provides the one to one relation between RN and
VT :
XN
N
R 3 u ↔ uh ∈ VT with uh = ϕi ui and ui = ψi (uh ).
i=1
Using the nodal basis expansion of uh in (4.1), and testing only with the set of basis
functions, one has
XN
A( ui ϕi , ϕj ) = f (ϕj ) ∀j = 1...N
i=1
With
Aji = A(ϕi , ϕj ) and f j = f (ϕj ),
one obtains the linear system of equations
Au = f
The preferred way to compute the matrix A and vector f is a sum over element contribu-
tions. The restrictions of the bilinear and linear form to the elements are
Z Z
AT (u, v) = ∇u · ∇v dx + αuv ds
T ∂Ω∩T
and Z Z
fT (v) = f v dx + gv ds
T ∂Ω∩T
Then X X
A(u, v) = AT (u, v) f (v) = fT (v)
T ∈T T ∈T
On each element, one defines the NT ×NT element matrix and element vector in terms
of the local basis on T :
AT,αβ = AT (ϕTβ , ϕTα ) f T,α = f T (ϕTα )
Then, the global matrix and the global vector are
X
A= CT AT CTt
T ∈T
and X
f= CT f T
T ∈T
Namely,
X X X
f i = f (ϕi ) = fT (ϕi |T ) = fT ( CT,iα ϕαT )
T ∈T T ∈T α
XX XX
= CT,iα fT (ϕαT ) = CT,iα f α
T ∈T α T ∈T α
4.2. FINITE ELEMENT ERROR ANALYSIS 55
and
X X X X
Aji = A(ϕi |T , ϕj |T ) = A( CT,iα ϕαT , CT,jβ ϕβT )
T ∈T T ∈T α β
X XX
= CT,iα AT,αβ CT,jβ
T ∈T α β
On the elements T , the integrands are smooth functions. Thus, numerical integration
rules can be applied.
ku − uh kV ≤ C inf ku − vh kV .
vh ∈Vh
The constant factor C is the ratio of the continuity bound and the coercivity bound of the
bilinear form A(., .).
Provided that the solution u is sufficiently smooth, we can take the finite element
interpolant to bound the best approximation error:
inf ku − vh kV ≤ ku − IT ukV
v∈Vh
Lemma 66. Let Tb and T be d-dimensional domains related by the invertible affine linear
transformation FT : Tb → T
FT (x) = a + Bx,
where a ∈ Rd and B is a regular matrix in Rd×d . Then there holds:
d d
∂ ∂ X X ∂ ∂
... (u ◦ FT ) = ... ... u ◦ FT Bjm ,im . . . Bj1 ,i1 (4.3)
∂xim ∂xi1 j =1 j =1
∂x j m ∂x j 1
m 1
hT = diam T
|T | h2T
with a “good” constant ∼ 1. If one studies convergence, one considers families of triangu-
lations with decreasing element sizes hT . In that case, the family of triangulations is called
shape regular, if there is a common constant C such that all elements of all triangulations
fulfill |T | ≥ Ch2T .
Lemma 67. Let FT = a + Bx be the mapping from the reference triangle to the triangle
T . Let |T | h2T . Then there holds
kBT k ' hT
kBT−1 k ' h−1
T
The following lemma is the basis for the error estimate. This lemma is the main
application for the Bramble Hilbert lemma. Sometimes, it is called the Bramble Hilbert
lemma itself:
Lemma 68. Let (T, VT , ΨT ) be a finite element such that the element space VT contains
polynomials up to order P k . Then there holds
kv − IT vkH 1 ≤ C|v|H m ∀ v ∈ H m (T )
The last step used that for H m , with m > d/2, point evaluation is continuous. Now, let
v ∈ P k (T ). Since P k ⊂ VT , and IT is a projection on VT , there holds v − IT v = 0. The
Bramble Hilbert Lemma applied for U = H 1 and L = id − IT proves the result. 2
To bound the finite element interpolation error, we will transform functions from the
elements T to the reference element Tb.
( )1/2
X
|v − IT v|H 1 (Ω) ≤ h2T |v|2H 2 (T ) ∀ v ∈ H 2 (Ω)
T ∈T
Proof: We prove the H 1 estimate, the L2 one follows the same lines. The interpolation
error on each element is transformed to the interpolation error on one reference element:
X
|v − IT v|2H 1 (Ω) = |(id − IT )vT |2H 1 (T )
T ∈T
X
(det BT ) kBT−1 k2 |(id − IT )vT ◦ FT |2H 1 (Tb)
T ∈T
X
= (det BT )kBT−1 k2 k(id − ITb )(vT ◦ FT )k2H 1 (Tb)
T ∈T
A triangulation is called quasi − uniform, if all elements are essentially of the same
size, i.e., there exists one global h such that
h ' hT ∀T ∈ T .
ku − uh kH 1 h |u|H 2
In the case of a symmetric bilinear form, the primal and the dual problem coincide.
Theorem 71 (Aubin-Nitsche). Assume that
• the dual weak bvp is H 2 regular
• A(., .) is continuous on V :
ku − uh kH 1 h|u|H 2
Proof: To make use of the coercivity of A(., .), we need an element in Vh0 . There holds
Galerkin orthogonality A(u − uh , vh ) = 0 ∀ vh ∈ Vh0 :
2α2 α22 1
ku − uh k2V ≤ (2 + )ku − Ih ukV + 2 2 ku − Ih uk2V + ku − uh k2V
2
α1 α1 2
hT ' hrTβ , ∀T ∈ T
where rT is the distance of the center of the element to the singular corner, and h ∈ R+ is
a global mesh size parameter.
We bound the interpolation error:
X X
ku − IT uk2H 1 h2T |u|H 2 (T ) ' h2 |rβ D2 u|L2 (T )
T ∈T T ∈T
2
' h kr D β 2
uk2L2 (Ω) C h2
The number of elements in the domain can be roughly estimated by the integral over
the density of elements. The density is number of elements per unit volume, i.e., the inverse
of the area of the element:
Z Z Z
−2 −2β −2
Nel ' −1
|T | dx = h r dx = h r−2β dx ' Ch−2
Ω Ω
ku − uh kV ≤ C1 η(uh , f ) (4.5)
An error estimator is efficient, if it is a lower bound for the error, i.e., there exists a
constant C2 such that
ku − uh kV ≥ C2 η(uh , f ). (4.6)
The constants may depend on the domain, and the shape of the triangles, but may not
depend on the source term f , or the (unknown) solution u.
One use of the a posteriori error estimator is to know the accuracy of the finite element
approximation. A second one is to guide the construction of a new mesh to improve the
accuracy of a new finite element approximation.
The usual error estimators are defined as sum over element contributions:
X
η 2 (uh , f ) = ηT2 (uh , f )
T ∈T
The local contributions should correspond to the local error. For the common error
estimators there hold the local efficiency estimates
ku − uh kH 1 (ωT ) ≥ C2 ηT (uh , f ).
In the following, we consider the Poisson equation −∆u = f with homogenous Dirichlet
boundary conditions u = 0 on ∂Ω. We choose piecewise linear finite elements on triangles.
Define the gradient p = ∇u and the discrete gradient ph = ∇uh . The discrete gradient
ph is a constant on each element. Let p̃h be the p.w. linear and continuous finite element
function obtained by averaging the element values of ph in the vertices:
1 X
p̃h (xi ) = ph|T for all vertices xi
|{T : xi ∈ T }| T :x ∈T
i
The hope is that the averaged gradient is a much better approximation to the true gradient,
i.e.,
kp − p̃h kL2 ≤ α kp − ph kL2 (4.7)
holds with a small constant α 1. This property is known as super-convergence.It is
indeed true on (locally) uniform meshes, and smoothness assumptions onto the source
term f .
The ZZ error estimator replaces the true gradient in the error p − ph by the good
approximation p̃h :
η(uh ) = kp̃h − ph kL2 (Ω)
If the super-convergence property (4.7) is fulfilled, than the ZZ error estimator is reli-
able:
and
1
k∇u − ∇uh kL2 ≤ kph − peh kL2 .
1−α
It is also efficient, a similar short application of the triangle inequality.
There is a rigorous analysis of the ZZ error estimator, e.g., by showing equivalence to
the following residual error estimator.
f + ∆ uh ,
in the natural norm H −1 . The classical ∆-operator cannot be applied to uh , since the first
derivatives, ∇uh , are non-continuous across element boundaries. One can compute the
residuals on the elements
f|T + ∆ uh|T ∀T ∈ T ,
and one can also compute the violation of the continuity of the gradients on the edge
E = T1 ∩ T2 . We define the normal-jump term
∂uh ∂uh ∂uh
:= |T1 + |T .
∂n ∂n1 ∂n2 2
64 CHAPTER 4. FINITE ELEMENT METHOD
To show the reliability of the residual error estimator, we need a new quasi-interpolation
operator, the Clément- operator Πh . In contrast to the interpolation operator, this operator
is well defined for functions in L2 .
We define the vertex patch of all elements connected with the vertex x
[
ωx = T,
T :x∈T
the edge patch consisting of all elements connected with the edge E
[
ωE = T,
T :E∩T 6=∅
and the element patch consisting of the element T and all its neighbors
[
ωT = T 0.
T 0 :T ∩T 0 6=∅
where ϕi are the nodal basis functions. Now, we replace the nodal value v(xi ) by a local
mean value.
Definition 74 (Clément quasi-interpolation operator). For each vertex x,let v ωx be the
mean value of v on the patch ωx , i.e.,
Z
ωx 1
v = v dx.
|ωx | ωx
The Clément operator is X
Πh v := v ωxi ϕi .
xi ∈V
In the case of homogeneous Dirichlet boundary values, the sum contains only inner vertices.
4.3. A POSTERIORI ERROR ESTIMATES 65
Theorem 75. The Clément operator satisfies the following continuity and approximation
estimates:
If v is constant on ωT , then the mean values in the vertices take the same values, and
also (Πh v)|T is the same constant. The constant function (on ωT ) is in the kernel of
kv − Πh vkH 1 (T ) . Due to the Bramble-Hilbert lemma, we can replace the norm on the right
hand side of (4.8) by the semi-norm:
The rest follows from scaling. Let F : x → hx scale the reference patch ω
bT to the actual
patch ωT . Then
The estimate for the edge term is similar. One needs the scaling of integrals from the
reference edge E
b to E:
1/2
kvkL2 (E) = hE kv ◦ F kL2 (Ê)
ku − uh k η res (uh , f )
A(u − uh , u − uh ) A(u − uh , v)
ku − uh kH 1 ≤ sup .
ku − uh kH 1 06=v∈H 1 kvkH 1
The Galerkin orthogonality A(u − uh , vh ) = 0 for all vh ∈ Vh allows to insert the Clément
interpolant in the numerator. It is well defined for v ∈ H 1 :
A(u − uh , v − Πh v)
ku − uh kH 1 ≤ sup .
06=v∈H 1 kvkH 1
66 CHAPTER 4. FINITE ELEMENT METHOD
We use that the true solution u fulfills A(u, v) = f (v), and insert the definitions of A(., .)
and f (.):
A(u − uh , v − Πh v) = f (v − Πh v) − A(uh , v − Πh v)
Z Z
= f (v − Πh v) dx − ∇uh ∇(v − Πh v) dx
Ω Z Ω
X XZ
= f (v − Πh v) dx − ∇uh ∇(v − Πh v) dx
T ∈T T T ∈T T
On each T , the finite element function uh is a polynomial. This allows integration by parts
on each element:
XZ X Z Z
∂uh
A(u − uh , v − Πh v) = f (v − Πh v) dx − − ∆uh (v − Πh v) dx + (v − Πh v) ds
T ∈T T T ∈T T ∂T ∂n
All inner edges E have contributions from normal derivatives from their two adjacent
triangles TE,1 and TE,2 . On boundary edges, v − Πh v vanishes.
A(u − uh , v − Πh v)
XZ X Z ∂uh ∂uh
= (f + ∆uh )(v − Πh v) dx + |T + |T (v − Πh v) ds
T T E E ∂n E,1 ∂n E,2
XZ X Z ∂uh
= (f + ∆uh )(v − Πh v) dx + (v − Πh v) ds
T T E E ∂n
A(u − uh , v − Πh v)
X X ∂uh
≤ kf + ∆uh kL2 (T ) kv − Πh vkL2 (T ) + kv − Πh vkL2 (E)
T E
∂n L2 (E)
X X 1/2 ∂uh −1/2
−1
= hT kf + ∆uh kL2 (T ) hT kv − Πh vkL2 (T ) + hE hE kv − Πh vkL2 (E)
T E
∂n L2 (E)
( )1/2 ( )1/2
X X
≤ h2T kf + ∆uh k2L2 (T ) h−2 2
T kv − Πh vkL2 (T ) +
T T
( )1/2 ( )1/2
2
X ∂uh X
+ hE h−1 2
E kv − Πh vkL2 (E)
E
∂n L2 (E) E
We apply the approximation estimates of the Clément operator, and use that only a
bounded number of patches are overlapping:
X X
h−2
T kv − Π h vk2
L2 (T ) k∇vk2L2 (ωT ) k∇vk2L2 (Ω) ,
T T
4.3. A POSTERIORI ERROR ESTIMATES 67
A(u − uh , v − Πh v)
ku − uh kV sup
v∈H 1 kvk1H
nP ∂uh 2
o1/2
2 2
P
T hT kf + ∆u h k L2 (T ) + E hE ∂n L2 (E)
k∇vkL2 (Ω)
sup
V ∈H 1 kvkH 1
( )1/2
2
X
2 2
X ∂uh
≤ hT kf + ∆uh kL2 (T ) + hE ,
T E
∂n L2 (E)
Theorem 77. If the source term f is piecewise polynomial on the mesh, then the error
estimator η res is efficient:
ku − uh kV η res (uh , f )
b(u) − b(uh )
is small. The technique is to solve additionally the dual problem, where the right hand
side is the goal functional:
Usually, one cannot solve the dual problem either, and one applies a Galerkin method also
for the dual problem:
In the case of point values, the solution of the dual problem is the Green function (which
is not in H 1 ). The error in the goal is
A rigorous upper bound for the error in the goal is obtained by using continuity of the
bilinear-form, and energy error estimates η 1 and η 2 for the primal and dual problem,
respectively:
But, the obtained mesh is not regular. To avoid such irregular nodes, also neighboring
elements must be split (called green closure):
4.4. EQUILIBRATED RESIDUAL ERROR ESTIMATES 69
If one continues to refine that way, the shape of the elements may get worse and worse:
A solution is that elements of the green closure will not be further refined. Instead, remove
the green closure, and replace it by red refinement.
To ensure finite termination, one has to avoid cycles in the initial mesh. This can be
obtained by first sorting the edges (e.g., by length), end then, always choose the largest
edges as marked edge.
The left hand side defines the bilinear-form A(·, ·), the right hand side the linear-form f (·).
We define a finite element sub-space Vh ⊂ V of order k, and the finite element solution
Since
A(u − uh , v) r(v)
ku − uh kA = sup = sup ,
v∈V kvkA v∈V kvkA
we aim in estimating krk in the norm dual to k · kA , which is essentially the H −1 -norm.
In general, the direct evaluation of this norm is not feasible. Using the structure of the
problem, we can represent the residual as
XZ XZ
r(v) = rT v + rE v,
T ∈T T E∈E E
Here, λE is some averaging of the coefficients on the two elements containing the edge E.
The equivalence holds with constants depending on the shape of elements, the relative
jump of the coefficient, and the polynomial order k.
The equilibrated residual error estimator η er is defined in terms of the same data rT
and rE . It satisfies
The lower bound depends on the shape of elements and the coefficient λ, but is robust
with respect to the polynomial order k.
4.4. EQUILIBRATED RESIDUAL ERROR ESTIMATES 71
The main idea is the following: Instead of calculating the H −1 -norm of r, we compute
a lifting σ ∆ such that div σ ∆ = r, and calculate the L2 -norm of σ ∆ . Since r is not a regular
function, the equation must be posed in distributional form:
Z
σ ∆ · ∇ϕ = −r(ϕ) ∀ϕ ∈ V
Ω
Then, the residual can be estimated without envolving any generic constant:
R ∆
r(v) σ · ∇v
krkA∗ = sup = sup
v∈V kvkA v kvkA
qR qR
R −1/2 ∆ 1/2 −1 ∆
λ |σ | 2 λ|∇v|2
λ σ · λ ∇v
= sup ≤ sup = kσ ∆ kL2 ,1/λ
v kvkA v kvkA
The norm kσ ∆ k := λ−1 |σ ∆ |2 can be evaluated easily.
R
We minimize the weighted-L2 norm since we want to find the smallest possible upper bound
for the error. This is already a computable approach. But, the problem is global, and its
solution is of comparable cost as the solution of the original finite element system. The
existence of a σ such that div σ = r also needs a proof.
We want to localize the construction of the flux. Local problems are associated with
vertex-patches ωV = ∪T :V ∈T T . We proceed in two steps:
72 CHAPTER 4. FINITE ELEMENT METHOD
rV
P
1. localization of the residual: r = V
with
rTV = φV rT and rEV = φV rE
The local residual vanishes on constants on the patch:
Exercise: Show that these dofs are unisolvent. Count dimensions, and prove that [∀i :
ψi (σ) = 0] ⇒ σ = 0.
Now, we give an explicit construction of equilibrated fluxes on a vertex patch. Label
elements T1 , T2 , . . . Tn in a counter-clock-wise order. Edge Ei is the common edge between
triangle Ti−1 and Ti (with identifying T0 = Tn ). We define σ by specifying the dofs of the
BDM element:
2. Continue with element T2 . On edge E2 common with T1 set σn such that [σ · n]E2 =
rE2 . Otherwise, proceed as on T1 . Thus
Z Z Z Z Z
V V V
σn = rT1 + rE1 + rT2 + rEV 2
E3 T1 E1 T2 E2
Literature:
1. D. Braess and J. Schöberl. Equilibrated Residual Error Estimator for Maxwell’s
Equations. Mathematics of Computation, Vol 77(262), 651-672, 2008
2. D. Braess, V. Pillwein and J. Schöberl: Equilibrated Residual Error Estimates are
p-Robust. Computer Methods in Applied Mechanics and Engineering. Vol 198,
1189-1197, 2009
For reasons of simpler implementation, or even of higher accuracy, the conforming frame-
work is often violated. Examples are:
74 CHAPTER 4. FINITE ELEMENT METHOD
• The finite element space Vh is not a sub-space of V = H m . Examples are the non-
conforming P 1 triangle, and the Morley element for approximation of H 2 .
• The Dirichlet boundary conditions are interpolated in the boundary vertices.
• The curved domain is approximated by straight sided elements
• The bilinear-form and the linear-form are approximated by inexact numerical inte-
gration
The lemmas by Strang are the extension of Cea’s lemma to the non-conforming setting.
ku − uh k ≤ inf ku − vh k + kvh − uh k
vh ∈Vh
and perform Galerkin discretization with P 1 triangles. The second term leads to a non-
diagonal matrix. The vertex integration rule
3
|T | X
Z
v dx ≈ v(xT,α )
T 3 α=1
R
is exact for v ∈ P 1 . We apply this integration rule for the term uv dx:
Z X |T | X3
Ah (u, v) = ∇u · ∇v + u(xT,α )v(xT,α )
T ∈T
3 α=1
The bilinear form is now defined only for u, v ∈ Vh . The integration is not exact, since
uv ∈ P 2 on each triangle.
Inserting the nodal basis ϕi , we obtain a diagonal matrix for the second term:
1 for xi = xj = xT,α
ϕi (xT,α )ϕj (xT,α ) =
0 else
To apply the first lemma of Strang, we have to verify the uniform coercivity
3
X |T | X XZ
2
|vh (xT,α )| ≥ α1 |vh |2 dx ∀ vh ∈ Vh , (4.12)
T
3 α=1 T T
which is done by transformation to the reference element. The consistency error can be
estimated by
3
|T | X
Z
| uh vh dx − uh (xα )vh (xα )| h2T k∇uh kL2 (T ) k∇vh kL2 (T ) (4.13)
T 3 α=1
76 CHAPTER 4. FINITE ELEMENT METHOD
• continuity:
Ah (u, vh ) ≤ α2 kukh kvh kh ∀ u ∈ V + Vh , ∀ vh ∈ Vh
The error can now be measured only in the discrete norm ku − uh kVh .
Lemma 79. Under the above assumptions there holds
|Ah (u, wh ) − fh (wh )|
ku − uh kh inf ku − vh kh + sup (4.14)
vh ∈Vh wh ∈Vh kwh kh
Remark: The first term in (4.14) is the approximation error, the second one is called
consistency error.
Proof: Let vh ∈ Vh . Again, set wh = uh − vh , and use the Vh -coercivity:
α1 kuh − vh k2h ≤ Ah (uh − vh , uh − vh ) = Ah (uh − vh , wh )
= Ah (u − vh , wh ) + [fh (wh ) − Ah (u, wh )]
4.5. NON-CONFORMING FINITE ELEMENT METHODS 77
Ah (u, wh ) − fh (wh )
kuh − vh kh ku − vh kh +
kwh kh
The functions in Vhnc are not continuous across edges, and thus, Vhnc is not a sub-space
of H 1 . We have to extend the bilinear-form and the norm in the following way:
XZ
Ah (u, v) = ∇u∇v dx ∀ u, v ∈ V + Vhnc
T ∈T T
and X
kvk2h := k∇vk2L2 (T ) ∀ v ∈ V + Vhnc
T ∈T
Let E be an edge of the triangle T . Define the mean value wh E . If E is an inner edge,
then the mean value on the corresponding edge of the neighbor element is the same. The
78 CHAPTER 4. FINITE ELEMENT METHOD
∂u
normal derivative ∂n on the neighbor element is (up to the sign) the same. If E is an edge
on the Dirichlet boundary, then the mean value is 0. This allows to subtract edge mean
values:
X X Z ∂u
r(wh ) = (wh − wh E ) ds
T E⊂T E
∂n
X X Z ∂u ∂Ih u
r(wh ) = − (wh − wh E ) ds
T E⊂T E
∂n ∂n
To estimate these terms, we transform to the reference element Tb, where we apply the
Bramble Hilbert lemma. Let T = FT (Tb), and set
b = u ◦ FT
u bh = wh ◦ FT
w
|wh |H 1 (T ) ' |w
bh |H 1 (Tb)
1/2 E
kwh − wh E kL2 (E) ' hE kw
b
bh − w
bh kL2 (E)
b
On the reference element, we apply the Bramble Hilbert lemma, once for wh , and once for
u. The linear operator
E
L : H 1 (Tb) → L2 (E)
b
bh → w
b :w bh − w
bh
Similar for the term in u: There is k∇(u − Ih u)kL2 (E) kukH 2 (T ) , and u − Ih u vanishes for
u ∈ P 1.
Rescaling to the element T leads to
ku − uh k h kukH 2
• It can be used for the approximation of problems in fluid dynamics described by the
Navier Stokes equations (see later).
• The finite element matrix has exactly 5 non-zero entries in each row associated with
inner edges. That allows simplifications in the matrix generation code.
where c is independent of h and p. This estimate proves also convergence of the p-version
finite element method: One may fix the mesh, and increase the order p.
A detailed analyis of local H m norms allows an optimal balance of mesh-size h and
polynomial order p. This hp-version leads to exponential convergence
α
inf ku − vhp kH 1 ≤ ce−N ,
vhp ∈Vhp
1 dn 2
Pn (x) := (x − 1)n .
2n n! dxn
P0 (x) = 1
P1 (x) = x
P2 (x) = 23 x2 − 1
2
Pn is even if n is even, and Pn is odd if n is odd. Since (x2 − 1)n = x2n − nx2n−2 + π2n−4
(with proper modification for small n) we have
1 1
dn 2 m
Z Z
n+m n d
2 n!m! Pn (x)Pm (x) dx = (x − 1) (x2 − 1)n dx
−1 −1 dxn dxm
1
1
dn+1 2 m−1 dn 2 m−1
Z
n d n d
2 m 2
m
= (x − 1) (x − 1) + (x − 1) (x − 1)
−1 dxn+1 dxm−1 dxn
|dx
m−1
{z }
=0 for x∈{−1,1} −1
= ·Z· ·
1
dn+m 2
= n+m
(x − 1)n (x2 − 1)m dx
−1 dx
For n < m, the first factor of the integrand vanishes, and we have orthogonality. For
4.6. HP - FINITE ELEMENTS 81
n = m this equals
Z 1 Z 1
2n 2
2 (n!) kPn k2L2 = 2 n
(2n)!(x − 1) dx = (2n)! (x − 1)n (x + 1)n
−1 −1
Z 1
n
= −(2n)! (x − 1)n+1 (x + 1)n−1
−1 n + 1
Z 1
n(n − 1)
= (2n)! (x − 1)n+2 (x + 1)n−2 = ...
−1 (n + 1)(n + 2)
Z 1
n! 1
= (2n)! (x − 1)2n dx = (n!)2 22n+1 ,
2n(2n − 1) · · · (n + 1) −1 2n + 1
Next we prove the 3-term recurrency, which can be used for efficient evaluation.
Proof. Set r(x) = (n + 1)Pn+1 (x) − (2n + 1)xPn (x) + nPn−1 (x). Using (4.15), we see that
the leading coefficients cancel, and thus r ∈ Πn−2 . From Lemma 80 we get for any q ∈ Πn−2
Z 1 Z 1 Z 1 Z 1
r(x)q(x) dx = (n + 1) Pn+1 q − (2n + 1) Pn xq +n Pn−1 q = 0,
−1 −1 −1 −1
|{z}
∈Πn−1
and thus r = 0.
d 2 d
(x − 1) Pn (x) = n(n + 1)Pn (x)
dx dx
Proof. Both sides are in Πn . We compare leading coefficients, for this set Pn = an xn + πn−2
(with an = 2n1n! (2n)!
n!
).
d 2 d n
lhs = (x − 1) (an x + πn−2 )
dx dx
d
(x2 − 1)(an nxn−1 + πn−3 )
=
dx
d
an nxn+1 + πn−1
=
dx
= n(n + 1)an xn + πn−2 ,
82 CHAPTER 4. FINITE ELEMENT METHOD
and we get the same leading coefficient for rhs. Furthermore, for q ∈ Πn−1 there holds
Z 1 Z 1
1
(x2 − 1)Pn0 q 0 dx + (x2 − 1)Pn0 q −1
lhs q = −
−1 −1 | {z }
=0
Z 1
0 1
Pn (x2 − 1)q 0 dx − Pn (x2 − 1)q 0 −1 = 0,
=
−1 | {z }
∈Πn−1
and the same for the rhs. Thus the identity is proven.
Lemma 82 implies that the Legendre polynomials are also orthogonal w.r.t.
(u0 , v 0 )L2 ,1−x2 , i.e.
Z 1
(1 − x2 )Pn0 Pm0 = n(n + 1)kPn k2L2 δn,m
−1
(u, Pn )L2
an = ,
kPn k2L2
and ∞
X
kuk2L2 = a2n kPn k2 .
n=0
Π
Let PL2p denote the L2 -projection onto Πp . There holds
p
Π
X
PL2p u = an P n
n=0
Π 1
ku − PL2p ukL2 (−1,1) ≤ p |u|H 1 (−1,1) (4.18)
(p + 1)(p + 2)
4.6. HP - FINITE ELEMENTS 83
Proof. Since Pn are orthogonal also w.r.t. (u0 , v 0 )L2 ,1−x2 , there holds
X
ku0 k2L2 ,1−x2 = a2n kPn0 k21−x2 ,
n∈N
Π
X X 1
ku − PL2p uk2L2 = a2n kPn k2L2 = a2n kP 0 k2 2
n>p n>p
n(n + 1) n 1−x
1 X 1 X
≤ a2n kPn0 k21−x2 ≤ a2 kP 0 k2 2
(p + 1)(p + 2) n>p
(p + 1)(p + 2) n∈N n n 1−x
1
= ku0 k21−x2
(p + 1)(p + 2)
with c 6= c(p), easily in 1D and tensor product elements, and also on n-dimensional sim-
plices [Braess+Schwab: Approximation on simplices with respect to weighted Sobolev
norms, J. Approximation Theory 103, 329-337 (2000)].
But, an interpolation operator to an H 1 -conforming finite element space has to satisfy
continuity constraints across element boundaries. We show that we get the same rate of
convergence under these constraints.
The 1D case
Let I = (−1, 1). We define the operator Ip : H 1 (I) → Πp such that
Proof. The range of both sides is Πp−1 . We have to show that (Ip u)0 is indeed the L2 -
projection of u0 , i.e. Z Z
(Ip u) q = u0 q
0
∀ q ∈ Πp−1 .
I I
0
R
This holds since {q : q ∈ Πp,0 } = {q ∈ Πp−1 : q = 0} and (4.20), and
Z 1 Z 1
0
(Ip u) 1 = (Ip u)(1) − (Ip u)(−1) = u(1) − u(−1) = u0 1.
−1 −1
The H 1 -error estimate follows directly from the commuting diagram property:
Π c
|u − Ip u|H 1 (I) = ku0 − (Ip u)0 kL2 = ku0 − PL2p−1 u0 kL2 ≤ |u0 |H m−1 .
pm−1
86 CHAPTER 4. FINITE ELEMENT METHOD
Note that Ip u on the edge E depends only on u|E , and thus the interpolant is continuous
across neighbouring elements.
Lemma 86. Let v ∈ C(∂T ) such that v|E ∈ Πp (E). Then there exists an extension
ṽ ∈ Πp (T ) such that ṽ|∂T = v and
where c is independent of p.
Major steps have been shown in exercises 5.2 and 6.6. Note that the minimal-norm
extension ṽ is the solution of the Dirichlet problem, i.e.
Z
∇ṽ∇w = 0 ∀ w ∈ Πp,0
T
for u ∈ H m , m ≥ 2.
Since Z Z Z
∇up ∇v = ∇u∇v = ∇Ip u∇v ∀ v ∈ Πp,0 (T ),
T T T
we have that
up − Ip u ⊥H 1 Πp,0 ,
i.e. up − Ip u is solution of the Dirichlet problem with boundary values (up − Ip u)|∂T .
Lemma 86 implies that
In the last step we used that H 1/2 (∂T ) = [L2 , H 1 ]1/2 (i.e. the interpolation space). Next,
we observe that Ip restricted to one edge E is exactly the 1D operator. Using Aubin-Nitsche
we get
The finite element method, or other discretization schemes, lead to linear systems of equa-
tions
Au = f.
The matrices are typically
• of large dimension N (104 − 108 unknowns)
• and sparse, i.e., there are only a few non-zero elements per row.
A matrix entry Aij is non-zero, if there exists a finite element connected with both
degrees of freedom i and j.
A 1D model problem: Dirichlet problem on the interval. A uniform grid with n ele-
ments. The matrix is
2 −1
−1 2 −1
A=
.. .. ..
,
. . .
−1 2 −1
−1 2 (n−1)×(n−1)
2
(n−1)
1 2 n−1
89
90 CHAPTER 5. LINEAR EQUATION SOLVERS
n ∼N time memory
10 102 1 ms 80 kB
100 104 16 min 800 MB
1000 106 30 years 8 TB
The LU -factorization maintains the band-width. L and U are triangular factors of band-
width b. A banded factorization method costs O(N b2 ) operations, and O(N b) memory.
For the 1D example, the band-with is 1. Time and memory are O(n). For the 2D example,
the band width is O(n). The time complexity is O(n4 ), the memory complexity is O(n3 ).
This corresponds to
n time memory
10 10 µs 8 kB
100 0.1 s 8 MB
1000 16 min 8 GB
1
time of writing was 2003
5.1. DIRECT LINEAR EQUATION SOLVERS 91
Block-elimination methods
By splitting the unknowns into two groups, we rewrite the equation Au = f as a block
system
A11 A12 u1 f1
= .
A21 A22 u2 f2
First, expressing u1 from the first row gives
u1 = A−1
11 (f1 − A12 u2 ),
The interior ones corresponding to different sub-domains have no connection in the matrix.
The block matrix is
AI,1 AIC,1
AI AIC
... ..
=
.
ACI AC
AI,m2 AIC,m2
ACI,1 · · · ACI,m2 AC
is of the same cost. The Schur complement is of size mn, and has band-width n. Thus,
the factorization costs O(mn3 ). The total costs are of order
n4
2
+ mn3
m
Equilibrating both terms lead to the optimal number of sub-domains m = n1/3 , and to the
asymptotic costs
n3.33
If a parallel computer is used, the factorization of AI and the computation of Schur com-
plements can be performed in parallel.
The hierarchical sub-structuring algorithm, known as nested dissection, eliminates in-
terior unknowns hierarchically:
1. C is a good approximation to A
uk+1 = uk + τ C −1 (f − Auk )
Let u be the solution of the equation Au = f . We are interested in the behavior of the
error uk − u:
uk+1 − u = uk − u + τ C −1 (f − Auk )
= uk − u + τ C −1 (Au − Auk )
= (I − τ C −1 A)(uk − u)
The matrix norm is the associated matrix norm to some vector norm. If ρ := kM k < 1,
then the error is reduced. The error after k steps is
kuk − uk ≤ ρk ku0 − uk
log ε
Nits =
log ρ
iterations.
We will focus on the symmetric (A = AT ) and positive definite (uT Au > 0 for u 6=
0) case (short: SPD). Then it makes sense to choose symmetric and positive definite
preconditioners C = C T . Eigenvalue decomposition allows a sharp analysis. Pose the
generalized eigenvalue problem
Az = λCz.
Let (λi , zi ) be the set of eigen-pairs. The spectrum is σ{C −1 A} = {λi }. The eigen-vectors
zi are normalized to
kzi kC = 1
The eigenvalues can are bounded from below and from above by the Rayleigh quotient:
v T Av v T Av
min ≤ λ i ≤ max
v v T Cv v v T Cv
The ratio of largest to smallest eigen-value is the relative spectral condition number
λN
κ=
λ1
γ1 v T Cv ≤ v T Av ≤ γ2 v T Cv ∀ v ∈ RN ,
λi ∈ [γ1 , γ2 ],
Lemma 88. The iteration matrix M can be bounded in A-norm and in C-norm:
kM kA ≤ sup |1 − τ λ|
λ∈[γ1,γ2 ]
kM kC ≤ sup |1 − τ λ|
λ∈[γ1,γ2 ]
P
Proof: Express v = vi zi . Then
X X
M v = (I − τ C −1 A)v = vi (I − τ C −1 A)zi = vi (1 − τ λi )zi
The norm is
X
kM vk2A = λi vi2 (1 − τ λi )2
X
≤ sup(1 − τ λi )2 λi vi2
i
≤ sup (1 − τ λ)2 kvk2A
λ∈[γ1 ,γ2 ]
and thus
kM vkA
kM kA = sup ≤ sup |1 − τ λ|.
v∈Rn kvkA λ∈[γ1 ,γ2 ]
1−τγ
1
1−τγ 1
γ2
γ
γ1
1−τγ2
1 − τ γ1 = −(1 − τ γ2 ),
i.e.,
2
τ=
γ1 + γ2
The convergence factor is
γ2 − γ1
1 − τ γ1 = .
γ2 + γ1
Assume we knew sharp spectral bounds γ1 = λ1 and γ2 = λN . Then the convergence factor
is
κ−1 2
kM k = ≈1−
κ+1 κ
96 CHAPTER 5. LINEAR EQUATION SOLVERS
For the 2D model problem with N = (n − 1)2 , the condition number behaves like
κ ' n2 .
The costs per digit are comparable to the band-factorization. The memory requirement is
optimal O(N ).
5.2. ITERATIVE EQUATION SOLVERS 97
dk = f − Auk wk = C −1 dk
i.e.,
wk A(u − uk ) w k dk
τopt = =
(wk )T Awk (wk )T Awk
Since the gradient method gives optimal error reduction in energy norm, its convergence
rate can be estimated by the Richardson iteration with optimal choice of the relaxation
parameter:
κ−1
ku − uk+1 kA ≤ ku − uk kA
κ+1
M = Mm . . . M2 M1 = (I − τm C −1 A) . . . (I − τ1 C −1 A).
We represent uk as
k−1
X
uk = u0 + α l pl
l=0
The optimality criteria are
k−1
X
0 = (u − uk , pj )A = (u − u0 − αl pl , pj )A 0 ≤ j < k.
l=0
dTk pk
αk =
pTk Apk
uk+1 = u k + α k pk
dk+1 = dk − αk Apk
dT C −1 Apk
βk = − k+1T
pk Apk
−1
pk+1 = C dk+1 + βk pk
Remark 89. In exact arithmetic, the conjugate gradient algorithm terminates at a finite
number of steps k ≤ N .
2. The uk minimizes
min ku − vkA
v∈u0 +Kk (d0 )
dTk pl = 0 ∀l < k
This is obvious for k = 0. We prove the property for k + 1: For l < k there holds
dTk pk T
dTk+1 pk = (dk − αk Apk )T pk = dTk pk − p Apk = 0.
pTk Apk k
(pk+1 , pl )A = (C −1 dk+1 + βk pk , pl )A
= dTk+1 C −1 Apl
5.2. ITERATIVE EQUATION SOLVERS 101
There is
C −1 Apl ∈ span{p0 , . . . pk },
and dTk+1 pj = 0 for j ≤ k. For l = k there is
(pk+1 , pk )A = (C −1 dk+1 + βk pk , pk )A
−1 dTk+1 C −1 Apk T
= (C dk+1 , pk )A − pk Apk = 0
pTk Apk
2
The coefficients αk and βk should be computed by the equivalent, and numerically more
stable expressions
dTk C −1 dk dTk+1 C −1 dk+1
αk = T βk = .
pk Apk dTk C −1 dk
Theorem 91. The conjugate gradient iteration converges with the rate
√ k
κ−1
ku − uk kA ≤ √
κ+1
Proof: The conjugate gradient gives the best approximation in the Krylov space. Thus,
it can be bounded by the Chebyshev method leading to that rate.
ku − uk kA ≤ ε ku − u0 kA
The costs for one digit are comparable to the recursive sub-structuring algorithm. In 3D,
the conjugate gradient method has better time complexity.
102 CHAPTER 5. LINEAR EQUATION SOLVERS
5.3 Preconditioning
In the following, let the symmetric and positive definite matrix A arise from the finite
element discretization of the H 1 -elliptic and continuous bilinear-form A(., .). We construct
preconditioners C such that the preconditioning action
w = C −1 × d
γ1 uT Cu ≤ uT Au ≤ γ2 uT Cu ∀ u ∈ RN
The analysis of the preconditioner is performed in the finite element framework. For
this, define the Galerkin isomorphism
X
G : RN → Vh : u → u = ui ϕi ,
To distinguish vectors and the corresponding finite element functions, we write vectors
u ∈ RN with underlines (when necessary).
The evaluation of the quadratic form is
Here, ei is the ith unit-vector. Thus, eTi Aei gives the ith diagonal element Aii of the matrix,
which is
Aii = A(ϕi , ϕi ) ' kϕi k2H 1 .
The quadratic form generated by the preconditioner is
N
X N
X
T
u Cu = u2i kϕi k2A ' u2i kϕi k2H 1
i=1 i=1
5.3. PRECONDITIONING 103
Theorem 92. Let h be the minimal mesh-size of a shape-regular triangulation. Then there
holds
h2 uT Cu uT Au uT Cu (5.2)
Proof: We start to prove the right inequality
X X
uT Au = k ui ϕi k2A uT Cu = u2i kϕi k2A .
i i
of O.
The other estimate is proven element by element. Note that
X X
uT Au ' kuk2H 1 (Ω) = k ui ϕi k2H 1 (T )
T i
and X XX
uT Cu ' kui ϕi k2H 1 (Ω) = kui ϕi k2H 1 (T ) .
i T i
We prove the inequality for each individual element. The triangle T has diameterP hT . On
T , we expand u in terms of the element shape functions ϕα , namely u|T = 3α=1 uα ϕα .
We transform to the reference element Tb:
X X X
k uα ϕα k2H 1 (T ) = k uα ϕα k2L2 (T ) + k∇ uα ϕα k2L2 (T )
α α α
X X
' h2T k bα k2L2 (Tb)
uα ϕ + k∇ bα k2L2 (Tb)
uα ϕ
α α
X
≥ h2T k bα k2L2 (Tb)
uα ϕ
α
104 CHAPTER 5. LINEAR EQUATION SOLVERS
and
X X X
kuα ϕα k2H 1 (T ) = kuα ϕα k2L2 (T ) + k∇uα ϕα k2L2 (T )
α α α
X X
' h2T bα k2L2 (Tb)
kuα ϕ + bα k2L2 (Tb)
k∇uα ϕ
α α
X
bα k2L2 (Tb)
kuα ϕ
α
nP o1/2
bα k2L are norms on R3 . Since all
P
Both, (u)α → k bα kL2 (Tb) and u →
α uα ϕ α kuα ϕ 2 (T )
b
norms in R3 are equivalent, we have
X X
kuα ϕα k2H 1 (T ) h−2
T k uα ϕα k2H 1 (T ) . (5.3)
α α
By summing over all elements and choosing h = min hT , we have proven the left inequality
of (5.2). 2
Block-Jacobi preconditioners
Instead of choosing the diagonal, one can choose a block-diagonal of A, e.g.,
• In the case of systems of PDEs, choose blocks consisting of all degrees of freedom
sitting in one vertex. E.g., mechanical deformations (ux , uy , uz ).
• For high order elements, choose blocks consisting of all degrees of freedom associated
to the edges (faces, inner) of the elements.
Ei ∈ RN ×Ni i = 1, . . . , M.
Evaluation gives
ku1 k2A = ku1 k2H 1 (I1 ) + ku1 k2H 1 (T )
' ku1 k2H 1 (I1 ) + h−1 |u(xn/2 )|2
kuk2H 1 (I) + h−1 kuk2H 1 (I) (trace theorem)
' h−1 kuk2A ,
and thus X
uT Cu = kui k2A h−1 kuk2A ' h−1 uT Au.
i
d
The situation is the same in R .
Exercise: Sub-divide the interval I into M sub-domains of approximative size H ≈ 1/M .
What are the sprectral bounds of the block-Jacobi preconditioner ?
106 CHAPTER 5. LINEAR EQUATION SOLVERS
Example: Choose the unit-interval problem from above. The block 1 contains all nodes in
(0, 3/4), and the block 2 contains nodes in (1/4, 1). The blocks overlap, the decomposition
is not unique.
The columns of the matrices Ei are not necessarily unit-vectors, but are linearly in-
dependent. In this general setting, the preconditioner is called Additive Schwarz precon-
ditioner. The following lemma gives a useful representation of the quadratic form. It
was proven in similar forms by many authors (Nepomnyaschikh, Lions, Dryja+Widlund,
Zhang, Xu, Oswald, Griebel, ...) and is called also Lemma of many fathers, or Lions’
Lemma:
Lemma 93 (Additive Schwarz lemma). There holds
M
X
uT Cu = inf uTi Ai ui
ui ∈RNi
P
u= Ei ui i=1
Proof: The right hand side is a constrained minimization problem of a convex function.
The feasible set is non-empty, the CMP has a unique solution. It is solved by means of
Lagrange multipliers. Define the Lagrange-function (with Lagrange multipliers λ ∈ RN ):
X X
L((ui ), λ) = uTi Aui + λT (u − Ei ui ).
= uT CC −1 Cu = uT Cu
2
Next, we rewrite the additive Schwarz iteration matrix
M
X
I − τC −1
A=I −τ Ei A−1 T
i Ei A
i=1
P
If the spaces Vi are A-orthogonal, then i Pi = I, and (with τ = 1), and the iteration
matrix is M = 0.
The reformulation of the additive Schwarz lemma 93 in the finite element framework is
108 CHAPTER 5. LINEAR EQUATION SOLVERS
Example: Let Z 1 Z
0 0
A(u, v) = uv +ε uv dx
0
with 0 ≤ ε 1. The bilinear-form is H 1 -elliptic and continuous, but the bounds depend
on the parameter ε. Let CJ be the Jacobi preconditioner. The proof of Theorem 92 shows
that
εh2 uT CJ u uT Au uT CJ u.
The non-robust lower bound is sharp: Take u = (1, . . . , 1)T .
The solution is to add the additional sub-space
V0 = span{1} = GE0 R1
h2 uT Cu uT Au uT Cu,
namely
M
X
uT Cu = inf kui k2A
ui ∈Vi
u= M
P
i=0
0 ui
M
X
= inf ku0 k2A + inf kui k2A
u0 ∈V0 ui ∈Vi
u−u0 = M
P
i=1
1 ui
The last stepR was the result of the Jacobi preconditioner applied to (u, v)H 1 . Finally, we
1
choose u0 = 0 u dx to obtain
and only a small number of Ω e i are overlapping. Choose a finite element mesh of mesh
size h ≤ H, and the finite element space is Vh . The overlapping domain decomposition
preconditioner is the additive Schwarz preconditioner defined by the sub-space splitting
X
Vh = Vi with Vi = Vh ∩ H01 (Ω
e i ).
The bilinear-form A(., .) is H 1 -elliptic and continuous. The implementation takes the sub-
matrices of A with nodes inside the enlarged sub-domains Ω e i.
Lemma 96. The overlapping domain decomposition preconditioner fulfills the spectral es-
timates
H 2 uT Cu uAu uT Cu.
Proof: The upperP bound is generic. For the lower bound, we construct an explicit
decomposition u = ui .
There exists a partition of unity {ψi } such that
M
X
0 ≤ ψi ≤ 1, supp{ψi } ⊂ Ω
e i, ψi = 1
i=1
and
k∇ψi kL∞ H −1 .
ui = Πh (ψi u).
Indeed ui ∈ Vi is a decomposition of u ∈ Vh :
X X X
ui = Πh (ψi u) = Πh ( ψi )u = Πh u = u
110 CHAPTER 5. LINEAR EQUATION SOLVERS
Example:
VH Vh
The matrix EH transforms the coefficients uH w.r.t. the coarse grid basis to the coefficients
uh = EH uH w.r.t. the fine grid basis. It is called prolongation matrix.
The DD preconditioner with coarse grid correction is
X
C −1 × d = Ei A−1 T T −1 T
i Ei d + EH (EH AEH ) EH d
i
The first part is the local DD preconditioner from above. The second part is the coarse
T
grid correction step. The matrix EH (called restriction matrix) transfers the defect d from
the fine grid to a defect vector on the coarse grid. Then, the coarse grid problem with
T
matrix EH AEH is solved. Finally, the result is prolongated to the fine grid.
T
The matrix AH := EH AEH is the Galerkin matrix w.r.t. the coarse grid basis:
AH,ij = eTj EH
T
AEH ei = A(Gh EH ei , Gh EH ej )
= A(GH ei , GH ej ) = A(ϕH H
i , ϕj ).
112 CHAPTER 5. LINEAR EQUATION SOLVERS
Theorem 97. The overlapping domain decomposition preconditioner with coarse grid sys-
tem fulfills the optimal spectral estimates
uT Cu uT Au uT Cu.
Again, the upper bound uT Au uT Cu follows from the finite overlap of the spaces
VH , V1 , . . . VM . To prove the lower bound, we come up with an explicit decomposition.
We split the minimization into two parts:
M
X
uT Cu = inf inf kuH k2A + kui k2A (5.4)
uH ∈VH ui ∈VP
i
u−uH = ui i=1
In the analysis of the DD precondition without coarse grid system we have observed that
M
X
inf kui k2A H −2 ku − uH k2L2 + k∇(u − uH )k2L2
ui ∈VP
i
u−uH = ui i=1
2
The inverse factor H −2 we have to pay for the local decomposition could be compensated
by the approximation on the coarse grid.
The costs for the setup depend on the underlying direct solver for the coarse grid
problem and the local problems. Let the factorization step have time complexity N α . Let
5.3. PRECONDITIONING 113
N be the number of unknowns at the fine grid, and M the number of sub-domains. Then
the costs to factor the coarse grid problem and the M local problems are of order
α
α N
M +M
M
N 4/3 .
Multi-level preconditioners
The preconditioner above uses two grids, the fine one where the equations are solved,
and an artificial coarse grid. Instead of two grids, one can use a whole hierarchy of grids
T0 , T1 , . . . , TL = T . The according finite element spaces are
V0 ⊂ V1 ⊂ . . . ⊂ VL = Vh .
Let El be the prolongation matrix from level l to the finest level L. Define
The setup, and the application of the preconditioner takes O(N ) operations. One can
show that the multi-level preconditioner fulfills optimal spectral bounds
uT Cu uT Au uT Cu.
V0 ⊂ V1 ⊂ . . . ⊂ VL
Assume hl ' 2−l . Let {ϕl,i : 1 ≤ i ≤ Nl } be the hat-basis for Vl , with Nl = dim Vl . Let Al
be the finite element matrix on Vl .
El ∈ RNl ×Nl−1 is the prolongation matrix from level l − 1 to level l.
The multi-level preconditioner is defined recursively:
C0−1 := A−1
0
Cl−1 := (diag Al )−1 + El Cl−1
−1 T
El 1 ≤ l ≤ L.
L
X
' inf ku0 k2A + h−2 2
l kul kL2
u= L ul
P
l=0 l=1
ul ∈Vl
L
X L
X L
X
ul k2A kul k2A ku0 k2A h−2 2
k ≤ (L + 1) L + l ku l k L2 .
l=0 l=0 l=1
Since the estimate holds for any decompositon, it also holds for the infimum.
5.4. ANALYSIS OF THE MULTI-LEVEL PRECONDITIONER 115
Define
u0 := Π0 u
ul := Πl u − Πl−1 u 1 ≤ l ≤ L.
PL
Then u = l=0 ul and
L
X
kuk2C kΠ0 uk2A + h−2 2 2 2
l kΠl u − Πl−1 ukL2 L kukH 1 ≈ L kukA
l=1
We have bound each of the L + 1 terms by the H 1 -norm of u, thus the factor L.
Next we show an improved estimate leading to the optimal condition number
κ(C −1 A) 1, independent of the number of refinement levels:
Lemma 99. There holds
CAC
PL
Proof. We show A C. Let u = l=0 ul an arbitrary decomposition. First, we split up
the coarsest level:
L
X
kuk2A ≤ ku0 k2A +k ul k2A
l=1
Okl = 2−|k−l|/2 .
Then
L
X N
X X
k ul k2A = A(ul , uk ) Okl h−1 −1
k kuk kL2 hl kul kL2
l=1 l,k=1 l,k
L
X
≤ ρ(O) h−2 2
l kul kL2
l=1
The spectral radius ρ(O) can be estimated by the row-sum-norm, which is bounded by a
convergent geometric sequence
L ∞
X
−|k−l|/2
X √ −k 2
2 ≤2 2 ≤ √ .
k=1 k=0
1− 2
Since the decomposition was arbitrary, the estimate holds for the minimal decomposition.
h−2 2 −2 2
l kul kL2 hl kukL2 ,
h−2 2 2
l kul kL2 hl kukH 2 .
The idea of the proof is that H 1 is the interpolation space [L2 , H 2 ]1/2 . We define the
K-functional
K(t, u)2 = u=uinf+u ku0 k2L2 + t2 ku2 k2H 2 .
0 2
u0 ∈L2 ,u2 ∈H 2
h−2 2 −2 2 2
l kul kL2 hl K (hl , u)
Next we use that K(s, .) ' K(t, .) for t ≤ s ≤ 2t and replace the sum by an integral, and
substitute t := 2−l , dt ' −2−l dl = −tdl:
L
X Z L+1
h−2 2
l kul kL2 ≤ 2l K 2 (2−l , u)dl
l=1 l=1
Z 1
dt
' t−1 K 2 (t, u)
−L−1 t
Z2 ∞
dt
t−1 K 2 (t, u)
0 t
= kuk2[L2 ,H 2 ]1/2 ' kuk2H 1
An intuitive explanation of the proof is that different terms of the sum Ll=1 h−2
P
l kΠl u −
2 1
Πl−1 ukL2 are dominated by different frequency components of u. The squared H -norm is
the sum over H 1 -norms of the individual frequency components.
118 CHAPTER 5. LINEAR EQUATION SOLVERS
Chapter 6
Mixed Methods
A mixed method is a variational formulation involving two function spaces, and a bilinear-
form of a special saddle point structure. Usually, it is obtained from variational problems
with constraints.
−∆u = f in Ω, (6.1)
∂u
The normal derivative ∂n
is not known on ΓD . We simply call it −λ:
∂u
λ := −
∂n
To pose the Dirichlet boundary condition, we multiply u = uD by sufficiently many test
functions, and integrate over ΓD :
Z Z
uµ ds = uD µ ds ∀µ ∈ ?
ΓD ΓD
119
120 CHAPTER 6. MIXED METHODS
Combining both equations, we get the system of equations: Find u ∈ V = H 1 (Ω) and
λ ∈ Q =? such that
R R R
Ω
∇u · ∇v dx + ΓD vλ ds = f v dx ∀ v ∈ V,
R R (6.2)
ΓD
uµ ds = ΓD
uD µ ds ∀ µ ∈ Q.
div(a∇u) = f in Ω,
u = uD on ΓD
∂u
a = g on ΓN
∂n
Next, we introduce the flux variable σ := a∇u to rewrite the equations as: Find u and σ
such that
a−1 σ − ∇u = 0, (6.3)
div σ = −f, (6.4)
u = uD on ΓD
σ·n = g on ΓN .
We want to derive a variational formulation for the system of equations. For that, we
multiply the first equations by vector-valued test functions τ , the second equation by test
functions v, and integrate:
R −1 R
Ω
(a σ) · τ dx − Ω τ · ∇u dx = 0 ∀τ
R R
Ω
div σ v dx = − f v dx ∀v
We would like to have the second term of the first equation of the same structure as the
first term in the second equation. This can be obtained by integration by parts applied to
either one of them. The interesting case is to integrate by parts in the first line to obtain:
Z Z Z Z
−1
(a σ) · τ dx + div τ u dx − τn u ds − τn u ds = 0.
Ω Ω ΓD ΓN
6.3. ABSTRACT THEORY 121
Here, we make use of the boundary conditions. On the Dirichlet boundary, we know
u = uD , and use that in the equation. The Neumann boundary condition σ · n = g must
be put into the approximation space, it becomes an essential boundary condition. Thus,
it is enough to choose test functions of the sub-space fulfilling τ · n = 0. The problem is
now the following. The space V will be fixed later. Find σ ∈ V, σn = g on ΓN , and u ∈ Q
such that
R −1 R R
Ω
R (a σ) · τ dx + Ω
div τ u dx = R uD τn ds
ΓD
∀ τ, τn = 0 on ΓN
Ω
div σ v dx = − f v dx ∀v
The derivatives are put onto the flux unknown σ (and its test function τ ). We don’t have
to derive the primal unknown u. This will give us better approximation for the fluxes than
for the scalar. That is one of the reasons to use this mixed method.
a(u, v) : V × V → R,
b(u, q) : V × Q → R,
f (v) : V → R,
g(q) : Q → R.
Instead of considering this as a system of equations, one can look at the mixed method
as one variational problem on the product spaces V × Q. For this, simply add both lines,
and search for (u, p) ∈ V × Q such that
and
B((u, p), (v, q)) = kvk2V + kqk2Q .
First, we use (6.10) to choose u1 ∈ V such that
Due to assumption (6.9), the left hand side is a coercive bilinear-form on V0 . The right
hand side is a continuous linear-form. By Lax-Milgram, the problem has a unique solution
fulfilling
ku0 kV kvkV + ku1 kV
We set
u = u0 + u1 .
By the Riesz-isomorphism, we define a z ∈ V such that
z = B ∗ p.
It fulfills
kpkQ ≤ β1−1 kzkV kvkV + kqkQ
124 CHAPTER 6. MIXED METHODS
and
Remember, H −1/2 (ΓD ) is the dual to H 1/2 (ΓD ). The later one is the trace space of H 1 (Ω),
the norm fulfills
kuD kH 1/2 (ΓD ) ' inf1 kwkH 1 (Ω) .
w∈H
tr w=uD
b(u, µ) = hµ, tr uiH −1/2 ×H 1/2 ≤ kµkH −1/2 k tr ukH 1/2 (ΓD ) kµkQ kukH 1 = kµkQ kukV
The LBB - condition of b(., .) follows more or less from the definition of norms:
hq, ui
kqkQ = sup
u∈H 1/2 kukH 1/2
hq, ui
' sup
u∈H 1/2 inf w∈H 1 (Ω) kwkH 1 (Ω)
tr w=u
hq, ui
= sup sup
u∈H 1/2 w∈H 1 (Ω) kwkH 1
tr w=u
hq, tr wi b(w, q)
= sup = sup
w∈H 1 kwkH 1 w∈V kwkV
its norms is
1/2
kσkH(div) = kσk2L2 + k div σk2L2
V = H(div) Q = L2
We assume that the symmetric matrix a ∈ Rd×d and its inverse a−1 are bounded.
126 CHAPTER 6. MIXED METHODS
Theorem 104. The mixed problem for the fluxes is well posed.
Proof: We check the conditions of the theorem of Brezzi: The bilinear-forms are
bounded, namely
Z
a(σ, τ ) = a−1 στ dx ≤ ka−1 kL∞ kσkL2 kτ kL2 kσkV kτ kV
and Z
b(σ, v) = div σv dx ≤ k div σkL2 kvkL2 ≤ kσkV kvkQ .
V0 = {τ ∈ H(div) : div τ = 0}
For given v ∈ L2 , we will construct a flux σ satisfying the inequality. For this, we solve
the artificial Poisson problem −∆ϕ = v with Dirichlet boundary conditions ϕ = 0 on ∂Ω.
The solution satisfies k∇ϕkL2 kvkL2 . Set σ = −∇ϕ. There holds div σ = v. Its norm is
such that for σ ∈ H(div) ∩ [C(Ω)]d it coincides with its normal component
trn σ = σ · n on ∂Ω.
Proof: For smooth functions, the trace operator gives the normal component on the
boundary. We have to verify that this operator is bounded as operator from H(div) to
H −1/2 (∂Ω). Then, by density, we can extend the trace operator to H(div). Let σ ∈
H(div) ∩ [C 1 (Ω)]d :
R R
∂Ω
σ · n ϕ ds σ · n tr ϕ ds
k trn σkH −1/2 = sup ' sup ∂Ω
ϕ∈H 1/2 (∂Ω) kϕkH 1/2 ϕ∈H 1 (Ω) kϕkH 1
R R
(σ tr ϕ) · n ds div(σϕ) dx
= sup ∂Ω = sup Ω
ϕ∈H 1 (Ω) kϕkH 1 ϕ∈H 1 (Ω) kϕkH 1
R R
(div σ)ϕ dx + Ω σ · ∇ϕ dx k div σkL2 kϕkL2 + kσkL2 k∇ϕkL2
= sup Ω ≤ sup
ϕ∈H 1 (Ω) kϕkH 1 ϕ∈H 1 (Ω) kϕkH 1
1/2
≤ kσk2L2 + k div σk2L2
= kσkH(div)
•
trn,i σ|Ωi = − trn,j σ|Ωj on γij .
We want to compute with functions in H(div). For this, we need finite elements for
this space. The characterization by sub-domains allows the definition of finite element
sub-spaces of H(div). Let T = {T } be a triangulation of Ω. One family of elements are
the BDM (Brezzi-Douglas-Marini) elements. The space is
This finite element space is larger than the piece-wise polynomial H 1 -finite element space
of the same order. The finite element functions can have non-continuous tangential com-
ponents across edges.
The cheapest element for H(div) is the lowest order Raviart-Thomas element RT0.
The finite element (T, VT , {ψi }) is defined by the space of shape functions VT , and linear
functionals ψi . The element space is
a x
VT = +c : a, b, c ∈ R ,
b y
the linear functionals are the integrals of the normal components on the three edges of the
triangle Z
ψi (σ) = σ · n ds i = 1, 2, 3
ei
The three functionals are linearly independent on VT . This means, for each choice of
σ1 , σ2 , σ3 , there exists three unique numbers a, b, c ∈ R such that
a
x
σ= +c .
b y
satisfies ψi (σ) = σi .
Exercise: Compute the shape functions for the RT0 - reference triangle.
The global finite element functions are defined as follows. Given one value σi for each
edge ei of the triangulation. The corresponding RT0 finite element function σ is defined
by Z
σ|T ∈ VT and σ|T · nei ds = σi
ei
We have to verify that this construction gives a function in H(div). For each ele-
ment, σ|T is a linear polynomial, and thus in H(div, T ). The normal components must be
continuous. By construction, there holds
Z Z
σ|T,i · n ds = σ|T,j · n ds
e e
6.4. ANALYSIS OF THE MODEL PROBLEMS 129
The global RT0-basis functions ϕRTi are associated to the edges, and satisfy
Z
ϕRT
j · ne ds = δij ∀ i, j = 1, . . . Nedges
ei
The analysis of the approximation error is based on the transformation to the reference
element. For H 1 finite elements, interpolation on the element T is equivalent to interpo-
lation on the reference element Tb, i.e., (Ih v) ◦ FT = Iˆh (v ◦ FT ). This is not true for the
RH(div) elements:
R The transformation F changes the direction of the normal vector. Thus
e
σ · n ds 6
= ê
σ̂ · n̂ ds.
The Piola transformation is the remedy:
130 CHAPTER 6. MIXED METHODS
Definition 109 (Piola Transformation). Let F : Tb → T be the mapping from the reference
element Tb to the element T . Let σ̂ ∈ L2 (Tb). Then, the Piola transformation
σ = P{σ̂}
is defined by
σ(F (x̂)) = (det F 0 )−1 F 0 σ̂(x̂).
The Piola transformation satisfies:
Lemma 110. Let σ̂ ∈ H(div, Tb), and σ = P{σ̂}. Then there holds
Since C0∞ is dense in L2 (T ), there follows the first claim. To prove the second one, we show
that Z Z
(σ · n)ϕ ds = (σ̂ · n)ϕ̂ dx
e ê
∞
holds for all ϕ ∈ C (T ), ϕ = 0 on ∂T \ e. Then, let ϕ → 1 on the edge e:
Z Z Z Z
(σ · n)ϕ ds = div(σϕ) dx = div(σ̂ ϕ̂) dx̂ = (σ̂ · n̂)ϕ̂ dŝ.
e T Tb ê
2
Lemma 111. The Raviart-Thomas triangle T and the Raviart-Thomas reference triangle
are interpolation equivalent:
IhRT P{σ̂} = P{IbhRT σ̂}
R Proof: The element spaces are equivalent, i.e., VT = P{VTb }, and the functionals ψi (σ) =
e
σ · n ds are preserved by the Piola transformation.
6.5. APPROXIMATION OF MIXED SYSTEMS 131
Proof: Transformation to the reference element, using that the interpolation preserves
constant polynomials, and the Bramble Hilbert lemma. The estimate for the divergence
uses the commuting diagram property
Theorem 113. Assume that the finite element spaces fulfill the discrete stability condition
B((u, p), (v, q))
inf sup ≥ β. (6.13)
v∈Vh ,q∈Qh u∈Vh ,p∈Qh (kvkV + kqkQ )(kukV + kpkQ )
ku − uh kV + kp − ph kQ inf {ku − vh kV + kp − qh kQ }
vh ∈Vh ,qh ∈Qh
Proof: Theorem 36 applied to the big system B((u, p), (v, q)). 2
The stability on the continuous level V × Q does not imply the discrete stability !
Usually, one checks the conditions of Brezzi on the discrete level to prove stability of B(., .)
on the discrete levels. The continuity of a(., .) and b(., .) are inherited from the continuous
levels. The stability conditions have to be checked separately. The discrete kernel ellipticity
The discrete LBB condition is posed for less dual variables qh in Qh ⊂ Q, but the space in
the supremum is also smaller. It does not follow from the LBB condition on the continuous
levels.
There is a canonical technique to derive the discrete LBB condition from the continuous
one:
Πh : V → Vh
which is continuous
kΠh vkV kvkV ∀ v ∈ V,
and which satisfies
b(Πh v, qh ) = b(v, qh ) ∀ qh ∈ Qh .
Then, the continuous LBB condition implies the discrete one.
Qh = {q ∈ L2 : q|T ∈ P 0 } ⊂ Q = L2 .
Lemma 115 (Discrete Stability). The discrete mixed variational problem (6.16) is well
posed.
Proof: By Brezzi’s theorem. Continuity of the bilinear-form and the linear-form follow
from the continuous level. We prove the kernel ellipticity: Since
div Vh ⊂ Qh ,
6.5. APPROXIMATION OF MIXED SYSTEMS 133
there holds Z
div σh qh dx = 0 ∀ qh ∈ Qh ⇒ div σh = 0,
and thus V0h ⊂ V0 . In this special case, the discrete kernel ellipticity is simple the restriction
of the continuous one to V0h . We are left with the discrete LBB condition. We would like
to apply Lemma 114. The quasi-interpolation operator is the Raviar-Thomas interpolation
operator IhRT . The abstract condition
b(IhRT σ, vh ) = b(σ, vh ) vh ∈ Qh
reads as Z Z
div IhRT σ dx = div σdx,
T T
which was proven in Lemma 108. But, the interpolation operator is not continuous on
H(div). The edge-integrals are not well defined on H(div). We have to include the sub-
space [H 1 ]d ⊂ H(div). There holds
kIhRT σkH(div) kσkH 1 ∀ σ ∈ [H 1 ]d ,
and the stronger LBB condition (see Section on Stokes below)
(div σ, v)L2
sup ≥ βkvkL2 ∀ v ∈ L2 .
σ∈[H 1 ]d kσkH 1
Brezzi’s theorem now proves that the discrete problem is well posed, i.e., it fulfills the
discrete inf-sup condition.
2
Theorem 116 (A priori estimate). The mixed finite element method for the flux satisfies
the error estimates
kσ − σh kL2 + k div(σ − σh )kL2 + ku − uh kL2 h (kσkH 1 + kukH 1 + kf kH 1 ) (6.17)
Proof: By discrete stability, one can bound the discretization error by the best approx-
imation error
kσ − σh kH(div) + ku − uh kL2 inf kσ − τh kH(div) + ku − vh kL2 .
τh ∈Vh
vh ∈Qh
The best approximation error is bounded by the interpolation error. The first term is
(using the commuting diagram property and div σ = f )
inf {kσ − τh kL2 + k div(σ − τh )kL2 } ≤ kσ−IhRT σkL2 +k(I−P 0 ) div σkL2 h (kσkH 1 + kf kH 1 ) .
τh ∈Vh
134 CHAPTER 6. MIXED METHODS
The smoothness requirements onto the solution of (6.17) are fulfilled for problems on
convex domains, and smooth (constant) coefficients a. There holds kukH 2 kf kL2 . Since
σ = a∇u, there follows kσkH 1 kf kL2 . The mixed method requires more smoothness
onto the right hand side data, f ∈ H 1 . It can be reduced to H 1 on sub-domains, what is
a realistic assumption. On non-convex domains, u is in general not in H 2 (and σ not in
H 1 ). Again, weighted Sobolev spaces can be used to prove similar estimates on properly
refined meshes.
Vh = {v ∈ C(Ω) : v|T ∈ P 1 ∀ T },
Proof: Exercises.
Both are formally equivalent: If the solutions are smooth enough for integration by parts,
both solutions are the same. In both cases, the big-B bilinear-form is inf − sup stable with
respect to the corresponding norms.
The natural discretization for the primal-mixed formulation uses standard H 1 -finite
elements of order k for u, and discontinuous L2 elements of order k − 1 for σ. Here,
the discrete Brezzi conditions are trivial. The dual one requires Raviart-Thomas (RT)
or Brezzi-Douglas-Marini (BDM) elements
R for σ,
R and L2 elements for u. This pairing
delivers locally exact conservation ( ∂T σn = − T f ). In particular this property makes
the method interesting by itself, but often this scheme is a part of a more complex problem
(e.g. Navier-Stokes equations).
Our plan is as follows: We want to use the dual finite element method, but analyze
it in a primal - like setting. Since Qh is no sub-space of H 1 , we have to use a discrete
counterpart of the H 1 -norm:
kτ k2Vh := kτ k2L2
X X X
kvk2Qh := kvk2H 1 ,h := k∇vk2L2 (T ) + 1
h
k[v]k2L2 (E) + 1
h
kvk2L2 (E)
T E⊂Ω E⊂ΓD
The factor h1 provides correct scaling: If we transform an element patch to the reference
patch, the jump term scales like the H 1 -semi-norm. This norm is called discrete H 1 -norm,
or DG-norm (as it is essential for Discontinuous Galerkin methods discussed later).
There holds a discrete Friedrichs inequality
kvkL2 kvkH 1 ,h .
Theorem 118. The dual-mixed discrete problem satisfies Brezzi’s conditions with respect
to L2 and discrete H 1 -norms.
Proof. The a(., .) bilinear-form is continuous and coercive on (Vh , k · kL2 ). Now we show
continuity of b(., .) on the finite element spaces. We integrate by parts on the elements,
and rearrange boundary terms:
Z XZ
b(σh , vh ) = div σh vh = div σh vh
Ω T
X Z ZT
= − σh · ∇vh + σh · n vh
T T ∂T
X Z XZ X Z X Z
= − σh · ∇vh + σh nE [v] + σh nE v + σh nE v
T E E E
| {z }
T E⊂Ω E⊂ΓD E⊂ΓN =0
The jump term is defined as [v](x) = limt→0+ v(x + tnE ) − v(x − tnE ). Thus, σh nE [v] is
independent of the direction of the normal vector. Next we apply Cauchy-Schwarz, and
136 CHAPTER 6. MIXED METHODS
use that hkσh · nk2L2 (E) kσh kL2 (T ) for some E ⊂ T (scaling and equivalence of norms on
finite dimensional spaces):
X X X
b(σh , vh ) ≤ kσh kL2 (T ) k∇vh kL2 (T ) + h1/2 kσh kL2 (E) h−1/2 k[vh ]kL2 (E) + ...
T E⊂Ω E⊂ΓD
kσh kL2 (Ω) kvh kH 1 ,h
The linear-forms are continuous with norms h−1/2 kuD kL2 (ΓD ) and kf kL2 (Ω) , respectively.
Finally, we show the LBB - condition: Given an vh ∈ Qh , we define σh as follows:
σh · nE = h1 [vh ] on E ⊂ Ω
1
σh · nE = h vh on E ⊂ ΓD
Zσh · nE = 0 Z on E ⊂ ΓN
σh · q = − ∇vh · q ∀ q ∈ [P k−1 ]2 .
T T
This definition mimics σ = −∇v. This construction is allowed by the definition of Raviart-
Thomas finite elements. Thus we get
X Z X X
2
b(σh , vh ) = − σh ∇vh + h
1
k[vh ]kL 2 (E) + 1
h
kvh k2L2 (E)
|{z}
T ∈[P k−1 ]2 E⊂Ω E⊂ΓD
XZ X X
= ∇vh · ∇vh + 1
h
k[vh ]k2L2 (E) + 1
h
kvh kL2 (E)
T E⊂Ω E⊂ΓD
= kvh k2H 1 ,h
By scaling arguments we see that kσh kL2 kvh kH 1 ,h . Thus we got σh such that
b(σh , vh )
kvh kH 1 ,h ,
kσh kL2
and we have constructed the candidate for the LBB condition.
By the usual Bramble-Hilbert and scaling arguments we see that (using the element-wise
L2 -projection Ph ):
ku − Ph ukH 1 ,h hk kukH 1+k k ≥ 0.
In the lowest order case (k = 0) we don’t get any convergence !!
But, we can show error estimates for σ in terms of approximability for σ only. Further-
more, we can perform a local postprocessing to improve also the scalar variable.
6.6. SUPPLEMENT ON MIXED METHODS FOR THE FLUX : DISCRETE NORMS, SUPER-CONVER
For the second one we use the commuting diagram, and orthogonality:
Z Z
div(Ih σ − σ)vh = (Ph − Id) div σ vh = 0
| {z } |{z}
∈Q⊥ ∈Qh
h
Thus, the right hand side of equation (6.19) can be estimated by kσ − Ih σkL2 . Finally, an
application of the triangle inequality proves the result.
Remark 120. This technique applies for BDM elements as well as for RT. Both satisfy
div Vh = Qh , and the commuting diagram. For RTk elements, i.e. [P k ]2 ⊂ RTk ⊂ [P k+1 ]2
as well as BDMk elements, i.e. BDMk = [P k ]d we get the error estimate
kσ − Ih σkL2 hk+1 kσkH k
with k ≥ 0 for RT and k ≥ 1 for BDM.
Remark 121. The scalar variable shows super-convergence: A filtered error, i.e. Ph u − uh
is of higer order than the error u − uh itself: One order for RT and two orders for BDM
We can apply a local post-processing to compute the scalar part with higher accuracy:
We use the equation σ = a∇u, and the good error estimates for σ and Ph u. We set
eh := P k+1 , and solve a local problem on every element:
Q
min ka∇ṽh − σh k2L2 (T ),a−1
ṽh ∈Q
Rh
e
R
T vh = T ṽh
138 CHAPTER 6. MIXED METHODS
σ = −A−1 B t u
−BA−1 B t u = −f
Thanks to the LBB-condition, B has full rank, and thus the Schur complement matrix is
regular. Since B is the discretization of the div-operator, B t of the negative gradient, and
A of a(x)−1 I, the equation can be interpreted as a discretization of
div a∇u = −f
This approach is not feasible, since A−1 is not a sparse matrix anymore.
One can use extensions of the conjugate gradient (CG) method for symmetric but
indefinit matrices (e.g. MINRES). Here, preconditioners are important. Typically, for
block-systems one uses block-diagonal preconditioners to rewrite the system as
! !
e−1 0 e−1 0
T
G V A B σ GV 0
e−1 = e−1
0 G Q
B 0 u 0 G Q
−f
where G
eV and G
eQ are approximations to the Gramien matrices in Vh and Qh :
One can either choose the H(div)-L2 , or the [L2 ]2 -H 1 setting, which leads to different kind
of preconditioners. Here, the later one is much simpler. This is a good motivation for
considering the alternative framework.
6.6.4 Hybridization
Hybridization is a technique to derive a new variational formulation which obtains the same
solution, but its system matrix is positive definit. For this, we break the normal-continuity
6.6. SUPPLEMENT ON MIXED METHODS FOR THE FLUX : DISCRETE NORMS, SUPER-CONVER
of the flux functions, and re-inforce it via extra equations. We obtain new variables living
on the element-edges (or faces in 3D).
We start from the first equation a−1 σ − ∇u = 0, multiply with element-wise discontin-
uous test-functions τ , and integrate by parts on the individual elements:
Z XZ Z
−1
a στ + u div τ − u τn = 0
Ω T T ∂T
We now introduce the new unknown variable û which is indeed the restriction of u onto
the mesh skeletonQu|∪E .
We set V := T H(div, T ) and Q := L2 (Ω) × E H 1/2 (E), and pose the so called
Q
hybrid problem: find σ ∈ V and (u, û) ∈ Q such that
R −1 P R P R
Ω
(a σ) · τ dx + T T div τ u dx + T ∂T û τn = 0 ∀τ ∈ V
P R R
T T div σ v dx = − f v dx ∀ v ∈ L2 (Ω)
P R
∀ v̂ ∈ E H 1/2 (E).
Q
T ∂T v̂ σn = 0
2. The components σh and uh of the solution of the hybrid problem correspond to the
solution of the mixed method.
This is now a system with a positive definite matrix for unknowns in the elements and
on the edges. Since the matrix block for the element-variables is still block-diagonal,
they can be locally eliminated, and only the skeleton variables are remaining. In the
lowest order case, the matrix is the same as for the non-conforming P 1 element.
140 CHAPTER 6. MIXED METHODS
Chapter 7
Discontinuous Galerkin (DG) methods approximate the solution with piecewise functions
(polynomials), which are discontinuous across element interfaces. Advantages are
DG methods require more unknowns, and also have a denser stiffness matrix. The last
disadvantage can be overcome by hybrid DG methods (HDG).
div(bu) = f on Ω,
where b is the given wind, and f is the given source. Boundary conditions are specified
u = uD on Γin ,
141
142 CHAPTER 7. DISCONTINUOUS GALERKIN METHODS
This inflow-outflow isometry is a stability argument. For time dependent problems (with
bn = 0 on ∂Ω), it ensures the conservation of L2 -norm in time.
7.1.1 Solvability
We assume b ∈ L∞ with div b = 0. We consider the problem: find u ∈ V , u = uD on Γin
and
B(u, v) = f (v) ∀v ∈ W
with Z Z
B(u, v) = div(bu)v and f (v) = fv
kukV = kb∇ukL2
It does not hold if b has vortices. Then k · kV is only a semi-norm. Note, for space-time
problems b̃ cannot have vortices. For theory, we will assume that
On the outflow boundary, the boundary integral cancels out, on the inflow boundary we
can write it as a jump term [u] = uup − u:
Z Z Z
b∇uv + bn [u]v = fv
T ∂Tin T
Vh := Wh := {v ∈ L2 : v|T ∈ P k }
B DG (uh , vh ) = f (vh ) ∀ vh ∈ Wh
For the discontinuous space, the jump-term is important. If we use continous spaces, the
jump-term disappears. The discrete norms are defined as
X X
kuh k2Vh := kb∇uk2L2 (T ) + 1
h
kbn [u]k2L2 (E)
T E
kvh kWh = kvh kL2
The part with the jump-term mimics the derivative as kind of finite difference term across
edges.
We prove solvability of the discrete problem by showing a discrete inf − sup condition.
But, in general, one order in h is lost due to a mesh-dependent inf − sup constant. This
factor shows up in the general error estimate by consistency and stability. It can be avoided
in 1D, and on special meshes.
Theorem 122. There holds the discrete inf − sup condition
B(uh , vh )
sup h kuh kVh
vh kvh kWh
We reorder the terms edge-by-edge. On the edge E we get contributions from two
elements: On the inflow-boundary of the down-wind element we get
Z Z Z
1 d 2 u d d 1 d 2 u d
2
b n (u ) + b n (u − u )u = |b n | 2
(u ) − u u
E E E
7.2. DISCONTINUOUS GALERKIN DISCRETIZATION 145
We used that b · n is negative on the inflow boundary. From the up-wind element we get
on its outflow-boundary: Z
1
|b | (uu )2
2 n
E
Summing up, we have the square
Z
1
|b |(uu
2 n
− ud )2 ,
E
An extra treatment of edges on the whole domain boundary gives that the jump must be
replaced by the function values on ∂Ω.
We plug in the second test function v2 :
XZ Z
2
B(uh , v2 ) = (b∇u) + bn [u] b∇u
T T ∂Tin
By the choice γ ' h and a inverse trace inequality (which needs smoothness assumptions
onto b) we can bound the last term by the first one on the right hand. Thus
XZ X1
B(uh , v2 ) (b∇u)2 − k[u]k2L2 (E),bn
T T E
h
Finally, we set
1
vh = v1 + v2
h
to obtain XZ X1
B(uh , vh ) (b∇u)2 + k[u]k2L2 (E),bn ' kuh k2Vh .
T T E
h
But, for this choice we get
kvh kWh h−1 kuh kVh ,
and thus the h-dependent inf − sup-constant.
146 CHAPTER 7. DISCONTINUOUS GALERKIN METHODS
Finally, to obtain stability (as proven below), we add the so called stabilization term
Z Z Z Z Z Z Z
α α
∇u∇v − ∂n uv − ∂n vu + uv = f v − ∂n vuD + uD v ∀v
Ω ∂Ω ∂Ω h ∂Ω h
These are the forms of Nitsche’s method:
Z Z Z Z
α
A(u, v) = ∇u∇v − ∂n uv − ∂n vu + uv
h ∂Ω
ZΩ Z ∂Ω Z∂Ω
α
f (v) = fv − ∂n vuD + uD v
Ω ∂Ω h ∂Ω
A(., .) is not defined for u, v ∈ H 1 , but it requires also well defined normal derivatives.
This is satisfied for the flux ∇u ∈ H(div) of the solution, and finite element test functions
v.
We define the Nitsche norm:
Lemma 123. If α = O(p2 ) is chosen sufficiently large, then A(., .) is elliptic on the finite
element space:
A(uh , uh ) kuh k21,h ∀ uh ∈ Vh
Proof. On one element there holds the inverse trace inequality
p2
kuh k2L2 (∂T ) ≤ c kuh k2L2 ∀ uh ∈ P p (T )
h
7.3. NITSCHE’S METHOD FOR DIRICHLET BOUNDARY CONDITIONS 147
The h-factor is shown by transformation to the reference element, the p-factor (polynomial
order) is proven by expansion in terms of orthogonal polynomials. Using the element-wise
estimate for all edges on the domain boundary, we obtain
p2
kuh k2L2 (∂Ω) ≤ c kuk2L2 (Ω) (7.1)
h
Evaluating the bilinear-form, and applying Young’s inequality for the mixed term we get
Z
2 α
A(uh , uh ) = k∇uh kL2 − 2 ∂n uu + kuk2L2 (∂Ω)
∂Ω h
α
≥ k∇uh k2L2 − γ1 kn · ∇uh k2L2 (∂Ω) − γkuk2L2 (∂Ω) + kuk2L2 (∂Ω)
h
The inverse trace inequality applied to ∇uh gives
p2
kn · ∇uh k∂Ω ≤ k∇uh k∂Ω ≤ c k∇uh kΩ
h
By choosing
p2 α
γ>c and γ≤
h h
we can absorb the negative terms into the positive ones. Therefore it is necessary to choose
α > cp2
For the error analysis we apply the discrete stability and consistency:
A(uh − Ih u, vh )
kuh − Ih uk1,h sup
vh kvh k1,h
A(u − Ih u, vh )
= sup
vh kvh k1,h
We cannot argue with continuity of A(., .) on H 1 (which is not true), but we can estimate
the interpolation error u − Ih u for all four terms of A(uh − Ih u, vh ).
Note that both terms, mean of normal derivative and jump, change sign if we exchange
the enumeration of sub-domains.
We procede as before and add consistent symmetry and stabilization terms:
XZ Z Z
α
Z Z
∇u∇v − {∂n1 u}[v] − {∂n1 v}[u] + [u][v] = f v.
i Ωi γ γ h γ
The variational formulation is consistent on the solution, and elliptic on Vh , which is proven
as before. This approach is an alternative to the mixed method (mortar method), since it
leads to positive definite matrices (called also gluing method).
(and proper treatment of integrals on the domain boundary). The factor 12 is coming from
splitting the consistent terms to the two elements on the edge.
Convergence analysis similar to Nitsche’s method.
Beside the SIP-DG, also different version are in use: The NIP-DG (non-symmetric
interior penalty) DG:
X Z Z Z Z
1 1 α
A(u, v) = ∇u∇v − 2 ∂n u[v] + 2 ∂n v[u] + h [u][v]
T T ∂T ∂T ∂T
The term formerly responsible for symmetry is added with a different sign. The variational
problem is still consistent on the true solution. The advantage of the NIP-DG is that
X
A(u, u) = k∇uk2L2 (T ) + αh k[u]k2L2 (∂T ) ,
T
7.4. DG FOR SECOND ORDER EQUATIONS 149
i.e. A(., .) is elliptic in any case α > 0. The disadvantage is that A(., .) is not consistent
for the dual problem, i.e. the Aubin-Nitsche trick cannot be applied. It is popular for
convection-diffusion problems, where the bi-form is non-symmetric anyway. The IIP-DG
(incomplete) skips the third term completely. Advantages are not known to the author.
7.4.1 Hybrid DG
One disadvantage of DG - methods is that the number of degrees of freedom is much
higher than a continuous Galerkin method on the same mesh. Even worse, the number of
non-zero entries per row in the system matrix is higher. The second disadvantage can be
overcome by hybrid DG methods: One adds additional variables û, v̂ on the inter-element
facets (edges in 2D, faces in 3D). The derivation is very similar:
XZ Z X
∇u∇v − ∂n uv = fv ∀ v ∈ P k (T ), ∀ T
T T ∂T T
P R
Using continuity of the normal flux, we may add T ∂T ∂n uv̂ with a single-valued test-
function on the facets:
XZ Z X
∇u∇v − ∂n u(v − v̂) = fv ∀ v ∈ P k (T ), ∀ T
T T ∂T T
The jump between neighbouring elements is now replaced by the difference of element-
values and facet values. The natural norm is
X
ku, ûk2 = k∇uk2 + h1 ku − ûk∂T
T
The HDG methods allows for static condensation of internal variables which results in a
global system for the edge-unknowns, only.
The lowest order method uses P 1 (T ) and P 1 (E), and we get O(h) convergence. When
comparing with the non-conforming P 1 -method, HDG has more unknowns on the edges,
but the same order of convergence. The Lehrenfeld-trick is to smuggle in a projector:
XZ Z Z
α
Z X
∇u∇v− ∂n u(v−v̂)− ∂n v(u−û)+ P k−1 (u−û)(v−v̂) = fv ∀ v ∈ P k (T ), ∀ T
T T ∂T ∂T h ∂T T
This allows to reduce the order on edges by one, while maintaining the order of convergence.
150 CHAPTER 7. DISCONTINUOUS GALERKIN METHODS
7.4.2 Bassi-Rebay DG
One disadvantage of IP-DG is the necessary penalty term with α sufficiently large. For well-
shaped meshes α = 5p2 is usually enough. But, for real problems the element deformation
may become large, and then a fixed α is not feasible. Setting α too large has a negative
effect for iterative solvers.
An alternative is to replace the penalty term by
([u], n · σh )2L2 (∂T )
k[u]k2BR := sup
σh ∈[P k−1 ]d kσh k2L2 (T )
The BR-norm scales like the IP - norm (in h and p), but the (typically unknown) constant
in the inverse trace inequality can be avoided.
Since the space Vh is not conforming for H 1 , the DG - technique is applied. The b(., .)
bilinear-form is well defined for the H(div)-conforming finite element space Vh . There holds
div Vh = Qh ,
7.4. DG FOR SECOND ORDER EQUATIONS 151
implies Z
k div uh k2L2 = div uh div uh = 0.
| {z }
∈Qh
Hybridizing the method leads to facet variables for the tangential components, only. This
method can be applied to the Navier Stokes equations. Here, the exact divergence-free
discrete solution leads to a stable method for the nonlinear transport term (References:
Master thesis Christoph Lehrenfeld: HDG for Navier Stokes, h-version LBB, Master thesis
Philip Lederer: p-robust LBB for triangular elements).
152 CHAPTER 7. DISCONTINUOUS GALERKIN METHODS
Chapter 8
Applications
Under reasonable conditions, this Oseen equation is uniquely solvable. Since uk is the
solution of the old step, it satisfies div uk = 0. Furthermore, we assume that the velocity
uk is bounded in L∞ -norm.
153
154 CHAPTER 8. APPLICATIONS
From now on, we continue to investigate the Oseen equation. Given a vector-field
w = (wx , wy , wz ) ∈ [L∞ ]3 such that div w = 0. Find u and p such that
−∆u + (w · ∇)u − ∇p = f
div u = 0.
We have removed the viscosity by rescaling the equation. The factor ρ/ν is incorporated
into the vector-field w.
Both forms are continuous. The form a(., .) is non-symmetric. In a(., .), the x, y, and
z components of u and v are independent. To investigate a(., .), it is enough to consider
scalar bilinear-forms. We define the inflow and outflow boundaries
Γi = {x ∈ ∂Ω : w · n < 0},
Γo = {x ∈ ∂Ω : w · n ≥ 0}.
If we pose Dirichlet boundary conditions on Γi , then a(., .) is coercive (see example 27, and
exercises). The ratio of the continuity bound and the coercivity bound depends on the
norm of the convection w. With increasing w, the problem is getting worse.
The form b(., .) satisfies the LBB condition:
R
div u q dx
sup kqkL2 ∀ q ∈ L2 .
1 ]3
u∈[H0,D kukH 1
1
In the case of (partial) Dirichlet boundary conditions (H0,D = {u : u = 0 on ΓD }),
this condition Ris very nontrivial to prove. If there are only Dirichlet b.c., one has to use
Q = L02 = {q : Ω q dx = 0}.
Under these conditions, Brezzi’s theorem proves a unique solution of the Oseen equa-
tion.
8.1. THE NAVIER STOKES EQUATION 155
The simplest spaces which lead to convergence are the non-conforming P1 element for
the velocities, and piece-wise constant elements for the pressure. The arguments are
• There are unknowns on the edges to construct a Fortin operator satisfying
Z Z
u · n ds = (Ih u) · n ds,
e e
• The error due to the non-conforming space Vh 6⊂ V is of the same order as the
approximation error (see Section 4.5).
Solvability follows from Brezzi’s theorem. The only non-trivial part is the LBB condition:
R
div v p
sup ≥ βkpkL2 ∀ p ∈ L02
v∈[H01 ]d kvkH 1
Take p ∈ L2 (Ω), extend it by 0 to L2 (Rd ). Now compute a right-inverse of div via Fourier
transform:
p̂(ξ) = F(p)
−iξ
û(ξ) = p̂(ξ)
|ξ|2
u(x) = F −1 (û)
Vh = P 1,nc , Qh = P 0,dc
8.1. THE NAVIER STOKES EQUATION 157
We have to extend the V -norm and forms by the sum over element-wise norms and forms.
The Fortin-operator IF : V → Vh is defined via
Z Z
IF u = u ∀ edges E
E E
and thus
bh (IF u, qh ) = b(u, qh ) ∀ q h ∈ Qh
The error estimate follows similar as in the second Lemma by Strang:
ku − uh kH 1 ,nc + kp − ph kL2
P R
T ∇u∇wh + p div wh − f wh
inf ku − vh kH 1 ,nc + kp − qh kL2 + sup
vh ,qh wh kwh kH 1 ,nc
ch (kukH 2 + kpkH 1 )
But, the vertex evaluation is not allowed in H 1 . We proceed now in two steps: First
approximate u in the finite element space via a Clément operator Πh :
u1h := Πh u,
Vh = P 2+ Qh = P 1,nc ,
It leads to second order convergence. Since the costs of a method depend mainly on the
coupling dofs, the price for the additional bubble is low.
Vh = P 1+ Qh = P 1,cont ,
where P 1+ is P 1 enriched by the cubic bubble. The continuous pressure allows integration
by parts: Z Z
div u qh = − u∇qh
uh := IF u = Πh u + IF2 (u − Πh u)
8.2 Elasticity
We start with a one-dimensional model. Take a beam which is loaded by a force density f
in longitudinal (x) direction. We are interested in the displacement u(x) in x direction.
The variables are
• The strain ε: It describes the elongation. Take two points x and y on the beam.
After deformation, their distance is y + u(y) − (x + u(x)). The relative elongation of
the beam is
{y + u(y) − (x + u(x))} − (y − x) u(y) − u(x)
= .
y−x y−x
In the limit y → x, this is u0 . We define the strain ε as
ε = u0 .
• The stress σ: It describes internal forces. If we cut the piece (x, y) out of the beam,
we have to apply forces at x and y to keep that piece in equilibrium. This force is
called stress σ. Equilibrium is
Z y
σ(y) − σ(x) + f (s) ds = 0,
x
or
σ 0 = −f
Hook’s law postulates a linear relation between the strain and the stress:
σ = Eε.
Combining the three equations
ε = u0 σ = Eε σ 0 = −f
leads to the second order equation for the displacement u:
−(Eu0 )0 = f.
Boundary conditions are
• Dirichlet b.c.: Prescribe the displacement at the boundary
• Neumann b.c: Prescibe the stress at the boundary
160 CHAPTER 8. APPLICATIONS
u : Ω → Rd .
• The strain ε becomes a symmetric tensor in Rd×d . The elongation in the direction of
the unit-vector n is
nT εn.
The (linearized!) relation between the displacement u and the strain is now
1 ∂ui ∂uj
εij = + ,
2 ∂xj ∂xi
or, in compact form
1
ε = ε(u) = ∇u + (∇u)T .
2
If the displacement is a pure translation (u = const), then the strain vanishes. Also,
if the displacement is a linearized (!) rotation, (in two dimensions u = (ux , uy ) =
(y, −x), the strain vanishes. We call these deformations the rigid body motions:
2D a1 y
R = +b : a1 , a2 , b ∈ R
a2 −x
R3D = a + b × x : a, b ∈ R3
div σ = −f.
in short
σ = Dε,
where D is a fourth order tensor. For an isotropic material (same properties in all
directions), the matrial law has the special structure
σ = 2µ ε + λ tr{ε} I.
The two parameters µ and λ are called Lamé’s parameters. The trace tr is defined
as tr{ε} = di=1 εii .
P
ε = ε(u) σ = Dε div σ = −f
leads to
− div D ε(u) = f.
Dε : ε ε : ε ∀ symmetric ε ∈ Rd×d
Theorem 124. Assume that the Dirichlet boundary ΓD has positive measure. Then the
equations of elasticity are well posed in [H 1 ]d .
162 CHAPTER 8. APPLICATIONS
Proof: Continuity of the bilinear-form and the linear-form are clear. Ellipticity of the
bilinear-form follows from the positive definite matrial law, and the (non-trivial) Korn
inequality Z
ε(u) : ε(v) dx kuk2H 1 (Ω) 1
∀ u ∈ [H0,D ]d
Ω
The Lax-Milgram theorem proves a unique solution u. 2
The discretization of the elasticity problem is straight forward. Take a finite dimensional
sub-space Vh ⊂ V , and perform Galerkin projection. One may use the ’standard’ nodal
finite elements for each component.
Structural mechanics
Many engineering applications involve thin structures (walls of a building, body of a car,
...). On thin structures, the standard approach has a problem: One observed that the
simulation results get worse as the thickness decreases. The explanation is that the constant
in Korn’s inequality gets small for thin structures. To understand and overcome this
problem, we go over to beam, plate and shell models.
t3 1 0 0 t 1 0
Z Z
(2µ + λ) β β̃ + 2µ (w − β)(w̃0 − β̃) dx
12 0 2 0
8.2. ELASTICITY 163
The meaning of the three functions is as follows. The function U (x) is the average
(over the cross section) longitudinal displacement, w(x) is the vertical displacement. The
function β is the linearized rotation of the normal vector.
We assume that the load f (x, y) does not depend on y. Then, the linear form is
! Z 1 Z 1
Ũ − y β̃
f =t fx Ũ dx + t fy w̃ dx
w̃ 0 0
The semi-discretization in this space leads to two decoupled problems. The first one
describes the longitudinal displacement: Find U ∈ H 1 (I) such that
Z 1 Z 1
0 0
(2µ + λ)t U Ũ dx = t fx Ũ dx ∀ Ũ ∈ H 1 (I).
0 0
The small thickness parameter t cancels out. It is a simple second order problem for the
longitudinal displacement.
The second problems involves the 1D functions w and β: Find (w, β) ∈ V =? such that
t3 1 0 0
Z Z 1 Z 1
0 0
(2µ + λ) β β̃ dx + µt (w − β)(w̃ − β̃) dx = t fy w̃ dx ∀ (w̃, β̃) ∈ V
12 0 0 0
The first term models bending. The derivative of the rotation β is (approximative) the
curvature of the deformed beam. The second one is called the shear term: For thin beams,
the angle β ≈ tan β is approximatively w0 . This term measures the difference w0 − β. This
second problem is called the Timoshenko beam model.
For simplification, we skip the parameters µ and λ, and the constants. We rescale the
equation by dividing by t3 : Find (w, β) such that
Z Z Z
1
β β̃ dx + 2 (w − β)(w̃ − β̃) dx = t−2 f w̃ dx.
0 0 0 0
(8.4)
t
This scaling in t is natural. With t → 0, and a force density f ∼ t2 , the deformation
converges to a limit. We define the scaled force density
f˜ = t−2 f
and coercive
A((w, β), (w, β)) ≥ kwk2H 1 + kβk2H 1
164 CHAPTER 8. APPLICATIONS
Proof: ...
As the thickness t becomes small, the ratio of the continuity and coercivity bounds
becomes large ! This ratio occurs in the error estimates, and indicates problems. Really,
numerical computations show bad convergence R for small thickness t.
The large coefficient in front of the term (w − β)(w̃0 − β̃) forces the difference w0 − β
0
to be small. If we use piece-wise linear finite elements for w and β, then wh0 is a piece-wise
constant function, and βh is continuous. If wh0 − βh ≈ 0, then βh must be a constant
function !
The idea is to weaken the term with the large coefficient. We plug in the projection P 0
into piece-wise constant functions: Find (wh , βh ) such that
Z Z Z
1
βh β̃h dx + 2 P (wh − βh ) P (w̃h − β̃h ) dx = f˜w̃h dx.
0 0 0 0 0 0
(8.5)
t
Now, there are finite element functions wh and βh fulfilling P 0 (wh0 − βh ) ≈ 0.
In the engineering community there are many such tricks to modify the bilinear-form.
Our goal is to understand and analyze the obtained method.
Again, the key is a mixed method. Start from equation (8.4) and introduce a new
variable
p = t−2 (w0 − β). (8.6)
Using the new variable in (8.4), and formulating the definition (8.6) of p in weak form leads
to the bigger system: Find (w, β) ∈ V and p ∈ Q such that
f˜w̃ dx
R 0 0 R 0 R
β β̃ dx + (w̃ − β̃)p dx = ∀ (w̃, β̃) ∈ V
R 0 R (8.7)
(w − β)p̃ dx − t2 p p̃ dx = 0 ∀ p̃ ∈ Q.
This is a mixed formulation of the abstract structure: Find u ∈ V and p ∈ Q such that
a(u, v) + b(v, p) = f (v) ∀ v ∈ V,
(8.8)
b(u, q) − t2 c(p, q) = 0 ∀ q ∈ Q.
The big advantage now is that the parameter t does not occur in the denominator, and
the limit t → 0 can be performed.
This is a family of well posed problems.
Theorem 126 (extended Brezzi). Assume that the assumptions of Theorem 101 are true.
Furthermore, assume that
a(u, u) ≥ 0,
and c(p, q) is a symmetric, continuous and non-negative bilinear-form. Then, the big form
We check Brezzi’s condition for the beam model. The spaces are V = [H 1 ]2 and Q = L2 .
Continuity of the bilinear-forms a(., .), b(., .), and c(., .) is clear. The LBB condition is
R 0
(w − β)q dx
sup kqkL2
w,β kwkH 1 + kβkH 1
Then
(w0 − β)q dx
R R 2
q dx
= kqkL2
kwkH 1 + kβkH 1 kw0 k
Finally, we have to check kernel ellipticity. The kernel is
V0 = {(w, β) : β = w0 }.
On V0 there holds
The lowest order finite element discretization of the mixed system is to choose contin-
uous and piece-wise linear elements for wh and βh , and piecewise constants for ph . The
discrete problem reads as: Find (wh , βh ) ∈ Vh and ph ∈ Qh such that
f˜w̃h dx
R 0 0 R 0 R
βh β̃h dx + (w̃h − βh )ph dx = ∀ (wh , βh ) ∈ Vh
R 0 R (8.9)
(wh − βh )p̃h dx − t2 ph p̃h dx = 0 ∀ p̃h ∈ Qh .
This is a inf-sup stable system on the discrete spaces Vh and Qh . This means, we obtain
the uniform a priori error estimate
k(w − wh , β − βh )kH1 + kp − ph kL2 inf k(w − w̃h , β − β̃h )kH1 + kp − p̃h kL2
w̃h ,β̃h ,p̃h
h {kwkH 2 + kβkH 2 + kpkH 1 }
ph = t−2 P 0 (wh0 − βh )
If we insert this observation into the first row, we obtain exactly the discretization method
(8.5) ! Here, the mixed formulation is a tool for analyzing a non-standard (primal) dis-
cretization method. Both formulations are equivalent. They produce exactly the same
finite element functions. The mixed formulation is the key for the error estimates.
166 CHAPTER 8. APPLICATIONS
The two pictures below show simulations of a Timoshenko beam. It is fixed at the left
end, the load density is constant one. We compute the vertical deformation w(1) at the
right boundary. We vary the thickness t between 10−1 and 10−3 . The left pictures shows
the result of a standard conforming method, the right picture shows the results of the
method using the projection. As the thickness decreases, the standard method becomes
worse. Unless h is less than t, the results are completely wrong ! The improved method
converges uniformly well with respect to t:
0.12 0.12
t=1e-1 t=1e-1
t=1e-2 t=1e-2
t=1e-3 t=1e-3
0.1 0.1
0.08 0.08
w(1)
w(1)
0.06 0.06
0.04 0.04
0.02 0.02
0 0
1 10 100 1000 10000 1 10 100 1000
Elements Elements
j ∈ [L2 (Ω)]3
div B = 0.
• The magnetic field intensity H (in German: magnetische Feldstärke). The field is
related to the current density by Henry’s law:
Z Z
j · n ds = H · τ ds ∀ Surfaces S
S ∂S
curl H = j
The differential operator is curl = rot = ∇×. Both fields are related by a material law.
The coefficient µ is called permeability:
B = µH
8.3. MAXWELL EQUATIONS 167
The coefficient µ is 103 to 104 times larger in iron (and other ferro-magnetic metals) as
in most other media (air). In a larger range, the function B(H) is also highly non-linear.
Collecting the equations we have
In principle, Maxwell equations are valid in the whole R3 . For simulation, we have to
truncate the domain and have to introduce artificial boundary conditions.
The picture below shows the magnetic field caused by a tangential current density in a
coil:
Compare these equations to the diffusion equation − div a∇u = f . Here, we could
introduce new unknowns g = ∇u and σ = ag. On simply connected domains, g is a
gradient field if and only if curl g = 0. We could reformulate the equations as: Find vector
fields g and σ such that
The system of magnetostatic equations looks similar. Only, the right hand side data is
applied to the curl-equation, instead of the div-equation. In a similar way as curl g = 0
allows to introduce a scalar field u such that g = ∇u, div B = 0 allows to introduce a
vector potential A such that
B = curl A.
Inserting the vector-potential into the equations (8.10), one obtains the second order equa-
tion
curl µ−1 curl A = j. (8.11)
The two original fields B and H can be obtained from the vector potential A.
168 CHAPTER 8. APPLICATIONS
The vector-potential A is not uniquely defined by (8.11). One may add a gradient field
to A, and the equation is still true. To obtain a unique solution, the so called Coloumb-
Gauging can be applied:
div A = 0. (8.12)
As usual, we go over to the weak form. Equations (8.11) and (8.12) together become:
Find A such that Z Z
−1
µ curl A curl v dx = j · v dx ∀ v ∈?
Ω Ω
and Z
A · ∇ψ dx = 0.
Ω
We want to choose the same space for A and the according test functions v. But, then
we have more equations than unknowns. The system is still solvable, since we have made
the assumption div j = 0, and thus j is in the range of the curl- operator. To obtain a
symmetric system, we add a new scalar variable ϕ. The problem is now: Find A ∈ V =?
and ϕ ∈ Q = H 1 /R such that
R −1 R R
µ curl A · curl v dx + ∇ϕ · v dx = j · v dx ∀v ∈ V
R (8.13)
A · ∇ψ dx = 0 ∀ψ ∈ Q
Again, the differential operator curl is understood in the weak sense. The canonical norm
is
1/2
kvkH(curl) = kvk2L2 + k curl vk2L2
.
Similar to H 1 and H(div), there exists a trace operator for H(curl). Now, only the
tangential components of the boundary values are well defined:
Theorem 127 (Trace theorem). There exists a tangential trace operator trτ v : H(curl) →
W (∂Ω) such that
trτ v = (v|∂Ω )τ
for smooth functions v ∈ [C(Ω)]3 .
Theorem 128. Let Ω = ∪Ωi . Assume that u|Ωi ∈ H(curl, Ωi ), and the tangential traces
are continuous across the interfaces γij . Then u ∈ H(curl, Ω).
The theorems are according to the ones we have proven for H(div). But, the proofs (in
R3 ) are more involved.
∇ : H 1 → H(curl)
8.3. MAXWELL EQUATIONS 169
H 0 (curl) = ∇ H 1
Theorem 129. The mixed system (8.13) is a well posed problem on H(curl) × H 1 /R.
and Z
b(v, ϕ) = v · ∇ϕ dx
k∇ϕk2L2
R R
v∇ϕ dx ∇ϕ · ∇ϕ dx
sup ≥ = = k∇ϕkL2 ' kϕkQ
v∈H(curl) kvkH(curl) k∇ϕkH(curl) k∇ϕkL2
The difficult part is the kernel coercivity of a(., .). The norm involves also the L2 -norm,
while the bilinear-form only involves the semi-norm k curl vkL2 . Coercivity cannot hold on
the whole V : Take a gradient function ∇ψ. On the kernel, the L2 -norm is bounded by the
semi-norm:
kvkL2 k curl vk ∀ v ∈ V0 ,
where Z
V0 = {v ∈ H(curl) : v∇ϕ dx = 0 ∀ ϕ ∈ H 1 }
We design tetrahedral finite elements. The pragmatic approach is to choose the element
space as VT = P 1 , and choose the degrees of freedom as the tangential component along
the edges in the end-points of the edges. The dimension of the space is 3 × dim{P 1 } =
3 × 4 = 12, the degrees of freedom are 2 per edge, i.e., 2 × 6 = 12. They are also linearly
independent. In each face, the tangential component has 2 components, and is linear.
Thus, the tangential component has dimension 6. These 6 values are defined by the 6
170 CHAPTER 8. APPLICATIONS
degrees of freedom of the 3 edges in the face. Neighboring elements share this 6 degrees of
freedom in the face, and thus have the same tangential component.
There is a cheaper element, called Nédélec, or edge-element. It has the same accuracy
for the curl-part (the B-field) as the P 1 -element. It is similar to the Raviart-Thomas
element. It contains all constants, and some linear polynomials. All 3 components are
defined in common. The element space is
VT = {a + b × x : a, b ∈ R3 }.
These are 6 coefficients. For each of the 6 edges of a tetrahedron, one chooses the integral
of the tangential component along the edge
Z
ψEi (u) = u · τEi ds.
Ei
Lemma 130. The basis function ϕEi associated with the edge Ei is
where Ei1 and Ei2 are the two vertex numbers of the edge, and λ1 , . . . λ4 are the vertex shape
functions.
Proof:
• These functions are in VT
• If i 6= j, then ψEj (ϕEi ) = 0.
• ψEi (ϕEi ) = 1
Thus, edge elements belong to H(curl). Next, we will see that they have also very
interesting properties.
Now, we discretize the mixed formulation (8.13) by choosing edge-finite elements for
H(curl), and nodal finite elements for H 1 : Find Ah ∈ Vh and ϕh ∈ Wh such that
R −1 R R
µ curl Ah · curl vh dx + ∇ϕh · vh dx = j · vh dx ∀ vh ∈ Vh
R (8.14)
Ah · ∇ψh dx = 0 ∀ ψh ∈ Wh
The stability follows (roughly) from the discrete sequence property. The verification of the
LBB condition is the same as on the continuous level. The kernel of the a(., .)- form are
the discrete gradients, the kernel of the b(., .)-form is orthogonal to the gradients. This
implies solvability. The discrete kernel-coercivity (with h-independent constants) is true
(nontrivial).
The complete sequences on the continuous level and on the discrete level are con-
nected in the de’Rham complex: Choose the canonical interpolation operators (vertex-
interpolation I W , edge-interpolation I V , face-interpolation I Q , L2 -projection I S ). This
relates the continuous level to the discrete level:
∇ curl div
H 1 −→ H(curl) −→ H(div) −→ L2
W V Q S
yI yI yI yI (8.15)
∇ curl div
Wh −→ Vh −→ Qh −→ Sh .
Proof: We prove the first part. Note that the ranges of both, ∇I W and I V ∇, are in
Vh . Two functions in Vh coincide if and only if all functionals coincide. It remains to prove
that Z Z
(∇I w) · τ ds = (I V ∇w) · τ ds
W
E E
V
Per definition of the interpolation operator I there holds
Z Z
V
(I ∇w) · τ ds = ∇w · τ ds
E E
172 CHAPTER 8. APPLICATIONS
We have already proven the commutativity of the H(div) − L2 part of the diagram. The
middle one involves Stokes´ theorem. 2
This is the key for interpolation error estimates. E.g., in H(curl) there holds
Since the estimates for the L2 -term and the curl-term are separate, one can also scale each
of them by an arbitrary coefficient.
Then
v̂ = ∇ŵ ⇒ v = ∇ w
q̂ = curl v̂ ⇒ q = curl v
ŝ = div q̂ ⇒ s = div q
Using these transformation rules, the implementation of matrix assembling for H(curl)-
equations is very similar to the assembling for H 1 problems (mapping to reference element).
Chapter 9
PDEs involving first order derivatives in time, and an elliptic differential operator in space,
are called parabolic PDEs. For example, time dependent heat flow is described by a
parabolic PDE.
Let Ω ⊂ Rd , and Q = Ω × (0, T ). Consider the initial-boundary value problem
∂u(x, t)
− div(a(x)∇x u(x, t)) = f (x, t) (x, t) ∈ Q,
∂t
with boundary conditions
1
Weak formulation in space: Find u : [0, T ] → H0,D (Ω) such that
Z Z Z Z
∂t u(x, t)v(x) dx + a∇u(x, t) · ∇v(x, t) dx = f (x, t)v(x, t) dx + g(x, t)v(x, t) dx
Ω Ω Ω ΓN
1
∀ v ∈ H0,D , t ∈ (0, T ]
173
174 CHAPTER 9. PARABOLIC PARTIAL DIFFERENTIAL EQUATIONS
Function spaces:
X = L2 ((0, T ), V ) X ∗ = L2 ((0, T ), V ∗ )
with norms
Z T 1/2 Z T 1/2
kvkX = kv(t)k2V dt kvkX ∗ = kv(t)k2V ∗ dt
0 0
Definition 134.
with norm
kvk2H 1 = kvk2X + kv 0 k2X ∗ .
a(u, u) ≥ µ1 kuk2V ∀u ∈ V
and continuous
a(u, v) ≤ µ2 kukV kvkV ∀ u, v ∈ V.
Then, the parabolic problem has a unique solution depending continuously on the right hand
side and the initial conditions:
Use that
d
ku(t)k2L2 = 2(u0 (t), u(t))L2 ,
dt
9.1. SEMI-DISCRETIZATION 175
9.1 Semi-discretization
We start with a discretization in space. Choose a (finite element) sub-space Vh ⊂ V . The
Galerkin discretiztaion is: Find u : [0, T ] → Vh such that
In general, the (mass) matrix M is non-diagonal. In the case of the (inexact) vertex
integration rules, or non-conforming P1 -elements, M is a diagonal matrix. Then, this ODE
can be efficiently reduced to explicit form
Rh : V → Vh : a(Rh u, vh ) = a(u, vh ) ∀ u ∈ V, ∀ vh ∈ Vh .
The first part, u(t) − Rh u(t) is the elliptic discretization error, which can be bounded by
Cea’s lemma. To bound the second term, we use the properties for the continuous and the
discrete formulation:
i.e.,
(u0 − u0h , vh ) + a(Rh u − uh , vh ) = 0,
or
(Rh u0 − u0h , vh ) + a(Rh u − uh , vh ) = (Rh u0 − u0 , vh ).
With the abbreviations from above we obtain the discrete parabolic equation for Θh :
kΘh kH 1 ((0,T ),V ;L2 ) k(I − Rh )u(0)kL2 (Ω) + kρ0 kL2 ((0,T ),V ∗ )
k(I − Rh )ukH 1 ((0,T ),V ;L2 )
2
9.2. TIME INTEGRATION METHODS 177
Next, we replace the integrals by numerical integration rules. The left-sided rectangle
rule leads to
M {u(tj+1 ) − u(tj )} + τj Au(tj ) = τj f (tj )
With the notation uj = u(tj ), this leads to the sequence of linear equations
M uj+1 = M uj + τj (fj − Auj )
In the case of a diagoal M -matrix, this is an explicit formulae for the new time step !
Using the right-sided rectangle rule leads to
M {uj+1 − uj } + τj Auj+1 = τj fj+1 ,
or
(M + τj A)uj+1 = M uj + τj fj+1 .
In case of the right-side rule, a linear system must be solve in any case. Thus, this method
is called an implicit time integration method. These two special cases are called the explicit
Euler method, and the implicit Euler method. A third simple choice is the trapezoidal rule
leading to
τj τj
(M + A)uj+1 = M uj + (fj + fj+1 − Auj )
2 2
It is also an implcit method. Since the trapezoidal integration rule is more accurate, we
expect a more accurate method for approximating the ODE.
All single-step time integration methods can be written in the form
uj+1 = Gj (uj , fj ),
where Gj is linear in both arguments and shall be continuous with bounds
kGj (uj , fj )kM ≤ L kuj kM + τj l kfj kM −1 ,
with L ≥ 1.
178 CHAPTER 9. PARABOLIC PARTIAL DIFFERENTIAL EQUATIONS
Lemma 138. The time integration method fulfills the stability estimate
j−1
X
j j
kuj kM ≤ L ku0 kM + lL τi kfi kM −1 (9.2)
i=0
The trapezoidal rule is A-stable, too. It is based on a more accurate integration rule,
and leads to second order convergence O(τ 2 ). Convergence of higher order can be obtained
by Runge-Kutta methods.
9.3. SPACE-TIME FORMULATION OF PARABOLIC EQUATIONS 179
We assume that hA(t)u, vi is integrable with respect to time. We do not assume that A(t)
is symmetric. We consider the parabolic equation: Find u : [0, T ] → V such that
u0 + Au = f ∀ t ∈ (0, T )
u(0) = u0
Adding up both equations leads to the variational problem B(u, v) = f (v) with the
bilinear-form B(., .) : X × (Y × H) → R:
Z T
B(u, (v, v0 )) = hu0 + Au, vi + (u(0), v0 )H
0
Proof. We apply the theorem by Babuška-Aziz. We observe that all forms are continuous
(trace-theorem). We have to verify both inf-sup conditions.
First, we show
B(u, v)
inf sup ≥β>0 (9.5)
u∈X (v,v0 )∈Y ×H kukX k(v, v0 )kY ×H
We fix some u ∈ X and set (with A−T the inverse of the adjoint operator)
v := A−T u0 + u
v0 := u(0)
and obtain
Z
B(u, v) = u0 + Au, A−T u0 + u dt + (u(0), u(0))H
Z
= A−1 u0 , u0 + hAu, ui + hu0 , ui + hu, u0 i dt + ku0 k2H
Z
d
= A−1 u0 , u0 + hAu, ui + kuk2H + ku0 k2H
dt
≥ α2−1 ku0 k2L2 (V ∗ ) + α1 kuk2L2 (V ) + ku(T )k2H
kuk2X
Since k(v, v0 )kY ×H kukX the first inf − sup-condition is proven. For the other one, we
show
∀ 0 6= (v, v0 ) ∈ Y × H ∃ u ∈ X : B(u, v) > 0 (9.6)
We fix some v, v0 . We define u by solving the parabolic equation
u0 + γLu = AT v, u(0) = v0 ,
where L is a symmetric, constant-in-time, continuous and elliptic operator on V . The
parameter γ > 0, γ = O(1) will be fixed later. The equation has a unique solution, which
can be constructed by spectral theory. If (v, v0 ) 6= 0, then also u 6= 0.
Z
B(u, v) = u0 + Au, A−T (u0 + γLu) + kv0 k2H
Z
= u0 , A−T u0 + hu, u0 i + u0 , A−T γLu + γ hu, Lui dt + kv0 k2H
Z
≥ 1
α2
ku0 k2V ∗ + 1 d
2 dt
kuk2H − ku0 kV ∗ kA−T γLukV + γ hu, Lui + kv0 k2H
The second term is integrated in time, and we apply Young’s inequality for the negative
term:
Z
B(u, v) ≥ 1
α2
ku0 k2V ∗ − 2α1 2 ku0 k2V ∗ − α22 kA−T γLuk2V + γ hu, Lui + 12 kv0 k2H + 12 kv(T )k2H
Z
2
≥ 1
2α2
ku0 k2V ∗ − α22γ kA−T Lk2V →V kuk2V + γ hu, Lui + 12 ku(0)k2H
9.3. SPACE-TIME FORMULATION OF PARABOLIC EQUATIONS 181
α2 γ 2
We fix now γ sufficiently small such that 2
kA−T γLk2V →V kuk2V ≤ γ hu, Lui to obtain
Xn
τj
= huj − uj−1 , vj i + 2
hA(uj−1 + uj ), vj i + (u0 , v0 )
j=1
Here, the time derivative evaluates to finite differences of point values in tj . Since uj ∈ V ,
the duality pairs coincide with inner products in H. Thus, for every time-step we get the
equation
τ
uj − uj−1 + A(uj + uj−1 ) = τ fj
2
This is the trapezoidal method (Crank-Nicolson). From numerics for odes we remember it
is A-stable, but not L-stable. We cannot prove a discrete inf − sup condition.
The higher H 1 -regularity is now put onto the test-space, which validates point-evaluation
at t = 0 and t = T . The trial-space is now only L2 , which gives no meaning for u(T ).
There are two possible remedies, either to introduce a new variable for u(T ), or, to restrict
the test space:
182 CHAPTER 9. PARABOLIC PARTIAL DIFFERENTIAL EQUATIONS
Both problems are well posed (continuity and inf − sup conditions, exercise). Now, the
initial condition was converted from an essential to a natural boundary condition.
Next, we integrate back, but we do not substitute the initial condition back:
Z Z
0
hu + Au, vi + (u(0), v(0))H = hf, vi + (u0 , v(0))
The initial condition is again a part of the variational formulation. Note that this for-
mulation is fulfilled for u ∈ H 1 , and smooth enough test functions providing the trace
v(0).
This technique to formulate initial conditions is used in the Discontinuous Galerkin
(DG) method. For every time-slab (tj−1 , tj ) we define a parabolic equation, where the
initial value is the end value of the previous time-slab.
Here, we first define a mesh T = {t0 , t1 , . . . tn }, and then the mesh-dependent formula-
tion:
Z tj Z tj
0 + +
hu + Au, vi+(u(tj−1 ), v(tj−1 ))H = hf, vi+(u(t− +
j−1 ), v(tj−1 ))H ∀ j ∈ {1, . . . n}
tj−1 tj−1
(with the notation u(t−0 ) := u0 ). By using left and right sided limits, we get the u from the
current time-slab, and the end-value from the previous time-slab, respectively. The vari-
ational formulation is valid for the solution u ∈ H 1 , and piece-wise regular test-functions
on the time-intervals.
The bilinear-form is defined as
X n Z tj
B(u, v) = hu0 + Au, vi + ([u]tj−1 , v(t+
j−1 ))H
j=1 tj−1
−
where the jump is defined as [u]tj = u(t+ +
j ) − u(tj ), and the special case [u]t0 = u(t0 ). The
solution satisfies
Z
B(u, v) = hf, vi + (u0 , v(0)) ∀ p.w. smooth v
9.3. SPACE-TIME FORMULATION OF PARABOLIC EQUATIONS 183
The bilinear-form is defined for discontinuous trial and discontinuous test functions. It
allows to define
Xh = Yh = P k,dc (V )
Let us elaborate the case of piece-wise constants in time:
vh := uh + γ
tj −tj−1
A(tj−1 )−1 [uh ]j−1 ,
with γ = O(1) to be fixed later. Thanks to the discontinuous test-space, this is a valid
test-function.
In the following we skip the subsripts h, and set τ = tj − tj−1 . There holds
kvkYh kukXh .
n Z
X tj X
B(uh , vh ) = Au, u + γτ A−T
j−1 [u]j−1 + ([u]j−1 , u + γτ A−1
j−1 [u]j−1 )H
j=1 tj−1 j
Z XZ X X
= hAu, ui + Au, γτ A−T [uj ] + (uj − uj−1 , uj )H + γ
τ
k[u]tj−1 kA−1
j j j
184 CHAPTER 9. PARABOLIC PARTIAL DIFFERENTIAL EQUATIONS
Thus, for sufficiently small γ it can be absorbed into the first and last term.
We reorder the summation of the third term:
Bh (Ih u − uh , vh )
kIh u − uh kXh sup
vh kvh kYh )
Bh (Ih u − u, vh )
= sup
vh kvh kY )
P R 0 h
hu + Au − (Ih u)0 + AIh u, vh i + j ([u] − [Ih u], vh )H
P
j
= sup
vh kvh kL2 (V )
...
where the convergence rate depends as usual on the regulariy of the exact solution
Chapter 10
ü + Au = f
10.1 Examples
• scalar wave equation (acoustic waves)
∂ 2u
− ∆u = f
∂t2
∂H
µ = − curl E
∂t
∂E
ε = curl H
∂t
with the magnetic field H and the electric field E, and material parameters perme-
ability µ and permittivity ε. By differentiating the first equation in space, and the
second one in time, we obtain
∂ 2E 1
ε 2
+ curl curl E = 0
∂t µ
185
186CHAPTER 10. SECOND ORDER HYPERBOLIC EQUATIONS: WAVE EQUATIONS
Newton’s law is
ρü = −J 0 (u),
in variational form Z
ρüv + hJ 0 (u), vi = 0 ∀v
We observe conservation of energy in the following sense for elasticity, and similar for
the other cases. We define the kinetic energy as 21 ku̇k2ρ and the potential energy as J(u).
Then
d 1
2
ku̇k2ρ + J(u) = (u̇, ü)ρ + hJ 0 (u), u̇i = 0
dt
For the linear equation set J(u) = 21 hAu, ui − hf, ui
M ü + Ku = f
We consider single-step methods: From given state un ≈ u(tn ) and velocity u̇n ≈ u̇(tn ) we
compute un+1 and u̇n+1 . The acceleration ün = M −1 (fn − Kun ) follows from the equation.
10.2. TIME-STEPPING METHODS FOR WAVE EQUATIONS 187
The Newmark method is based on a Taylor expansion for u and u̇, where second order
derivatives are approximated from old and new accelerations. The real parameters β and
γ will be fixed later, τ is the time-step:
Now we keep unknows left and put known variables to the right:
The Newmark method requires to solve one linear system with the spd matrix M + τ 2 βK,
for which efficient direct or iterative methods are available. After computing the new
acceleration, the new state un+1 and velocity u̇n+1 are computed from the explicit formulas
(10.1) and (10.2).
The Newmark method satisfies a discrete energy conservation. See [Steen Krenk: ”En-
ergy conservation in Newmark based time integration algorithms” in Compute methods in
applied mechanics and engineering, 2006, pp 6110-6124] for the calculations and various
extensions:
1 1 T
n+1
2
u̇M u̇ + 2
u K eq u n
= −(γ − 21 )(un+1 − un )Keq (un+1 − un )
where
Keq = K + (β − 12 γ)τ 2 KM −1 K,
and the notation [E]ba := E(b) − E(a). Here, the right hand side f is skipped. From this,
we get the conservation of a modified energy with the so called equivalent stiffness matrix
Keq . Depending on the parameter γ we get
• γ = 21 : conservation
• γ > 12 : damping
• γ < 12 : growth of energy (unstable)
If Keq is positive definite, then this conservation proves stability. This is unconditionally
true if β ≥ 21 γ (the method is called unconditionally stable). If β < 12 γ, the allowed time
step is limited by
1
τ 2 ≤ λmax (M −1 K)−1 1 .
2
γ−β
For second order problems we have λmax (M −1 K) ' h−2 , and thus τ h which is a
reasonable choice also for accuracy.
Choices for β and γ of particular interests are:
188CHAPTER 10. SECOND ORDER HYPERBOLIC EQUATIONS: WAVE EQUATIONS
σ̇ = ∇u
u̇ − div σ = f˜
Rt
with the integrated source f˜ = 0 f . In the following we skip the source f .
A mixed variational formulation in H(div) × L2 , for given initial conditions u(0) and
σ(0), is:
Runge-Kutta methods, we need methods such that i [−τ ρ(B), τ ρ(B)] is in the stability
region. For large systems, explicit methods (M cheaply invertible !) are often preferred.
While the stability region for the explicit Euler and improved Euler method do not include
an interval on the imaginary axis, the RK4 method does.
Methods taylored for the skew-symmetric (Hamiltonian) structure are symplectic meth-
ods: The symplectic Euler method is
σn+1 − σn
Mσ = −B T un
τ
un+1 − un
Mu = Bσn+1
τ
For updating the second variable, the new value of the first variable is used. For the
analysis, we can reduce the large system to 2 × 2 systems, where β are singular values of
−1/2 −1/2
Mσ BMu :
σ̇ = −βu u̇ = βσ
The symplectic Euler method can be written as
σn+1 1 0 1 −τ β σn
=
un+1 τβ 1 0 1 un
| {z
}
1 −τ β
T=
τ β 1 − (τ β)2
√
The eigenvalues of T satisfy λ1 λ2 = det(T ) = 1, and iff τ β ≤ 2 they are conjugate
complex, and thus |λ1 | = |λ2 | = 1. Thus, the discrete solution is oscillating without
damping or growth.
Again, diagonal mass matrices Mu and Mσ render explicit methods efficient.
190CHAPTER 10. SECOND ORDER HYPERBOLIC EQUATIONS: WAVE EQUATIONS
Chapter 11
191
192 CHAPTER 11. HYPERBOLIC CONSERVATION LAWS
(initial condition is skipped here, easily covered by non-vanishing test-functions for t = 0).
The weak form states that for F = (f, u) there holds
divx,t F = 0
in weak senses. Thus, F ∈ H(div). This requires that F · n is continuous across disconti-
nuities. Let s(t) the position of the shock. The normal vector satisfies
n ∼ (1, −s0 )
Thus, [F · n] = 0 reads as
f (ul ) − ul s0 = f (ur ) − ur s0
and we get the Rankine-Hugoniot relation
f (ul ) − f (ur )
s0 =
ul − ur
Example Burgers: The speed of the shocks is
1 2
u
2 l
− 12 u2r ul + ur
s0 = =
ul − ur 2
11.1. A LITTLE THEORY 193
F 0 = E 0f 0
Thus Z Z Z Z
d
E(u) = E(u)t = − F (u)x = − F (u) · n
dt Ω Ω Ω ∂Ω
No entropy changes for smooth solutions with isolated boundary. But, this is not true for
discontinuous solutions.
We pose the entropy decrease E(u)t + F (u)x ≤ 0 in weak sense:
Z
− E(u)ϕt + F (u)∇ϕ ≤ 0 ∀ ϕ ∈ C0∞ , ϕ ≥ 0
Ω×(0,T )
Calculating
ur + ul 2 3
[E]s0 − [F ] = (u2r − u2l ) + (ur − u3l ) = . . .
2 3
2
(ur − ul )
= −(ur − ul )
6
Now, posing the non-negative condition for [E]s0 − [F ] we allow jumps only for ur < ul .
g(u, u) = f (u)n