• No results found

2 The incompressible Navier-Stokes equations

N/A
N/A
Protected

Academic year: 2021

Share "2 The incompressible Navier-Stokes equations"

Copied!
26
0
0

Bezig met laden.... (Bekijk nu de volledige tekst)

Hele tekst

(1)

faculty of mathematics and natural sciences

Modeling turbulent flow

Bachelor Project Applied Mathematics

July 2016 Student: Leo Sok

First supervisor: Prof.dr.ir. R.W.C.P. Verstappen Second supervisor: Dr. M.A. Grzegorczyk

(2)

Abstract

Fluid flow is mathematically modelled by the Navier-Stokes equations.

In this thesis we will focus at turbulent flows. Therefore we will first look at the incompressible Navier-Stokes equations. To simulate turbu- lent flows with the incompressible Navier-Stokes, it is important that the kinetic energy of the flow is conserved. Therefore, we will derive the conservation of the kinetic energy. Then we will discretize the Navier- Stokes equations using the finite volume method and derive in this case the kinetic energy. At last we will derive a model called the QR model.

Therefore we start with a large eddy simulation(LES), which means we will add a spatial filter to a solution of the incompressible Navier-Stokes equations. From this LES, we will derive an eddy-viscosity model called the QR model.

(3)

Contents

1 Introduction 4

2 The incompressible Navier-Stokes equations 4

2.1 The incompressible Navier-Stokes equations . . . 4

2.2 The evolution of the kinetic energy . . . 5

3 Discretization of the Navier-Stokes equation 7 3.1 Discretization of the Navier-Stokes equation . . . 7

3.2 The evolution of the kinetic energy . . . 9

4 QR model 11 4.1 notation and useful lemmas . . . 11

4.1.1 notation . . . 11

4.1.2 useful lemmas . . . 12

4.2 LES . . . 20

4.3 Finding the QR model . . . 21

4.4 QR eddy viscosity . . . 25

(4)

1 Introduction

The Navier-Stokes equations provide a model for turbulent flow. In this thesis we will follow the study of Henry Bandringa [1].

In section 2 we will look at the incompressible Navier-Stokes equations. Be- cause the conservation of the kinetic energy is important, we will compute the evolution of the kinetic energy in time and see that the kinetic energy will decrease.

In section 3 we will discretize the incompressible Navier-Stokes equations and then compute the evolution of the kinetic energy in time of these discretized Navier-Stokes equation. We will see that the equation for this evolution of the kinetic energy the discrete version is of the equation we computed in the first section and that for the discrete version also the kinetic energy will decrease.

In section 4 we will look at large-eddy simulation (LES). For LES, we add a filter to the incompressible Navier-Stokes equations. This filter introduces a closure model τ . We will use scale-truncation to get a condition on this τ . Then we will introduce an eddy viscosity model for τ , and using the condition on τ , we will derive a model called the QR-model [3].

2 The incompressible Navier-Stokes equations

In this section we will see that the incompressible Navier-Stokes equations are

∂u

∂t + (u · ∇)u + ∇p − ν∆u = 0

∇ · u = 0

From these equations, we will derive the evolution of the kinetic energy en see that the kinetic energy decreases.

2.1 The incompressible Navier-Stokes equations

In this subsection we will give the incompressible Navier-Stokes equations.

Therefore we introduce the following symbols: u is the velocity vector in R3, ρ the density, p the pressure and µ the dynamic viscosity. For the incompress- ible Navier-Stokes equations, we assume that the density, the temperature and viscosity are constant.

So the equation for conservation of mass

∂ρ

∂t + ∇ · (ρu) = 0 becomes, using the constancy of the density,

∇ · u = 0 (1)

The conservation of momentum is given by ρ∂u

∂t + ρ∇ · (u ⊗ u) + ∇p − µ∆u = 0

(5)

where ⊗ indicates the outer product, which is defined as u ⊗ v = uvTWhen we divide this equation by ρ and define ν = µρ and ˆp = pρ and call this again p, we get

∂u

∂t + ∇ · (u ⊗ u) + ∇p − ν∆u = 0 (2) Now we rewrite ∇ · (u ⊗ u):

∇ · (u ⊗ u) =X

ij

∂xi

(uiuj) =X

ij

 ∂ui

∂xi

uj+ ui

∂uj

∂xi



using equation 1,P

i

∂ui

∂xi = ∇ · u = 0, so we get

∇ · (u ⊗ u) =X

ij

ui

∂uj

∂xi

= (u · ∇)u (3)

So we end up with the following incompressible Navier-Stokes equations:

∂u

∂t + (u · ∇)u + ∇p − ν∆u = 0 (4)

∇ · u = 0 (5)

2.2 The evolution of the kinetic energy

In this subsection we will compute the evolution of the kinetic energy 1

2 d

dt(u, u) = −ν Z

∇u : ∇u dΩ + boundary terms

and see that if we neglect the boundary terms, the kinetic energy decreases.

We define the inner product (·, ·) as (f, g) = R

f · g dΩ. Then the time derivative kinetic energy is given by

1 2

d dt

Z

u · u dΩ = 1 2

d

dt(u, u) = 1 2

 ∂

∂tu, u

 +1

2

 u, ∂

∂tu



Using (f, g) =R

f · g dΩ =R

g · f dΩ = (g, f ) we get 1

2 d

dt(u, u) = ∂u

∂t, u



Now we rewrite equation 4 as ∂u∂t = −(u · ∇)u − ∇p + ν∆u and put it into the above equation. Then we get

1 2

d

dt(u, u) = −((u · ∇)u, u) − (∇p, u) + ν(∆u, u) (6) We will work this out with the following product rule

∇ · (f u) = ∇f · u + f (∇ · u) (7) When we replace f by u · u and use conservation of mass (equation 5), we get

∇ · ((u · u)u) = ∇(u · u) · u

(6)

Using ∇(u · u) · u =P

ij

∂xi(ujuj)ui=P

ij2ui∂u∂xj

iuj= 2(u · ∇)u · u, we get 1

2∇ · ((u · u)u) = (u · ∇)u · u Now we take the integral over Ω and get

1 2

Z

∇ · ((u · u)u) dΩ = Z

(u · ∇)u · u dΩ

= ((u · ∇)u, u) Using Gauss’s divergence theorem, we get

Z

∇ · ((u · u)u) dΩ = Z

Γ

(u · u)(u · n) dΓ

where Γ is the boundary of Ω and n is the orthonormal vector at Γ. So when we combine the two above equations, we get

((u · ∇)u, u) =1 2

Z

Γ

(u · u)(u · n) dΓ So equation 6 becomes

1 2

d

dt(u, u) = −1 2

Z

Γ

|u|2(u · n) dΓ − (∇p, u) + ν(∆u, u) (8)

where |u|2= u · u.

Now we set in equation 7 f = p and see that (∇p, u) =

Z

∇ · (pu) dΩ − (p, ∇ · u) (9) When we now use conservation of mass (equation 5) and Gauss’s divergence theorem, we get

(∇p, u) = Z

Γ

(u · n)p dΓ So equation 8 becomes

1 2

d

dt(u, u) = − Z

Γ

(u · n)(1

2|u|2+ p) dΓ + ν(∆u, u) (10) When we replace in equation 7 f by a tensor A, it becomes

∇ · (Au) = (∇ · A) · u + A : ∇u Where : is the Frobenius inner product, which is defined by

A : B =X

i,j

AijBij = tr(ATB) = tr(BTA)

When we fill in A = ∇u, we get

∇ · ((∇u)u) = (∆u) · u + ∇u : ∇u (11)

(7)

Thus

ν(∆u, u) = ν Z

(∇ · ((∇u)u) − ∇u : ∇u) dΩ When we now apply Gauss’s divergence theorem, we get

ν(∆u, u) = ν Z

Γ

((∇u)u) · n dΓ − ν Z

∇u : ∇u dΩ

When we now use ((∇u)u) · n = u ·∂u∂n, we end up with the following equation for the evolution of the kinetic energy in time

1 2

d

dt(u, u) = − Z

Γ

(u · n)(1

2|u|2+ p) dΓ + ν Z

Γ

u ·∂u

∂n dΓ − ν Z

∇u : ∇u dΩ (12) So if we use the no-slip boundary condition, the first two terms on the right hand side vanishes and we get

1 2

d

dt(u, u) = −ν Z

∇u : ∇u dΩ

When we now use ν > 0 and ∇u : ∇u = P

ij

∂ui

∂xj

2

≥ 0, we see that

1 2 d

dt(u, u) ≤ 0 and we get 12dtd(u, u) = 0 only if u is constant, in which case u = 0 due to the no-slip boundary condition. So if u 6= 0, the kinetic energy will decrease.

3 Discretization of the Navier-Stokes equation

In this section we will derive the folliwing discrete incompressible Navier-Stokes equations.

∂ui

∂t Ωi+ X

j∈Ni

uijuij· nijAij+ X

j∈Ni

pijnijAij− X

j∈Ni

ν uj− ui

(xj− xi) · nij

Aij = 0 X

j∈Ni

uij· nijAij = 0

Furthermore we will show that for these discrete incompressible Navier-Stokes equations the kinetic energy decreases too.

3.1 Discretization of the Navier-Stokes equation

In this section, we will approximate the Navier-Stokes equations using the finite volume method. Furthermore we need a computational grid. We will use a body conforming unstructured grid. We will use the co-located cell-centered grid arrangement.

The conservation of mass in cell i is discretized by taking the integral of equation 5 over the control volume Ωi:

Z

i

∇ · u dΩi= Z

Γi

u · n dΓi= X

j∈Ni

uij· nijAij = 0 (13)

(8)

Figure 1: A part of an unstructured grid

Where Niconsist of indices j of cells adjacent to cell i, Aij the surface between cells i and j and nijthe normal vector to this surface Aijin the direction of cell j as can be seen in figure 3.1. Furthermore Γi is the boundary of Ωi and uij is the face velocity which is computed as

uij= γijui+ (1 − γij)uj

where ui is the velocity vector in cell i and γij is the geometric interpolation factor, defined as

γij= (xj− xij) · nij (xj− xi) · nij

(14) Integrating the momentum equation 2 over an arbitrary control volume Ωigives

Z

i

∂u

∂t dΩi+ Z

i

∇ · (uu) dΩi+ Z

i

∇p dΩi− Z

i

∇ · (ν∇u) dΩi= 0 (15) Now we will discretize the four parts of this equation. When we discretize the first part, we get

Z

i

∂u

∂t dΩi≈∂ui

∂t Ωi (16)

For the second part, we use first Gauss’s divergence theorem and get Z

i

∇ · (uu) dΩi= Z

Γi

u(u · n) dΓi≈ X

j∈Ni

uijuij· nijAij (17)

Before discretizing the third part, we again first apply Gauss’s divergence theorem.

Z

i

∇p dΩi= Z

Γi

pn dΓi≈ X

j∈Ni

pijnijAij (18) The last part is a little bit harder to discretize. When we start fromR

i∇ · (ν∇u) dΩi, we get, using Gauss’s divergence theorem,

Z

i

∇ · (ν∇u) dΩi= Z

Γi

ν∇u · n dΓi≈ X

j∈Ni

ν(∇u)ij· nijAij (19)

(9)

When we now assume that the fluxes are normal to the faces, we get (∇u)ij·nij =

∂u

∂n



ij(xuj−ui

j−xi)·nij, so equation 19 becomes Z

i

∇ · (ν∇u) dΩi≈ X

j∈Ni

ν(∇u)ij· nijAij≈ X

i∈Ni

ν uj− ui (xj− xi) · nij

Aij (20)

Combining equations 15, 16, 17, 18 and 20, we get the following discrete form of the conservation of momentum equation

∂ui

∂t Ωi+X

j∈Ni

uijuij· nijAij+X

j∈Ni

pijnijAij−X

j∈Ni

ν uj− ui

(xj− xi) · nijAij= 0 (21)

3.2 The evolution of the kinetic energy

In this section we will compute evolution of the kinetic energy in time for the discretized incompressible Navier-Stokes equation and show that the kinetic energy decreases.

The evolution of the kinetic energy is given by X

i

ui·∂ui

∂t Ωi Using equation 21, this equation becomes

X

i

ui· ∂ui

∂t Ωi = −X

i

ui· X

j∈Ni

uijuij· nijAij−X

i

ui· X

j∈Ni

pijnijAij

+X

i

ui· X

j∈Ni

ν uj− ui

(xj− xi) · nijAij (22) We will now rewrite this equation using the following identity [1]

φi

X

j∈Ni

ψijQij+ ψi

X

j∈Ni

φijQij= X

j∈Ni

φψcijQij+ φiψi

X

j∈Ni

Qij (23)

Where φ and ψ are general variables, Qij is known on the cell face, φij = γijφi+ (1 − γijj, ψij = γijψi+ (1 − γijj, with γij the interpolation function defined in equation 14, and cφψij = 12iψj+ ψiφj)

Now we take in equation 23 φ = u, ψ = φ and Qij = uij · nijAij and interpolate the face velocity as uij =12(ui+ uj). Then we get

X

i

ui· X

j∈Ni

φijuij· nijAij+X

i

φi· X

j∈Ni

1

2(ui+ uj)uij· nijAij

=X

i

X

j∈Ni

1

2(ui· φj+ φi· uj)uij· nijAij+X

i

uiφi

X

j∈Ni

uij· nijAij (24)

Using equation 13, the last term vanishes. When we split the second term into two partsP

i 1

2φi· uiP

j∈Niuij· nijAij+P

i

P

j∈Ni 1

2i· uj)uij· nijAij we see, using again equation 13, that the first part vanishes and the second part is also on the other hand of the equal sign in equation 24, so equation 24 becomes

X

i

ui· X

j∈Ni

φijuij· nijAij =X

i

X

j∈Ni

1

2(ui· φj)uij· nijAij (25)

(10)

When we now substitute φ = u, ψ = p and Qij = nijAij into equation 23, we get

X

i

ui· X

j∈Ni

pijnijAij+X

i

pi X

j∈Ni

uij· nijAij

=X

i

X

j∈Ni

cupijnijAij+X

i

uipi· X

j∈Ni

nijAij

Using equation 13, we see that the second term vanishes. Using geometric arguments, we see that P

j∈NinijAij = 0, so the last term vanishes also. Thus we end up with

X

i

ui· X

j∈Ni

pijnijAij =X

i

X

j∈Ni

upcijnijAij (26) Putting equations 22, 25 (with φ = u) and 26 together, we get the following equation for the kinetic energy

X

i

ui·∂ui

∂t Ωi= −X

i

X

j∈Ni

1

2(ui· uj)uij· nijAij−X

i

X

j∈Ni

upcijnijAij

+ νX

i

ui· X

j∈Ni

uj− ui

(xj− xi) · nijAij (27) So this equation is the discrete version of equation 12. In this equation, we see that the first two terms on the right hand side vanishes at the interior. This is because uij = uji, nij = −nji, Aij = Aji and upcij =upcji. The only relation here which is not trivial is uij = uji, so we will prove this relation. Therefore we will first show that γij = 1 − γji.

1 − γji=(xi− xj) · nji

(xi− xj) · nji −(xi− xji) · nji

(xi− xj) · nji =(xj− xij) · nij

(xj− xi) · nij = γij

With this, we see that

uij = γijui+ (1 − γij)uj= (1 − γji)ui+ γjiuj = uji

So when we use the no-slip boundary condition, the first two terms of equation 27 vanishes and we end up with

X

i

ui· ∂ui

∂t Ωi = νX

i

ui· X

j∈Ni

uj− ui

(xj− xi) · nij

Aij

To see why this is non-positive, we use the fact that if j ∈ Ni, then i ∈ Nj, so for a term νui·(xuj−ui

j−xi)·nijAij with j ∈ Ni, we get also a term νuj·(xui−uj

i−xj)·njiAji

with i ∈ Nj. So we get the sum over pairs X

i

ui·∂ui

∂t Ωi= νX

i

X

j∈Ni

ui· uj− ui

(xj− xi) · nij

Aij

= 1 2νX

i

X

j∈Ni



ui· uj− ui

(xj− xi) · nij

Aij+ uj· ui− uj

(xi− xj) · nji

Aji



(11)

When we now use uj·(xui−uj

i−xj)·njiAji= −uj· (xuj−ui

j−xi)·nijAij we get X

i

ui·∂ui

∂t Ωi=1 2νX

i

X

j∈Ni

(ui− uj) · uj− ui (xj− xi) · nij

Aij

=1 2 ν

|{z}

>0

X

i

X

j∈Ni

(ui− uj) · (uj− ui)

| {z }

≤0

1 (xj− xi) · nij

| {z }

>0

Aij

|{z}

>0

≤ 0

From this we see that the kinetic energy equals zero if ui= ujfor all pairs i and j ∈ Ni, which means that u is constant. Because we use the no-slip boundary condition, u = 0 in this case. So if u 6= 0, the kinetic energy will be negative. So the discrete and continuous form of the incompressible Navier-Stokes equations give the same conclusion.

4 QR model

In this section we will derive a model called the QR model. Therefore we will first give some notation and useful lemmas which we will use in the derivation of the OR model. Then we will start from large-eddy simulation (LES) and use scale-truncation to get the QR model

τ −1

3tr(τ )I = −2Cδ

max {r(v), 0}

q(v) S

4.1 notation and useful lemmas

In this subsection, we will give some notations and lemmas which we will use during this section.

4.1.1 notation

For clarity, we will first recall the definition of the Frobenius inner product A : B =X

i,j

AijBij = tr(ATB) = tr(BTA)

We will use the following notations

|A|2:= A : A

|A|3:= A2: A

||A||2:=

Z

δ

A : A dx = Z

δ

|A|2 dx

||A||3:=

Z

δ

A2: A dx = Z

δ

|A|3 dx

(∇v)ij:= ∂vj

∂xi

(12)

→ei is the ith standard basic vector in R3. We define the Levi-Civita symbol ijk as

ijk:=

1 if (i, j, k) is (1, 2, 3), (2, 3, 1) or (3, 1, 2)

−1 if (i, j, k) is (1, 3, 2), (2, 1, 3) or (3, 2, 1) 0 if i = j, i = k or j = k

(28)

For the rest of this section, we will call S and T the symmetric and antisym- metric part of ∇v:

S := 1

2 ∇v + ∇vT , T := 1

2 ∇v − ∇vT We define ω as the curl of v.

The QR model uses the invariants of S. We define q(v) and r(v) as minus the second and third invariant of S. Then q(v) and r(v) are given by

q(v) = 1

2|S|2, r(v) = −1 3|S|3 We will show this in lemma 4.1.

In this section we will not write down the summation sign (P) for clarity reasons. So one should read for example P

ijAijBij for AijBij. When we integrate over Ωδ, we use periodic boundary conditions, so the boundary terms are equal to zero. So every time we use integration by parts, we will neglect the boundary terms.

4.1.2 useful lemmas

Lemma 4.1. Let v be in R3such that ∇ · v = 0 and let S be the symmetric part of ∇v, then the second and third invariant of S, q(v) and r(v) are given by

q(v) = 1

2|S|2, r(v) = −1 3|S|3

Proof. Let v ∈ R3 be such that ∇ · v = 0 and let S be the symmetric part of

∇v. Then the invariants of S are defined using the characteristic polynomial of S:

λ3+ Iλ2+ IIλ + III and are given by

I = tr(S) II =1

2 tr(S)2− tr(S2) III = det(S) = 1

6tr(S)3−1

2tr(S2)tr(S) + 1 3tr(S3) When we now use ∇ · v = 0, these invariants become

I = tr(S) = ∇ · v = 0 II = 1

2 tr(S)2− tr(S2) = −1 2tr(S2) III = 1

6tr(S)3−1

2tr(S2)tr(S) +1

3tr(S3) = 1 3tr(S3)

(13)

When we now call q(v) minus the second invariant and use the definition of the Frobenius inner product, we get

q(v) = 1

2tr(S2) = 1

2tr(STS) =1 2|S|2

When we now call r(v) minus the third invariant and use the definition of the Frobenius inner product, we get

r(v) = −1

3tr(S3) = −1

3tr(STS2) = −1 3|S|3

Lemma 4.2. If A and B are respectively a symmetric and a skew-symmetric matrix, then A : B = 0

Proof. Let A be a symmetric matrix and B an antisymmetric matrix. Then A : B = AijBij = AjiBji= AT

ij BT

ij

= AT : BT = A : (−B) = −A : B So A : B = −A : B, thus A : B has to be zero

Corollary 4.3. If S is a symmetric matrix and A a matrix, then S : A = S : B

where B is the symmetric part of A

Lemma 4.4. If v is a vector in R3with ∇ · v = 0, then ∆v = ∇ · ∇v = 2∇ · S, where S is the symmetric part of ∇v

Proof. Let v = (v1, v2, v3) and ∇ · v = ∂v∂xi

i = 0 then 2∇ · S = ∇ · (∇v + ∇vT)

= ∂

∂xi

 ∂vj

∂xi

+ ∂vi

∂xj

−→ej

= ∂2vj

∂x2i

→ej+ ∂

∂xj

∂vi

∂xi

→ej

This last term is equal to zero because ∂v∂xi

i = 0, so 2∇ · S =∂2vj

∂x2i

→ej = ∆v

Lemma 4.5. If ω is the curl of a vector v ∈ R3, then we can write ωi as ωi= ijk

∂vk

∂xj

(14)

Proof. Let ω be the curl of v. Then, by definition,

ω =

→e1 −→e2 −→e3

∂x1

∂x2

∂x3

v1 v2 v3

= ∂v3

∂x2 − ∂v2

∂x3

−→e1+ ∂v1

∂x3− ∂v3

∂x1

−→e2+ ∂v2

∂x1− ∂v1

∂x2

−→e3

= ijk

∂vk

∂xj

→ei

So ωi= ijk∂vk

∂xj

Lemma 4.6. If v is a vector in R3, T the antisymmetric part of ∇v and ω the curl of v, then we can write Tij as

Tij= 1 2ijkωk

Proof. Let v ∈ R3 and let T and ω be respectively the antisymmetric part and the curl of v. Then we get when we write T out

T =1

2 ∇v − (∇v)T

=1 2

0 ∂v∂x2

1∂v∂x1

2

∂v3

∂x1∂v∂x1

∂v1 3

∂x2∂x∂v2

1 0 ∂x∂v3

2∂v∂x2

∂v1 3

∂x3∂x∂v3

1

∂v2

∂x3∂v∂x3

2 0

When we now apply lemma 4.5, we get

T =1 2

0 ω3 −ω2

−ω3 0 ω1

ω2 −ω1 0

= 1 2

0 123ω3 132ω2

213ω3 0 231ω1

132ω2 321ω1 0

So

Tij= 1 2ijkωk

Lemma 4.7. If a is a vector in R3 with ∇ · a = 0, then

∇ × (∇ × a) = −∆a

Proof. Let a ∈ R3 be such that ∇ · a = 0, then we use 4.5 to see that the ith element of a is given by

(∇ × (∇ × a))i= ijk

∂xj(∇ × a)k = ijk

∂xj



klm∂am

∂xl



Now we use klm= lmk to get

(∇ × (∇ × a))i= ijklmk

∂xl

∂am

∂xj

(15)

The product ijklmk is not zero if i 6= j 6= k and l 6= m 6= k, in which cases i = l and j = m or i = m and j = l. Thus

(∇ × (∇ × a))i= ijkijk

∂ai

∂vj

∂xj + ijkjik

∂xj

∂ai

∂xj

= γij

∂xi

∂aj

∂xj − γij

2ai

∂x2j where γij = 0 if i = j

1 if i 6= j. When we now use ∇ · a = ∂x∂aj

j = 0, the first term becomes

γij

∂xi

∂aj

∂xj

= − ∂

∂xi

∂ai

∂xi

= −∂2ai

∂x2i so we end up with

(∇ × (∇ × a)) = −∂2ai

∂x2i − γij2ai

∂x2j

!

→ei = −∂2ai

∂x2j

→ei = −∆a

Lemma 4.8. If a and b are vectors in R3, then, if we neglect boundary terms, Z

(∇ × a) · b dx = Z

a · (∇ × b) dx Proof. Let a, b ∈ R3. Then

Z

(∇ × a) · b dx = Z

ijk∂ak

∂xjbi dx Now we use integration by parts to get

Z

(∇ × a) · b dx = − Z

ijkak

∂bi

∂xj

dx

where we neglect the boundary terms. Now we use ijk = −kji to get Z

(∇ × a) · b dx = Z

akkji∂bi

∂xj

dx = Z

ak(∇ × b)k dx = Z

a · (∇ × b) dx

Corollary 4.9. When we combine lemmas 4.7 and 4.8, we get Z

(∇ × a) · (∇ × b) dx = Z

a · (∇ × (∇ × b)) dx − Z

a · ∆b dx Lemma 4.10. If a is a vector in R3 with ∇ · a = 0, then

∇ · (∆a) = 0 Proof. Let a ∈ R3such that ∇ · a = ∂x∂ai

i = 0, then

∇ · (∆a) = ∂

∂xi

2ai

∂x2j = ∂2

∂x2j

∂ai

∂xi

= 0

(16)

Lemma 4.11. If a is a vector in R3, S the symmetric part of ∇a and ˜S the symmetric part of ∇∆a, then

S = ∆S˜

Proof. Let a ∈ R3, S be the symmetric part of ∇a and ˜S be the symmetric part of ∇∆a. Then we get when we write ˜Sij =12 (∇∆a)ij+ ((∇∆a)T)ij out

ij = 1 2

 ∂(∆a)j

∂xi

+∂(∆a)i

∂xj



=1 2

 ∂

∂xi

2aj

∂x2k + ∂

∂xj

2ai

∂x2k



When we now reorder terms we get S˜ij = ∂2

∂x2k

 1 2

 ∂aj

∂xi +∂aj

∂xi



= ∂2

∂x2kSij= (∆S)ij

Lemma 4.12. If v is a vector in R3 with ∇ · v = 0 and we use the definition of S stated at the start of this subsection, then

Z

(v · ∇)v · ∆v dx = − Z

∇vT∇v : S dx

Proof. Let v ∈ R3 be such that ∇ · v = 0 and let S be the symmetric part of

∇v.

Writing outR (v · ∇)v · ∆v dx gives Z

(v · ∇)v · ∆v dx = Z

vk

∂xk

vj

2

∂x2ivj dx (29) Integration by parts gives

Z vk

∂xk

vj

2

∂x2ivj dx = − Z ∂

∂xi

 vk

∂vj

∂xk

 ∂vj

∂xi

dx

= − Z ∂vk

∂xi

∂vj

∂xk

∂vj

∂xi

dx − Z

vk

2vj

∂xi∂xk

∂vj

∂xi

dx (30) We will look a little bit closer on this last term. For clarity, we call a = ∂v∂xj

i, so we get

Z vk

∂a

∂xka dx =

Z ∂

∂xk (vka) a dx − Z ∂vk

∂xka2 dx Using ∇ · v = ∂v∂xk

k = 0 the last term vanishes, so Z

vk ∂a

∂xk

a dx =

Z ∂

∂xk

(vka) a dx When we now use integration by parts we get

Z vk ∂a

∂xk

a dx = − Z

vka ∂a

∂xk

dx = − Z

vk ∂a

∂xk

a dx So we conclude

Z vk

∂a

∂xk

a dx = 0

(17)

Now, as we go back to equation 30, we get Z

vk

∂xk

vj2

∂x2ivj dx = − Z ∂vk

∂xi

∂vj

∂xk

∂vj

∂xi

dx (31)

When we work this out, we get

∂vk

∂xi

∂vj

∂xk

∂vj

∂xi

= (∇v)ik(∇v)kj(∇v)ij = (∇v∇v)ij(∇v)ij = (∇v2) : ∇v With the definition of the Frobenius inner product, we rewrite this as

∂vk

∂xi

∂vj

∂xk

∂vj

∂xi = (∇v2) : ∇v = tr((∇v2)T∇v) = tr(∇vT(∇vT∇v)) = (∇vT∇v) : ∇v So equation 31 becomes, using corollary 4.3,

Z vk

∂xk

vj2

∂x2ivj dx = Z

(∇vT∇v) : ∇v dx = Z

(∇vT∇v) : S dx Thus we get, using equation 31,

Z

(v · ∇)v · ∆v dx = − Z

∇vT∇v : S dx

Lemma 4.13. If v is a vector in R3 with ∇ · v = 0 and we use the definitions of ω and ijk stated at the start of this subsection, then

∇ × ((v · ∇)v) = −(ω · ∇)v + (v · ∇)ω

Proof. Let v ∈ R3be such that ∇ · v = 0 and let ω be the curl of v and ijk be the Levi-Civita symbol.

Using lemma 4.5, we get

∇ × ((v · ∇)v) = ∇ ×

 vi∂vj

∂xi

→ej



= jkl

∂xk

 vi∂vl

∂xi

−→ej

= jkl

∂vi

∂xk

∂vl

∂xi

→ej+ jklvi

2vl

∂xi∂xk

→ej (32)

We will work this two terms out. For jkl∂vi

∂xk

∂vl

∂xi

→ej, the jth component is given by jkl

∂vi

∂xk

∂vl

∂xi∂v∂xi

l

∂vk

∂xi



, where k and l are chosen such that k 6= l 6= j. Now we write out the sum over i by filling in j, k and l for i and add∂x∂vj

k

∂vj

∂xl∂v∂xj

l

∂vj

∂xk.

jkl

 ∂vi

∂xk

∂vl

∂xi

−∂vi

∂xl

∂vk

∂xi



= jkl

 ∂vl

∂xj

∂vj

∂xk

−∂vk

∂xj

∂vj

∂xl

+ ∂vl

∂xk

∂vk

∂xk

− ∂vk

∂xk

∂vk

∂xl

+∂vl

∂xl

∂vl

∂xk

−∂vk

∂xl

∂vl

∂xl

+ ∂vj

∂xk

∂vj

∂xl

−∂vj

∂xl

∂vj

∂xk



= −jkl

  ∂vl

∂xk

−∂vk

∂xl

 

−∂vk

∂xk

−∂vl

∂xl



+ ∂vj

∂xl

− ∂vl

∂xj

 ∂vj

∂xk

+ ∂vk

∂xj

− ∂vj

∂xk

 ∂vj

∂xl



(18)

Now we use ∂v∂xj

j = −∂x∂vk

k∂v∂xl

l to get

jkl ∂vi

∂xk

∂vl

∂xi

− ∂vi

∂xl

∂vk

∂xi



= −jkl ∂vl

∂xk

−∂vk

∂xl

 ∂vj

∂xj

+ ∂vj

∂xl

− ∂vl

∂xj

 ∂vj

∂xk

+ ∂vk

∂xj

− ∂vj

∂xk

 ∂vj

∂xl



When we now use lemma 4.5, we get

jkl ∂vi

∂xk

∂vl

∂xi

−∂vi

∂xl

∂vk

∂xi



= −

 ωj∂vj

∂xj

+ ωk∂vj

∂xk

+ ωl∂vj

∂xl



= −

 ωi

∂xi

 vj Thus

jkl

∂vi

∂xk

∂vl

∂xi

→ej = −

 ωi

∂xi



vj−→ej = −(ω · ∇)v (33) For jklvi 2vl

∂xi∂xk

→ej, we get, using again lemma 4.5,

jklvi2vl

∂xi∂xk

→ej = vi

∂xi

jkl∂vl

∂xk

→ej = (v · ∇)ω (34)

Combining equations 32, 33 and 34 gives us

∇ × ((v · ∇)v) = −(ω · ∇)v + (v · ∇)ω

Lemma 4.14. If v is a vector in R3 with ∇ · v = 0 and we use the definition of ω stated at the start of this subsection, then

Z

((v · ∇)ω) · ω dx = 0

Proof. Let v ∈ R3be such that ∇ · v = 0 and let ω be the curl of v.

Writing outR ((v · ∇)ω) · ω dx gives Z

((v · ∇)ω) · ω dx = Z

vi

∂ωj

∂xi

ωj dx = Z ∂ωj

∂xi

viωj dx Now we use integration by parts

Z

((v · ∇)ω) · ω dx = − Z

ωj

∂viωj

∂xi dx

= − Z

ωj∂vi

∂xi

ωj dx − Z

ωjvi∂ωj

∂xi

dx Now we use ∇ · v = ∂v∂xi

i = 0 and see that the first term is equal to zero. So we get

Z

((v · ∇)ω) · ω dx = − Z

vi

∂ωj

∂xiωj dx

= − Z

((v · ∇)ω) · ω dx

(19)

So we conclude

Z

((v · ∇)ω) · ω dx = 0

Lemma 4.15. If v is a vector in R3 with ∇ · v = 0 and we use the definitions of ω, ijk, S and T stated at the start of this subsection, then

((ω · ∇)v) · ω = Sijωiωj

Proof. Let v ∈ R3 be such that ∇ · v = 0 and use the definitions of ω, ijk, S and T stated at the start of this subsection. Then writing out ((ω · ∇)v) · ω gives

((ω · ∇)v) · ω =



ωi

∂xi

 vj



ωj = ωi

∂vj

∂xi

ωj

When we now use ∂v∂xj

i = (∇v)ij= Sij+ Tij we get

((ω · ∇)v) · ω = Sijωiωj+ Tijωiωj (35) Let ω123= ω1ω2ω3, then, using lemma 4.6 andP

ijkijk= 0 we get Tijωiωj =1

2ijkωkωiωj= 1

2ijkω123= 0 When we put this into equation 35, we get

((ω · ∇)v) · ω = Sijωiωj

Lemma 4.16. If v is a vector in R3 with ∇ · v = 0 and we use the definitions of ω, ijk, S and T stated at the start of this subsection, then

(∇vT∇v) : S = |S|3−1

4Sjkωjωk

Proof. Let v ∈ R3 be such that ∇ · v = 0 and use the definitions of ω, ijk, S and T stated at the start of this subsection. We rewrite (∇vT∇v) : S using

∇v = S + T

(∇vT∇v) : S = (S + T )T(S + T ) : S

= STS + STT + TTS + TTT : S

Using the definition of the Frobenius inner product, we get

STT : S + TTS : S = tr(T STS) + tr(TTSST) = tr(T SS) − tr(T SS) = 0 So

(∇vT∇v) : S = S2: S + TTT : S = |S|3+ TikTijSkj (36)

(20)

We compute SjkTikTij using lemma 4.6:

SjkTikTij = Sjk

 1

2ikmωm

  1 2ijlωl



= Sjk

1

4ikmijlωmωl

For the product ikmijl we have two possibilities, namely

ikmijl= 1 if k = j and l = m

−1 if l = k and m = j So we get

SjkTikTij= 1

4Sjjωmωm−1

4Sjkωjωk Using Sjj = ∂v∂xj

j = 0 this equation becomes SjkTikTij= −1

4Sjkωjωk

When we fill this into equation 36, we get (∇vT∇v) : S = |S|3−1

4Sjkωjωk

4.2 LES

In this subsection, we introduce a methodology called large-eddy simulation (LES). For LES, we add a filter to the incompressible Navier-Stokes equations.

In this filter, only the large eddies in a flow are resolved. So we get a filtered solution ¯u which is much easier to compute by a computer.

We start again with the Navier-Stokes equations (equations 2 and 5)

∂u

∂t + ∇ · (u ⊗ u) + ∇p − ν∆u = 0

∇ · u = 0

Now we will use a filter, which we will denote by an overline. Because it will be a linear filter, we can apply it on each component:

∂u

∂t + ∇ · (u ⊗ u) + ∇p − ν∆u = 0 = 0 When we now assume that ∇ · a = ∇ · a, we get

∂u

∂t + ∇ · u ⊗ u + ∇p − ν∆u = 0

When we rewrite this a little bit, we get the filtered incompressible Navier-Stokes equations:

∂ ¯u

∂t + ∇ · (¯u ⊗ ¯u) + ∇¯p − ν∆¯u = −∇ · (u ⊗ u − ¯u ⊗ ¯u)

(21)

∇ · ¯u = 0

with filtered velocity field ¯u. When we now call τ = u ⊗ u − ¯u ⊗ ¯u and use the approximation v ≈ ¯u and p ≈ ¯p, we get, using equation 3

∂v

∂t + (v · ∇)v − ν∆v + ∇p = −∇ · τ (37)

∇ · v = 0 (38)

4.3 Finding the QR model

In this section we will find the QR model by splitting v into an average ¯v and residue v0 and find the following condition for which the residual field will be suppressed.

4 Z

δ

r(v) dx ≤ Z

δ

τ : ∆S dx We set v = ¯v + v0, where

¯ v = 1

|Ωδ| Z

δ

v(x, t) dx (39)

is the average of v on a periodic box Ωδ with diameter δ. The residual field in v is then v0. When we want to use this ¯v in our model, the residual field should not become significant. Therefore we bound the kinetic energy from above

1 2

d

dt||v0||2≤ 0 (40)

Note that when we satisfy this condition, and we add the initial condition

||v0||(t = 0) = 0 and boundary condition v0 = 0, we get ||v0|| = 0 for all t > 0. In order to satisfy condition 41, we use the Poincar´e inequality [3]

1

2||v0||2≤ 1

2Cδ||∇v||2

where Cδ > 0 is the Poincar´e constant. So when we satisfy the condition 1

2 d

dt||∇v||2≤ 0 (41)

we also satisfy our condition 40:

1 2

d

dt||v0||2≤ Cδ

1 2

d

dt||∇v||2≤ 0

With this Poincar´e condition, we do not have to compute v0 explicitly.

Now we will compute 12dtd||∇v||2 and see that it is given by 1

2 d

dt||∇v||2= −4

3||S||3− 2ν||∇S||2− Z

δ

τ : ∆S dx

When we compute 12dtd||∇v||2, we get, using integration by parts, 1

2 d

dt||∇v||2= Z

δ



∇∂v

∂t · ∇v

 dx =

Z

δ



−∂v

∂t · ∆v

 dx

(22)

Now we fill in equation 37 and get 1

2 d

dt||∇v||2= Z

δ

(v · ∇)v · ∆v dx − Z

δ

ν∆v · ∆v dx +

Z

δ

∇p · ∆v dx + Z

δ

(∇ · τ ) · ∆v dx (42) We will first rewrite the first part (R

δ(v · ∇)v · ∆v dx) of equation 42 and see that it is equal to −43||S||3.

We will start again with our filtered Navier-Stokes equations 37 and 38

∂v

∂t + (v · ∇)v − ν∆v + ∇p = −∇ · τ (43)

∇ · v = 0 (44)

From this equations, we will compute 12dtd||∇v||2 and 12dtd||ω||2and see that these two quantities are the same and from this will follow that R

δ(v · ∇)v ·

∆v dx = −43||S||3

Computing 12dtd||∇v||2 gives again equation 42:

1 2

d

dt||∇v||2= Z

δ

(v · ∇)v · ∆vdx + Z

δ

∇p · ∆v dx

− ν||∆v||2+ Z

δ

(∇ · τ ) · ∆v dx

Using equation 53R

δ∇p · ∆v dx = 0

, this becomes 1

2 d

dt||∇v||2= Z

δ

(v · ∇)v · ∆vdx − ν||∆v||2+ Z

δ

(∇ · τ ) · ∆v dx (45) Now we take the curl of equation 43 and use ∇ × ∇p = 0 and get

∂ω

∂t + ∇ × ((v · ∇)v) − ν∇ × ∆v = −∇ × (∇ · τ ) Using lemma 4.13 this equation becomes

∂ω

∂t − (ω · ∇)v + (v · ∇)ω − ν∇ × ∆v = −∇ × (∇ · τ ) We will now compute 12dtd||ω||2using the above equation

1 2

d

dt||ω||2= Z

δ

∂ω

∂t · ω dx

= Z

δ

− ((v · ∇)ω) · ω + ((ω · ∇)v) · ω + ν(∇ × ∆v) · ω − (∇ × (∇ · τ )) · ω dx Using lemma 4.14 this equation becomes

1 2

d

dt||ω||2= Z

δ

((ω · ∇)v) · ω + ν(∇ × ∆v) · ω − (∇ × (∇ · τ )) · ω dx (46)

Referenties

GERELATEERDE DOCUMENTEN

At the fixed voltage of 50kV used for potential and electric field distribution tests along a 4-disc glass insulator string, the tests indicate a reduction in voltage from a

These sign types were then compared with counterparts in six potential lexifier sign languages, American Sign Language (ASL), British Sign Language (BSL), Irish Sign Language

The lexical semantic representation of the verb pompa reflecting structural and event structural properties displayed by the sentences in 62a is as follows:.. Ngaka e alafa

But to turn the situation to our advantage, Thomas says South African businesses and institutions of learning must try to understand Africa better. “Who in South Africa is teaching

The common approach to the regulation of civil proceedings is especially evident in two broad areas: first, the legislative provisions and court rules setting out the

Voor de aanleg van een nieuwe verkaveling, werd een grid van proefsleuven op het terrein opengelegd. Hierbij werden geen relevante

The insensitivity of chemisorption towards changes in interstitial Zn concentrations is ev- idenced by the absence of a difference in PZC shift between ZnO/O2 and ZnO/H2 on going