• Nebyly nalezeny žádné výsledky

2-Dimensional Primal Domain Decomposition Theory in Detail ∗

N/A
N/A
Protected

Academic year: 2022

Podíl "2-Dimensional Primal Domain Decomposition Theory in Detail ∗ "

Copied!
22
0
0

Načítání.... (zobrazit plný text nyní)

Fulltext

(1)

2-Dimensional Primal Domain Decomposition Theory in Detail

Dalibor Luk´aˇs

, Jiˇr´ı Bouchala

, Petr Vodstrˇcil

, and Luk´aˇs Mal´y

January 21, 2014

Abstract

We give details of the theory of primal domain decomposition (DD) methods for a 2-dimensional second order elliptic equation with homo- geneous Dirichlet boundary conditions and jumping coefficients. The problem is discretized by the finite element method. The computa- tional domain is decomposed into triangular subdomains that align with the coefficients jumps. We prove that the condition number of the vertex-based DD preconditioner isO (1 + log(H/h))2

, indepen- dently of the coefficient jumps, where H and hdenotes discretization parameters of the coarse and fine triangulations, respectively. Al- though this preconditioner and its analysis date back to the pioneering work by Bramble, Pasciak, and Schatz published in 1986, and it was revisited and extended by many authors including Dryja and Wid- lund in 1989, or Toselli and Widlund in 2005, the theory is hard to understand and some details, to our best knowledge, have never been published. In this paper we present all the proofs in detail by means of fundamental calculus.

Keywords: domain decomposition methods, finite element method, preconditioning

MSC 2010: 65N55, 65N30, 65F08

This work was supported by the European Regional Development Fund in the IT4Innovations Centre of Excellence project (CZ.1.05/1.1.00/02.0070), by the Czech Min- istry of Education under the project MSM6198910027, and by VˇSB-TU Ostrava under the grant SGS SP2013/191.

SB–Technical University of Ostrava, 17. listopadu 15, 708 33 Ostrava-Poruba, Czech Republic. Emails: {dalibor.lukas,jiri.bouchala,petr.vodstrcil,lukas.maly}@vsb.cz

(2)

1 Introduction

We consider the homogeneous Dirichlet problem for the Poisson equation

−div (ρ(x)∇u(x)) = f(x), x∈Ω, u(x) = 0, x∈∂Ω,

where Ω ⊂R2 is a bounded polygonal domain with Lipschitz boundary, f ∈ L2(Ω), andρ∈L(Ω) is a positive piecewise constant material function. The domain Ω is decomposed intoN nonoverlapping open triangular subdomains Ωi by means of a conforming finite element (FE) discretization Ω =SN

i=1i. This is referred to as the coarse discretization or the domain decomposition (DD). The decomposition aligns with jumps of the material function so that ρ(x) = ρi > 0 for x ∈ Ωi. We denote by Γ := SM

i=1Ei, the skeleton of the decomposition, where Ei is the interior of an edge apart from ∂Ω, see Fig. 1.

We denote the coarse discretization parameter by H := max

i=1,...,N diam(Ωi).

≈h

≈H

Figure 1: Decomposition of Ω into N = 10 subdomains with nV = 2 vertices xVi (marked by squares); dashed-line depicts ∂Ω; solid-bold-lines denote Γ decomposed into M = 11 edges with edge nodes xEi,j (marked by circles);

solid-thin-lines denote the fine triangulation with n = 65 nodes; diamonds depict interior nodes xIi,j.

(3)

The related weak formulation find u∈H01(Ω) :

XN i=1

ρi

Z

i

∇u(x)∇v(x)dx

| {z }

=:a(u,v)

= Z

f(x)v(x)dx

| {z }

=:b(v)

∀v ∈H01(Ω)

is discretized by the conforming finite element (FE) method on a subspace V := Vh := hϕ1(x), . . . , ϕn(x)i ⊂ H01(Ω), where (ϕi)ni=1 denote the linear Lagrange basis functions related to the nodes depicted in Fig. 1. The under- lying fine triangulation align with the domain decomposition. We arrive at the linear system

A u=b, (1)

where (A)i,j := a(ϕi, ϕj), (b)i := b(ϕi), and uh(x) := Pn

j=1(u)jϕj(x) ap- proximates u(x). By hwe denote the fine discretization parameter, which is the maximal fine-triangle diameter.

Primal DD-methods rely on re-sorting the basis functions (ϕi)ni=1 into N sets of functions ϕIi,jnIi

j=1, i = 1, . . . , N, related to subdomain interior nodes xIi,j ∈Ωi, see Fig. 1, and a set of functions ϕΓknΓ

k=1 related to skeleton nodes xΓk ∈Γ\∂Ω, which either belongs to an edge Ei, xΓk =xEi,j, or it is a subdomain (coarse) vertex xΓk =xVi , see Fig. 1. This translates (1) into the saddle-point system







AI,I1 0 . . . 0 AI,Γ1 0 AI,I2 . . . 0 AI,Γ2 ... ... . .. ... ... 0 0 . . . AI,IN AI,ΓN AΓ,I1 AΓ,I2 . . . AΓ,IN AΓ,Γ











 uI1 uI2 ... uIN

uΓ







=





 bI1 bI2 ... bIN

bΓ







, (2)

where (AI,Ik )i,j := a(ϕIk,i, ϕIk,j), (AI,Γk )i,j = (AΓ,Ik )j,i := a(ϕIk,i, ϕΓk,j), (bIk)i :=

b(ϕIk,i), and (bΓ)i :=b(ϕΓi). Using a particular-solution approach, (2) can be solved in three steps:

1. Solve N independent systems AI,Ii vIi =bIi, being FE-counterparts of

−ρi△viI(x) = f(x), x∈Ωi, viI(x) = 0, x∈∂Ωi. on subspaces Vi :=Vih :=hϕIi,1, . . . , ϕI Ii.

(4)

2. Solve S uΓ =bΓ−PN

i=1AΓ,Ii viI, where S:=AΓ,Γ

XN i=1

AΓ,Ii

AI,Ii −1

AI,Γi . (3)

3. SolveN concurrent systemsAI,Ii wiI=−AI,Γi uΓ, being FE-counterparts of −ρi△wiI(x) = 0, x∈Ωi,

wiI(x) = uΓ(x), x∈∂Ωi∩Γ, wiI(x) = 0, x∈∂Ωi∩∂Ω, and set uIi :=viI+wiI.

The method can be also viewed in terms of the block LDLT-factorization A=

II 0 AΓ,I AI,I−1

IΓ

AI,I 0 0 S

II AI,I−1

AI,Γ 0 IΓ

,

where II, IΓ denote the identity matrices, AI,I and AI,Γ = (AΓ,I)T is the upper-block-diagonal and off-diagonal part of A, respectively.

The idea of primal DD-preconditioners is to replace the Schur complement S in Step 2 by an approximation S, which is cheap to invert, the conditionb number κ

Sb−1S

increases modestly with H/h and it is independent of (ρi)Ni=1.

The primal DD-methods can be thought as a block Gauss elimination combined with preconditioned Krylov space methods. The idea of re-ordering of the nodes date back to the nested-dissection sparse direct solver developed by George [5]. The base for the analysis of DD-preconditioners was given in a famous series of papers by Bramble, Pasciak, and Schatz, cf. [1]. Analysis in the Schwarz framework was presented by Dryja, Smith, and Widlund [3].

Let us mention at least two other important DD-methods such as balancing DD proposed and analyzed by Mandel and Brezina [6], or finite element tearing and interconnecting proposed by Farhat and Roux [4] and analyzed by Mandel and Tezaur [7]. We refer to the monograph by Toselli and Widlund [9]

for a more comprehensive overview.

The aim of this paper is to present a complete theory for the vertex-based DD-preconditioner in 2 dimensions by means of simple calculus. Although many other DD-preconditioners rely on this theory, to our best knowledge it

(5)

has never been presented in a single paper or a monograph without exter- nal references. Neither we have found a complete proof of the 2-dimensional counterpart of the edge lemma, a brief sketch of which is given in [2]. More- over, we found and corrected an inaccuracy in the proof [1] of a frequently- used discrete Sobolev inequality. We hope that our effort will be of some help to researchers, at a position similar to ours, who need to get a deeper understanding of the theory in order to develop their novel DD-methods.

The rest of the paper is organized as follows: In Section 2 we give the construction of the preconditioner. In Section 3 we present the analysis of the condition number of the DD-preconditioned algebraic system.

2 Vertex-based preconditioner

In Section 1 we re-ordered the basis functions (ϕi)ni=1 into N sets of interior functions and a set of skeleton functions, which arrived at (2). Similarly we shall now re-order the set of skeleton basis functions ϕΓinΓ

i=1 into M, being the number of edges, sets of functions ϕEi,jnEi

j=1, i = 1, . . . , M, related to nodes xEi,j ∈ Ei, see Fig. 1, and into a set of functions ϕVi nV

i=1 related to subdomain vertices xVi ∈ Γ. This re-ordering induces a permutation of the Schur complement (3), still denoted by S,

S=

SE,E SE,V SV,E SV,V

, (4)

where the E-blocks of rows or columns are associated to the edge functions ϕEi,j and the V-blocks are associated to the vertex functions ϕVi . The matrix SE,E admits the following block structure

SE,E =



SE,E1,1 . . . SE,E1,M ... . .. ...

SE,EM,1 . . . SE,EM,M

, (5)

where SE,Ei,j

k,l is related to interaction of the basis functions ϕEi,k and ϕEj,l. From (3) we can see that the block structure is sparse, since SE,Ei,j is zero if there is no subdomain adjacent to both Ei and Ej.

(6)

Denote the overall number of interior edge nodes by nE :=PM

i=1nEi . We introduce the matrix

RE= RE1, . . . ,REM

∈RnV×nE, REi ∈RnV×nEi,

the transpose of which linearly interpolates function values from the coarse vertices xVk into interior nodes xEi,j of an associated edgeEi. That means the entries of RE are given by values of the coarse-space basis functions

REi

k,jHk xEi,j

, (6)

where ϕHi nV

i=1 are FE-functions uniquely defined by the values at vertices xVi of the domain decomposition. We change the base ϕVi nV

i=1 to ϕHi nV i=1 so that

S=

IE 0

−RE IV

SE,E eSE,V SeV,E SeV,V

! IE − RET

0 IV

, (7)

where IE, IV are identity matrices. Now the block AH := SeV,V is the FE- discretization of the bilinear form a(u, v) in the coarse base.

The primal, so-called vertex-based DD-preconditioner is constructed by neglecting SeE,V, eSV,E, and by skipping the off-diagonal blocks in (5), i.e.

b S=

IE 0

−RE IV

SE,E 0 0 AH

IE − RET

0 IV

,

where SE,E := diag

SE,E1,1 , . . . ,SE,EM,M .

In each iteration of, e.g., the preconditioned conjugate gradient method an action of Sb−1 is required. We have the formula

Sb−1 =

IE RET

0 IV

SE,E−1

0 0 AH−1

IE 0 RE IV

=

= XM

i=1

IEi

0 SE,Ei,i −1

IEi ,0 +

RET

IV

AH−1

RE,IV

| {z }

=:RH

. (8)

This results in a modification of Step 2 of the three-steps method.

(7)

2a. Set

cΓ :=

cE cV

:=bΓ−AΓ,IvI. 2b. Solve M independent local systems SE,Ei,i wEi =cEi .

2c. Solve the global coarse system AHwH =cV+REcE. 2d. Set

b uΓ :=

wE+ (RE)TwH wH

The action of bS−1 comprises solution to a global system with the coarse matrix AH and solution toM local edge problems with matricesSE,Ei,i , which are local Schur complements related to the following systems:

AI,Ij 0 AI,Ej,i 0 AI,Ik AI,Ek,i AE,Ii,j AE,Ii,k AE,Ei

 wjI wIk wEi

=

 0 0 cEi

,

where the relation ofi, j, and k is such that the domains Ωj and Ωk are con- nected via the edgeEi. We solve the system forwiE. It is an FE-discretization on the space Vj +Vk+ViE, where ViE := hϕEi,linl=1Ei , of the following problem solved over the patch Ωj∪Ωk:

−ρj△wjI(x) = 0, x∈Ωj, wIj(x) = 0, x∈∂Ωj \Ei,

−ρk△wkI(x) = 0, x∈Ωk, wIk(x) = 0, x∈∂Ωk\Ei, wiE(x) :=wIj(x) = wkI(x), x∈Ei, ρj

dwIj

dnj(x) +ρkdwIk

dnk(x) = cEi (x), x∈Ei,

wherenj andnkdenote the outward unit normals to Ωj and Ωk, respectively.

The resulting preconditioner admits the following factorization b

A=

II 0 AΓ,I AI,I−1

IΓ

AI,I 0 0 Sb

II AI,I−1

AI,Γ 0 IΓ

. (9)

(8)

3 Analysis of the condition number

We shall analyze the condition number κ b A−1A

by means of finding spec- tral bounds λmin >0 and λmax >0 such that

∀u∈V : λminba(u, u)≤a(u, u)≤ λmaxba(u, u),

whereba(u, u) is the quadratic form related to A. It will turn out that underb shape-regularity and quasi-uniformity of both the coarse and fine discretiza- tions the condition number κ is bounded by C(1 + ln(H/h))2 from above.

The constant C as well as all the other generic constants that appear in the theory below are independent of H, h, and (ρi)Ni=1.

3.1 Orthogonal space splitting

Let us re-visit the algebraic construction of A. First we re-sorted the basisb functions according to the interior and skeleton nodes. This leads to

V = (V1a· · · ⊕aVN) +VΓ,

where VΓ := hϕΓ1, . . . , ϕΓnΓi and where the a-orthogonality of Vi and Vj, for i6=j, follows from Ωi∩Ωj =∅.

Now we take into account the transformation of base determined by the right factor of (9). It transforms the basis functions ϕΓi to their discrete har- monic extensions ϕeΓi :=H(ϕΓi). Recall that the discrete harmonic extension e

uΓ of uΓ ∈VΓ is the solution to the following problem:

find euΓ ∈V : euΓ(x) =uΓ(x) on Γ and ∀j ∀v ∈Vj : a(euΓ, v) = 0.

Note that euΓ|j, j = 1, . . . , N, is an FE-counterpart of

−△euΓ(x) = 0, x∈Ωj, e

uΓ(x) = uΓ(x), x∈Γ∩∂Ωj, e

uΓ(x) = 0, x∈∂Ω∩∂Ωj.

Denoting by VeΓ:=H(VΓ) we arrive at the a-orthogonal decomposition V =V1a· · · ⊕aVNaVeΓ.

(9)

The Schur complement S is the FE-discretization of the bilinear form s(uΓ, vΓ) := a(H(uΓ),H(vΓ)), uΓ, vΓ ∈VΓ,

in the base ϕΓinΓ

i=1. The latter can be deduced from S =

−AΓ,I AI,I−1

IΓ AI,I AI,Γ

AΓ,I AΓ,Γ − AI,I−1

AI IΓ

,

where the transformation factors consist of nodal coordinates of (ϕeΓi)ni=1Γ . Finally, we take a closer look at the last transformation determined by the factorRH in (8). It transforms functions to the linear interpolation from its vertex values along all the skeleton edges. We denote this interpolation operator by IH :C0(Ω) →C0(Ω), IH(v)(x) :=PnV

i=1v(xViHi (x). In partic- ular, IH ϕVi

Hi , see (6). Since the latter are discrete harmonic, we end up with the following decomposition

V =V|1a· · · ⊕{z aVN}

=:VI

a(VeE+VH)

| {z }

=eVΓ

, (10)

whereVH :=IH(V),VeE :=H V −VH

=HPM i=1ViE

. Therefore, every u=uI+uE+uV∈V admits the unique decomposition

u=ueIa ueE+uH ,

whereuH :=IH(u),euE=H u−uH

, and euI:=u−euE−uH. The quadratic forms now read as follows:

a(u, u) = XN

i=1

a ueIi,euIi

| {z }

=a(euI,euI)

+ XM i,j=1

a ueEi,ueEj

| {z }

=a(ueE,euE)

+2a euE, uH

+a uH, uH ,(11)

ba(u, u) = XN

i=1

a ueIi,euIi +

XM i=1

a ueEi,ueEi

+a uH, uH

(12) with ueI =PN

i=1ueIi,ueIi ∈Vi and ueE=PM

i=1ueEi ,ueEi ∈ H ViE .

(10)

3.2 Upper bound

Theorem 1. For all u∈V we have

a(u, u)≤10ba(u, u), i.e., λmax := 10.

Proof. Let us take an arbitrary u ∈ V and its unique splitting u = uIa

e

uE+uH

. For each skeleton edge Ei we define its edge-neighbourhood Ni :={j ∈ {1, . . . , M}: i6=j and ∃k ∈ {1, . . . , N}: Ei, Ej ⊂∂Ωk}. Since |Ni| ≤4, as each skeleton edge Ei is associated to at most four other edges via two subdomains, and j ∈Ni ⇔i∈Nj, using 2a(v, w)≤a(v, v) + a(w, w),

a ueE,ueE

= XM

i=1

XM j=1

a euEi,euEj

= XM

i=1

(

a euEi,ueEi

+X

j∈Ni

a ueEi,ueEj)

≤ XM

i=1

(

a euEi,euEi

+ X

j∈Ni

1 2

a ueEi,euEi

+a ueEj,euEj)

1 + 4 2

XM

i=1

a ueEi ,euEi + 4

2 XM

j=1

a ueEj,euEj

= 5 XM

i=1

a ueEi,ueEi .

Using the latter estimate the mixed term is estimated as follows:

a ueE, uH

≤ 1 2

a euE,ueE

+a uH, uH

≤ 5 2

XM i=1

a ueEi ,ueEi +1

2a uH, uH .

Combining the estimates completes the proof with λmax := 10, a(u, u)≤a ueI,ueI

+ 10 XM

i=1

a ueEi ,euEi

+ 2a uH, uH

≤10ba(u, u).

(11)

3.3 Shape-regular quasi-uniform triangulations

Assumption 1. Let us assume that the fine triangulation is from a family of shape-regular discretizations by which we mean that there exists αmin ∈ (0, π/3i independent ofh such that every angle in the FE-triangulation, thus also in the domain decomposition, is bounded by αmin from below. Shape- regularity guarantees the angles to be bounded from above by αmax := π − 2αmin. From the law of sines we have a uniform upper bound on the ratio between the largest and shortest edge of a triangle Ti or a subdomain Ωi, i.e.,

himax himin,Hmaxi

Hmini

1, 1 sinαmin

. (13)

For the sake of simplicity we assume that to each xVk being a corner of Ωi

there is exactly one adjacent triangle T such that T ⊂Ωi.

Assumption 2. Let us further assume that both the fine and coarse triangu- lations are from families of quasi-uniform discretizations by which we mean that there exists a common constant CA2 ∈ (0,1i independent of h and H such that for every triangle Ti and every subdomain Ωi the diameter himax and Hmaxi , respectively, is bounded

himax ≥CA2h, Hmaxi ≥CA2H. (14) For the sake of simplicity we assume that H ≥2h.

We will need a discrete Sobolev inequality for the FE-functions.

Lemma 1. Given a linear function v on a triangle with vertices A, B, C and an angle α at A, we have

k∇vk2≤ 2 [(v(B)−v(A))2+ (v(C)−v(A))2] min{kB−Ak2,kC−Ak2} sin2α .

Proof. We introduce the coordinate system such that A is in the origin and the line segment AB is the x1-axis, then

∂v

∂x1

= v(B)−v(A)

kB−Ak , cosα ∂v

∂x1

+ sinα ∂v

∂x2

= v(C)−v(A) kC−Ak =: dv

ds.

(12)

The assertion follows from the following manipulations:

k∇vk2 = ∂v

∂x1

2

+ 1

sin2α dv

ds −cosα ∂v

∂x1

2

≤ 1 sin2α

"

sin2α ∂v

∂x1

2

+ 2 dv

ds 2

+ 2 cos2α ∂v

∂x1

2#

≤ 2 sin2α

"

∂v

∂x1

2

+ dv

ds 2#

.

Corollary 1. Under Assumptions 1 and 2 there exists CC1 >0 such that

∀i∈ {1, . . . , N} ∀u ∈V : hk∇ukL(Ωi)≤CC1kukL(Ωi). (15)

Proof. For x ∈ Tj ⊂ Ωi with vertices A, B, C Assumption 1 and Lemma 1 yield

k∇u(x)k ≤

√2 hjmin sinαmin

p4u(A)2+ 2u(B)2+ 2u(C)2 ≤ 4kukL(Ωi)

hjmin sinαmin. The assertion follows from (13) and (14)

k∇u(x)k ≤ 4kukL(Ωi)

hjmax sin2αmin ≤ 1 h

4 CA2 sin2αmin

| {z }

=:CC1

kukL(Ωi).

3.4 Stability of the coarse space

The next lemma is crucial for the stability of the coarse space in the energy norm. We are inspired by the proof of Bramble, Pasciak, and Schatz in [1, L.3.3].

Lemma 2. Under Assumptions 1 and 2 there exists CL2 > 0 such that for all i∈ {1, . . . , N}

∀u∈V : kuk2L(Ωi) ≤CL2

1 + lnH h

1

H2kuk2L2(Ωi)+|u|2H1(Ωi)

.

(13)

Proof. Without a loss of generality, assume thatkukL(Ωi) =|u(0)|. We shall find an open cone Λ0,KH,γ ⊂ Ωi with the vertex at the origin 0, the radius KH and the angleγ :=αmin withK independent ofH. For the construction of Λ0,KH,γ we refer to Fig. 2 and the following description. Denote by da, db, and dc the distances of the origin to the prolongations of the sides of Ωi with lengths a, b, and c, respectively, and assume that da is the largest distance. We choose KHe :=da. We take the open cone ΛA,KH,αe ⊂Ωi at the vertex Aof Ωi that is opposite to the sidea, where αdenotes the angle atA.

By moving ΛA,KH,αe to the origin we get the cone Λ0,KH,αe ⊂ Ωi. It remains to find K > 0 independent of H such that K ≤ K. The areae |Ωi| can be estimated as follows

|Ωi|= a da+b db+c dc

2 ≤ a+b+c 2 K H.e

By (14) and (13) we have an H-independent estimate for the constant Ke Ke ≥2

1

2Hmaxi Hmini sinαmin

3Hmaxi H ≥ CA2 3

Hmini sinαmin

Hmaxi ≥ CA2

3 sin2αmin=:K.

The construction of Λ0,KH,γ is completed by shortening the radius and the angle of Λ0,KH,αe .

i

A

B

C 0

a

b

c da

db dc

α

γ ΛA,KH,αe Λ0,KH,αe

Λ0,KH,γ

y1

y2

Figure 2: Construction of Λ0,KH,γ.

We consider the coordinate system according to a side of Λ0,KH,γ. For y(ρ, ϑ) =ρ(cosϑ,sinϑ)∈Λ0,KH,γ the fundamental theorem of calculus gives

u(0) =u(y(ρ, ϑ))− Z ρ

0 ∇u(y(t, ϑ)) (cosϑ,sinϑ)

| {z }

=:u(t,ϑ)

dt.

(14)

Integrating ϑ from 0 to γ and applying the triangle inequality yield γ|u(0)| ≤

Z γ 0

u(y(ρ, ϑ))dϑ +

Z γ 0

Z ρ 0

ut(t, ϑ)dt dϑ

. (16) Choose, independently of h and H,δ := min{(√

2−1)/(√

2CC1), K}, where CC1 is the constant in (15). We shall consider two cases. First, if δh < ρ, the Cauchy-Schwarz and triangle inequalities yield

γ|u(0)| ≤√ γ

sZ γ 0

u2(y(ρ, ϑ))dϑ+

Z γ 0

Z δh 0

ut(t, ϑ)dt dϑ +

Z γ 0

Z ρ δh

ut(t, ϑ)dt dϑ

. (17) The second and third term in (17) can be estimated as follows:

Z γ 0

Z δh 0

ut(t, ϑ)dt dϑ

≤γ δ hk∇ukL(Ωi) ≤γ δ CC1|u(0)|,

Z γ

0

Z ρ δh

ut(t, ϑ)dt dϑ =

Z

Λ0,ρ,γ0,δh,γ

∇u(y) y kyk2dy

≤ k∇ukL2(Ωi)√γ r

ln ρ δh.

Using the estimates, moving the second term from the right-hand side of (17) to the left, squaring the inequality and dividing by γ2 yield

1

2|u(0)|2 ≤(1−δ CC1)2|u(0)|2 ≤ 2 γ

Z γ 0

u2(y(ρ, ϑ))dϑ+ ln ρ

δhk∇uk2L2(Ωi)

. (18) In the second case, δh≥ρ, we estimate the first term on the right-hand side of (16) by the Cauchy-Schwarz inequality and the second term byγ δ CC1|u(0)|, which leads to

1

2|u(0)|2 ≤(1−δ CC1)2|u(0)|2 ≤ 2 γ

Z γ 0

u2(y(ρ, ϑ))dϑ. (19) Multiplying (18) and (19) by 2ρ, integrating ρ from δh to KH and from 0 to δh, respectively, and summing up the resulting inequalities yield

(KH)2

2 |u(0)|2 ≤ 4 γ

Z KH 0

Z γ 0

ρ u2(y(ρ, ϑ))dϑ dρ +k∇uk2L2(Ωi)

Z KH δh

ρ ln ρ δhdρ

.

(15)

By estimating the second term on the right-hand side we complete the proof

|u(0)|2 ≤ 4 γ

2

(KH)2 kuk2L2(Ωi)+

lnK

δ + lnH h

|u|2H1(Ωi)

≤ 4 γ max

1, 2

K2,lnK δ

| {z }

=:CL2

1 + lnH h

1

H2 kuk2L2(Ωi)+|u|2H1(Ωi)

.

Corollary 2. Under Assumptions 1 and 2 there existsCC2>0such that for all i∈ {1, . . . , N}

∀u∈V : ku−uik2L(Ωi) ≤CC2

1 + lnH h

|u|2H1(Ωi), where ui := |Ω1

i|

R

iu(x)dx with |Ωi| being the area of Ωi.

Proof. Combining the previous lemma and the Poincar´e inequality [8]

ku−uik2L2(Ωi) ≤CPH2|u|2H1(Ωi),

where CP:= 1/π2, the assertion follows with CC2:=CL2(1 +CP).

The next lemma gives stability of the coarse space. It can be found in [9, L.4.12].

Lemma 3. Under Assumptions 1 and 2 there exists CL3 > 0 such that for all i∈ {1, . . . , N}

∀u∈ V : IH(u)2

H1(Ωi)≤CL3

1 + lnH h

|u|2H1(Ωi), as a consequence of which

∀u∈V : a(uH, uH)≤CL3

1 + lnH h

a(u, u).

(16)

Proof. Denote by P1, P2, andP3 the vertices of a subdomain Ωi. We have IH(u)2H1(Ω

i)=IH(u)−ui

2H1(Ω

i) =

X3 j=1

(u(Pj)−uiHj

2

H1(Ωi)

. (20) Forj ∈ {1,2,3}and the remaining indicesk and l we employ Lemma 1 with A :=Pk,α :=αk the angle atPk, B :=Pj, andC :=Pl and using (13) yield

Hj |2H1(Ωi) =k∇ϕHj k2|Ωi| ≤ 2· 12kPj −Pkk kPl−Pkk sinαk

min{kPj −Pkk2,kPl−Pkk2}sin2αk

≤ Hmaxi

Hmini sinαk ≤ 1 sin2αmin

=:ec, where |Ωi| denotes the area of Ωi. By (20) and Corollary 2 we have IH(u)2

H1(Ωi)≤3 X3

j=1

|u(Pj)−ui|2Hj |2H1(Ωi)≤9ec CC2

1 + lnH h

|u|2H1(Ωi),

which completes the proof with CL3 := 9ec CC2.

3.5 Stability of the edge space

To findλmin it remains to estimate the edge-term in (12) by (11) from above.

Being inspired by [9, L.4.23] we introduce a system of edge-based functions (θi(x))Mi=1 ⊂C(Ω), wheree Ω := Ωe \

xVj :j = 1, . . . , nV . For the construction we refer to Fig. 3 and the following paragraph.

We decompose each subdomain Ωj,j ∈ {1,2, . . . , N}, with all three edges being a part of the skeleton, i.e.,Ej1, Ej2, Ej3 ⊂Γ, into six trianglesωk. With- out loss of generality we take x∈ ω1\ {P1} and introduce local coordinates x = (x1, x2). We denote the angle at P1 by α1 and define the related edge functions θj1, θj2, and θj3 in ω1 by

θj1(x) := 1− 2 3 tanα21

x1

x2

, θj2(x) =θj3(x) := 1 3 tanα21

x1

x2

. (21) The edge functions are analogously defined in ω2, . . . , ω6. For a subdomain Ωj with only one or two edges assigned to the skeleton the construction of the related edge functions is similar. Note that the system completed by edge-functions assigned to ∂Ω forms a partition of unity on Ω.e

(17)

Ej1

Ej2

Ej3

ω1

ω2

ω3

ω4

ω5

ω6 x x1

x2

P1

P2

P3

α1 α1/2

α2

α2/2

α3

α3/2

Figure 3: Decomposition of Ωj used for the construction of θj1, θj2, and θj3. Lemma 4. Under Assumption 1 there exists CL4 > 0 such that for all i ∈ {1, . . . , M}

k∇θi(x)k ≤CL4/rH(x) almost everywhere in Ω,e where, for x∈Ωj with the verticesP1, P2, and P3, rH(x) := min

k=1,2,3kx−Pkk. Proof. The assertion follows from the construction above. For x∈ω1: k∇θj1(x)k= 2

3 tanα21

p(x1)2+ (x2)2

(x2)2 ≤ 2

3 tanαmin2 cos2 αmax2

| {z }

=:CL4

p 1

(x1)2 + (x2)2

| {z }

≤1/rH(x)

by Assumption 1. The estimate holds true fork∇θj2(x)kandk∇θj3(x)k. The other cases, x∈ωk, are analogous.

Similarly to replacing the FE-projection by interpolation when estimat- ing the FE-approximation error, we will estimate the energy of the FE- interpolation of θi(u − uH), rather than the energy of ueEi. We need the following, so-called edge lemma, the proof of which is sketched in [2].

(18)

Lemma 5. Under Assumptions 1 and 2 there exists CL5 > 0 such that for all edges Ei, i∈ {1, . . . , M}, both the adjacent domains Ωj, Ei ⊂∂Ωj, and

∀u∈V : |Ihiw)|2H1(Ωj) ≤CL5

1 + lnH h

kwk2L(Ωj)+|w|2H1(Ωj)

, (22) where w := u−uH and Ih : C0(Ω) → V is the FE-interpolation operator, i.e., Ih(v)(x) :=Pn

i=1v(xii(x), where xi is the node related to ϕi.

Proof. Let us take an edge Ei and an adjacent domain Ωj. By Assumption 1 to each coarse vertex Pk, k = 1,2,3, of Ωj an exactly one fine triangle T with vertices A = Pk, B, and C is associated. In the case that none of B and C lies on Ei, Ihiw) vanishes on T. We are left to analyze the other two triangles, for both of which we can consider C ∈ Ei. The contribution of such a triangle to |Ihiw)|2H1(Ωj) is, using (13), as follows:

Ihiw)2

H1(T) = w2(C) kC−Ak2 sin2α

kB−Ak kC−Ak sinα 2

≤ hTmax

2hTmin sinαminw2(C)≤ 1 2 sin2αmin

| {z }

=:ek1

kwk2L(Ωj). (23)

In case of a triangle T ⊂ Ωj that none of its vertices A, B, and C is a vertex of Ωj, Lemma 1 yields

∇Ihiw)2 ≤ 2

[(θiw)(B)−(θiw)(A)]2+ [(θiw)(C)−(θiw)(A)]2 min{kB −Ak2,kC−Ak2} sin2α , whereαdenotes the angle atA. Sinceθiwis piecewise differentiable along the line segments AB andAC, we can adopt the Lagrange mean value theorem.

The latter combined with (13), the construction (21), and Lemma 4 yields ∇Ihiw)2 ≤ 2k∇(θiw)k2L(T)

sin2α

kB−Ak2+kC−Ak2 min{kB −Ak2,kC−Ak2}

| {z }

≤1+(hTmax/hTmin)2

≤ 4

1 + sin21αmin

sin2αmin

| {z }

=:ek2

k∇θik2L(T)kwk2L(T)+kθik2L(T)k∇wk2L(T)

≤ek2 n

CL4/rH,h(x)2

kwk2L(T)+k∇wk2L(T)

o,

(19)

wherek∇fkL(T):= ess sup

x∈T k∇f(x)kandrH,h(x) := dist(T(x),{P1, P2, P3}), whereT(x) is the open triangle containingx, which is a well-defined function up to the interfaces between fine triangles. Denote by Ωej the union of such non-corner triangles. They contribute to |Ihiw)|2H1(Ωj) as follows:

Ihiw)2

H1(ej)≤ek2

(

kwk2L(Ωj) (CL4)2 Z

ej

1/rH,h(x)2

dx+|w|2H1(ej)

) . (24) It remains to estimate the integral. We have

Z

ej

1

(rH,h(x))2 dx≤ X3 k=1

Z

ej

1

y∈Tinf(x)ky−Pkk2dx. (25) Let us introduce three systems of local polar coordinates so that, each of which has the respective origin at a coarse vertex Pk, the x1-axis coincides with an edge of Ωj, and Ωj lies in the upper half-space. We denote by vminT the smallest height of a triangle T. The law of sines, Assumptions 1 and 2 yield

vTmin ≥hTmin sinαmin ≥hTmax sin2αmin ≥CA2h sin2αmin. Thus, by choosing c:=CA2 sin2αmin the domain

Λ :=

x= (x1, x2) =ρ(cosα,sinα)∈R2 : ch≤ρ≤H and 0≤α≤αmax

covers Ωej with respect to each of the coordinate systems. Let us denote the respective counterparts of Λ associated toP1,P2, andP3 by Λ1, Λ2, and Λ3. Let us adopt the k-th local polar coordinatesx(ρ, α) and note that

y∈Tinf(x(ρ,α))ky−Pkk ≥max{ch, ρ−h}. We have the estimate

Z

ej

1

y∈Tinf(x)ky−Pkk2 dx≤

αZmax

0

ZH ch

ρ

(max{ch,(ρ−h)})2 dρ dα

max

2c+ 1

2c2 + lnH−h ch + h

ch− h H−h

≤αmax

4c+ 1 2c2

| {z }

=:ec

+ ln H ch

,

(20)

where we used H ≥2h from Assumption 2. Using the latter and (25), (24) is estimated by

Ihiw)2

H1(ej) ≤ek2

kwk2L(Ωj) (CL4)2max

ec+ ln H ch

+|w|2H1(ej)

.

After adding the two contributions (23), the assertion follows with CL5 := maxn

3ek2(CL4)2αmax (ec−lnc) + 2ek1,3ek2(CL4)2αmax,ek2

o.

Now we can analyze the stability of the edge space. The following lemma is proven in [9].

Lemma 6. Under Assumptions 1 and 2 there exists CL6 >0 such that

∀u∈V : XM

i=1

a ueEi ,euEi

≤CL6

1 + lnH h

2

a(u, u).

Proof. Denote by Ωi1 and Ωi2 domains adjacent to Ei and by{Eji}Mi=1j,Mj ≤ 3, edges adjacent to Ωj. Recall thatw:=u−IH(u) andeuEi :=H(wEi), where wEi :=w on Ei and wiE := 0 elsewhere on Γ∪∂Ω. The discrete harmonicity of ueEi and Lemma 5 yield

XM i=1

a ueEi ,euEi

= XM

i=1

X2 j=1

ρij euEi2

H1(Ωij) ≤ XM

i=1

X2 j=1

ρijIhiw)2

H1(Ωij)

= XN

j=1

ρj Mj

X

i=1

Ihjiw)2

H1(Ωj)

≤ XN

j=1

ρj3CL5

1 + lnH h

kwk2L(Ωj)+|w|2H1(Ωj)

.

Now (α+β)2 ≤2(α22) and Corollary 2 give kwk2L(Ωj)=k(u−uj)−(IH(u)−uj)k2L(Ωj)

≤2

ku−ujk2L(Ωj)+IH(u)−uj2

L(Ωj)

| {z }

≤ku−ujk2L(Ωj)

≤4CC2

1 + lnH h

|u|2H1(Ωj).

(21)

Similarly, Lemma 3 gives

|w|2H1(Ωj)=u−IH(u)2

H1(Ωj) ≤2

|u|2H1(Ωj)+IH(u)2

H1(Ωj)

≤2 (1 +CL3)

1 + lnH h

|u|2H1(Ωj). Combining the estimates yields CL6 := 3CL5[4CC2+ 2(1 +CL3)].

3.6 Lower bound

Theorem 2. Under Assumptions 1 and 2 there exists C >0 such that

∀u∈V : ba(u, u)≤C

1 + lnH h

2

| {z }

=1/λmin(H,h)

a(u, u).

Proof. Comparing (11) and (12), the assertion is a consequence of Lemma 3 and 6 with C := 1 +CL3+CL6.

We conclude with an estimate of the condition number κ

Ab−1A

≤10C

1 + lnH h

2

with C > 0 independent of H, h, and (ρi)Ni=1 in a family of shape-regular quasi-uniform triangulations.

References

[1] J.H. Bramble, J.E. Pasciak, A.H. Schatz: The construction of precon- ditioners for elliptic problems by substructuring, I. Math. Comp. 47 (1986), 103–134. Zbl 0615.65112, MR 842125

[2] M. Dryja, O.B. Widlund: Some domain decomposition algorithms for elliptic problems. In Iterative Methods for Large Linear Systems, 273–

291. Academic Press, 1989.

Odkazy

Související dokumenty

Ge, “Existence of multiple positive solutions for multipoint boundary value problems with a one-dimensional p-Laplacian,” Nonlinear Analysis: Theory, Methods &amp; Applications,

[5] Habets P., Omari P.: Existence and localization of solutions of second order elliptic boundary value problem using lower and upper solutions in the reversed

Before proceeding to solve equation (29), we require a simple result concerning elliptic functions... For transcendental meromorphic solutions of order n/2, we give

Wu, “Positive solutions of two-point boundary value problems for systems of nonlinear second-order singular and impulsive differential equations,” Nonlinear Analysis: Theory,

In Subsection 1.2 we prove the existence theorem under an assumption on the boundary data g that is reminiscent of the compatibility conditions in the theory of 1st

[2] Agmon S., Douglis A., Nirenberg L., Estimates near the boundary for solutions of elliptic partial differential equations satisfying general boundary conditions, I, Comm..

Wiener’s criterion for the regularity of a boundary point with respect to the Dirichlet problem for the Laplace equation [71] has been extended to various classes of elliptic

In this paper, we obtained the three-dimensional Pauli equation for a spin-1/2 particle in the presence of an electromagnetic field in a noncommutative phase-space as well as