• Keine Ergebnisse gefunden

4.2 Finite element approximation with Taylor-Hood and Raviart-Thomas

4.2.2 Computational considerations

CHAPTER 4. DISCRETIZATION OF THE WEAK FORMULATION 48











A(1)11 A(1)12 (B(1)1 )T A(I)11 A(I)12 0 0 A(1)21 A(1)22 (B(1)2 )T A(I)21 A(I)22 0 0 B1(1) B2(1) 0 B1(I) B2(I) 0 0 (A(I)11)T (A(I)21)T (B1(I))T C11(I) C12(I) 0 0 (A(I)12)T (A(I)22)T (B2(I))T C21(I) C22(I)+D (A)T B

0 0 0 0 A A(2) B(2)

0 0 0 0 (B)T (B(2))T 0











| {z }

Kh:=









 u(1)1 u(1)2 p(1) u(I)1 u(I)2 c p(2)











=











f(1)

11

f(1)12 f(1)

2

f(I)

11

f(I)

12

f(2)

1

f(2)

2











(4.79) This matrix form can be displayed more clearly in the following way:







AStokes BStokesT A(I)Stokes 0 0

BStokes 0 BStokes(I) 0 0

(A(I)Stokes)T (BStokes(I) )T C(I) [0A]T [0 (B)T]T

0 0 [0A] ADarcy BDarcy

0 0 [0 (B)T] BDarcyT 0











uStokes pStokes

uInterf ace cDarcy pDarcy





=







f1,Stokes

f2,Stokes

f(I) f1,Darcy

f2,Darcy







(4.80) Here we want to point out that in the left upper part of our discretization matrix the 2×2 block discretization matrix for the usual Stokes problem occurs and in the right lower part the2×2block discretization matrix for the Darcy equations emerges. The other appearing matrices are referable to the coupling of the Stokes and the Darcy equations.

y

x 1

0

-1

1

bb

b bb

bbb b b

b b bcbcbcbcbc

bc

bc

bc

bcbcbcbcbc bbc

degrees of freedom for the velocity inΩ1

dirichlet nodes for the velocity onΓ1 degrees of freedom for the velocity inΩ2

known normal components of the velocity onΓ2

Figure 4.3: Degrees of freedom for approximating the velocity u.

For the integral approximation the following Gauss quadrature rule of degree 2 on the reference triangle is used:

1 0

1y 0

f(x, y)dx dy= 1

6(f(0,1

2) +f(1

2,0) +f(1 2,1

2)), (4.81) see [8]. This quadrature formula is exact for arbitrary polynomials of degree 2.

For the approximation of the appearing integrals over the edges on ΓI in the bilinear form a1 we rst transform them to an integral over the reference edge with length1and then we use the Newton Cotes formula (see, e.g. [11]) of degree n = 4 (Milne rule)

1

0

f(t)dt =h

4 i=0

αif(xi) (4.82)

with weights 1445,6445,2445,6445 and 1445 and sampling points xi =ih, i= 0, . . .4, with h= n1. We use the Milne rule because it is exact for polynomials of degree 4. The linear shape functions on the reference triangle are given by

N1 = 1−x−y, (4.83)

N2 = x, (4.84)

N3 = y. (4.85)

CHAPTER 4. DISCRETIZATION OF THE WEAK FORMULATION 50 y

x 1

0

-1

1

bb bb

bbb b b b

*

* * *

*

*

* *

*

degrees of freedom for the pressure inΩ1 degrees of freedom for the pressure inΩ2

Figure 4.4: Degrees of freedom for approximating the pressure p.

The quadratic shape functions on the reference triangle are given by

N1 = 13x3y+ 4xy+ 2x2+ 2y2, (4.86)

N2 = −x+ 2x2, (4.87)

N3 = −y+ 2y2, (4.88)

N4 = 4x4xy4x2, (4.89)

N5 = 4xy, (4.90)

N6 = 4y4xy4y2. (4.91)

Before we write down the explicit form of our basis functionsϕE, E∈ E2, we want to clarify the notation for elements with a common edge E ∈ E2 and determine the orientation of nE by the next denition.

Denition 4.4. [2, Def 4.2] Let T± =conv{E∪ {P±}} for the vertex P± opposite to E of T± such that the edge E = conv{A, B} orients from A to B. Then nE points outward fromT+ to T (see Figure 4.5) with a positive sign. If E is an exterior edge, i.e., E ∈ Eh2)∪ EhI), then n2 =nE is the exterior normal and E ⊂∂T+ denes T+ (and T is undened).

Note that the normal direction depends on the orientation of the edge E = conv{A, B}. Hence, we choose the orientation of E ∈ E2 in such a way that

for all interior edges it is arbitrary but xed and for the edges on the boundary it is chosen such thatnE coincides with the exterior normal vector n2.

Now we can move on to the denition of the edge-basis functions for the lowest-order Raviart-Thomas nite element space.

Denition 4.5. [2, Def 4.3] Given an edge E ∈ E2 there are either two elements T+ and T in T2h with the joint edge E =∂T+∩∂T or there is exactly one element T+ in T2h with E ∂T+. Then if T± = conv{E∪ {P±}} for the vertex P± opposite to E of T± set

ϕE(x, y) :=

{±2||ET±||((x, y)−P±), for (x, y)∈T±,

0, elsewhere. (4.92)

Lemma 4.6. [2, Lemma 4.1] There hold 1. ϕE ·nE =

{

0, along (∪E2)\E, 1, along E;

2. ϕE ∈H(div,2);

3. E :E ∈ E2} is a basis of RT0(T);

4. divϕE =

{±||TE±||, on T±, 0, elsewhere.

Proof. For a proof see [2].

B

P

+

A

P

E n

E

T

+

T

Figure 4.5: Orientation ofnE.

The assembling of the matrices in Kh associated to the Darcy region and the Matlab implementation of right-hand sides and Neumann conditions is done following section 4 and 6 of [2]. Note that before we solve the algebraic problem we project the

CHAPTER 4. DISCRETIZATION OF THE WEAK FORMULATION 52 right hand side into the orthogonal space of the kernel. Since we approximated the appearing integrals on the right hand side with quadrature formulas, the computation was not exact. We use projection to guarantee orthogonality to the kernel, which implies solvability of the algebraic problem. Let f be the right hand side of the algebraic formulation of the coupled Stokes-Darcy problem and let x0 be an element of the kernel of the stiness matrix Kh, i.e. x0 ker{Kh}, then the projection f˜:=f+αx0 shall fulll

f +αx0 ⊥x0 (4.93)

which is equivalent to

f ·x0 +αx0 ·x0 = 0. (4.94)

Therefore we get

α=−f·x0

x0·x0. (4.95)

Note that for the vector x0 ker{Kh} we choose a vector consisting of one and zero entries. For the velocity nodes the corresponding entries are zero and for pressure nodes the corresponding entries are equal 1.

After the assembling of the stiness matrix Kh and the right hand side we x one degree of freedom for the pressure. This means that we delete the corresponding row and column ofKh and the corresponding entry in the right hand side. The so obtained system of equations is solved with the backslash operator in Matlab. Note that Matlab uses a LU factorization for that. Remember that as a last step we have to subtract the mean value ofph from the computed solutionph to get the seeked solution in Mh.

Convergence rate:

First we indicate that u = ug+ω, where ug Vg and ω V is the solution of the homogenized problem.

Before we discuss the convergence of the discrete solution to the Stokes-Darcy problem using Taylor-Hood and Raviart-Thomas elements we collect some denitions of interpolation operators and estimates from [9] and the references therein.

First let IVh :W →Vh,0 be the interpolation operator where W is the subspace of suciently smooth functions

W := {v = (v1, v2)∈X :vi ∈Wi :=Xi(Hsi(Ωi))2, i= 1,2 and v1·n2|ΓI =v2·n2|ΓI inL2I)},

wherebysi is chosen suciently large. We deneIVh := (IXh

1v1, IXh

2v2−δ2h) :W →Vh,0, whereIXhi :Wi →Xih,0, i= 1,2are nite element interpolation operators andδ2h is the correction such that the continuity of the normal velocities is guaranteed in a discrete sense across the interface ΓI. We dene δ2h := IXh2v1 −IXh2(IXh1v1). For more detailed information of the construction of the correction δ2h see [9].

In our case the interpolation operator IVh can be interpreted in the following way.

We constructIXh1ω1 inX1h,0as a linear combination of the basis functions inX1h,0where

we use the function values of the exact solutionω1 in the corresponding interior nodes as coecients. The interpolated functionIXh2ω2−δh2 is a linear combination of the edge basis functions in X2h,0. The corresponding coecients are the normal components of the exact solutionω2in the midpoints of the edges except for the edges on the interface.

There we use equation (4.63) to compute the normal components of ω2.

Due to Proposition 4.2 in the paper of Layton, Schieweck an Yotov [9] we know that for all ω∈W ⊂V

∥ω−IVhω∥=O(hT). (4.96) Remember that IMh

1 :M1∩H2(Ω1)→M1h is the interpolation operator such that

∥q1−IMh

1q10,T ≤Ch2T|q1|2,T (4.97) and IMh

2 :M2 →M2h is the L2-orthogonal projection such that for all q2 ∈M2 (IMh

2q2−q2, qh2)0,Ω2 = 0 for all q2h ∈M2h and

∥q2−IMh2q20,T ≤ChT|q2|1,T. (4.98) Next, let IMh := (IMh

1p1, IMh

2p2) :M →M1h×M2h be the interpolation operator for the pressure functions inM.

From (4.97) and (4.98) we get that ∥p1 IMh1p1M1 = O(h2T) and

∥p2−IMh

2p2M2 =O(hT), respectively. This implies

∥p−IMh p∥M = (∥p1−IMh

1p12M1 +∥p2−IMh

2p22M2)1/2 =O(hT). (4.99) Since X1h and M1h contain polynomials of degree r1 = 2 and r1 1 = 1 and X2h andM2h contain polynomials of degreer2 = 0 and l2 = 0, respectively we know due to Theorem 4.3 that

∥ω−ωhX +∥p−phM =O(hrT1 +hrT2+1+hlT2+1) = O(hT), (4.100) which means that the convergence rate is equal one. If we halve the mesh width h then also the discretization error halves itself.

Note that all statements and estimates which hold for the homogeneous problem can also be shown for the inhomogeneous case.

Chapter 5

Numerical results

In this chapter we want to verify the error estimate in Theorem 4.3, which is based on Layton, Schieweck and Yotov [9], with a numerical experiment.

We consider the following concrete problem: Find u1, u2, p1 and p2 such that the equations

divT(u1, p1) = f1 in Ω1 (balance of momentum), (5.1) divu1 = 0 in Ω1 (conservation of mass), (5.2) u1 =g1 on Γ1 (boundary condition), (5.3) u2 =−K∇p2 in Ω2 (Darcy's law), (5.4) divu2 =f2 in Ω2 (balance of mass), (5.5) u2·n2 =g2 on Γ2 (boundary condition), (5.6) u1·n1+u2 ·n2 = 0 on ΓI (conservation of mass), (5.7) p12µD(u1)n1·n1 =p2 on ΓI (balance of normal forces), (5.8) u1·τ1 =

k˜1

µα (−⃗t(u1, p1))·τ1, on ΓI (Beavers-Joseph-Saman cond.), (5.9) are fullled for the uid region Ω1 = (0,1) × (0,1), the porous medium region Ω2 = (0,1)×(1,0), the interface ΓI = (0,1)× {0} and for the functions g1, g2, f1

and f2, which are given by g1 :=

( cos(πx) sin(πy) sin(πx) cos(πy)

)

, g2 :=



sin(πy) on {0} ×(0,1) sin(πx) on (0,1)× {−1}

sin(πy) on {1} ×(0,1) ,

f1 :=

( (4π2+ 1) cos(πx) sin(πy)

sin(πx) cos(πy)

)

, f2 :=2πsin(πx) sin(πy), Furthermore we setα =µ= 1 and K =I. Note thatτ1 =

( 1 0

) . The exact solution to this problem is

u1 =

( cos(πx) sin(πy) sin(πx) cos(πy)

)

, p1 =sin(πx) sin(πy)(1

π + 2π) + 4 π, 54

Mesh width h 101 201 401 801 Error: ∥IVhu−uhX +∥IMhp−phM 0.0854 0.021 0.0052 0.0013 Table 5.1: The error∥IVhu−uhX +∥IMh p−phM computed for dierent meshes.

u2 =

( cos(πx) sin(πy) sin(πx) cos(πy)

)

, p2 =1

πsin(πx) sin(πy) + 4 π. The approximated solutions are depicted in Figure 5.1 and Figure 5.2.

Remember that we know due to Theorem 4.3 that

∥u−uhX +∥p−phM =O(hT). (5.10) Now we want to illustrate that our numerical results are in good agreement with this error estimation. Note that we computed the error between the interpolated solutionsu, pand the approximated solutions uh, ph since it is easier to compute than

∥u−uhX +∥p−phM. Let h be the short side of the triangles in our uniform grid.

In Table 5.1 we can observe that if we halve the mesh width h then the error between the interpolated solutions u, p and the approximated solutions uh, ph is divided by a factor around 4. This means that ∥IVhu−uh+∥IMh p−ph= O(h2). However, from the triangular inequality and from (4.96) and (4.99) we get that the disretization error satises

∥u−uhX+∥p−phM ≤ ∥|u−{zIVhu∥X}

=O(h)

+|p−{zIMh p∥M}

=O(h)

+|IVhu−uhX +{z∥IMh p−phM}

=O(h2)

.

This means that the discretization error for our model problem

∥u−uhX +∥p−phM is equal toO(h)which coincides with the error estimate (5.10).

CHAPTER 5. NUMERICAL RESULTS 56

Figure 5.1: Computed solution for the velocity u plotted in the midpoints of the elements.

Figure 5.2: Computed solution for the pressure p in the Stokes and the Darcy region.

Chapter 6 Conclusion

In this thesis we considered a Stokes ow and a porous media ow coupled across an interface through appropriate interface conditions. We gured out that the in-terface condition by Beavers and Joseph does not t in our problem setting but the Beavers-Joseph-Saman condition leads us to a well posed problem. We derived a weak formulation for our model problem and also other possible formulations were discussed. We showed boundedness, ellipticity and the inf-sup condition for the re-spective bilinear forms and we concluded from Brezzi's theorem the well-posedness of the Stokes-Darcy problem.

Then we treated the discrete problem for which we also veried existence and uniqueness of a solution. Note that while the verication of the boundedness and ellipticity was rather simple, the proof of the discrete inf-sup condition was quite elaborate. In the next step we exhibited a possible nite element discretization, where we used Taylor-Hood elements in the uid region and Raviart-Thomas elements in the porous medium region. We took a closer look at the characterization of the discrete velocity and how the degrees of freedom are linked on the interface. Then we showed the resulting matrix form of the problem and gave short computational explanations and hints.

In the end we presented numerical results and conrmed that the behaviour of the error between the exact and approximated solution is in good agreement with the error estimation obtained from theory.

58

Bibliography

[1] R. A. Adams. Sobolev Spaces. Academic Press, 1975.

[2] C. Bahriawati and C. Carstensen. Three matlab implementations of the lowest-order Raviart-Thomas MFEM with a posteriori error control. Computational methods in applied mathematics, Vol. 5, No. 4, pp. 333-361, 2005.

[3] D. Braess. Finite Elemente: Theorie, schnelle Löser und Anwendungen in der Elastizitätstheorie. Springer-Verlag Berlin Heidelberg, 2007.

[4] F. Brezzi and M. Fortin. Mixed and hybrid nite element methods. Springer-Verlag, New York, 1991.

[5] M. Discacciati and A. Quarteroni. Navier-Stokes/Darcy coupling: modeling, anal-ysis, and numerical approximation. Rev. Mat. Complut. 22, No. 2, 315-426, 2009.

[6] J. Galvis and M. Sarkis. Non-matching mortar discretization analysis for the coupling Stokes-Darcy equations. Electronic Transactions on Numerical Analysis, Vol. 26, pp. 350-384, 2007.

[7] V. Girault and P.-A. Raviart. Finite element methods for Navier-Stokes equations.

Theory and algorithms. Springer-Verlag, Berlin, 1986.

[8] P. C. Hammer and A. H. Stroud. Numerical Integration over Simplexes. Math.

Tables and other Aids to Computation, Vol. 10, No 55, pp. 137-139, 1956.

[9] W. J. Layton, F. Schiewek and I. Yotov. Coupling Fluid Flow with Porous Media Flow. SIAM Journal on Numerical Analysis, Vol. 40, No. 6, pp. 2195-2218, 2003.

[10] T. P. Mathew. Domain Decomposition and Iterative Renement Methods for Mixed Finite Element Discretizations of Elliptic Problems. Ph.D. thesis, Courant Institute of Mathematical Sciences, New York University, New York, 1989.

[11] J. Stoer. Numerische Mathematik 1. Springer-Verlag, Berlin, 2005 (9. Auage).

59