Finite Elements · 2020-03-06 · Finite Elements Colin Cotter February 22, 2019 ... First, we note...

51
Finite Elements Colin Cotter February 22, 2019 Colin Cotter FEM

Transcript of Finite Elements · 2020-03-06 · Finite Elements Colin Cotter February 22, 2019 ... First, we note...

Page 1: Finite Elements · 2020-03-06 · Finite Elements Colin Cotter February 22, 2019 ... First, we note that the zero function u(x) := 0 is in V, and satis es the above properties. ...

Finite Elements

Colin Cotter

February 22, 2019

Colin CotterFEM

Page 2: Finite Elements · 2020-03-06 · Finite Elements Colin Cotter February 22, 2019 ... First, we note that the zero function u(x) := 0 is in V, and satis es the above properties. ...

In the previous sections, we introduced the concept of finiteelement spaces, which contain certain functions defined on adomain Ω. Finite element spaces are examples of vector spaces(hence the use of the word “space”).

Colin CotterFEM

Page 3: Finite Elements · 2020-03-06 · Finite Elements Colin Cotter February 22, 2019 ... First, we note that the zero function u(x) := 0 is in V, and satis es the above properties. ...

Definition 1

Vector spaces A vector space over the real numbers R is a set V ,with an addition operator + : V × V → V , plus a scalarmultiplication operator ∗ : R× V → V , such that:

1. There exists a unique zero element e ∈ V such that:

1.1 ke = e for all k ∈ R,1.2 0v = e for all v ∈ V ,1.3 e + v = v for all v ∈ V .

2. V is closed under addition and multiplication, i.e., au + v ∈ Vfor all u, v ∈ V , a ∈ R.

Colin CotterFEM

Page 4: Finite Elements · 2020-03-06 · Finite Elements Colin Cotter February 22, 2019 ... First, we note that the zero function u(x) := 0 is in V, and satis es the above properties. ...

Proposition 2

Let V be a finite element space. Then V is a vector space.

Proof.

First, we note that the zero function u(x) := 0 is in V , andsatisfies the above properties. Further, let u, v ∈ V , and a ∈ R.Then, when restricted to each triangle Ki , u + av ∈ Pi . Also, foreach shared mesh entity, the shared nodal variables agree, i.e.Ni ,j [u + av ] = Ni ,j [u + av ], by linearity of nodal variables.Therefore, u + av ∈ V .

Colin CotterFEM

Page 5: Finite Elements · 2020-03-06 · Finite Elements Colin Cotter February 22, 2019 ... First, we note that the zero function u(x) := 0 is in V, and satis es the above properties. ...

We now develop/recall some definitions.

Definition 3 (Bilinear form)

A bilinear form b(·, ·) on a vector space V is a mappingb : V × V → R, such that

1. v → b(v ,w) is a linear map in v for all w .

2. v → b(w , v) is a linear map in v for all w .

It is symmetric if in addition, b(v ,w) = b(w , v), for all v ,w ∈ V .

Colin CotterFEM

Page 6: Finite Elements · 2020-03-06 · Finite Elements Colin Cotter February 22, 2019 ... First, we note that the zero function u(x) := 0 is in V, and satis es the above properties. ...

Example 4

Let Vh be a finite element space. The following are bilinear formson Vh,

b(u, v) =

∫Ωuv dx , (1)

b(u, v) =

∫Ω∇u · ∇v dx . (2)

Colin CotterFEM

Page 7: Finite Elements · 2020-03-06 · Finite Elements Colin Cotter February 22, 2019 ... First, we note that the zero function u(x) := 0 is in V, and satis es the above properties. ...

Definition 5 (Inner product)

A real inner product, denoted by (·, ·), is a symmetric bilinear formon a vector space V with

1. (v , v) ≥ 0 ∀v ∈ V ,

2. (v , v) = 0 ⇐⇒ v = 0.

Definition 6 (Inner product space)

We call a vector space (V , (·, ·)) equipped with an inner productan inner product space.

Colin CotterFEM

Page 8: Finite Elements · 2020-03-06 · Finite Elements Colin Cotter February 22, 2019 ... First, we note that the zero function u(x) := 0 is in V, and satis es the above properties. ...

Example 7 (L2 inner product)

Let f , g be two functions in L2(Ω). The L2 inner product betweenf and g is defined as

(f , g)L2 =

∫Ωfg dx . (3)

Remark 8

The L2 inner product satisfies condition 2 provided that weunderstand functions in L2 as being equivalence classes offunctions under the relation f ≡ g ⇐⇒

∫Ω(f − g)2 dx = 0.

Colin CotterFEM

Page 9: Finite Elements · 2020-03-06 · Finite Elements Colin Cotter February 22, 2019 ... First, we note that the zero function u(x) := 0 is in V, and satis es the above properties. ...

Example 9 (H1 inner product)

Let f , g be two C 0 finite element functions. The H1 inner productbetween f and g is defined as

(f , g)H1 =

∫Ωfg +∇f · ∇g dx . (4)

Remark 10

The H1 inner product satisfies condition 2 since

(f , f )L2 ≤ (f , f )H1 . (5)

Colin CotterFEM

Page 10: Finite Elements · 2020-03-06 · Finite Elements Colin Cotter February 22, 2019 ... First, we note that the zero function u(x) := 0 is in V, and satis es the above properties. ...

We have already used the Schwarz inequality for L2 inner productsin our approximation results.

Theorem 11 (Schwarz inequality)

If (V , (·, ·)) is an inner product space, then

|(u, v)| ≤ (u, u)1/2(v , v)1/2. (6)

Equality holds if and only if u = αv for some α ∈ R.

Proof.

See a course on vector spaces.

Colin CotterFEM

Page 11: Finite Elements · 2020-03-06 · Finite Elements Colin Cotter February 22, 2019 ... First, we note that the zero function u(x) := 0 is in V, and satis es the above properties. ...

We have already mentioned some norms.

Definition 12 (Norm)

Given a vector space V , a norm ‖ · ‖ is a function from V to R,with

1. ‖v‖ ≥ 0, ∀v ∈ V ,

2. ‖v‖ = 0 ⇐⇒ v = 0,

3. ‖cv‖ = |c |‖v‖∀c ∈ R, v ∈ V ,

4. ‖v + w‖ ≤ ‖v‖+ ‖w‖.

Colin CotterFEM

Page 12: Finite Elements · 2020-03-06 · Finite Elements Colin Cotter February 22, 2019 ... First, we note that the zero function u(x) := 0 is in V, and satis es the above properties. ...

Proposition 13

Let (V , (·, ·)) be an inner product space. Then ‖v‖ =√

(v , v)defines a norm on V .

Proof

From bilinearity we have

‖αv‖ =√

(αv , αv) =√α2(v , v) = |α|‖v‖,

from bilinearity, hence property 3.‖v‖ = (v , v)1/2 ≥ 0, hence property 1.If 0 = ‖v‖ = (v , v)1/2 =⇒ (v , v) = 0 =⇒ v = 0, hence property2.

Colin CotterFEM

Page 13: Finite Elements · 2020-03-06 · Finite Elements Colin Cotter February 22, 2019 ... First, we note that the zero function u(x) := 0 is in V, and satis es the above properties. ...

Proof (Cont.)

We finally check the triangle inequality (property 4).

‖u + v‖2 = (u + v , u + v) (7)

= (u, u) + 2(u, v) + (v , v) (8)

= ‖u‖2 + 2(u, v) + ‖v‖2 (9)

≤ ‖u‖2 + 2‖u‖‖v‖+ ‖v‖2 [Schwarz], (10)

= (‖u‖+ ‖v‖)2, (11)

hence ‖u + v‖ ≤ ‖u‖+ ‖v‖.

Colin CotterFEM

Page 14: Finite Elements · 2020-03-06 · Finite Elements Colin Cotter February 22, 2019 ... First, we note that the zero function u(x) := 0 is in V, and satis es the above properties. ...

Definition 14 (Normed space)

A vector space V with a norm ‖ · ‖ is called a normed vector space,written (V , ‖ · ‖).

Definition 15 (Cauchy sequence)

A Cauchy sequence on a normed vector space (V , ‖ · ‖) is asequence vi∞i=1 satisfying ‖vj − vk‖ → 0 as j , k →∞.

Colin CotterFEM

Page 15: Finite Elements · 2020-03-06 · Finite Elements Colin Cotter February 22, 2019 ... First, we note that the zero function u(x) := 0 is in V, and satis es the above properties. ...

Definition 16 (Complete normed vector space)

A normed vector space (V , ‖ · ‖) is complete if all Cauchysequences have a limit v ∈ V such that ‖v − vj‖ → 0 as j →∞.

Definition 17 (Hilbert space)

An inner product space (V , (·, ·)) is a Hilbert space if thecorresponding normed space (V , ‖ · ‖) is complete.

Remark 18

All finite dimensional normed vector spaces are complete. Hence,C 0 finite element spaces equipped with L2 or H1 inner productsare Hilbert spaces. Later we shall understand our finite elementspaces as subspaces of infinite dimensional Hilbert spaces.

Colin CotterFEM

Page 16: Finite Elements · 2020-03-06 · Finite Elements Colin Cotter February 22, 2019 ... First, we note that the zero function u(x) := 0 is in V, and satis es the above properties. ...

We will now quote some important results from the theory ofHilbert spaces.

Definition 19 (Continuous linear functional)

Let H be a Hilbert space.

1. A functional L is a map from H to R.

2. A functional L : H → R is linear if u, v ∈ H, α ∈ R=⇒ L(u + αv) = L(u) + αL(v).

3. A functional L : H → R is continuous if there exists C > 0such that

|L(u)− L(v)| ≤ C‖u − v‖H ∀u, v ∈ H.

Colin CotterFEM

Page 17: Finite Elements · 2020-03-06 · Finite Elements Colin Cotter February 22, 2019 ... First, we note that the zero function u(x) := 0 is in V, and satis es the above properties. ...

Definition 20 (Bounded functional)

A functional L : H → R is bounded if there exists C > 0 such that

|L(u)| ≤ C‖u‖H , ∀u ∈ H.

Lemma 21

Let L : H → R be a linear functional. Then L is continuous if andonly if it is bounded.

Proof

L bounded =⇒ L(u) ≤ C‖u‖H =⇒ |L(u)− L(v)| =|L(u − v)| ≤ C‖u − v‖H ∀u, v ∈ H, i.e. L is continuous.

Colin CotterFEM

Page 18: Finite Elements · 2020-03-06 · Finite Elements Colin Cotter February 22, 2019 ... First, we note that the zero function u(x) := 0 is in V, and satis es the above properties. ...

Proof (Cont.)

L continuous =⇒ |L(u − v)| ≤ C‖u − v‖H ∀u, v ∈ H.Pick v = 0, then |L(u)| = |L(u − 0)| ≤ C |u − 0|H = C |u|H , i.e. Lis bounded.

Definition 22 (Dual space)

Let H be a Hilbert space. The dual space H ′ is the space ofcontinuous (or bounded) linear functionals L : H → R.

Colin CotterFEM

Page 19: Finite Elements · 2020-03-06 · Finite Elements Colin Cotter February 22, 2019 ... First, we note that the zero function u(x) := 0 is in V, and satis es the above properties. ...

Definition 23 (Dual norm)

Let L be a continuous linear functional on H, then

‖L‖H′ = sup06=v∈H

L(v)

‖v‖H.

Colin CotterFEM

Page 20: Finite Elements · 2020-03-06 · Finite Elements Colin Cotter February 22, 2019 ... First, we note that the zero function u(x) := 0 is in V, and satis es the above properties. ...

Lemma 24

Let u ∈ H. Then the functional Lu : H → R defined by

Lu(v) = (u, v), ∀v ∈ H,

is linear and continuous.

Proof.

For v ,w ∈ H, α ∈ R we have

Lu(v + αw) = (u, v + αw) = (u, v) + α(u, v) = Lu(v) + αLu(w).

Hence Lu is continuous. Lu is bounded by Schwarz inequality,

|Lu(v)| = |(u, v)| ≤ C‖v‖H with C = ‖u‖H .

Colin CotterFEM

Page 21: Finite Elements · 2020-03-06 · Finite Elements Colin Cotter February 22, 2019 ... First, we note that the zero function u(x) := 0 is in V, and satis es the above properties. ...

The following theorem states that the converse is also true.

Theorem 25 (Riesz representation theorem)

For any continuous linear functional L on H there exists u ∈ Hsuch that

L(v) = (u, v) ∀v ∈ H.

Further,‖u‖H = ‖L‖H′ .

Proof.

See a course or textbook on Hilbert spaces.

Colin CotterFEM

Page 22: Finite Elements · 2020-03-06 · Finite Elements Colin Cotter February 22, 2019 ... First, we note that the zero function u(x) := 0 is in V, and satis es the above properties. ...

We will consider finite element methods that can be formulated inthe following way.

Definition 26 (Linear variational problem)

Let b(u, v) be a bilinear form on a Hilbert space V , and F be alinear form on V . This defines a linear variational problem: findu ∈ V such that

b(u, v) = F (v), ∀v ∈ V .

Colin CotterFEM

Page 23: Finite Elements · 2020-03-06 · Finite Elements Colin Cotter February 22, 2019 ... First, we note that the zero function u(x) := 0 is in V, and satis es the above properties. ...

Example 27 (Pk discretisation of (modified) Helmholtzproblem with Neumann bcs)

For some known function f ,

b(u, v) =

∫Ωuv +∇u · ∇v dx , F (v) =

∫Ωvf dx ,

and V is the Pk continuous finite element space on a triangulationof Ω.

Colin CotterFEM

Page 24: Finite Elements · 2020-03-06 · Finite Elements Colin Cotter February 22, 2019 ... First, we note that the zero function u(x) := 0 is in V, and satis es the above properties. ...

Example 28 (Pk discretisation of Poisson equation with partialDirichlet bcs)

For some known function f ,

b(u, v) =

∫Ω∇u · ∇v dx , F (v) =

∫Ωvf dx ,

and V is the subspace of the Pk continuous finite element spaceon a triangulation of Ω such that functions vanishes on Γ0 ⊆ ∂Ω.

Colin CotterFEM

Page 25: Finite Elements · 2020-03-06 · Finite Elements Colin Cotter February 22, 2019 ... First, we note that the zero function u(x) := 0 is in V, and satis es the above properties. ...

Example 29 (Pk discretisation of Poisson equation with pureNeumann bcs)

For some known function f ,

b(u, v) =

∫Ω∇u · ∇v dx , F (v) =

∫Ωvf dx ,

and V is the subspace of the Pk continuous finite element spaceon a triangulation of Ω such that functions satisfy∫

Ωu dx = 0.

Colin CotterFEM

Page 26: Finite Elements · 2020-03-06 · Finite Elements Colin Cotter February 22, 2019 ... First, we note that the zero function u(x) := 0 is in V, and satis es the above properties. ...

Definition 30 (Continuous bilinear form)

A bilinear form is continuous on a Hilbert space V if there exists aconstant 0 < M <∞

|b(u, v)| ≤ M‖u‖V ‖v‖V .

Colin CotterFEM

Page 27: Finite Elements · 2020-03-06 · Finite Elements Colin Cotter February 22, 2019 ... First, we note that the zero function u(x) := 0 is in V, and satis es the above properties. ...

Definition 31 (Coercive bilinear form)

A bilinear form is coercive on a Hilbert space V if there exists aconstant 0 < γ <∞

|b(u, u)| ≥ γ‖u‖V ‖u‖V .

Colin CotterFEM

Page 28: Finite Elements · 2020-03-06 · Finite Elements Colin Cotter February 22, 2019 ... First, we note that the zero function u(x) := 0 is in V, and satis es the above properties. ...

Theorem 32 (Lax-Milgram theorem)

Let b be a bilinear form, F be a linear form, and (V , ‖ · ‖) be aHilbert space. If b is continuous and coercive, and F is continuous,then a unique solution u ∈ V to the linear variational problemexists, with

‖u‖V ≤1

γ‖F‖V ′ .

Proof.

See a course or textbook on Hilbert spaces.

We are going to use this result to show solveability for FEdiscretisations.

Colin CotterFEM

Page 29: Finite Elements · 2020-03-06 · Finite Elements Colin Cotter February 22, 2019 ... First, we note that the zero function u(x) := 0 is in V, and satis es the above properties. ...

Definition 33 (Stability)

Consider a sequence of triangulations Th with corresponding finiteelement spaces Vh labelled by a maximum triangle diameter h,applied to a variational problem with bilinear form b(u, v) andlinear form L. For each Vh we have a corresponding coercivityconstant γh.

If γh → γ > 0, ‖F‖V ′h→ c <∞,

then we say that the finite element discretisation is stable.

With this in mind it is useful to consider h-independent definitionsof ‖ · ‖V (such as L2 norm and H1 norm).

Colin CotterFEM

Page 30: Finite Elements · 2020-03-06 · Finite Elements Colin Cotter February 22, 2019 ... First, we note that the zero function u(x) := 0 is in V, and satis es the above properties. ...

Proposition 34 (Solving the (modified) Helmholtz problem)

Let b, L be the forms from the Helmholtz problem, with‖f ‖L2 <∞. Let Vh be a Pk continuous finite element spacedefined on a triangulation T . Then the finite elementapproximation uh exists and the discretisation is stable in the H1

norm.

Proof

First we show continuity of F . We have

F (v) =

∫Ωfv dx ≤ ‖f ‖L2‖v‖L2 ≤ ‖f ‖L2‖v‖H1 ,

since ‖v‖L2 ≤ ‖v‖H1 .

Colin CotterFEM

Page 31: Finite Elements · 2020-03-06 · Finite Elements Colin Cotter February 22, 2019 ... First, we note that the zero function u(x) := 0 is in V, and satis es the above properties. ...

Proof (Cont.)

Continuity of b:

|b(u, v)| = |(u, v)H1 | ≤ ‖u‖H1‖v‖H1 .

Coercivity of b:b(u, u) = ‖u‖2

H1 ≥ ‖u‖2H1 .

The continuity and coercivity constants are both 1, independent ofh, so the discretisation is stable.

Colin CotterFEM

Page 32: Finite Elements · 2020-03-06 · Finite Elements Colin Cotter February 22, 2019 ... First, we note that the zero function u(x) := 0 is in V, and satis es the above properties. ...

For the Helmholtz problem, we have

b(u, v) =

∫Ωuv +∇u · ∇v dx = (u, v)H1 .

For the Poisson problem, we have

b(u, v) =

∫Ω|∇u|2 dx = |u|2H1 6= ‖u‖2

H1 .

Some additional results are required.

Colin CotterFEM

Page 33: Finite Elements · 2020-03-06 · Finite Elements Colin Cotter February 22, 2019 ... First, we note that the zero function u(x) := 0 is in V, and satis es the above properties. ...

Lemma 35 (Mean estimate for finite element spaces)

Let u be a member of a C 0 finite element space, and define

u =

∫Ω u dx∫Ω dx

.

Then there exists a positive constant C , independent of thetriangulation but dependent on (convex) Ω, such that

‖u − u‖L2 ≤ C |u|H1 .

Colin CotterFEM

Page 34: Finite Elements · 2020-03-06 · Finite Elements Colin Cotter February 22, 2019 ... First, we note that the zero function u(x) := 0 is in V, and satis es the above properties. ...

Proof

Let x and y be two points in Ω. We note thatf (s) = u(y + s(x − y)) is a C 0, piecewise polynomial function of s,with f ′(s) = (x − y) · ∇u(y + s(x − y)), where ∇u is the finiteelement derivative of u, and thus

u(x) = u(y)+

∫ 1

0f ′(s) ds = u(y)+

∫ 1

0(x−y)·∇u(y+s(x−y)) ds,

Then

u(x)− u =1

|Ω|

∫Ωu(x)− u(y) dy

=1

|Ω|

∫Ω

(x − y) ·∫ 1

s=0∇u(y + s(x − y)) ds dy ,

Colin CotterFEM

Page 35: Finite Elements · 2020-03-06 · Finite Elements Colin Cotter February 22, 2019 ... First, we note that the zero function u(x) := 0 is in V, and satis es the above properties. ...

Proof (Cont.)

Therefore

‖u − u‖2L2(Ω)

=1

|Ω|2

∫Ω

(∫Ω

(x − y) ·∫ 1

s=0∇u(y + s(x − y)) ds dy

)2

dx ,

≤ 1

|Ω|2

∫Ω

∫Ω|x − y |2 dy

∫Ω

∫ 1

s=0|∇u(y + s(x − y))|2 ds dy dx ,

≤C∫

Ω

∫Ω

∫ 1

s=0|∇u(y + s(x − y))|2 ds dy dx .

Colin CotterFEM

Page 36: Finite Elements · 2020-03-06 · Finite Elements Colin Cotter February 22, 2019 ... First, we note that the zero function u(x) := 0 is in V, and satis es the above properties. ...

Proof (Cont.)

Split into two parts (to avoid singularities):

‖u − u‖2L2(Ω) ≤ C (I + II ),

where

I =

∫Ω

∫ 1/2

s=0

∫Ω|∇u(y + s(x − y))|2 dy ds dx ,

II =

∫Ω

∫ 2

s=1/2

∫Ω|∇u(y + s(x − y))|2 dx ds dy ,

which we will now estimate separately.

Colin CotterFEM

Page 37: Finite Elements · 2020-03-06 · Finite Elements Colin Cotter February 22, 2019 ... First, we note that the zero function u(x) := 0 is in V, and satis es the above properties. ...

Proof (Cont.)

To evaluate I , change variables y → y ′ = y + s(x − y), definingΩ′s ⊂ Ω as the image of Ω under this transformation. Then,

I =

∫Ω

∫ 1/2

s=0

1

(1− s)2

∫Ω′

s

|∇u(y ′)|2 dy ′ ds dx ,

≤∫

Ω

∫ 1/2

s=0

1

(1− s)2

∫Ω|∇u(y ′)|2 dy ′ ds dx ,

=|Ω|2|∇u|2H1(Ω).

Colin CotterFEM

Page 38: Finite Elements · 2020-03-06 · Finite Elements Colin Cotter February 22, 2019 ... First, we note that the zero function u(x) := 0 is in V, and satis es the above properties. ...

Proof (Cont.)

To evaluate II , change variables x → x ′ = y + s(x − y), definingΩ′s ⊂ Ω as the image of Ω under this transformation. Then,

II =

∫Ω

∫ 2

s=1/2

1

s2

∫Ω′

s

|∇u(x ′)|2 dx ′ ds dy ,

≤∫

Ω

∫ 1/2

s=0

1

s2

∫Ω|∇u(x ′)|2 dx ′ ds dy ,

= |Ω||∇u|2H1(Ω).

Combining, ‖u − u‖2L2(Ω) ≤ C (I + II ) =

3C |Ω|2|u|2H1(Ω),

which has the required form.

Colin CotterFEM

Page 39: Finite Elements · 2020-03-06 · Finite Elements Colin Cotter February 22, 2019 ... First, we note that the zero function u(x) := 0 is in V, and satis es the above properties. ...

Proposition 36 (Solving the Poisson problem with pureNeumann conditions)

Let b, L, V , be the forms for the pure Neumann Poisson problem,with ‖f ‖L2 <∞. Let Vh be a Pk continuous finite element spacedefined on a triangulation T , and define

Vh = u ∈ Vh : u = 0.

Then for Vh, the finite element approximation uh exists and thediscretisation is stable in the H1 norm.

Colin CotterFEM

Page 40: Finite Elements · 2020-03-06 · Finite Elements Colin Cotter February 22, 2019 ... First, we note that the zero function u(x) := 0 is in V, and satis es the above properties. ...

Proof.

Using the mean estimate, for u ∈ Vh, we have

‖u‖2L2 = ‖u − u︸︷︷︸

=0

‖2L2 ≤ C 2|u|2H1 .

Hence we obtain the coercivity result,

‖u‖2H1 = ‖u‖2

L2 + |u|2H1 ≤ (1 + C 2)|u|2H1 = (1 + C 2)b(u, u).

Continuity follows from Schwarz inequality,

|b(u, v)| ≤ |u|H1 |v |H1 ≤ ‖u‖H1‖v‖H1 .

Colin CotterFEM

Page 41: Finite Elements · 2020-03-06 · Finite Elements Colin Cotter February 22, 2019 ... First, we note that the zero function u(x) := 0 is in V, and satis es the above properties. ...

Proving the coercivity for the case with Dirichlet or partialDirichlet boundary conditions requires some additional results.

Colin CotterFEM

Page 42: Finite Elements · 2020-03-06 · Finite Elements Colin Cotter February 22, 2019 ... First, we note that the zero function u(x) := 0 is in V, and satis es the above properties. ...

Lemma 37 (Finite element divergence theorem)

Let φ be a C 1 vector-valued function. and u ∈ V be a member ofa C 0 finite element space. Then∫

Ω∇ · (φu) dx =

∫∂Ωφ · nu dS ,

where n is the outward pointing normal to ∂Ω.

Colin CotterFEM

Page 43: Finite Elements · 2020-03-06 · Finite Elements Colin Cotter February 22, 2019 ... First, we note that the zero function u(x) := 0 is in V, and satis es the above properties. ...

Proof.∫Ω∇ · (φu) dx =

∑K∈T

∫K∇ · (φu) dx ,

=∑K∈T

∫∂Kφ · nKu dS ,

=

∫∂Ωφ · nu dS +

∫Γφ · (n+ + n−)u dS︸ ︷︷ ︸

=0

.

Colin CotterFEM

Page 44: Finite Elements · 2020-03-06 · Finite Elements Colin Cotter February 22, 2019 ... First, we note that the zero function u(x) := 0 is in V, and satis es the above properties. ...

Proposition 38 (Trace theorem for continuous finite elements)

Let Vh be a continuous finite element space, defined on atriangulation T , on a polygonal domain Ω. Then

‖u‖L2(∂Ω) ≤ C‖u‖H1(Ω), (12)

where C is a constant that depends only on the geometry of Ω.

Colin CotterFEM

Page 45: Finite Elements · 2020-03-06 · Finite Elements Colin Cotter February 22, 2019 ... First, we note that the zero function u(x) := 0 is in V, and satis es the above properties. ...

Proof

The first step is to construct a C 1 function ξ satisfying ξ · n = 1 onΩ. We do this by finding a triangulation T0 (unrelated to T ), anddefining an C 1 Argyris finite element space V0 on it. We thenchoose ξ so that both Cartesian components are in V0, satisfyingthe boundary condition.

Colin CotterFEM

Page 46: Finite Elements · 2020-03-06 · Finite Elements Colin Cotter February 22, 2019 ... First, we note that the zero function u(x) := 0 is in V, and satis es the above properties. ...

Proof (Cont.)

Then,

‖u‖2L2(∂Ω) =

∫∂Ω

u2 dS =

∫∂Ωξ · nu2 dS ,

=

∫Ω∇ · (ξu2) dx ,

=

∫Ωu2∇ · ξ + 2uξ · ∇u dx ,

≤ ‖u‖2L2‖∇ · ξ‖∞ + 2|ξ|∞‖u‖L2 |u|H1 ,

Colin CotterFEM

Page 47: Finite Elements · 2020-03-06 · Finite Elements Colin Cotter February 22, 2019 ... First, we note that the zero function u(x) := 0 is in V, and satis es the above properties. ...

Proof (Cont.)

So,

‖u‖2L2(∂Ω) ≤ ‖u‖

2L2‖∇ · ξ‖∞ + |ξ|∞

(‖u‖2

L2 + |u|2H1

),

≤ C‖u‖2H1 ,

where we have used the geometric-arithmetic mean inequality2ab ≤ a2 + b2.

Colin CotterFEM

Page 48: Finite Elements · 2020-03-06 · Finite Elements Colin Cotter February 22, 2019 ... First, we note that the zero function u(x) := 0 is in V, and satis es the above properties. ...

Proposition 39 (Solving the Poisson problem with partialDirichlet conditions)

Let b, L, V , be the forms for the (partial) Dirichlet Poissonproblem, with ‖f ‖L2 <∞. Let Vh be a Pk continuous finiteelement space defined on a triangulation T , and define

Vh = u ∈ Vh : u|Γ0.

Then for Vh, the finite element approximation uh exists and thediscretisation is stable in the H1 norm.

Colin CotterFEM

Page 49: Finite Elements · 2020-03-06 · Finite Elements Colin Cotter February 22, 2019 ... First, we note that the zero function u(x) := 0 is in V, and satis es the above properties. ...

Proof

Proof taken from Brenner and Scott. We have

‖v‖L2(Ω) ≤ ‖v − v‖L2(Ω) + ‖v‖L2(Ω),

≤ C |v |H1(Ω) +|Ω|1/2

|Γ0|

∣∣∣∣∫Γ0

v dS

∣∣∣∣ ,≤ C |v |H1(Ω) +

|Ω|1/2

|Γ0|

(∣∣∣∣∫Γ0

v dS +

∫Γ0

v − v dS

∣∣∣∣) .

Colin CotterFEM

Page 50: Finite Elements · 2020-03-06 · Finite Elements Colin Cotter February 22, 2019 ... First, we note that the zero function u(x) := 0 is in V, and satis es the above properties. ...

Proof (Cont.)

We have ∣∣∣∣∫Γ0

(v − v) ds

∣∣∣∣ ≤ |Γ0|1/2‖v − v‖L2(∂Ω),

≤ |Γ0|1/2C |v |H1(Ω).

Combining, we get

‖v‖L2(Ω) ≤ C1|v |H1(Ω),

and hence coercivity,

‖v‖2H1(Ω) ≤ (1 + C 2

1 )b(v , v).

Colin CotterFEM

Page 51: Finite Elements · 2020-03-06 · Finite Elements Colin Cotter February 22, 2019 ... First, we note that the zero function u(x) := 0 is in V, and satis es the above properties. ...

We have developed some techniques for showing that variationalproblems arising from finite element discretisations for Helmholtzand Poisson problems have unique solutions, that are stable in theH1-norm. This means that we can be confident that we can solvethe problems on a computer and the solution won’t becomesingular as the mesh is refined.

Now we would like to go further and ask what is happening to thenumerical solutions as the mesh is refined. What are theyconverging to?

Colin CotterFEM