76
Variational Methods for Computational Fluid Dynamics Fran¸ cois Alouges and Bertrand Maury

Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

  • Upload
    others

  • View
    8

  • Download
    0

Embed Size (px)

Citation preview

Page 1: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

Variational Methods forComputational Fluid Dynamics

Francois Alouges and Bertrand Maury

Page 2: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

2

Page 3: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

Contents

1 Models for incompressible fluids 5

1.1 Some basics on viscous fluid models . . . . . . . . . . . . . . . . . . . . . . . . . 5

1.2 Mathematical framework . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 9

1.3 Free in-/outlet conditions . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 13

1.3.1 Prescribed normal stress . . . . . . . . . . . . . . . . . . . . . . . . . . . . 14

1.4 Some typical problems . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 16

1.4.1 Flow around an obstacle . . . . . . . . . . . . . . . . . . . . . . . . . . . . 16

1.4.2 Some simple fluid-structure interaction problems . . . . . . . . . . . . . . 16

2 Navier-Stokes equations, numerics 19

2.1 The incompressibility constraint, Stokes equations . . . . . . . . . . . . . . . . . 19

2.2 Time discretization . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 21

2.2.1 Generalities . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 21

2.2.2 Going back to Navier-Stokes equations . . . . . . . . . . . . . . . . . . . . 23

2.2.3 The method of characteristics . . . . . . . . . . . . . . . . . . . . . . . . . 24

2.3 Projection methods . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 25

3 Moving domains 27

3.1 Lagrangian standpoint . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 27

3.2 Arbitrary Lagrangian Eulerian (ALE) point of view . . . . . . . . . . . . . . . . 29

3.2.1 Actual computation of the domain velocity . . . . . . . . . . . . . . . . . 31

3.2.2 Navier–Stokes equations in the ALE context . . . . . . . . . . . . . . . . 32

3.3 Some applications of the ALE approach . . . . . . . . . . . . . . . . . . . . . . . 33

3.3.1 Water waves . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 33

3.3.2 Falling water . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 33

3.4 Implementation issues . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 34

4 Fluid-structure interactions 35

4.1 A non deformable solid in a fluid . . . . . . . . . . . . . . . . . . . . . . . . . . . 35

4.2 Rigid body motion . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 36

4.3 Enforcing the constraint . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 38

4.4 Yet other non deformable constraints . . . . . . . . . . . . . . . . . . . . . . . . . 39

4.5 Conclusion . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 40

5 Duality methods 41

5.1 General presentation of the approach . . . . . . . . . . . . . . . . . . . . . . . . . 42

5.2 The divergence-free constraint for velocity fields . . . . . . . . . . . . . . . . . . . 44

5.3 Other types of constraints . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 45

3

Page 4: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

4 CONTENTS

5.3.1 Obstacle problem . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 455.3.2 Prescribed flux . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 465.3.3 Prescribed mean velocity . . . . . . . . . . . . . . . . . . . . . . . . . . . 46

6 Stokes equations 496.1 Mixed finite element formulations . . . . . . . . . . . . . . . . . . . . . . . . . . . 49

6.1.1 A general estimate without inf-sup condition . . . . . . . . . . . . . . . . 506.1.2 Estimates with the inf-sup condition . . . . . . . . . . . . . . . . . . . . . 526.1.3 Some stable finite elements for Stokes equations . . . . . . . . . . . . . . . 54

7 Complements 577.1 Estimation of interaction forces . . . . . . . . . . . . . . . . . . . . . . . . . . . . 577.2 Energy balance . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 587.3 Visualization . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 607.4 Surface tension . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 60

8 Projects 638.1 General . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 63

8.1.1 Which mesh for which Reynolds number ? . . . . . . . . . . . . . . . . . 638.2 Drag and lift of an obstacle . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 63

8.2.1 Benchmark . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 638.2.2 Rotating cylinder . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 648.2.3 Airfoil . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 64

8.3 Moving objects . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 648.3.1 Free fall . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 648.3.2 Fluid structure interaction . . . . . . . . . . . . . . . . . . . . . . . . . . . 648.3.3 oscillating cylinder . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 64

8.4 Free surface . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 648.4.1 Glass forming process . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 648.4.2 Density waves . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 648.4.3 Inclined plane . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 648.4.4 Waves on the beach . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 658.4.5 Rayleigh-Taylor instability . . . . . . . . . . . . . . . . . . . . . . . . . . . 65

8.5 Free convection . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 65

A Appendix 67A.1 Hilbert spaces, minimization under constraint . . . . . . . . . . . . . . . . . . . . 67A.2 Elliptic problems and Finite Element Method . . . . . . . . . . . . . . . . . . . . 68A.3 Differential calculus. Integration by parts . . . . . . . . . . . . . . . . . . . . . . 71

Page 5: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

Chapter 1

Models for incompressible fluids

1.1 Some basics on viscous fluid models

Definition 1 (Stress tensor)We consider a fluid, possibly in motion, x a point in the domain occupied by the fluid, n a unitvector, and Dε(n) a disc (or a segment is the space dimension is 2) centered at x, with areaε (length ε in dimension 2), and perpendicular to n. We denote by Fε(n) the force exerted onDε(n) by the fluid located on the side of Dε(n) to which n points. If Fε(n)/ε goes to F(n) whenε goes to 0, and if the mapping n 7−→ F(n) is linear, we call stress tensor at x the tensor σ thatrepresents this linear mapping:

F(n) = σ · n.

The motion of a fluid that admits a stress tensor follows an evolution equation that can beformalized in a very general way. We denote by ρ = ρ(x, t) the local density, by u the velocityfield, and by f a body force acting on the fluid (like gravity). Consider a fluid element ω(t), i.ea set of particle which we follow in their motion. Newton’s law write

d

dt

ω(t)ρu = sum of external forces. (1.1)

The right-hand side is the sum of the body force contribution∫

ω f , and the net force exerted onω by the fluid located outside ω, which writes, according to Definition 1,

∂ωσ · n =

ω∇ · σ.

The left-hand side of Eq. 1.1 now writes

d

dt

ω(t)ρu =

ω(t)

∂(ρu)

∂t+

∂ω(t)ρu(u · n),

and the last term can be transformed onto a volume integral:∫

∂ω(t)ρu(u · n) =

ω(t)∇ · (ρu⊗ u) ,

where u⊗u stands for the symmetric matrix (ui uj)i,j. Since all integrals are now expressed asvolume integrals, and since the fluid element is arbitrary, we deduce that the integrand vanishesidentically.

5

Page 6: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

6 CHAPTER 1. MODELS FOR INCOMPRESSIBLE FLUIDS

Model 1 (General evolution equation for an inertial fluid)We consider a fluid with density ρ(x, t) and velocity field u(x, t), submitted to a body force f .We assume that this fluid admits a stress tensor σ(x, t). Newton’s law writes

∂t(ρu) +∇ · (ρu⊗ u)−∇ · σ = f . (1.2)

Mass conservation writes∂ρ

∂t+∇ · (ρu) = 0.

Model 2 (Force balance equation for an non-inertial fluid)Whenever inertia can be considered as negligible, Newton’s law is replaced by instantaneous forcebalance for all fluid element, which expresses

−∇ · σ = f .

Definition 2 (Perfect fluid)A fluid is said to be perfect if it admits a stress tensor which is diagonal, i.e. there exists ascalar field p, called pressure, such that

σ(x) = −p Id,

where Id is the identity tensor.

According to the previous models and definitions, an inertial perfect fluid is such that

−∇ · σ = ∇ · (p Id) = ∇p,

and we obtain Euler’s equation

∂t(ρu) +∇ · (ρu⊗ u) +∇p = f .

In the case where the fluid is homogeneous (ρ is uniform) and incompressible (the divergenceof the velocity field is 0), one has

∇ · (ρu⊗ u) = ρ (u · ∇)u,

where (u · ∇)u is such that

((u · ∇)u)i =d∑

j=1

uj∂ui∂xj

.

Remark 1 Consider the velocity field u as stationary, and consider a scalar function f definedon the domain. Denote by X(t) the path of a particle (advected by the velocity field). Then

d

dtf (X(t)) =

d∑

j=1

uj∂f

∂xj.

Page 7: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

1.1. SOME BASICS ON VISCOUS FLUID MODELS 7

+

+

=

Figure 1.1: Local decomposition of a two-dimensional velocity field

Newtonian fluids. Real fluids are characterized by a resistance to deformation. We considera fluid element moving in the neighborhood of t 7→ x(t). The velocity field can be expanded inthe neighborhood of x as

u(y, t) ≈ u(x, t) +∇u(x, t) · (y − x)

= u(x, t)︸ ︷︷ ︸

Translation

+

∇u− t∇u

2︸ ︷︷ ︸

Rotation

+∇u+ t∇u

2︸ ︷︷ ︸

Deformation

· (y − x).

The motion of a material segment xy can therefore be decomposed into 3 contributions: atranslational motion at the local velocity, a rotational motion (skew symmetric part of thevelocity gradient), and a last contribution that accounts for local deformations (symmetricpart of the velocity gradient). See Fig. 1.1 for an illustration of this decomposition for a twodimensional velocity field.

Definition 3 (Strain tensor)

Page 8: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

8 CHAPTER 1. MODELS FOR INCOMPRESSIBLE FLUIDS

Considering a fluid moving according to the velocity field u, the strain tensor is defined as

T =∇u+ t∇u

2=

1

2

2∂u1∂x1

∂u1∂x2

+∂u1∂x2

∂u1∂x2

+∂u1∂x2

2∂u2∂x2

(in 2d).

The simplest real fluid model is built by considering that the stress tensor is proportional tothis strain tensor, up to a diagonal contribution:

Definition 4 (Newtonian fluid)A fluid is said newtonian is there exists a positive parameter µ, called viscosity, and a scalarfield p = p(x, t) (pressure), such that

σ = 2µT− p Id = µ(∇u+ t∇u

)− p Id .

We consider now incompressible fluids, i.e. such that the volume of a fluid element remainsconstant: ∇ ·u = 0. We furthermore assume that the fluid is homogeneous: ρ is supposed to beuniform and constant.

The incompressible Stokes and Navier-Stokes equations are straightforward expressions ofthe Newtonian character, in the non-inertial and inertial settings, respectively.

Since ρ is constant, it can be taken out of the time derivative. Besides, as

∇ · u =

d∑

i=1

∂ui∂xi

= 0,

we have

∇ · (u⊗ u) = ∇ · (ui uj)i,j =

(d∑

i=1

ui∂uj∂xi

)

1≤j≤d

.

The latter quantity expresses the derivative of the velocity in its own direction, and it is denotedby (u · ∇)u.

Model 3 (Incompressible Navier-Stokes equations)An inertial fluid that is newtonian, incompressible, and homogeneous (the density is constant),and which is subject to a body force f , follows the incompressible Navier-Stokes equations

ρ

(∂u

∂t+ (u · ∇)u

)

− µ∆u+∇p = f

∇ · u = 0.

Adimensional form of the Navier-Stokes equations. Let U be the order of magnitude ofthe velocity, L the length scale (a characteristic dimension of the domain), and T = L/U theassociated time scale. We introduce the dimensionless quantities

u⋆ =u

U, x⋆ =

x

L, t⋆ =

t

T.

Denoting by ∇⋆ (resp. ∆⋆) the gradient (resp. Laplacian) operator with respect to the adimen-sional space variable, we obtain

∂u⋆

∂t⋆+ (u⋆ · ∇⋆)u⋆ −

µ

ρUL∆⋆u⋆ +∇⋆p⋆ = f⋆,

Page 9: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

1.2. MATHEMATICAL FRAMEWORK 9

where p⋆ = p/(ρU2) is the adimensional pressure, and f⋆ = fL/(ρU2) the adimensional forcingterm.

The quantity Re = ρUL/µ is called the Reynolds number. It quantifies the relative impor-tance of inertia compared to viscous effects. When this number is small compared to 1, it can beconsidered that inertial effects are negligible, so that Newton’s law for fluid elements simplifiesto local force balance

Model 4 (Incompressible Stokes equations)A fluid that is newtonian and incompressible, subject to a body force f in a regime where inertiacan be neglected, follows the incompressible Stokes equations

−µ∆u+∇p = f

∇ · u = 0(1.3)

If we consider the situation where the fluid is enclosed in a domain delimited by physical,impermeable walls, it is usually considered1 that the fluid sticks to the wall, which expresses ashomogeneous Dirichlet boundary conditions u = 0 on the boundary ∂Ω.

Exercise 1 One considers a circular domain Ω centered at 0, and ω a given angular velocity.Show that the rigid velocity field

u = ω

(−yx

)

is a steady solution to the incompressible Navier-Stokes equations, i.e. that there exists a pressurefield p(x, y) such that (u,p) is a solution to (3.20), with ∂u/∂t = 0.

Remark 2 The description of phenomena associated to flows at high Reynolds number goes farbeyond the scope of this course, and the understanding of turbulence (which refers to situationswhere complex motions occur over a large large a space scales) still raises many open questions.Let us simply say here that high Reynolds flows can be pictured as containing eddies over a largerange of sizes, starting to the global size of the observed phenomenon, down to much smallerscales. It is usually considered that dissipation occurs at some space scale η (smaller size ofthe eddies). According to Kolmogorov’s theory, L/η is of the order Re3/4. This formula givesa precious indication in the context of numerical simulations. If one aims at discretizing thespace in order to “capture” (i.e. represent on the mesh) the smallest eddies, the number of meshvertices in each direction scales at Re3/4, so that in 3d, the total number of vertices is Re9/4. Thisremark concerns Direct Navier-Stokes simulations (called DNS). Other methods, like Large EddySimulation (LES) method, or methods based on the so-called k−ε model, have been introduced tolimit the cost of numerical simulation by discretizing at a scale larger than η. Those approachesrely on assumptions regarding what happens at scales smaller than the mesh size, and involveextra unknown pertaining to those phenomena (like the kinetic energy k associated to smallerscales in the k − ε model).

1.2 Mathematical framework

A variational formulation is obtained by considering a test function v which vanishes on theboundary of the domain Ω, taking the scalar product of the first equation of (1.3) by v and

1This strong assumption is sometimes ruled out. In some situations it is in particular more relevant to usethe so-called Navier conditions, which still preserve the impervious character of the wall, but allow a non zerotangential velocity.

Page 10: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

10 CHAPTER 1. MODELS FOR INCOMPRESSIBLE FLUIDS

integrating by part, which leads to

µ

Ω∇u : ∇v −

Ωp∇ · v =

Ωf · v.

Considering now a scalar test function q, the incompressibility constraint can be expressessimilarly in a weak form. Note that, since only the gradient of the pressure appears in (1.3),only uniqueness up to an additive constant may be expected2. For this reason, we shall prescribean extra constraint on this variable: the mean value over the domain must be zero. The problemmay now be expressed in an appropriate mathematical sense as follows

V = H10 (Ω)

d , X = L20(Ω)

µ

Ω∇u : ∇v−

Ωp∇ · v =

Ωf · v ∀v ∈ V

Ωq∇ · u = 0 ∀q ∈ X.

(1.4)

where H10 (Ω)

d is the Sobolev space of vector fields the components of which are L2 functionwith square integrable gradient, and which vanish on the boundary ∂Ω, and

L20(Ω) =

q ∈ L2(Ω) ,

Ωq = 0

.

Proposition 1 Let f be given in L2(Ω)d. Problem (1.4) admits a unique solution (u,p) ∈ V×X,where u minimizes

v 7−→ J(v) =µ

2

Ω|∇v|2 −

Ωf · v,

among all those fields in H1(Ω) which are divergence-free (i.e. ∇ · u = 0).

Proof : Problem (1.4) is the saddle-point formulation of a minimization problem of the type (A.2)(page 67), where K = kerB is the set of divergence free fields. By Proposition 12, page 68, it issufficient to prove that B, which is the (opposite of the) divergence operator is surjective. Thisenlightens the necessity to consider the set of pressure with zero mean. As V consists of velocityfields which vanish on the boundary, any field v ∈ V is such that

Ω∇ · u =

∂Ωu · n = 0,

so that B maps V onto scalar fields with zero means. We refer to [10] for a proof of this property.

Because of the advective term (u · ∇)u, which comes from the fact that Newton’s law iswritten for a fluid element in motion, the Navier-Stokes equations are nonlinear, and this non-linearity makes the problem much more difficult to solve. A huge literature is dedicated to thisproblem, which still presents unresolved issues. In particular, in the three-dimensional setting,i.e. in the most interesting case from the modeling standpoint, there is no general proof of exis-tence of smooth solutions defined globally in time. Weak solutions (in the spirit of Definition 5below) can be defined, and there existence under very general assumptions is known since the

2In the context of lung modeling, this technical problem will actually disappear, as we shall deal with domainwith inlet and outlets, so that this indeterminacy shall not be met.

Page 11: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

1.2. MATHEMATICAL FRAMEWORK 11

celebrated paper by Leray [13], but uniqueness of those weak solutions is an open issue. Thetwo standpoints are related, as uniqueness of smooth solutions holds. We shall focus in thischapter on the notion of weak solution, and in particular the role played by a priori estimates,which make it possible to build weak solutions by means of compactness arguments. We referthe reader to [19, 14, 9] for details on the analysis of the Navier-Stokes equations.

To emphasize the role played by a priori estimates, let us start with the so-called energybalance, which expresses how the different types of energy interact. In the case of a fluid enclosedin a domain with no-slip condition on the wall, this balance will contain three contribution:

1. time derivative of the kinetic energy (stored by the system);

2. power dissipated by viscous effects (lost by the system);

3. power of external forces (supplied to the system).

Note that the system is not closed in terms of energy as temperature is not accounted for. Inpractice, dissipation transforms kinetic energy into heat, which ends up in the system as internalenergy (the temperature increases).

Energy balance is obtained by multiplying the momentum equation by the velocity itself,and by integrating by part. Assuming that the velocity is sufficiently regular to allow thoseoperations, we obtain

d

dt

Ω

ρ

2|u| 2 + µ

Ω|∇u|2 =

Ωf · u.

Time integration over an interval (0, T ) gives

Ω

ρ

2|u(x, T )| 2 =

Ω

ρ

2|u(x, 0)| 2 −

∫ T

Ω|∇u|2 +

∫ T

0

Ωf · u, (1.5)

which expresses that the kinetic energy is the sum of its initial value and the work of externalforces, minus the dissipated energy during (0, T ). Assuming that a finite energy is supplied to thesystem, the kinetic energy will remain bounded, and so is the dissipated energy. Those physicalconsiderations are integrated in the mathematical framework through the space in which theproblem is set. We introduce

V =

v ∈ H10 (Ω)

d , ∇ · v = 0

, H = VL2

, (1.6)

where VL2

is the complete closure of V for the L2 norm. Considering now a divergence-freevelocity field u(x, t) over Ω×(0, T ), the fact that the kinetic energy is bounded over (0, T ) writes

u ∈ L∞(0, T ;H) =

v , ess sup(0,T )

Ω|v(·, t)|2 dx < +∞

.

Similarly, boundedness of the dissipated energy over the interval (0, T ) is equivalent to therequirement that u belongs to

L2(0, T ;V ) =

v ,

∫ T

0

Ω|∇v|2 dx dt < +∞

.

The theoretical framework is based on a variational formulation of the problem, which is obtainedby multiplying the momentum equation by a test function v ∈ V , and integrating by part theviscous term, which leads to the following formulation of the problem:

Page 12: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

12 CHAPTER 1. MODELS FOR INCOMPRESSIBLE FLUIDS

Definition 5 (Weak solution of the Navier-Stokes equations)Let V and H be defined by (1.6). We consider a forcing term f ∈ L2(0, T ;V ′), and an initialcondition u0 ∈ H. Following [14], we say that (x, t) 7→ u(x, t) is a weak solution to the Navier-Stokes equations, with initial condition u0, if

u ∈ L2(0, T ;V ) ∩ L∞(0, T ;H),

ρd

dt

Ωu · v + ρ

Ω(u · ∇)u · v + µ

Ω∇u : ∇v =

Ωf · v ∀v ∈ V

u(·, 0) = u0.

Theorem 1 Let Ω be a bounded, regular domain, T > 0. The incompressible Navier-Stokesequations admit at least a solution u(x, t) in (0, T ), in the sense of Definition 5.

Proof : We give here a sketch of the proof, based on the Faedo-Galerkin approach, which consistsin introducing a special basis of V . We refer to [14, 19] for a detailed proof. We aim out pointintout the difficulties that we can expect in extending this approach to the situation that we areinterested in, namely the case of open domains (with fluid getting in or out of the domain). Thus,we shall restrict our attention here to the way a priori estimates allow to prove well-posednessof a finite dimensional version of the original problem. Let us first note that the problem canbe written in an abstract form as

d

dt(u, v) + c(u, v, v) + a(u, v) = 〈ϕ , v〉 ∀v ∈ V, (1.7)

where V and H are two Hilbert spaces, V ⊂ H with compact and dense injection, and (·, ·)denotes the scalar product in H × H. The bilinear form a(·, ·) is symmetric, continuous, andelliptic over V × V , so that we can use it as a scalar product in V . We denote by ‖·‖ the normin V , and by |·| the norm in H.

Consider the eigenvalue problem

a(w, v) = λ(w, v) ∀v ∈ V.

We define the operator A ∈ L(V, V ′) by (Au, v) = a(u, v), for all v ∈ V . For any f ∈ H, thereexists a unique u such that a(u, v) = (f, v), so that A−1 is in L(H). Since

∥∥A−1f

∥∥ ≤ C |f |,

A−1 is compact. The eigenvalue problem therefore admits a sequence of solutions (wn, λn),where 0 < λ0 ≤ λ1 ≤ . . . , the sequence (λn) goes to infinity, and (wn) is an Hilbert basis of H.Denoting by Vm the linear space spanned by w1, . . . , wm, the variational problem (1.7) can bewritten in Vm, by looking for a solution of the form

um =m∑

j=1

ujm(t)wj ,

such that (1.7) is verified for all test functions in Vm. We obtain a system of m ordinary differ-ential equations with unknown functions t 7→ ujm(t), for which the Cauchy Lipschitz Theoremensures existence and uniqueness of a maximal solution. Now the energy balance (1.5) can bewritten in the abstract setting, for any t ∈ (0, T ):

1

2|um(t)|2 +

∫ t

0a(um, um) =

1

2|um(0)|2 +

∫ t

0〈ϕ , um〉.

We have

|〈ϕ , um〉| ≤ ‖ϕ‖ ‖um‖ ≤1

2‖ϕ‖2 +

1

2‖um‖2 ,

Page 13: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

1.3. FREE IN-/OUTLET CONDITIONS 13

Ω

Γw

Γw

Γin

Γout

Figure 1.2: Pipe-like domain

with ‖um‖2 = a(um, um), so that finally

|um(t)|2 +

∫ t

0a(um, um) = |um(0)|2 +

∫ t

0‖ϕ‖2V ′ .

As a consequence, |um(t)| can not blow up in finite time, and the solution given by the CauchyLipschitz theorem is global, i.e. defined up to the end T of the time interval. The sequence (um)is bounded in

L2(0, T ;V ) ∩ L∞(0, T ;H).

The proof is ended by compactness arguments: um weakly converges (up to a subsequence) toa limit u ∈ L2(0, T ;V ) ∩ L∞(0, T ;H), and the rest of the proof mainly consists in proving thatu is a weak solution to the Navier-Stokes equations. We refer to [14, 19, 9] for details.

1.3 Free in-/outlet conditions

To fix the ideas, we consider a pipe-like domain Ω whose boundary ∂Ω = Γ is decomposed intothree components: The lateral component Γw corresponds to a rigid wall, on which homogeneous

Page 14: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

14 CHAPTER 1. MODELS FOR INCOMPRESSIBLE FLUIDS

Dirichlet boundary conditions are prescribed, Γin is the inlet, and Γout the outlet. We aim atmodeling the flow of some viscous fluid through the pipe, in a way which allows to keep thepossibility to couple this pipe to other components of a multi-element model.

1.3.1 Prescribed normal stress

The simplest approach for setting boundary conditions consists in considering that the normalcomponent of the stress tensor (see Definition 1, page 5) is known. The stress tensor is

σ = µ(∇u+ t∇u)− p Id

so that free outlet conditions (expressing force balance in the normal direction) reads

µ(∇u+ t∇u) · n− pn = −Pextn. (1.8)

This option may make sense from a modeling point of view, yet it corresponds to a situationwhere the viscous fluid is separated by Γout (or Γin) from a fluid in which the stress tensor isdiagonal (like a perfect gas), and it would make clear sense if Γout were indeed a free surfaceseparating the viscous fluid and such a medium.

But it might not be the case, if we are interested in a situation where the pipe continuesbeyond Γout. It turns out that a better way to account for this continuing pipe consists inprescribing a boundary condition of the type

µ∇u · n− pn = −Pextn (1.9)

which does not make clear sense from a physical point of view (the non symmetric tensor ∇uhas no mechanical significance), but which makes it possible to recover the exact solution incase of Poiseuille’s flow in a cylinder. As Conditions (1.9) correspond to the situation where theactual fluid domain continues beyond the boundary, we shall call those conditions free outlet (orinlet) conditions.

Figure 1.3 illustrates the difference between the 2 types of conditions. The velocity field onthe left (parabolic profile) corresponds to free outlet conditions (1.9), and the plot on the rightrepresents the same zone for free surface conditions (1.8). Computation have been performedwith the software FreeFem++[8].

Mathematical framework. Neumann conditions (1.8) (free surface) or (1.9) (free outlet)raise theoretical issues. For the Navier-Stokes equations, as we shall see, the fact that some fluidis entering the domain will make it much more difficult to establish a priori estimates. As a firststep, we start with the Stokes problem. We introduce

V =

v ∈ H1(Ω)d , v|Γw= 0,

and the set of pressure X = L2(Ω). The variational formulation corresponding to the free outletconditions is

µ

Ω∇u : ∇v−

Ωp∇ · v =

Ωf · v −

Γin

Pinn · v −

Γout

Poutn · v ∀v ∈ V, (1.10)

together with the weak expression of the divergence free constraint∫

Ωq∇ · u = 0 ∀q ∈ X.

Page 15: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

1.3. FREE IN-/OUTLET CONDITIONS 15

Figure 1.3: Free outlet conditions based on the velocity gradient (left) and on the strain tensor(right).

Proposition 2 We consider the Stokes problem on domain Ω represented in Figure 1.2, withhomogeneous Dirichlet on the lateral boundary Γw and free in-/ out-let conditions (1.9) onΓin ∪ Γout. The problem admits a unique solution.

Proof : In the present situation, the velocity may have non zero values on some part of theboundary, and the pressure is no longer defined up to a constant. This makes the proof ofthe surjectivity of the divergence operator B slightly different. Considering a pressure fieldq ∈ L2(Ω), the first step consists in building a velocity field v such that

∫∇ · v =

∫q, which

is straightforward as v may have non zero values on Γin ∪ Γout. The rest of the proof is thenidentical to the case of homogenous boundary conditions, by considering the pressure minus itsmean value over Ω.

Remark 3 If one considers free surface conditions (1.8), the variational formulation is modi-fied:

µ

Ω

(∇u+ t∇u

):(∇v + t∇v

)−

Ωp∇ · v

=

Ωf · v −

Γin

Pinn · v −

Γout

Poutn · v ∀v ∈ V,

The bilinear form involves the symmetrized velocity gradient. Ellipticity of this bilinear form is

Page 16: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

16 CHAPTER 1. MODELS FOR INCOMPRESSIBLE FLUIDS

a consequence of Korn’s inequality, which ensures existence of a constant such that∫

Ω

∣∣∇v + t∇v

∣∣2 ≥ C

Ω|∇v|2 ∀v ∈ V,

as soon as V is a subset of H1(Ω)d which does not contain any rigid motion other than 0,which is the case here thanks to the no-slip condition on the lateral boundary. Those conditionscomplicate the numerical resolution. Whereas the matrix corresponding to free outlet conditionsis block-diagonal (scalar Laplace operator for each component of the velocity), it is no longerblock-diagonal for the form that is based on the symmetrized tensor.

1.4 Some typical problems

We describe here some situations for which the exact solution cannot be given analytically.

1.4.1 Flow around an obstacle

A great amount of computational strategies to approximate solutions to the Navier-Stokes equa-tion have been developed during the last decades to address the following problem (representedin the two dimensional setting by Fig. 1.4): consider a flow of a viscous fluid around a fixedobstacle O, one is interested in estimating the forces exerted by the fluid on the obstacle. Theproblem consists in solving incompressible Navier-Stokes equations in the fluid part Ω, withno-slip conditions on the boundary γ of the obstacle. The question of boundary conditions onthe outer boundary raises some interesting issues. A first model consists in assuming that theouter boundary is far enough from ω, so that the flow there is not affected by the presenceof the obstacle. In this case, it is reasonable to assume the velocity to be fixed on Γ = ∂Ω,equal to a “velocity at infinity” U∞. The approach may lead to a large exterior domain, andthereby high computational costs. A great amount of investigations has been undertaken topropose alternative strategies to overcome this problem, by elaborating appropriate boundaryconditions on the outer boundary.

In the case where ω represent an airfoil, quantities of interested are the lift force (portancein french) Fy, and the drag (traınee) Fx

Fy = −ey ·

γσ · n , Fx = −ex ·

γσ · n.

The lift force maintains the aircraft in the air (it balances the total weight of the flying plane),whereas drag is opposed to motion, thereby conditioning the price to pay to make the planeflying.

1.4.2 Some simple fluid-structure interaction problems

In real life application, one is commonly interested in modeling the way a fluid interacts withanother medium, like an elastic structure. This problem raises issues which are still the objectof active research, both on the theoretical and numerical aspects. We present here here twosituations where the number of degrees of freedom for the structure is finite.

Spring-mass-fluid system. We consider the situation represented in Fig. 1.5 (left). Thedomain Ω is bounded on the right side by a piston with mass m, attached to a spring withstiffness k > 0. Despite its formal simplicity, this example calls for a special care of boundary

Page 17: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

1.4. SOME TYPICAL PROBLEMS 17

O γ

Ω

Figure 1.4: Flow around an obstacle

conditions : as the motion of the piston is not compatible with the no-slip condition on thelateral boundary, we shall assume that the fluid may slip freely along this part of the boundary.Assuming the fluid sticks to the piston, the global problem may be written

ρ

(∂u

∂t+ (u · ∇)u

)

− µ∆u+∇p = 0 in Ω(t)

∇ · u = 0 in Ω(t)

u = 0 on Γ0

σ · n = 0 on Γin

u · n = 0 , t · σ · n = 0 on Γℓ

u = x ex on Γm

supplemented by Newton’s law for the piston:

md2x

dt2= −k(x− x0)−

Γm

σ · n.

Fluid particle flow. In this second example (see Fig. 1.5, right), we consider a rigid discflowing freely in a viscous fluid. Denoting by ρs the density of the solid, and by m its mass,the fluid problem can be written in the form of incompressible Navier-Stokes equations in themoving domain Ω(t) (with right-hand side ρg, supplemented by two types of coupling conditions:

1. Kinematic coupling. No-slip condition on the boundary of the body writes

u = U+ ω ∧ r on γ.

2. Dynamic coupling. Newton’s law for the particle translational and angular velocity write

mdU

dt= −

γσ · n+mg , J

dt= 0,

where J is the moment of inertia of the disc.

Page 18: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

18 CHAPTER 1. MODELS FOR INCOMPRESSIBLE FLUIDS

Ω Ω

OΓ0

Γ0

Γin Γm

Γℓ

Γℓ

γ

k

U

ω

Figure 1.5: Interaction with a rigid structure

The problem is written here for a single particle, but it can be extended straightforwardly to themany-body situation (with 3 degrees of freedom per particle, together with a three dimensionalcoupling between each particle and the fluid).

Page 19: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

Chapter 2

Navier-Stokes equations, numerics

Navier-Stokes equations possess several terms that need to be handled adequately in view of afull numerical scheme. Indeed, one faces three problems that seem quite uncoupled and followdifferent (though complementary) strategies:

• The incompressibility constraint div u = 0 and the related pressure gradient ;

• The nonlinearity present in the convective term ;

• The time dependence. The equation is non stationary, and a suitable time marchingalgorithm needs to be written.

We hereafter discuss those three aspects of the problem and detail the natural links betweenthem as far as the discretization by the finite element method is concerned.

2.1 The incompressibility constraint, Stokes equations

Let us start with the first problem, namely the discretization of the constraint div u = 0 . Tothis aim, we consider only Stokes equations, where, in order to focus only on the mathematicalaspects of the problem, the viscosity has been taken equal to unity :

[−∆u+∇p = f ,div u = 0 .

(2.1)

We have already seen that, depending on the Neumann boundary conditions that one con-siders, there are typically two variational formulations associated to (2.1), namely

Find (u, p) ∈ V ×M , such that for all (v, q) ∈ V ×M ,

Ω∇u : ∇vdx−

Ωpdiv v dx =

Ωf · v dx ,

Ωq div u dx = 0 ,

(2.2)

orFind (u, p) ∈ V ×M , such that for all (v, q) ∈ V ×M ,

Ω(∇u+ t∇u) : ∇vdx−

Ωp div v dx =

Ωf · v dx ,

Ωq div u dx = 0 .

(2.3)

19

Page 20: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

20 CHAPTER 2. NAVIER-STOKES EQUATIONS, NUMERICS

Both variational formulation lead to the same Stokes equations inside the domain due to thefact that

div(t∇u

)= ∇(div u) = 0

since the vector field must be incompressible. They however lead to different Neumann boundaryconditions when one integrates by part. It can be shown that both formulations leads to well-posed problems1 provided V ⊂ H1(Ω,R3) and M = L2(Ω,R)/R.

When the discretization by the finite element method is concerned, it turns out that thereis an additional problem due to the discretization of the Hilbert spaces V and M . Indeed, thediscrete variational formulation associated with (2.2) for instance (the corresponding holds for(2.3)) reads as follows

Find (uh, ph) ∈ Vh ×Mh , such that for all (vh, qh) ∈ Vh ×Mh ,

Ω∇uh : ∇vhdx−

Ωph div vh dx =

Ωf · vh dx ,

Ωqh div uh dx = 0 ,

(2.4)

where Vh ⊂ V and Mh ⊂M are two finite dimensional subspaces of V and M respectively. Thepreceding problem has a clear energetic formulation. Namely uh can be seen as minimizing

E(uh) =1

2

Ω|∇uh|

2 dx−

Ωf · uh dx

under the constraint(s)∫

Ωqh div uh dx = 0 ,∀qh ∈Mh . (2.5)

One sees that if the constraints expressed by (2.5) are too numerous, there might be only onefunction satisfying all those which is uh = 0. This might for instance be the case if unfortunatelydim(Mh) > dim(Vh). If on the other hand, there are not enough constraints in (2.5), then theremight be a convergence problem. It is unclear why the discrete solution found uh should beclose to the continuous one u. Therefore the finite element spaces Vh andMh need not be chosenseparately. Some choices are known to be unstable (they do not lead to a convergent discretesolution as the space step h goes to 0) like the natural couples

Vh = P 1 , Mh = P 1 or Vh = P 1 , Mh = P 0 .

Other choices lead to both convergent and well posed discrete formulations, the most knownbeing

Vh = P 2 and Mh = P 1 .

In the former, P k stands for the classical polynomial approximation of degree k on a triangula-tion, also known as the Lagrange finite element of degree k.

To finish for the time being on this question, let us say that stable and convergent choicesfor the finite element spaces Vh and Mh are those which satisfy the following Inf-Sup condition

infh>0

infqh∈Mh

supvh∈Vh

Ωqh div vh dx

||qh||M ||vh||V≥ β > 0 . (2.6)

1Of course, extra work is needed here. Lax-Milgram lemma does not apply directly because the bilinear formis not coercive, suitable boundary conditions need to be considered, Korn’s inequality is needed to prove existenceand uniqueness of the second formulation, etc. It is not the aim of the authors, at this level of the discussion todiscuss these problems.

Page 21: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

2.2. TIME DISCRETIZATION 21

Temporary conclusion: Due to stability problems the velocity/pressure need to be computedusing a stable finite element, typically (P 2, P 1).

2.2 Time discretization

2.2.1 Generalities

Let us focus now on the time discretization. At first sight, Navier-Stokes equations are verysimilar to the scalar heat equation, in the sense that forgetting the nonlinearity for the timebeing, the remaining terms of the equations are parabolic.

For scalar and linear problems like the heat equation

∂u

∂t−∆u = f,

time discretization strategies can be described straighforwardly. The simplest time-discretizationapproach is the explicit Euler scheme

un+1 − un

δt−∆un = f, (2.7)

where δt is the time step. The implicit version writes

un+1 − un

δt−∆un+1 = f.

Extensions of those two approaches can be built to obtain a better accuracy in the time reso-lution. As an example, the Crank-Nicholson scheme (which can be described as half explicit -half implicit)

un+1 − un

δt−

1

2

(∆un +∆un+1

)= f,

is more accurate (second order in time), whereas it preserves the stability properties of theimplicit scheme.

Of course, all these schemes must be thought in weak form. Namely, calling Vh the finiteelement space in which the solution is sought, we have for the explicit Euler scheme (2.7)

Ωun+1v dx =

Ωunv dx− δt

Ω∇un∇v dx+ δt

Ωfv dx .

Similar expressions can be derived for the implicit or Crank-Nicholson schemes.

All these schemes enter in the class of the so-called θ−scheme which for a parameter θ ∈ [0, 1]writes

un+1 − un

δt−((1− θ)∆un + θ∆un+1

)= f, (2.8)

where θ = 0 corresponds to the explicit scheme, θ = 1 the implicit scheme and θ = 12 is the

Crank-Nicholson scheme.

There is again a stability issue given by the following proposition.

Proposition 3 After a finite element space discretization, the θ−scheme is uniformly and un-conditionally stable (and convergent) provided θ ≥ 1

2 .

Page 22: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

22 CHAPTER 2. NAVIER-STOKES EQUATIONS, NUMERICS

Proof : (Hint.) A recipe to prove the stability is to look for a discrete energy bound. Thesolution to the heat equation, verifies, when the right-hand side f vanishes the two following

estimates abstained respectively by multiplying the equation by u anddu

dt:

1

2

d

dt

Ωu2 dx+

Ω|∇u|2 dx = 0 ,

and∫

Ω

∣∣∣∣

du

dt

∣∣∣∣

2

dx+1

2

d

dt

Ω|∇u|2 dx = 0 .

Both equations give after integration in time a bound of a positive quantity, namely L2 and the10 norms respectively

||u(T )||2L2 +

∫ T

0

Ω|∇u|2 dx = ||u(0)||2L2

and

||∇u(T )||2L2 +

∫ T

0

Ω

(du

dt

)2

dx = ||∇u(0)||2L2 .

The idea is to mimic those results in the discrete case. For the L2 stability, multiplying thescheme (2.8) by uθ := (1− θ)un + θun+1 (with f = 0) and integrating by parts leads to

Ω

un+1 − un

δtuθ +

Ω|∇uθ|

2 dx = 0 ,

which, noticing that uθ =un + un+1

2+ (2θ − 1)

un+1 − un

2leads to the estimate

Ω

(un+1)2

2δtdx+ (2θ − 1)

Ω

(un+1 − un)2

2δtdx+

Ω|∇uθ|

2 dx =

Ω

(un)2

2δtdx .

When θ ≥ 12 this gives the uniform bound (for all n, δt, h) for the L2 norm

Ω(un)2 dx ≤

Ω(u0)2 dx .

Similarly, one can use the second estimate. Namely, multiplying now (2.7) byun+1 − un

δtgives

Ω

(un+1 − un

δt

)2

dx+

Ω∇uθ · ∇

(un+1 − un

δt

)

dx = 0 ,

which, writing again uθ =un + un+1

2+ (2θ − 1)

un+1 − un

2leads now to the estimate

Ω

∣∣∇un+1

∣∣2

2δtdx+

Ω

(un+1 − un

δt

)2

dx+ (θ −1

2)δt

Ω

∣∣∣∣∇

(un+1 − un

δt

)∣∣∣∣

2

dx =

Ω

|∇un|2

2δtdx ,

Again, when θ ≥ 12 , we obtain the uniform estimate (for all n, δt, h)

Ω|∇un|2 dx ≤

Ω

∣∣∇u0

∣∣2dx .

Page 23: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

2.2. TIME DISCRETIZATION 23

Exercise 2 Extend those results for the case of a non vanshing external force f .

Temporary conclusion: Implicitizing the Laplace term in the heat equation increases thestability of the underlying finite element scheme. It is typically unconditional between theCrank-Nicolson scheme (θ = 1

2) and the fully implicit scheme (θ = 1).

2.2.2 Going back to Navier-Stokes equations

From the preceding section, we deduce that the Laplace term is more stable when discretizedimplicitly. However, there is still the problem of the non linear term that can be treated explicitlyor implicitly.

Fully explicit scheme. The fully explicit scheme is based on an explicit evaluation of the nonlinear term in the Navier Stokes equations

ρun+1 − un

δt+ ρ (un · ∇)un − µ∆un+1 +∇pn+1 = f ,

with ∇ · un+1 = 0. As for Burger’s equation, or the even simpler transport equations, thisapproach is expected to raise stability issues. In particular, it obviously requires a so called CFLcondition, i.e. condition of the type

uδt ≤ Ch,

where C is a dimensionless constant smaller than 1.Note that it leads to a so called generalized Stokes problem

[αu− µ∆u+∇p = f ,∇ · u = 0 ,

where α = ρ/δt, and the new right-hand side f = f − ρ (un · ∇)un + ρδtu

n accounts for inertialterms. This problem has exactly the same mathematical structure as the standard Stokesproblem, and can be handled numerically as such. Note that complete space discretization maynecessitate special quadrature formulae to compute (or at least estimate) the term

(un · ∇)un · v,

in the variational formulation.

Semi-explicit scheme.The semi explicit scheme is also very popular, it consists in writing the nonlinear term as an

advection of the unknown velocity by the known one:

ρun+1 − un

δt+ ρ (un · ∇)un+1 − µ∆un+1 +∇pn+1 = f ,

with ∇ · un+1 = 0 which leads to a problem of the type[αu− µ∆u+ (U · ∇)u+∇p = f ,∇ · u = 0 ,

where U = ρun is known. The problem is still linear, but the associated bilinear form is nolonger symmetric, it is defined by

a(u,v) = α

Ωu · v + µ

Ω∇u : ∇v +

Ωv · (U · ∇)u.

Page 24: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

24 CHAPTER 2. NAVIER-STOKES EQUATIONS, NUMERICS

Fully implicit scheme. The fully implicit scheme is based on an implicit evaluation of thenon linear term in the Navier Stokes equations

ρun+1 − un

δt+ ρ

(un+1 · ∇

)un+1 − µ∆un+1 +∇pn+1 = f ,

with ∇ · un+1 = 0.Note that this approach requires to solve a nonlinear problem at each time step.

Exercise 3 Notice that if u and v are two vector fields with div u = 0 (and suitable, e.g.homogeneous Dirichlet boundary conditions), one has

Ω(u · ∇)v · v dx = 0 .

Then apply the energy method to prove unconditional stability of the semi explicit and implicitschemes.

2.2.3 The method of characteristics

The method of characteristics can be seen as a direct discretization of the total derivative.Compared to the previous methods, it is also a way of handling the non linear term explicitlybut which enjoys better stability properties than the previous explicit scheme.

Considert 7−→ χ(t)

the trajectory of a fluid particle located at x at time τ For any function Φ (scalar or vector),the total derivative of Φ at (x, τ) is

Dt

∣∣∣∣(x,τ)

=d

dtΦ(χ(t), t)

∣∣∣∣t=τ

= limε→0

Φ(χ(τ + ε), τ + ε)− Φ(χ(τ), τ)

ε

= limε→0

Φ(χ(τ), τ)− Φ(χ(τ − ε), τ − ε)

ε

∼Φ(χ(τ), τ) − Φ(χ(τ − δt), τ − δt)

δt.

Now consider that the solution un at time nδt is known, for any point of the domain. Using thepreceding formula, we see that

Du

Dt

∣∣∣∣(x,τ)

∼un+1(x) − un(y)

δt

where y is the position at time nδt of the characteristic which ends at x at time (n + 1)δt (yis the so-called “foot” of the characteristic). Notice that y is obtained by integrating backwardalong the vector field un which is known.

Calling

X : Ω −→ Ω

x 7→ y

Page 25: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

2.3. PROJECTION METHODS 25

the scheme is usually written as

αun+1 − αun X− µ∆un+1 +∇pn+1 = f .

As for the explicit scheme, the term containing X goes to the right hand side, which yields ageneralized Stokes problem:

αu− µ∆u+∇p = f ,

∇ · u = 0

where f carries the initial forcing term supplemented by the inertial term αun X.

This method can be implemented in Freefem++ using the command convect as follows.

+int2d(Th)(-convect([ux,uy],-dt,ux)*tux-convect([ux,uy],-dt,uy)*tuy)

In the preceding command, the first argument ([ux,uy]) of the convect command is the vectorfield along which the quantity needs to be advected, the second argument (-dt) is the time ofthe advection and the third argument (ux or uy) what has to be advected. The variables (tuxand tuy) stand for the test functions in the weak formulation. Notice that the integration ofthe characteristic flow is done backward.

2.3 Projection methods

Projection methods are very popular, as they split the saddle point problem onto two Poisson likeproblems. The approach described here does not rely to the way the inertial term is handled. Weshall present the approach coupled with the method of characteristics, but the other approacheswhere it is treated explicitly or implicitly could be used as well:

1. (Prediction) The velocity is predicted by solving

αun+1 − αun X− µ∆un+1 +∇pn = f ,

without the divergence constraint (notice that the pressure has be frozen to its previousvalue). This step is nothing that an implicit heat flow time step. It is clear that theincompressibility constraint has been lost during this step.

2. The velocity is now corrected by adding a pressure gradient correction term ∇rn+1 to un+1

in order that un+1 be divergence free. More precisely, one writes

[αun+1 − αun+1 +∇rn+1 = 0 ,∇ · un+1 = 0 ,

(2.9)

which yields

−∇ · ∇rn+1 = −∆rn+1 = −α∇ · un+1.

and[

un+1 = un+1 −1

α∇rn+1

pn+1 = pn + rn+1.

Page 26: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

26 CHAPTER 2. NAVIER-STOKES EQUATIONS, NUMERICS

This discretization approach therefore to Poisson like problems only : a vector problem for themomentum equation, and a scalar one for the incompressibility constraint.

Notice that (2.9) is nothing than the projection of un+1 on divergence free vector fields.Indeed, one can rewrite (2.9) as

[un+1 +∇

(1αr

n+1)= un+1 ,

∇ · un+1 = 0 ,(2.10)

which is the Helmholtz’s decomposition of un+1 as

un+1 = ∇φ+ curl ψ .

Notice also that, although there are two seemingly uncoupled steps, this splitting algorithm isconsistent with the original Navier-Stokes equations since one has

αun+1 − αun X− µ∆un+1 +∇(pn + rn+1) = f .

Page 27: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

Chapter 3

Moving domains

3.1 Lagrangian standpoint

For the sake of clarity, the kinematical approach is applied to a particular, and somewhatidealized, situation. We shall consider here a 2D free surface flow, with no inlet nor outlet, norany contact with any wall. All surfaces and functions are supposed to be sufficiently regular.The domain Ω(t) is delimited by

∂Ω(t) = Γ(t), (3.1)

where Γ(t) is the free surface. We shall disregard here the equations to which the velocity u(x, t)is a solution, and focus on the kinematical aspects. The fact that the domain Ω(t) is “moved”by the physical velocity can be expressed the following way (Lagrangian approach): one canbuild mappings

L( . , t) : Ω(0) −→ Ω(t)

x0 7−→ xt = L(x0, t) (3.2)

where s 7−→ L(x0, s) is the characteristic curve from x0 to xt in R2:

∂sL(x0, s) = u(L(x0, s), s)

L(x0, 0) = x0.

(3.3)

It can be written in integral form

L(x0, t) = x0 +

∫ t

0u (L(x0s), s) ds. (3.4)

The domain at time t can be written as

Ω(t) = L(x0, t) , x0 ∈ Ω(0). (3.5)

Navier-Stokes equations. We consider that the domain moves according to Navier-Stokesequations. Let us denote by u0 the Lagrangian velocity with respect to the initial configuration,i.e.

u0(x0, t) = u(L(x0, t), t).

27

Page 28: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

28 CHAPTER 3. MOVING DOMAINS

Since the space variable is Lagrangian, the partial time derivative of u0 is the total derivative.Indeed, for x0 fixed,

d

dtu0(x0, t) =

d

dt(u(L(x0, t), t)) =

∂tu+ (

d

∂tL(x0, t) · ∇)u

=∂

∂tu(L(x0, t), t) + (u · ∇)u =

Du

Dt.

As a consequence, the Navier-Stokes equation expressed in the Lagrangian variable at t = 0write

ρ∂u0

∂t− µ∆u0 +∇p0 = f , (3.6)

with ∇ · u0 = 0.This linearization of Navier-Stokes equations is only valid instantaneously. If one aims at

expressing it at a time t different from that of the reference domain, the partial time derivativewill still express the total derivative (i.e., the term (u · ∇)u is dropped), but the terms thatcorrespond to space derivatives will be deeply affected, in a nonlinear way. Indeed, the euleriancoordinate at time t (according to which the Laplacian et gradient operators are defined) andthe Lagrangian one x0 are related by

x0 7−→ x = L(x0, t).

Nevertheless, assuming that (3.6) is valid at the first order in a neighborhood of t = 0,it is possible to design a numerical method of the Lagrangian type, by using the Lagrangiancoordinates that corresponds to the current configuration. The time stepping approach can bedescribed in the following way.

Denote by Ωn and un the domain and velocity at time tn. We denote by un+1n the next

velocity, defined in the lagrangian coordinates associated with Ωn. It can be computed as thesolution to

ρun+1n − un

δt− µ∆un+1

n +∇pn+1n = f. (3.7)

The domain Ωn+1 is now defined the as the push forward of Ωn by δtun:

Ωn+1 = x+ δtun(x) , x ∈ Ωn .

The velocity un+1 is then defined by

un+1(x+ δtun(x)) = un+1n (x).

Note that the latter operation, as tricky as it may look, is actually trivial in terms of computation.In the discrete setting, e.g. for piecewise affine functions, un+1

n is an array of values associatedto the vertices of the triangulation T n of Ωn. The next triangulation is obtained by performing

T n+1 = T n + δtun.

The equation defining un+1 from un+1n simply consists in doing nothing to the array of velocities1.

The method that has been presented is quite simple to implement, and is based on solutionsof linear systems (the nonlinear term has been dropped). Yet, it is restricted to very fewsituations, because in practice the underlining mesh is likely to degenerate, up to creation ofreversed triangles, that will stop the computation.

1With some softwares like Freefem++, a special attention to this step has to be paid. Indeed, when a fieldis defined on a certain mesh, if the mesh is moved (e.g. with the command movemesh), when the initial fieldis called, an interpolation between the two meshes is automatically performed. In a way, Freefem++ favors thefunction represented by a discrete field before the array of values that represented. It is necessary to use auxiliaryarrays to bypass this automatic interpolation (see Section 3.4).

Page 29: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

3.2. ARBITRARY LAGRANGIAN EULERIAN (ALE) POINT OF VIEW 29

3.2 Arbitrary Lagrangian Eulerian (ALE) point of view

In what follows, we investigate the possibility to build mappings between the domains (similarto (3.5)), with a field which is not the fluid velocity. The approach is based on a definitionof the domain velocity that is partially decoupled from the fluid velocity: it has to satisfysome consistency relations so that the computational domain will follow the actual fluid domain(globally Lagrangian behavior), but it will defined within the domain in order to minimizethe domain motion (Eulerian tendency: move the vertices as little as possible). The fact thatthe second step can be performed arbitrarily explains the name of the approach: ArbitraryLagrangian Eulerian.

The definition of the domain velocity is based on a mapping

(u,Ω) 7−→ c = C(u,Ω), (3.8)

where Ω is a smooth domain, u and c are regular fields defined in Ω (domains and fields aresupposed at least C1).

Definition 6 (Consistent ALE mapping, continuous case) The ALE mapping

u 7→ c = C(u,Ω)

is said to be consistent if, for any Ω, u,

u(x) · n(x) = c(x) · n(x) , ∀x ∈ Γ, (3.9)

where n(x) is the normal vector to Γ = ∂Ω at x.

We consider a consistent ALE mapping C, and the associated domain velocity field c(x, t).

Proposition 4 The characteristics associated to the space–time field (c(x, t), 1) remain in thespace–time domain

S =⋃

t∈[0,T ]

Ω(t)× t.

In other words, the 3D field (c(x, t), 1) can be integrated in the physical space-time domain Scorresponding to the time interval [0, T ].Proof :Let us show how equation (3.9) ensures that this field is tangent to the “lateral” boundaryof S (boundary of S excepting Γ(0)×0 and Γ(T )×T). Let t = (tx, ty) be the vector tangentto Γ(t) at x. The normal vector to the space–time domain S at (x, t) can be expressed

N =

txty0

×

uxuy1

=

ty−tx

tx uy − ty ux

, (3.10)

so that, on the lateral boundary,

(c1

)

· N =

cxcy1

·

ty−tx

tx uy − ty ux

= cx ty − cy tx + tx uy − ty ux (3.11)

= u · n− c · n (3.12)

= 0 (3.13)

Page 30: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

30 CHAPTER 3. MOVING DOMAINS

t

x

yParticle pathline

ALE trajectorycc

u

(u,1)(c,1)

Figure 3.1: Space time domain

as soon as u and c verify the consistency relation (3.9).

Proposition 4 makes it possible to define applications between the Ω(t):

γ(·, t1; t2) : Ω(t1) −→ Ω(t2)

x1 ∈ Ω(t1) 7−→ x2 = γ(x1, t1; t2)

where (γ(x1, t1; t), t) is the characteristic curve from (x1, t1) to (x2, t2) in S:

d

dt(γ(x1, t1; t), t) = [c(γ(x1, t1; t), t), 1]

γ(x1, t1; t1) = (x1, t1)

For each τ , the ALE velocity is then defined by

uτ (x, t) = u(γ(x, τ ; t), t) (x ∈ Ω(τ), γ(x, τ ; t) ∈ Ω(t)) (3.14)

which is equivalent to

uτ (γ(x, t; τ), t) = u(x, t) (x ∈ Ω(t)). (3.15)

Partial derivation with respect to t of (3.15) at t = τ gives

∂u

∂t=

∂uτ

∂t+∇uτ ·

∂γ

∂t

∣∣∣∣t=τ

=∂uτ

∂t− (cτ · ∇)uτ (3.16)

Note that identity (3.15) can be used to define the ALE version of any scalar or vector fieldΦ(x, t) defined in the space time domain (for x ∈ Ω(t)).

Page 31: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

3.2. ARBITRARY LAGRANGIAN EULERIAN (ALE) POINT OF VIEW 31

c

u

R

Figure 3.2: Fields u, R, and c.

Remark 4 Evolution problems in a fixed domain lead to a cylindrical space–time domain (setproduct of the space domain by the time interval). When the domain moves, this space–timeS is non longer cylindrical. The approach which has been carried out can be seen as a way tostraighten S locally by introducing the ALE velocity: the partial time derivative of the new fieldfollows the lateral boundary of S.

3.2.1 Actual computation of the domain velocity

The proper way to define the velocity c on the boundary is highly dependent on the type of flowwhich is considered. We shall restrict ourself here to a simple way which consists in prescribingthe direction R of the boundary velocity. For a given class of domains, let R(·,Ω) be a givenfamily of vector fields : for any Ω, R is defined on Γ = ∂Ω, and it is such that R ·n > 0 on Γ. Ifwe prescribe R to be the direction of the boundary velocity, then the consistency relation (3.9)imposes the consistent ALE mapping

(u,Ω) 7−→ c = C(u,Ω) (3.17)

to be defined uniquely (on the boundary) as

c =( u · n

R · n

)

R. (3.18)

See Fig. 2 for an example of field c.

Definition of the domain velocity within the domain plays little role in the present approach.We chose to solve a Laplace equation for each component of the domain velocity c, which can

Page 32: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

32 CHAPTER 3. MOVING DOMAINS

be expressed in vector form

c = 0 (3.19)

with boundary conditions given by (3.18).

3.2.2 Navier–Stokes equations in the ALE context

We consider now a fluid motion governed by the incompressible Navier–Stokes equations

∂u

∂t+ u · ∇u− νu+∇p = g

∇ · u = 0(3.20)

with conditions on the free boundary

σ · n = −pe n− κn

R(3.21)

where R is the radius of curvature of Γ(t), κ is the surface tension coefficient (between the fluidand the external gas), pe the external pressure (which we shall take equal to 0 in the following),and σ is the total stress tensor

σ = ν(∇u+t∇u)− p1. (3.22)

ALE velocity uτ (x, t) and ALE pressure, which are defined on Ω(τ) and related to the Eulerianvelocity by (3.14), verify the ALE Navier–Stokes equations at t = τ , for every τ ∈]0, T ]:

ρ∂uτ

∂t+ ρ ((uτ − cτ ) · ∇)uτ − µuτ +∇pτ = g

∇ · uτ = 0(3.23)

The ALE Navier-Stokes equations can be discretized in time. Whereas in the Lagragianapproach, the nonlinear term disappears, it does not in the present context, since the motion ofthe domain is partially decoupled from the actual motion of fluid particles. As a consequence,a modified nonlinear term remains in the equations, and it has to be handled in some way. Themethod of characteristics can be used to handle it. The difference with the full eulerian case isthat the velocity must be advected by the velocity that is relative to the domain velocity, i.e.u− c. In the time discretized setting, the scheme consists in computing the domain velocity cn,and then solving

ρun+1n − un X

δt− µ∆un+1

n +∇pn+1n = g,

in the current domain Ωn, with ∇ · un+1n = 0, and X is the foot of the characteristic, which is

obtained by upstream integration of un − cn during δt. The next domain is then obtained as

Ωn+1 = Ωn + δtcn.

The last step consists in transferring ALE quantities to the new domain but, as explained atthe end of the previous section, this operation can be performed at zero cost.

Page 33: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

3.3. SOME APPLICATIONS OF THE ALE APPROACH 33

σ · n = 0

u = 0

u · n = 0

Figure 3.3: Fluid in a container

3.3 Some applications of the ALE approach

3.3.1 Water waves

We consider the situation illustrated by Fig. 3.3. A viscous fluid is located in a container, withan open top (free surface), in contact with a gas considered as perfect. The fluid is subject togravity forces. It is assumed to stick to the bottom boundary, and to slip with no friction onthe lateral walls:

ρ∂u

∂t+ ρ (u · ∇)uτ − µu+∇p = g in Ω(t)

∇ · u = 0 in Ω(t)

σ · n = 0 on Γ3(t)

u · n = 0 , t · σ · n = 0 on Γ2(t) ∪ Γ4(t)

u = 0 on Γ1.

In this context, it is natural to define a vertical velocity of the domain. Since its normalcomponent must equal that of the fluid velocity, the vertical component is determined:

c = c ey , c · n = u · n =⇒ c =u · n

ey · n. (3.24)

A natural way to define the interior domain velocity is to interpolate between the upperboundary and 0. It may not be so straightforward in practice: for any mesh vertex inside thedomain, one has to determine the velocity of the corresponding boundary point. This task isnot trivial for a general mesh. An alternative way consists in solving a Laplace problem overthe whole domain, for the vertical component of the domain velocity. In order to avoid diffusionin the horizontal direction, it is possible to solve use an anistropic diffusion tensor, i.e. to solve

−∇ ·D∇c = 0,

with c = 0 on Γ1, ∂c/∂n = 0 on Γ2 ∪ Γ4, and relation (3.24) on Γ3.

3.3.2 Falling water

The next situation corresponds to water falling out of a tap (see Fig. 3.4, left), and falling downa corner (see Fig. 3.4, right).

Page 34: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

34 CHAPTER 3. MOVING DOMAINS

Figure 3.4: Falling water

In the first situation, the domain velocity can be taken horizontal. In the second case, thedirection cannot be taken constant: it can be prescribed in the way indicated by the dotted linesin Fig. 3.4, right.

3.4 Implementation issues

As previously pointed out, Freefem considers a discrete field as a function more than an arrayof values. Consider a field like ux (first component of the velocity) that has been computed asa piecewise affine function on a mesh Th, and another field pux that is defined in the space P1associated to the same mesh. If the mesh is moved according to

Th = movemesh(Th,[x+dt*cx,y+dt*cy]);and if one updates pux with the instruction pix = ux, Freefem++ will interpolate the values

between the two meshes. More precisely, to compute the nodal value of pux at a vertex i ofthe new mesh, the position of the vertex will be located in the previous configuration, andthe corresponding value of the field will be computed by interpolation of ux in the previousconfiguration. To keep the same nodal values for ux and pux, the following trick can be used:

tmp=ux[]; pux=0; pux[]=tmp ;

where tmp has been defined previously as an auxiliary array :

real[int] tmp(ux[].n);

Page 35: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

Chapter 4

Fluid-structure interactions

Many problems involve the interaction between a fluid and a solid. The solid can be either adeformable boundary for the fluid like for the blood flow in the arteries and veins, or piecesimmersed in the fluid or at its surface like for instance a boat on a lake or the sand in concrete,particles in the air, etc.

The coupling between both elements, the fluid and the solid is not obvious since, at firstsight the physics involved is different. Indeed, for a non deformable solid immersed in a fluid,one has to write Newton’s laws for the solid where the external forces contains the ones given bythe fluid. This is a discrete system, in which only a few degrees of freedom need to be computed,while the fluid is modeled through e.g. Navier-Stokes equations which describe a continuum.

4.1 A non deformable solid in a fluid

We focus for the time being on the case of a non deformable solid ΩS in the fluid. The fluiddomain will be denoted by ΩF while the total domain (fluid+solid) is Ω = ΩS ∪ ΩF . Classicalmechanics, given by Newton’s law describes the motion of the solid by the system of differentialequations

mdV

dt= F ,

dL

dt= T .

(4.1)

In the former equations, m stands for the mass of the solid, V the velocity of its center ofmass and L its angular momentum. On the right hand sides, F and T are respectively the totalforce and torque induced by external forces, here due to the fluid and external forces density1

fext, so that assuming that the fluid obeys Navier-Stokes equations

F = −

∂ΩS

σ · n dσ(x) +

ΩS

fext dx ,

T = −

∂ΩS

(x−G(t))× σ · n dσ(x) +

ΩS

(x−G(t))× fext dx .(4.2)

where G(t) stands for the position of the center of mass of the solid ΩS , which depends on time,and the normal n points from the fluid to the solid.

A second difficulty stands for the fact that at the boundary of the solid, the fluid must alsofulfill the no-slip boundary condition which imposes that the velocity of the fluid equates a rigid

1Those external forces are commonly the gravity, but could be as well magnetic or electric forces if the bodyis magnetized or charged for instance.

35

Page 36: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

36 CHAPTER 4. FLUID-STRUCTURE INTERACTIONS

motion, namely those of the solid. However this rigid motion is unknown and precisely obtainedthrough the coupling.

Putting everything together, we therefore consider the system

ρF∂u

∂t+ ρF (u · ∇)u− µ∆u+∇p = f in ΩF , (4.3)

div u = 0 in ΩF , (4.4)

u = G+ ω × (x−G) on ∂ΩS , (4.5)

mG = −

∂ΩS

σ · n dσ +Fext , (4.6)

d

dt(Jω) = −

∂ΩS

(x−G)× σ · n dσ +Text , (4.7)

where we have denoted by ρF the density of the fluid, and by ω the rotational vector of thesolid, and

Fext =

ΩS

fext dx , and Text =

ΩS

(x−G)× fext dx

respectively stand for the total force and torque on the solid due to external forces.

4.2 Rigid body motion

The coupling of the PDE and the ODE in the preceding problem needs very specific numericaldevelopment. Indeed, the mathematical features of the equations are different, and the numericalmethods for the PDE and the ODE as well. The idea we aim at explaining hereafter is to considerthe solid as a very viscous fluid. Therefore, we extend the velocity field inside the body by setting

u(x) = G+ ω × (x−G) for all x in ΩS . (4.8)

Notice that the continuity of the velocity at the boundary ∂ΩS is naturally enforced. Moreover,since u is a rigid body motion in the solid, one has

∇u+ t∇u = 0 in ΩS .

The total momentum of the solid is then given by

mV =

ΩS

ρSu dx ,

where ρS is the density of the solid2, and V = G is the velocity of the center of mass G of thesolid. Similarly, the angular momentum of the solid is given by

L =

ΩS

ρS(x−G)× u dx .

Doing so, we can rewrite the balances of momentum and angular momentum respectively as

d

dt

ΩS

ρSu dx = −

∂ΩS

σ · n dσ + Fext (4.9)

d

dtL =

d

dt

ΩS

ρS(x−G)× u dx = −

∂ΩS

(x−G)× σ · n dσ +Text . (4.10)

2One has typically ρS =m

|ΩS |if the solid is homogeneous, but this is not mandatory.

Page 37: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

4.2. RIGID BODY MOTION 37

On the left hand side, both expression can be written as

d

dt

ΩS

ρSu dx =

ΩS

ρS

(∂u

∂t+ (u · ∇)u

)

dx (4.11)

d

dt

ΩS

ρS(x−G)× u dx =

ΩS

ρS(x−G)×

(∂u

∂t+ (u · ∇)u

)

dx , (4.12)

and we recognize terms that are present in Navier-Stokes equations, though with a differentdensity (ρS instead of ρF ). In view of this, we define the density in all Ω by setting

ρ(x) =

ρF if x ∈ ΩF ,ρS if x ∈ ΩS ,

we also extend the pressure inside the body by setting p = 0 in ΩS and the force f that wetake to be equal to fext inside ΩS. We now consider a test function φ (smooth or at least inH1(Ω,R3)) defined on all Ω such that φ is a rigid body motion in ΩS

φ(x) = φ+ φω × (x−G) in ΩS ,

where both φ and φω are constant vectors in R3.

We now compute

Ω

(

ρ∂u

∂t+ ρ(u · ∇)u

)

· φdx =

ΩF

(

ρF∂u

∂t+ ρF (u · ∇)u

)

· φdx+ φ ·d

dt(mV) + φω ·

dL

dt

because of (4.11) and (4.12). On the other hand

µ

Ω

(∇u+ t∇u

): ∇φdx = µ

ΩF

(∇u+ t∇u

): ∇φdx .

Indeed, φ and u being rigid body motions in ΩS we have

∇u+ t∇u = ∇φ+ t∇φ = 0 in ΩS .

Similarly

Ωp div φdx = −

ΩF

p div φdx

since div φ = 0 in ΩS , and eventually

Ωf · φdx = −

ΩF

f · φdx−

ΩS

fext · φdx

= −

ΩF

f · φdx− Fext · φ−Text · φω .

Summing up all contributions, and noticing that

µ

ΩF

(∇u+ t∇u

): ∇φdx−

ΩF

p div φdx =

ΩF

(−µ∆u+∇p) · φdx

+φ ·

∂ΩF

σ · n dσ + φω ·

∂ΩF

(x−G)× σ · n dσ ,

Page 38: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

38 CHAPTER 4. FLUID-STRUCTURE INTERACTIONS

we obtain∫

Ω

(

ρ∂u

∂t+ ρ(u · ∇)u

)

· φdx+ µ

Ω

(∇u+ t∇u

): ∇φdx−

Ωp div φdx−

Ωf · φdx

=

ΩF

(

ρF∂u

∂t+ ρF (u · ∇)u− µ∆u+∇p− f

)

· φdx+ φ ·

(d

dt(mV) −

∂ΩF

σ · n dσ −Fext

)

+φω ·

(dL

dt−

∂ΩF

(x−G)× σ · n dσ −Text

)

= 0 .

Therefore the variational formulation, which encodes the system (4.3–4.7) in a whole is given bytesting with functions that are rigid motions inside the solid. The situation is very symmetricsince at a time t the solution u also belongs to the space of velocity fields that are rigid bodymotions inside the solid. The time discretization can then be obtained using one of the strategiesthat were described in chapter 2.

4.3 Enforcing the constraint

Nevertheless, the question of implementation of the constraint of being a rigid motion inside thesolid remains entire. What is the easiest way to take the constraint into account? Should we usespecial finite element spaces? How to handle such a constraint inside a FreeFem++ code?

A possible way that we explain below consists in penalizing the rigid body motion constraint.Namely, the idea consists in changing the variational formulation in order that the constraintwill be naturally approximately satisfied. In order to do so we modify the viscous term in thevariational formulation as follows:

Ωµ(∇u+ t∇u

): ∇φdx −→

Ωµε(∇u+ t∇u

): ∇φdx

where the viscosity has been extended to all Ω by

µε(x) =

µ if x ∈ ΩF ,1

εotherwise .

(4.13)

In the preceding definition, ε > 0 is meant to be a small parameter.hence, a typical discrete variational formulation at time nδt for the whole problem will be

given by

Find (un+1, pn+1) such that for all (v, q)

Ωρ

(un+1 − un

δt+ (un · ∇)un

)

· φdx +

Ωµε(∇un+1 + t∇un+1

): ∇φdx

Ωpn+1 div φdx−

Ωf · φdx = 0 ,

Ωq div un+1 = 0 ,

Formally, this variational formulation discretizes the continuous variational formulation

Ωρ

(∂u

∂t+ (u · ∇)u

)

· φdx+

Ωµε(∇u+ t∇u

): ∇φdx−

Ωp div φdx−

Ωf · φdx = 0 ,

Ωq div u = 0 ,

Page 39: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

4.4. YET OTHER NON DEFORMABLE CONSTRAINTS 39

for which one has the energy inequality (test formally with φ = u)

1

2

d

dt

Ωρ|u|2 dx+

Ωµε∣∣∇u+ t∇u

∣∣2 dx =

Ωf · u , (4.14)

from which we deduce a uniform L2 bound for u and the estimation

∃C > 0 , such that ∀t > 0 ,

∫ t

0

Ωµε∣∣∇u+ t∇u

∣∣2 dx ≤ C . (4.15)

This leads to ∫ t

0

ΩS

∣∣∇u+ t∇u

∣∣2 dx ≤ Cε . (4.16)

which means that ∇u+ t∇u tends to 0 as ε tends to 0 inside the solid. Therefore, in the solid,u is approximately a rigid motion.

Physically speaking, the method above amounts to saying that the solid is a fluid with veryhigh viscosity (actually 1/ε). As we know, due to the incompressibility constraint and theconservation of mass, both fluids never mix, and it is expected that the fluid with very highviscosity only deforms very little. At the limit ε → 0 it seems reasonable to think that thesolution converges towards the solution of the previous variational formulation3

4.4 Yet other non deformable constraints

The method described above can be easily generalized to other type of constraints. For instance,if the solid can not rotate but only translate, we can use the previous approach, in the continuoussetting by restricting both the unknown and the test functions to be constant in the solid ΩS,in the penalized setting by replacing the term

1

ε

ΩS

(∇u+ t∇u) : ∇φdx ,

by1

ε

ΩS

∇u : ∇φdx .

Similarly to the former case, the solution u satisfies an estimate∫ t

0

ΩS

|∇u|2 dx ≤ Cε (4.17)

which ensures that u is close to a constant inside the solid (though this constant may dependon time).

Eventually, a fixed rigid body can be modeled by u = 0 inside the solid. This can be alsoenforced by penalty by replacing again the same term by

1

ε

ΩS

u · φdx .

Proofs of convergence as ε tends to 0 of the corresponding formulation to the constrainedNavier-Stokes problem are possible although not obvious. This field is still active at the researchlevel.

3This is true although not obvious to prove. However, proving the very same statement but for Stokes equationsis much easier and left as an interesting exercise to the curious reader.

Page 40: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

40 CHAPTER 4. FLUID-STRUCTURE INTERACTIONS

4.5 Conclusion

The aim of this chapter was to design slight changes that can be made in the classical variationalformulation of Navier-Stokes equations in order to handle different material. We have focusedour attention to the case of a non deformable solid in a viscous (incompressible) fluid, and wehave seen that it can be seen as a mixture of two incompressible fluids: the original one, and avery viscous one which becomes solid when its viscosity tends to infinity.

Page 41: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

Chapter 5

Duality methods

This chapter describes an general approach to deal with constraints in fluid mechanics. Sometypical situations have already been presented, e.g.

1. Incompressibility: this condition can be seen as a constraint on the fluid velocity1.

2. Obstacle: a fixed body in a fluid domain can be considered as a subdomain where thevelocity is zero.

3. Rigid body: when a rigid object moves in a fluid, it can be considered at each instant asa subdomain where the velocity field is that of a rigid motion (translation + rotation), byprescribing that the strain tensor identically vanishes.

4. Constrained rigid body: consider the typical case of an helix in a fluid flow. It can bemodeled as a rigid body attached at one of its point. The attachment can be modeled byprescribing that the mean velocity in a ball contained in the rigid part, and centered atthe fixed point.

5. No slip conditions: this type of boundary condition has been considered in an essentialmanner, by integrating them to the space where the unknown velocity is defined. But itcan be also considered as a constraint2.

6. Global constraints. In some situations, it can be of great interest to prescribe the value ofsome average quantity. For example, on the outlet of a pipe flow, it may be more relevantto prescribe the global flow rather than the whole velocity profile.

Some of these problems can be addressed by the penalty approach presented in the previouschapter. Yet, this approach, presents some drawbacks. Firstly, it modifies the underlying opera-tor (like the Laplace operator) by addition of a term in 1/ε. Discretization of the correspondingproblem will lead to matrices that are ill-conditionned3, therefore the systems will be harder tosolve. Secondly, in some cases, the penalty approach significantly affects the structure of thematrix, and necessitates a deep change in the assembling procedure. We present here a generalapproach based on a dual expression of the constraints, and we shall see that it circumventsthose problems.

1The pressure has been introduced in the first chapter according to physical considerations. We shall see inthis chapter that it can be formalized from a constrained minimization point of view. In particular the pressurewill be interpreted as a Lagrange multiplier of the incompressibility constraint.

2This is actually the way it is handled in Freefemm++.3It means that the condition number, that is the ratio between extremal eigenvalues, is large.

41

Page 42: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

42 CHAPTER 5. DUALITY METHODS

5.1 General presentation of the approach

Consider a smooth functional J in a Hilbert space V . We want to find a minimizer of thisfunctional on a subspace K, defined as the kernel of a continuous linear operator B ∈ L(V,Λ),where Λ is also a Hilbert space.

Suppose that such a minimizer u exists. It holds that

J(u+ tv) ≥ J(u) ∀v ∈ K , ∀t ∈ R,

from which we deduce that(∇J(u), v) = 0 ∀v ∈ K,

i.e. ∇J(u) ∈ (kerB)⊥. If the dimension of Λ is finite, we have (kerB)⊥ = imB⋆, so that thereexists λ ∈ Λ such that

∇J(u) + B⋆λ = 0Bu = 0,

In the case where J is a quadratic functional,

J(v) =1

2(v, v) − 〈ϕ , v〉,

it takes the form Au + B⋆λ = ϕBu = 0,

It can also be written in a variational way:

a(u, v) + (Bv, λ) = 〈ϕ , v〉 ∀v ∈ V(Bu, µ) = 0 ∀µ ∈ Λ.

(5.1)

The latter system is called a saddle point formulation of the minimization problem (seeProposition 10, page 68, for an explanation of this term).

In general (Λ is infinite dimensional), (kerB)⊥ = imB⋆ no longer holds, but we have

(kerB)⊥ = imB⋆.

In the case where imB⋆ is closed (which is equivalent to saying that imB is closed), thesaddle-point formulation is still valid, i.e. existence of a saddle point (u, λ) is guaranteed. On theother hand, existence of a saddle-point (u, λ) implies that u minimizes the quadratic functionalJ over K (see Proposition 10, page 68). Note also that if B is onto, B⋆ is one-to-one, thus theLagrange multiplier is unique.

When the image of B is not closed, the existence of a solution to (5.1) might be ruled out.Yet, in the context of PDE’s, the corresponding formulation can be discretized in space, whichleads to a finite dimensional problem for which existence of a saddle point is guaranteed. Thequestion of the behavior of the discrete Lagrange multiplier when the mesh size goes to 0 isdelicate, since the limit does not exist in Λ, but it can be rigorously proven that the approachis efficient in terms of approximation of the primal part u, i.e. the minimizer of J over K

Interpretation of the Lagrange multipliers in a mechanical context.Consider a horizontal system of n+ 1 masses 0, 1, 2, . . . , n, linked to each other (0 to 1, 1

to 2, etc...) by springs with stiffness k and length at rest 0 . The positions are represented bythe vector (x0, x1, . . . , xn) ∈ R

n+1. The potential energy writes

J(x) =1

2k

n∑

i=1

|xi − xi−1|2 =

1

2k(Ax,x),

Page 43: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

5.1. GENERAL PRESENTATION OF THE APPROACH 43

where A is, up to a multiplicative constant, the discrete Laplacian with Neuman boundaryconditions. Any configuration (x, x, . . . , x) de Rn+1 obviously minimizes this energy Let us nowconsider the situation where 0 is fixed at x0 = 0, and the n− th mass to the point xn = L > 0.We now want to minimize J over the affine space

E = x , x0 = 0 , xn = L = X + kerB , avec B : x ∈ Rn+1 7−→ (x0, xn) ∈ R

2.

The matrix B writes

B =

(1 0 . . . 0 00 0 . . . 0 1

)

.

There exists λ = (λ0, λ1) ∈ R2 such that

Ax+Bλ = 0.

The two end lines of this system are

k(x0 − x1) + λ0 = 0

k(−xn−1 + xn) + λ1 = 0.

These relations express the balance of end masses, and allows to interpret −λ0 (resp. −λ1) asthe force exert by the wall at 0 upon the mass 0 (resp. by the wall at 1 upon the mass n).

Uzawa algorithm. We shall end this introductory section by describing a practical way to solvethe saddle-point problem. The Uzawa algorithm is an iterative procedure to solve Problem (5.1).Given a parameter ρ > 0, and an initial guess λ0, it consists in in computing λ1, λ2, . . . accordingto the following procedure

1. Assuming that λn is known, compute un+1 as the solution to

a(un+1, v) + (Bv, λn) = 〈ϕ , v〉∀v ∈ V.

2. Update the Lagrange multiplier

λn+1 = λn + ρBun+1.

This algorithm can be shown to converge in the following sense: if the saddle-point problemadmits a solution (u, λ) (not necessarily unique), and if ρ > 0 is sufficiently small (ρ < 2α/ ‖B‖,where α is the ellipticity constraint of A), then the sequence un converges to the solution u tothe constrained minimization problem.

Non-homogeneous constraint. In the car where the constraint reads Bu = z 6= 0, a similarapproach can be carried out, and the corresponding saddle point problem reads simply

Au + B⋆λ = ϕBu = z,

The first step of the Uzawa algorithm is unchanged, and the second one writes

λn+1 = λn + ρ(Bun+1 − z).

Page 44: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

44 CHAPTER 5. DUALITY METHODS

Small number of constraints. When the number of scalar constraints is small, the Lagrangemultiplier can be directly computed. For instance, in the case of a unique linear constraint,denoting by u0 (resp. u1) the solution to the primal problem associated to λ = 0 (resp. λ = 1),the exact solution can be written

u = (1− θ)u0 + θu1.

The value of θ is obtained by prescribing that the constrained is met:

θ =Bu0

Bu0 −Bu1.

5.2 The divergence-free constraint for velocity fields

This constraint plays a special role in the context of contained minimization. Consider theStokes problem:

−µ∆u+∇p = f ,

with ∇ ·u = 0, and homogeneous Dirichlet boundary conditions. The simplest way to handle itconsists in taking divergence free test-functions, to obtain

µ

Ω∇u : ∇v =

Ωf · v.

Thus, the problem which consists in finding a function in H10 , that is divergence free, directly

fits in Lax-Milgram framework. Yet, this approach presents two main drawbacks:

1. The pressure, that has a meaning in terms of modeling, has disappeared from the formu-lation.

2. Numerical implementation of this approach necessitates to account for the divergence freeconstraint in the discretization space for the velocity. It can be done in practice, but it isvery delicate in terms of implementation, and it is rarely done in practice.

From the mathematical standpoint, the pressure can be recovered by considering that theproblem consists in minimizing the functional

J(v) =µ

2

Ω|v|2 −

Ωf · v,

over

K = kerB , B : v ∈ H10 (Ω)

d 7−→ −∇ · v ∈ L2(Ω).

The fact that the constrained is distributed over the whole fluid domain requires to pay aspecial attention to the well-posedness of the saddle-point formulation. At the continuous level,existence of a pressure as a Lagrange multiplier of incompressibility constraint is a consequence ofthe surjective character of the divergence operator from H1(Ω)d to L2(Ω). As the discrete level,good approximation properties required special conditions between the two discretization spaces(in velocity and pressure). This so called inf-sup (or Babuska-Brezzi) condition expresses in someway that the discrete divergence operator asymptotically behaves like a surjection between twoinfinite dimensional Hilbert spaces.

Page 45: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

5.3. OTHER TYPES OF CONSTRAINTS 45

5.3 Other types of constraints

5.3.1 Obstacle problem

We consider here the flow around a fixed cylinder. We denote by ω the subdomain occupiedby the cylinder. Consider the Stokes problem in a domain Ω \ ω around the cylinder, andhomogeneous Dirichlet boundary condition on the external boundary ∂Ω.

The (double) saddle-point formulation can be written

µ

Ω∇u : ∇v −

Ωp∇ · v +

ωλ · v =

f · v ∀v ∀v ∈ H10 (Ω),

Ωq∇ · u = 0 ∀q ∈ L2(Ω),

ωµ · u = 0 ∀µ ∈ L2(ω).

If one considers that the Stokes problem can be directly solved (i.e. without the use of aniterative algorithm), the Uzawa algorithm on λ writes:

1. Choose λ0 ∈ L2(ω).

2. Compute un+1 (together with pn+1) as the solution to

µ

Ω∇un+1 : ∇v −

Ωpn+1∇ · v +

ωλ · v = 〈ϕ , v〉 ∀v ∈ H1

0 (Ω)

Ωq∇ · un+1 = 0 ∀q ∈ L2(Ω).

3. Compute λn+1 as

λn+1 = λn + ρun+1|ω.

Note that the continuous saddle-point formulation is not well-posed, since B maps a field inH1 to its restriction in ω as a function of L2. Yet, the approach can be shown to be work inpractice, and it can even be proved that the discretized velocity field uh converges to the exactsolution.

Another approach would consist here in defining B as the restriction operator to the spaceH1(ω)d. In that case, the saddle-point problem writes

µ

Ω∇u : ∇v −

Ωp∇ · v +

ωλ · v +

ω∇λ · ∇v =

f · v ∀v ∀v ∈ H10 (Ω),

Ωq∇ · u = 0 ∀q ∈ L2(Ω),

ωµ · u+

ω∇µ · ∇u = 0 ∀µ ∈ H1(ω),

and the Uzawa algorithm can be written accordingly.

Page 46: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

46 CHAPTER 5. DUALITY METHODS

5.3.2 Prescribed flux

Consider the flow in a pipe-like domain, with two end boundaries Γin and Γout. We aim atprescribing the flux through Γout, without prescribing the whole velocity profile. For the Stokesproblem, it consists in minimizing the functional

J(v) =µ

2

Ω|∇v| 2

among all those fields v that are divergence free, and that verify∫

Γout

v · n = Q,

where Q is prescribed.The (double) saddle-point formulation can be written

µ

Ω∇u : ∇v −

Ωp∇ · v +

Γout

λv · n =

f · v ∀v ∈ H10 (Ω),

Ωq∇ · u = 0 ∀q ∈ L2(Ω),

Γout

µu · n = Qµ ∀µ ∈ L2(Γout).

Note that, in this situation, it is not necessary to run the Uzawa algorithm. Indeed, denotingby u0 (resp. u1) the velocity field corresponding to λ = 0 (resp. λ = 1), the exact solution ucan be written

u = (1− λ)u0 + λu1.

The value of λ is then obtained by requiring that the constraint is verified, i.e.

Γout

µu · n = Q =⇒ λ =Q−

Γoutu0 · n

Γoutu1 · n−

Γoutu0 · n

.

5.3.3 Prescribed mean velocity

Consider a Stokes (or Navier-Stokes) flow in a domain Ω, coupled with the motion of a rigidobject, say, a disc (subdomain ω ⊂ Ω). Consider the case where the disc is attached at its center,and is free rotate around it. Prescribing a zero velocity at the center is not sound in the presentcontext, since pointwise values are not4 defined in H1. It is more appropriate to prescribe azero mean velocity over the disc, i.e. ∫

ωu = 0.

The could be done by penalizing this quantity. It would lead to an extra term in the Stokes (orNavier-Stokes) variational formulation of the type

1

ε

(∫

ωu

)(∫

ωv

)

.

4In the present case, where the point lies within a zone that is considered rigid, it would actually make sense.But it would involve linear functionals that are not defined over the unconstrained space, which makes it trickyto formalize properly.

Page 47: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

5.3. OTHER TYPES OF CONSTRAINTS 47

Note that this term will couple all the degrees of freedom associated to vertices within theparticle. Besides, it cannot be straightforwardly implemented in a software like freefem++. Thismotivates the use of a duality method to account for this constraint. In order to illustrate thepossibility to couple different approaches, we will handle the rigid body constraint by following apenalty approach. In case of homogeneous Dirichlet boundary conditions on the outer boundary,we obtain the variational formulation (for the Stokes problem)

1

Ω(∇u+ t∇u) : (∇v + t∇v)−

Ωp∇ · v+

1

ε

ω(∇u+ t∇u) : (∇v + t∇v) + λ ·

ωv =

f · v ∀v ∈ H10 (Ω)

2,

Ωq∇ · u = 0 ∀q ∈ L2(Ω),

µ ·

ωu = 0 ∀µ ∈ R

2.

Note that, as in the previous case, the space of Lagrange multiplier has low dimension (2 in thepresent case), so that a direct strategy can be followed: Denote by

λ00 =

(00

)

, λ10 =

(10

)

, λ01 =

(01

)

,

and by u00, u10, u01 the corresponding velocity fields (solutions of the Stokes problem with thecorrespond choice of λ). By linearity of the Stokes problem, the exact velocity writes

u = u00 + λ1 (u10 − u00) + λ2 (u01 − u00) .

Finally, λ = (λ1, λ2)T can be determined as a solution to a 2 × 2 linear system, obtained by

writing that u (expressed as above), verifies the (two) constraints.

Interpretation as forces. The corresponding λ accounts for the force exerted by the fluidon the particle. More precisely, the variational term in λ corresponds to an extra term in theright-hand side of the momentum equation:

· · · = −λ1ω,

so that |ω|λ is the resultant force exerted by the obstacle on the fluid.Following the principle of virtual power, the penalty term can also be interpreted as a force.

Indeed, consider the linear form

Ψε : v 7−→ 〈Ψε , v〉 =1

ε

ω(∇u+ t∇u) : (∇v + t∇v).

For any test function considered as a virtual velocity field, −〈Ψε , v〉 is the power that the forcesexerted on the fluid to maintain a quasi rigid motion would develop. It follows immediately thatthe corresponding force field has a zero resultant and a zero torque.

Implementation issues. The penalty method does not require a conforming mesh. Yet,using a conforming mesh (i.e. without any element crossed by the boundary) can improve spaceaccuracy. In this spirit, the approach presented above can be discretized over a conformingmesh, i.e. a mesh that covers the whole computational domain (including ω), but that containsa piecewise approximation of the disc boundary. Such a mesh can be build in the following way

Page 48: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

48 CHAPTER 5. DUALITY METHODS

int Np = 20, NB = 2*Np ;

real L = 2, xB = 0.5 , yB = 0.5 , rB = 0.1 ;

border Gs(t=0,L)x=t;y=0;label=1;

border Ge(t=0,1)x=L;y=t;label=2;

border Gn(t=0,L)x=L-t;y=1;label=3;

border Gw(t=0,1)x=0;y=1-t;label=4;

border Gin (t=0,2*pi)x=xB+rB*cos(t);y=yB+rB*sin(t);label=5;

mesh Th=buildmesh(Gs(L*Np)+Ge(Np)+Gn(L*Np)+Gw(Np)+Gin(NB));

Note that Gin(NB) is written without a minus sign, so that a mesh will be created within theparticle. To compute integrals over the discretized disc, a robust way consists in defining thecharacteristic function of the disc as a piecewise constant function, and to multiply the integrandby this function when the integration is to be limited to the disc.

Page 49: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

Chapter 6

Elements of numerical analysis forsaddle-point problems

6.1 Mixed finite element formulations

We consider here the general saddle-point formulation of the problem which consists in mini-mizing a quadratic functional

J(v) =1

2a(v, v) − 〈ϕ , v〉,

defined in a Hilbert space V , when the minimizers is subject to belong to a linear space that iswritten as the V -kernel of a bilinear form:

(v, µ) ∈ V × Λ 7−→ b(v, µ) , K = v ∈ V , b(v, µ) = 0 ∀µ ∈ Λ .

The formulation readsa(u, v) + b(v, p) = 〈ϕ , v〉 ∀v ∈ Vb(u, µ) = 0 ∀µ ∈ Λ.

(6.1)

One denotes by B ∈ L(V,Λ) the operator defined by (Bv, µ) = b(v, µ). Note that b(v, p) canalso be written 〈B⋆p , v〉.

It is natural to introduce Vh and Λh, approximation spaces for V and Λ, respectively, andthe associated discretized problem

a(uh, vh) + b(vh, ph) = 〈ϕ , vh〉 ∀vh ∈ Vhb(uh, µh) = 0 ∀µh ∈ Λh.

(6.2)

We define the operator Bh ∈ L(V,Λh) by

(Bhv, µh) = (Bv, µh) ∀µh ∈ Λh,

and the discrete constrained space is denoted by

Kh = Vh ∩ kerBh = vh , b(vh, µh) = 0 ∀µh ∈ Λh

The problem 6.2 consists in minimizing

J(v) =1

2a(v, v) − 〈φ , v〉

49

Page 50: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

50 CHAPTER 6. STOKES EQUATIONS

over Kh. Considering finite dimensional approximation spaces Vh and Λh, Kh has finite di-mension, therefore it is closed, so that Problem 6.2 is obviously well-posed, at least in termsof existence. Uniqueness holds for the primal variable uh, but not necessarily for the Lagrangemultiplier ph.

The question is now: assuming that (Vh) and (Λh) are suitable sequences of approximationspaces, i.e. dist(v, Vh) and dist(q,Λh) both go to zero as the discretization parameter h goes to0, can uh be expected to converge to the solution u of the continuous constrained minimizationproblem ? As for the dual part ph, in case it is uniquely defined, one may also wonder whetherit converges to p.

Extension of the theory developed for standard (unconstrained) variational problems is infact not straightforward. Informally, if Λh is much “richer” than Vh in terms of approximation,the discrete problem might be overconstrained, so that Kh does not approximate V properly(it might even be reduced to 0). On the other way, if Λh is too poor, the problem mightbe underconstrained, so that the solution uh to the discrete constrained minimization problemmight converge (if ever) outside K. Both approximations have obviously to be balanced in someway. This balance necessitates a fine tuning between the two discretization spaces, which willbe expressed by the discrete inf-sup (or BBL) condition.

Remark 5 In the case of Stokes problem, as the velocity is H1 and the pressure L2, it wouldbe very natural to approximate velocities with continuous, piecewise P 1 functions (as for thepoisson problem), while pressures would be approximated by P 0 functions. As we shall see, thisstraightforward approach does not work, for reasons that we shall detail below.

6.1.1 A general estimate without inf-sup condition

To enlight how this inf-sup condition allows a proper error estimation of primal and dual quanti-ties (i.e. |u− uh| and |p− ph|), we shall start the numerical analysis by a very general estimationof the sole primal quantity, under very loose conditions (in particular without the inf-sup condi-tion). Although this estimate will not be used as such in the context of divergence free constraint,it proves powerful in other contexts, e.g. for the fictitious domain method.

We assume here that a(·, ·) is a continuous, symmetric and coercive bilinear form over V ×V ,and B ∈ L(V,Λ), so that K = kerB is closed. The problem which consists in minimizing

J(v) =1

2a(v, v) − 〈φ , v〉

over K is well-posed by Lax Milgram theorem, and we denote by u its solution. We do not makeextra assumptions on B, so that the saddle-point problem may be ill-posed in terms of existenceof a Lagrange multiplier. Concerning approximation spaces, we simply assume that Vh ⊂ V ,but Λh is any finite dimensional space, and Bh ∈ L(V,Λh). Of course, it will be necessary tomake extra assumptions on Λh and Bh to obtain useful estimates, but it is not necessary for thetime being.

We consider the (abstract) discretized saddle-point problem:

a(uh, vh) + (Bhvh, ph) = 〈ϕ , vh〉 ∀vh ∈ Vh(Bhuh, qh) = 0 ∀qh ∈ Λh.

(6.3)

This problems consists in minimizing

J(v) =1

2a(v, v) − 〈φ , v〉

Page 51: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

6.1. MIXED FINITE ELEMENT FORMULATIONS 51

over Kh = kerBh. As Λh is finite dimensional, the saddle-point problem is well-posed in thefollowing sense: it admits a solution (uh, ph), and uh is uniquely defined as the minimizer of Jover Kh.

Let us start by a very simple remark on the continuous problem: there exists a unique ξ ∈ V ′

(more precisely in K⊥) such that

Au+ ξ = φ.

As u is uniquely defined, ξ is uniquely defined as φ − Au. The basis of the following estimatewill be to prove that, even if ξ cannot be written B⋆p, some convergence of uh toward u can beexpected as soon as ξ can be approximated by B⋆

hµh.

Proposition 5 Let a(·, ·) be a continuous, symmetric, coercive, bilinear form over V × V ,φ ∈ V ′, B ∈ L(V,Λ). We denote by u the unique minimizer of J over K = kerB. LetVh ⊂ V and Λh be finite-dimensional spaces, Bh ∈ L(V,Λh), and Kh = kerBh ∩Vh. Let (uh, ph)be a solution of the saddle point-problem (6.2). Then

|u− uh| ≤ C

(

infwh∈Kh

|wh − u|+ infqh∈Λh

‖ξ −B⋆hqh‖V ′

h

)

(6.4)

Proof : For any vh ∈ Kh, (Bhvh, ph) = 0, so that

a(uh, vh) = 〈φ , vh〉.

The core of the proof consists in taking vh in the form uh − wh, where wh is in Kh. It comes

a(vh, vh) = 〈φ , vh〉 − a(wh, vh).

The exact solution u verifies

a(u, vh) + 〈ξ , vh〉 = 〈φ , vh〉,

so that

a(vh, vh) = a(u− wh, vh) + 〈ξ , vh〉.

As vh is in Kh, 〈B⋆hqh , vh〉 = (Bhvh, µh) = 0 for any µh ∈ Λh, so that this quantity can be

substracted to the right-hand side.

a(vh, vh) = a(u− wh, vh) + 〈ξ −B⋆hµh , vh〉.

One obtains

α |vh|2 ≤ ‖a‖ |u−wh| |vh|+ ‖B⋆

hqh − ξ‖ |vh| ⇒ α |uh − wh| ≤ ‖a‖ |u− wh|+ ‖B⋆hqh − ξ‖

and therefore

|uh − u| ≤ C(

|u− wh|+ ‖B⋆hqh − ξ‖V ′

h

)

.

for any wh ∈ Kh, any qh ∈ Λh, which ends the proof.

Estimate (6.4) expresses the required balance between both approximation spaces. Firstly, Λh

has to be rich enough (and Bh has to approximate B in some sense) for the second term to besmall. But if Λh is too rich, it may constrain excessively the problem, so that Kh may not be agood approximation space for K, preventing the first term to go to 0.

Page 52: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

52 CHAPTER 6. STOKES EQUATIONS

6.1.2 Estimates with the inf-sup condition

We may now introduce the framework which we will favor for Stokes equation. We consider herea saddle point formulation which is well-posed at the continuous level, i.e. B is surjective.

Proposition 6 Notations and assumptions are those of Proposition 5. We furthermore assumehere that B ∈ L(V,Λ) is surjective, so that the continuous saddle point problem admits a uniquesolution (u, p). We also assume that both approximations are conforming, i.e. Vh ⊂ V andΛh ⊂ Λ, that Bh is defined by

(Bhv, qh) = (Bv, qh) = b(v, qh),

and that it verifies the discrete inf-sup condition:

infqh∈Λh

supvh∈Vh

b(vh, qh)

|vh| |qh|≥ β > 0,

where β is independent1 of h. Then we have the following error estimate

|u− uh|+ |p− ph| ≤ C

(

infwh∈Vh

|wh − u|+ infqh∈Λh

|qh − p|

)

(6.5)

Proof : The proof is based on estimate (6.4). As preliminary step, let us first note that theinfimum over Λh of ‖B⋆

hqh − ξ‖V ′

h

takes the form (as ξ = B⋆p)

infqh∈Λh

|B⋆(qh − p)| ≤ infqh∈Λh

‖B⋆‖ |qh − p| .

The first step of the proof, which is essential to use approximation properties of Vh, consistsin showing that the first infimum in (6.4) can be replaced by an infimum over the unsconstrainedapproximation space Vh.

In a second step, we will show that the estimate on |u− uh| induces an estimate on |p− ph|.

Step 1. As for the first term in estimate (6.4), we proceed as follows: consider an approximationvh ∈ Vh of u, we build an approximation wh = vh + zh ∈ Kh with the same approximationproperties (up to a multiplicative constant which does not depend on h).

Let vh ∈ Vh be given. We denote by zh the element of Vh which verifies

Bhzh = −Bhvh

and which minimizes the norm (i.e. wh = vh + zh is the projection of vh onto Kh). This zh isthe primal part of the solution to the saddle point problem

(zh, yh) + (ηh, Bhyh) = 0 ∀yh ∈ Vh

(µh, Bhzh) = −(µh, Bhvh) ∀µh ∈ Λh.

Thanks to the inf-sup condition, we have

|ηh| ≤1

βsupyh

〈B⋆hηh , yh〉

|yh|=

1

β|zh| .

1As always in such contexts, we implicitly consider sequences of approximation spaces (Vh) and (Λh), indexedby a parameter h (which will represent the mesh diameter in actual Finite Element discretization, which goes to0 as the dimension of the spaces goes to infinity.

Page 53: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

6.1. MIXED FINITE ELEMENT FORMULATIONS 53

On the other hand, taking yh = zh, it comes

|zh|2 ≤ |(ηh, Bhzh)| ≤ |ηh| |Bhvh| = |ηh| |Bh(u− vh)| ≤ C |zh| |Bh(u− vh)| .

The new approximant wh = vh + zh is then such that

|u− wh| ≤ |u− vh|+ |zh| ≤ C |u− vh| .

Step 2. To estimate |p− ph|, we substract the discrete variational formulation from the con-tinuous one. We get

(ph, Bvh) = a(u− uh, vh) + (p,Bvh),

so that, for any qh ∈ Λh

(ph − qh, Bvh) = a(u− uh, vh) + (p− qh, Bvh) ∀qh ∈ Λh.

By the inf-sup condition, we have

|ph − qh| ≤1

βsupvh∈Vh

|a(u− uh, vh) + (λ− µh, Bvh)|

|vh|

≤1

β(‖a‖ |u− uh|+ ‖B‖ |p− qh|) ,

so that, finally,

|p− ph| ≤‖a‖

β|u− uh|+

(

1 +‖B‖

β

)

infqh∈Λh

|p− qh| .

The discrete inf-sup condition, which is not easily verified in its native form, is equivalentto the existence of an operator from V to Vh which preserves the discrete constraint, with abounded norm2. More precisely, we have

Proposition 7 (Fortin’s criterium)We assume that B ∈ L(V,Λ) verifies the inf-sup condition. Then the sequence (Vh,Λh) verifiesthe discrete inf-sup condition iff there exists a constant C > 0 and a family (Πh)h, with Πh ∈L(V, Vh), such that

b (Πhv − v, qh) = 0 ∀(v, qh) ∈ V × Λh,

with|Πhv| ≤ C |v| .

Proof : Assume that b(·, ·) verifies the inf-sup condition. For any v ∈ V , we build vh which mini-mizes the norm among all those wh that verify Bwh = Bv (as in the beginning of Proposition 6).The saddle point formulation of the problem writes

(vh, wh) + (ph, Bwh) = 0 ∀wh ∈ Vh

(qh, Bvh) = (qh, Bv) ∀qh ∈ Λh.

By the inf-sup condition, one has |ph| ≤ |vh| /β, and by taking wh = vh in the first line, weobtain |vh| ≤ C |v|. We define Πhv as vh (orthogonal projection onto B⋆(Λh).

2As always, this assertion refers to a family (Πh) of operators which is uniformly bounded with respect to h.

Page 54: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

54 CHAPTER 6. STOKES EQUATIONS

On the other way, consider qh ∈ Λh ⊂ Λ, denote by v its reciprocal image by B whichminimizes the norm. This norm is controlled by that of qh because the range of B is closed. Wehave

supvh

b(vh, qh)

|vh|≥b(Πhv, qh)

|Πhv|≥

1

C|qh| ,

which ends the proof.

6.1.3 Some stable finite elements for Stokes equations

A finite element (Vh,Λh) for the mixed formulation of Stokes problem is said to be stable when-ever it verifies the discrete inf-sup condition uniformly with respect to the discretization param-eter h. Among natural candidates, neither (P 1, P 1) (piecewise affine functions for the velocityand the pressure), nor (P 1, P 0) (piecewise constant functions for the pressure) meet this require-ment.

Bubble element. The simplest stable element is the so called mini element, or bubbleelement.It is obtained from the unstable family (P 1, P 1) by adding a degree of freedom in the center ofeach element. It is usually performed by considering the so-called bubble function associatedto each element, which is the product of the barycentric coordinates. Let us denote by wK thebubble function associated to element K. For a triangulation Ωh, Vh is defined as the set of allthose vector fields which can be written

uh =

d∑

α=1

(∑

i

uαi wieα +∑

K

βαKwKeα

)

where the first sum goes over “free” vertices (vertices of Ωh which do not belong to a boundaryon which Dirichlet boundary condition is prescribed), the second sum goes over all simplices ofΩh, and wi is the hat function associated to vertex i. The approximation space for pressure issimply

Λh =

qh =∑

i

qiwi

Proposition 8 We consider a polygonal domain, and a regular family (Ωh) of triangulations.The family (Vh,Λh) defined previously is stable.

Proof : The proof is based on the Fortin’s criterium (see Prop. 7): we give en explicit constructionof Πh. For a given v in H1

0 (Ω)d, the idea consists in building Πhv with a norm controlled by

the norm of v (uniformly with respect to h), such that the mean value of each of its componentequals the mean value of the corresponding component of v. If we are able to build such anoperator, we shall have

b(Πhv − v, qh) =

Ωqh∇ · (v −Πhv) = −

Ω(v −Πhv) · ∇qh.

As qh is piecewise affine, its gradient is constant in each element K, so that the latter quantityis 0 by construction.

Let us now detail how Πh can be built. It is actually built component by component, and weshall keep the same notation Πh to denote the operator which acts on scalar functions. Consider

Page 55: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

6.1. MIXED FINITE ELEMENT FORMULATIONS 55

v ∈ H10 (Ω). The first step consists in associating a piecewise affine function vh which approxi-

mates v. The difficulty is that standard pointwise interpolation is impossible, as pointwise valuesof v are not defined (as soon as d ≥ 2). To overcome this difficulty, we consider instead Rhv,where Rh is the so-called Clement operator (the existence of which we admit here), which issuch that

|v −Rhv|0,K ≤ ChK |v|1,∆K,

where ∆K is the set of elements in contact with K. The approach consists then in correctingRhv within each element (using the bubble degree of freedom) to respect the mean value. Moreprecisely, for any element K, we write

Πhv = Rhv + wh,

where wh is a bubble function, chosen in such a way that∫

KΠhv =

Kv.

Let us denote by wh the mean value of wh over K. One has

wh =

K wh

|K|= |K|−1

∣∣∣∣

Kv −

KRhv

∣∣∣∣≤ |K|−1/2 |v −Rhv|0,K ≤ C |K|−1/2 hK |v|1,∆K

Besides, for elements with a controlled aspect ratio (i.e. hK/ρK is uniformly bounded), the H1

semi-norm of wh verifies|wh|1,K ≤ Ch−1

K wh |K|1/2 .

We finally have|wh|1,K ≤ C |v|1,∆K

.

As the semi-norm in the right-hand side involves a neighborhood of K, we have

|wh|1,Ω ≤ |v|1,Ω .

We therefore have |Πhv| 1,Ω ≤ C |v| 1,Ω, which ends the proof

Remark 6 We assumed that B verifies the continuous inf-sup condition, which means that Bis surjective. It requires to restrict pressure fields to scalar fields with zero mean value. Asa consequence, the set of discrete pressures is that of piecewise affine fields with zero meanvalue over Ω. This constraint is a priori difficult to handle, as hat functions do not verify thisconstraint. In practice, one commonly considers a modified saddle-point problem of the form

Au+B⋆p = φ,

Bu+ εp = 0,

where ε > 0 is a small parameter.Note that, in the case where Neuman conditions are prescribed on some part of the boundary,

then the pressure is no longer defined up to a constant, so that the couple (Vh,Λh) verifies directlythe inf-sup condition (without any additional requirement on discrete pressure fields).

Taylor-Hood element. An higher order element is the so-called Taylor-Hood, or P2 − P 1,element. As suggested , It is based on a quadratic description of the velocity in each element,whereas the pressure is piecewise affine.

Page 56: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

56 CHAPTER 6. STOKES EQUATIONS

Page 57: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

Chapter 7

Complements

7.1 Estimation of interaction forces

We consider the situation illustrated by figure 7.1. the domain is a 2×1 rectangle. A newtonianfluid flows around a fixed cylinder centered at (0.5, 0.5) (radius 0.1), according to Navier-Stokesequations

ρ

(∂u

∂t+ (u · ∇)u

)

− µ∆u+∇p = 0 in Ω

∇ · u = 0 in Ω

Boundary conditions will be taken as follows: Dirichlet boundary conditions on the inlet bound-ary Γ4 (uniform horizontal velocity), and free outlet boundary conditions on the rest of theboundary

µ∇u · n− pn = 0 on Γ1 , Γ2 , Γ3.

No slip conditions (u = 0) will be prescribed on the boundary of the disc.

Γ1

Γ2

Γ3

Γ4

Figure 7.1: Flow around a cylinder

We propose here to use the method of characteristics to handle the advection term. Thetime discretized problem leads to the generalized Stokes problem

ρ

δtu− µ∆u+∇p =

ρ

δtu X in Ω (7.1)

∇ · u = 0 in Ω,

57

Page 58: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

58 CHAPTER 7. COMPLEMENTS

where u is the velocity at the previous time step.We aim at estimating the forces exerted by the cylinder on the fluid. Freefem++ makes it

possible to directly estimate the boundary integral

γ(µ∇u · n− pn) ,

but it is more stable to use a volume integral.To that purpose, we consider a smooth vector field v that is ex on γ and 0 on other parts of

the fluid domain boundary. In the expression of the horizontal (drag) force

D =

γ(µ∇u · n− pn) · ex,

ex can be replaced by v. In can be integrated by parts,which yields

Ω∆u · v +

Ω∇u : ∇v−

Ω∇p · v −

Ωp∇ · v.

Thanks to Eq. (7.1), we have that

∆u−∇p =ρ

δtu−

ρ

δtu X,

so that D can be expressed

D =ρ

δtu−

ρ

δtu X +

Ω∇u : ∇v −

Ωp∇ · v.

The form we obtain is exactly the variational formulation of the force balance equation, sothat effective computation of the force is straightforward under freefem++, by re-using theimplemented variational formulation.

7.2 Energy balance

The models proposed in these lecture notes express standard physical laws (mainly mass con-servation and Newton’s law), therefore a relevant energy balance can be expected. This sectiondescribes the way such an energy blanches can be established in some typical situation. Thisstandpoint can be fruitful in the context of numerical simulation. Since an analytical solutionis rarely known, checking that a “numerical” energy balance can be obtained is a efficient wayto check the physical relevancy of the computed solution.

Homogeneous Dirichlet boundary conditions. The simplest situation is that of a Navier-Stokes fluid in a closed container Ω, with no-slip conditions conditions on the wall. Multiplyingthe momentum equations by the velocity itself and integrating over the domain yields

ρ

Ω∂tu · u+ ρ

Ω((u · ∇)u) · u− µ

Ω∆u · u+

Ωu · ∇p =

Ωf · u.

The right-hand side is the power of external forces. The first term can be written

d

dt

Ω

ρ

2|u|2 ,

Page 59: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

7.2. ENERGY BALANCE 59

it is the time derivative of the kinetic energy. For the second one, we can use the formula

(u · ∇)u =1

2∇ |u|2 − u× (∇×)u,

which leads to

ρ

Ω((u · ∇)u) · u = ρ

Ω

1

2∇ |u|2 u =

Γ

ρ

2|u|2 u · n,

that vanishes since u is zero on the boundary. The viscous term is

−µ

Ω∆u · u = µ

Ω|u|2 ,

it corresponds to viscous dissipation.We finally obtain that the time derivative of kinetic energy equals the power of external

forces (rate of energy injected into the system) minus the rate of energy lost as heat by viscouseffects.

Free boundary problem. Let us consider a richer situation: the fluid domain moves, and itsboundary is assumed to separate the viscous fluid in consideration from an outside fluid that isassumed to be perfect, at constant pressure P . We consider the free fall a drop of viscous fluid:

ρ∂u

∂t+ ρ (u · ∇)u− µu+∇p = g in Ω(t)

∇ · u = 0 in Ω(t)

σ · n = µ(∇u+ t∇u) · n− pn = −P n on Γ(t)

We multiply again by the velocity u, integrate over Ω, with two main differences: since thedomain is moving according to the fluid velocity u , the time derivative of an integral quantitywrites

d

dt

Ω(t)Ψ(x, t) =

Ω(t)∂tΨ(x, t) +

Γ(t)Ψ(x, t)u · n. (7.2)

Besides, the term

ρ

Ω((u · ∇)u) · u = ρ

Ω

1

2∇ |u|2 u =

Γ

ρ

2|u|2 u · n

is no longer 0. Putting things together, we obtain

Ω

(

ρ∂u

∂t+ ρ (u · ∇)u

)

· u =

Ω∂t

2|u|2

)

+

Γ

ρ

2|u|2 u · n

that is exactly, thanks to (7.2), the quantity

d

dt

Ω

ρ

2|u|2 ,

that is the time derivative of the kinetic energy.The power of external forces writes

Ωg · u = −

Ωgey · u = −

Ωg∇y · u =

Ωgy∇ · u︸ ︷︷ ︸

=0

Γ(t)yu · n.

Page 60: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

60 CHAPTER 7. COMPLEMENTS

The latter quantity can be written (using again (7.2))

Γ(t)yu · n = −

d

dt

Ω(t)gy.

We finally obtain that the derivative of the total energy (kinetic + potential) balances the viscouslosses:

d

dt

(∫

Ω

ρ

2|u|2 +

Ω(t)gy

)

= −µ

2

∫∣∣∇u+ t∇u

∣∣2 .

7.3 Visualization

The graphic representation of the velocity field is often not sufficient to give a clear idea of thefluid flow structures. An alternative way consists in representing the vorticity, that is scalar in2d:

ω = ∂uy/∂x− ∂ux/∂y.

This can be done under Freefem++ by directly computing the partial derivatives:

om = dy(ux)-dx(uy)

Since the discrete velocities are not C1 over the domain, this function is a priori discontinuous.It can be defined in a natural way as a P 0 function, which rules out the possibility to drawisolines. Defining it as a P 1 function will force freefem++ to perform some interpolation todefine nodal values. Another approach consists in solving a variational problem discretized inthe space of piecewise affine functions.

7.4 Surface tension

When two immiscible fluids are separated by an interface, short range forces between the fluidinduce a non zero resulting force whenever the interface is not flat. The effect can be modeled bya pressure drop through the interface. This pressure drop is the product of the mean curvatureof the interface and a coefficient κ. This coefficient depends of the properties of both fluids, andon the chemical state of the interface itself. Consider the case of a (two-dimensional) viscousfluid flowing freely in a perfect fluid, which we will consider at pressure zero. The correspondingboundary condition can be written

σ · n = −κC n,

where C is the curvature, i.e. the inverse of the radius of curvature. This curvature will beconsidered positive in case of a convex body, so that the force points toward the center of theradius of curvature.

This effect is delicate to be accounted for numerically, since it involves a quantity thatinvolves the second derivative of the boundary. Let us show here that there is a natural wayto integrate it in the finite element method. We shall consider the case of a boundary with noends, i.e. the interface is the whole boundary of the domain.

The approach is based on elementary calculus in differential geometry, namely the formula

Cn =n

R=

d

ds,

Page 61: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

7.4. SURFACE TENSION 61

where is the tangent vector, and s the curvilinear abscissa. Now consider the term that corre-sponds to the surface tension effect in the variational formulation:

ΓCn · v,

where v is a vector test function.

Page 62: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

62 CHAPTER 7. COMPLEMENTS

Page 63: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

Chapter 8

Projects

In the following, we present subjects that are open to students for personal projects. It isexpected that the students choose one of them and spend 10 to 15 hours of personal timeworking on them. At the end, they are asked to present their own work in a short 15 mndefense.

All the subjects are described very shortly. This is intentional since we expect the studentsto bring the chosen subject into personal directions. Both professors are available for discussionupon request during the total duration of the projects.

8.1 General

8.1.1 Which mesh for which Reynolds number ?

Given a problem to solve, e.g. the flow around a cylinder at a certain Reynolds number (sayRe=1000), propose an approach (possibly a heuristic/experimental one) to determine the “right”mesh to use in order to provide relevant simulations. By “right” we mean the cheapest onethat allows to properly describe the features of the flow, and to accurately compute relevantquantities.

8.2 Drag and lift of an obstacle

Describe a method to compute the two components of the instantaneous force exerted by aNavier-Stokes fluid on an obstacle: in the direction of the flow (drag), and perpendicular to thisdirection (lift).

8.2.1 Benchmark

A benchmark is proposed in

http://www.math.u-psud.fr/~maury/paps/NUM_NS.BenchmarkTurek.pdf

for the 2d flow around a cylinder, in a specific geometry. Check your Freefem++ implementationby comparing your results in terms of drag and lift forces. Investigate the roles of the time step,the mesh diameter, and possibly the chosen approach (direct approach, penalty, saddle-pointformulation).

63

Page 64: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

64 CHAPTER 8. PROJECTS

8.2.2 Rotating cylinder

We consider that the obstacle is a rotating cylinder (disc in 2d). Investigate numerically the liftinduced by the rotation of the cylinder around its center.

8.2.3 Airfoil

For a given shape of airfoil, and a given regime (choice of a Reynolds number between 20 and500), investigate the dependence of the mean lift force upon the angle of attack.

8.3 Moving objects

8.3.1 Free fall

Propose and implement a numerical strategy to compute (in 2d) the motion of a rigid object(different from a disc) falling freely in a Navier-Stokes fluid. The case of an elongated body(ellipse or rectangle) is of particular interest.

8.3.2 Fluid structure interaction

Propose a way to compute the motion of a rigid disc in a Navier-Stokes flow, when the disc isassumed to be connected to a fixed point by a spring of a certain stiffness and a zero length.Investigate the interaction between the fluid flow and the moving object, in the case where theReynolds number is sufficiently high to induce a oscillations downstream the cylinder.

8.3.3 oscillating cylinder

Propose a numerical approach to compute the problem presented at page 25 in

http://pastel.archives-ouvertes.fr/docs/00/54/59/37/PDF/Duclercq-Marion_these.pdf

8.4 Free surface

8.4.1 Glass forming process

The production of flat glass is based on the so called float process: glass at high temperature(i.e. liquid glass) is poured on a glass of tin (liquid metal, with a very small viscosity), andpulled mechanically at the other end of the bath. We aim here at modeling the motion of theglass sheet over the tin bath, by considering the tin as a perfect fluid, with a pressure that isconsidered hydrostatic.

8.4.2 Density waves

Propose a way to simulate the motion of two layers of immiscible fluids, a light one and aheavier one, one on the top of the other, and investigate the propagation of waves on theinterface between the two fluids.

8.4.3 Inclined plane

Situation: a viscous and inertial fluid flows down an inclined plane. Investigate the effect ofbumps in the supporting surface upon the shape of the free boundary.

Page 65: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

8.5. FREE CONVECTION 65

8.4.4 Waves on the beach

Investigate the effect of a depth change upon a traveling water wave. Consider for example thecase of a bottom profile that is flat on the left hand of the domain, and raises up to anotherheight in the right hand part of the domain.

8.4.5 Rayleigh-Taylor instability

A container is filled with two fluids of different densities, the heavier being on top of the lighter.If the free surface between them were flat, the situation would be stationary (though highlyunstable). At time t = 0, we thus consider that the velocity vanishes, but the surface betweenboth fluids is sinusoidal. Give a method which can compute this evolving situation.

8.5 Free convection

We consider the following situation: The bottom of a container filled with a viscous fluid ismaintained at temperature 1, whereas its top is maintained at 0 (no-flux conditions on thelateral boundaries). Investigate numerically the so-called Rayleigh Benard instabilities, due tothe tendency of warm fluid to go up.

Page 66: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

66 CHAPTER 8. PROJECTS

Page 67: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

Appendix A

Appendix

A.1 Hilbert spaces, minimization under constraint

We collect here some basic properties of Hilbert spaces, and we refer e.g. to [?] for a moredetailed presentation.

Theorem 2 (Riesz- Frechet )Let V be a Hilbert space and ϕ ∈ V ′ a continuous linear functional over V . There exists aunique u such that

(u, v) = 〈ϕ , v〉 ∀v ∈ V.

Theorem 3 (Lax Milgram)Let V be a Hilbert space, and a(·, ·) a bilinear form which is continuous and elliptic, i.e. there

exists a positive constants M < +∞ and α > 0

|a(u, v)| ≤M |u| |v| , a(u, u) ≥ α |u|2 .

For any ϕ ∈ V ′, there exists a unique u such that

a(u, v) = 〈ϕ , v〉 ∀v ∈ V. (A.1)

If a(·, ·) is symmetric, the solution u can be characterized as the unique minimizer of the func-tional

v 7−→ J(v) =1

2a(v, v) − 〈ϕ , v〉.

Note that, in case the bilinear form is symmetric, continuity and ellipticity ensure that thecorresponding scalar product defines a norm which is equivalent to the native one. In this case,the Lax-Milgram theorem is a straightforward consequence of Riesz-Frechet theorem.

We consider the following set of assumptions∣∣∣∣∣∣∣∣∣∣∣∣∣∣∣∣

V and Λ Hilbert spaces,

a(·, ·) bilinear, symmetric, elliptic functional in V × V ,

ϕ ∈ V ′ , B ∈ L(V,Λ),

K = kerB = u ∈ V , Bu = 0

J(v) =1

2a(v, v) − 〈ϕ , v〉,

(A.2)

67

Page 68: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

68 APPENDIX A. APPENDIX

and the constrained optimization problem:

Find u ∈ K such that J(u) = infv∈K

J(v). (A.3)

Definition 7 (Saddle point)A couple (u, λ) is said to be a saddle point to L(·, ·) : V × Λ 7→ R, if

L(u, µ) ≤ L(u, λ) ≤ L(v, λ) ∀v ∈ V , ∀µ ∈ Λ.

We define the Lagrangian of the problem as

L : (v, µ) ∈ V × Λ 7−→ L(v, µ) = J(v) + (µ,Bv). (A.4)

Proposition 9 Under the set of assumptions (A.2), (u, λ) is a saddle-point for L (definedby (A.4)) if and only if

Au + B⋆λ = ϕBu = 0,

(A.5)

where A ∈ L(V, V ′) is defined by

〈Au , v〉 = a(u, v) ∀v ∈ V.

The saddle-point problem (A.5) is tightly related to the original problem, which consists inminimizing J over K.

Proposition 10 Let (u, λ) be a saddle point for L (or, equivalently, (u, λ) is a solution to (A.5)).Then u minimizes J over K.

On the other hand, expressing that u minimizes J over K, i.e. J(u + th) ≥ J(u) for allt ∈ R and h ∈ K, we obtain (∇J,w) = 0 for all w ∈ kerB, i.e. ∇J ∈ (kerB)⊥. In thefinite dimension setting, we have (kerB)⊥ = imB⋆, so that existence of λ such that ∇J+B⋆λ isstraightforward. But in general (infinite dimensional setting), we simply have imB⋆ ⊂ (kerB)⊥,so that full equivalence between the saddle point formulation (A.5) and the initial minimizationproblem does not hold in general.

Proposition 11 Under the set of assumptions (A.2), if B has a closed range, there exists λ ∈ Λsuch that (u, λ) is a saddle point for the Lagrangian L, i.e. (u, λ) is a solution to (A.5).

Proposition 12 In the previous proposition, if B is furthermore assumed to be surjective, thenthe Lagrange multiplier λ is unique.

A.2 Elliptic problems and Finite Element Method

We give here some basic facts on the discretization of an elliptic problem by the Finite Elementapproach. We shall restrict this section to the simplest case, namely the first order LagrangeFinite Element. We refer e.g. to [17, 7] for a general presentation of the approach, and to [16]for its application to fluid flows.

Let Ω be a domain of Rd, we consider the Poisson problem in Ω:

−∆u = f in Ω

u = 0 on Γ = ∂Ω

Page 69: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

A.2. ELLIPTIC PROBLEMS AND FINITE ELEMENT METHOD 69

The variational formulation of the problem can be formally obtained by multiplying the equationby a test function that vanishes on Γ, and integrating by part:

Ω∇u · ∇v =

Ωfv.

Remark 7 The elaboration of the variational formulation is not covered by strict mathematicalrules, so it does not make sense to make precise assumptions on the regularity of the test func-tions, and all operation (like integration by parts) are performed formally. The process allowsto obtain a new formulation of the problem, which fits into a precise mathematical framework assoon as functional spaces are defined. The initial phase which consists in obtaining the varia-tional formulation does not guarantee any rigorous link between the initial problem and its newformulation. If one aims at establishing properly that the solution to the variational problemis a solution to the initial problem in some sense, a rigorous proof has to be provided after thesolution to the variational problem has been identified and characterized.

Considering the Sobolev space V = H10 (Ω), space of all those functions in L2(Ω) with a

gradient in L2(Ω)d, the problem fits into the framework of the Lax-Milgram theorem. Assumethat f is in L2(Ω), the problem can be written

Find u ∈ V such that∫

Ω∇u · ∇v =

Ωfv ∀v ∈ V

(A.6)

which can also be written in an abstract way as (A.1).The Finite Element Method is based on the introduction of a finite dimensional approxima-

tion space Vh ∈ V , in which the variational formulation above makes sense. Such a space can bebuilt as follows: We first consider a triangulation of Ω in the sense of the following definition.

Definition 8 (Conforming triangulation)A conforming triangulation Th is a set of non degenerated simplices (triangles in the two-dimensional setting, tetrahedra for d = 3), with

Ω =⋃

K∈Th

K,

such that, for any two simplices K and K ′ in Th. the intersection K ∩ K′is either empty, a

common vertex, a common edge, or (in the case d = 3), a common face.

We now define Vh as the set of all those functions of V such that their restriction to any elementof Th is affine. Note that, as they are required to belong to V , they are continuous over Ω. Thediscrete problem is now

Find uh ∈ Vh such that∫

Ω∇uh · ∇vh =

Ωfh ∀vh ∈ Vh

(A.7)

If one considers a sequence of such spaces Vh which converges in some sense to the infinitedimensional space V , it is natural to expect a convergence of uh to u. This behavior is ensuredby the following lemma, which can be seen as the abstract core of the Finite Element Method:

Page 70: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

70 APPENDIX A. APPENDIX

Lemma 1 (Cea’s)Let V be a Hilbert space, and Vh ⊂ V a subspace. Let a(·, ·) a bilinear form over V × V whichis continuous and elliptic. We define u and uh as solutions to the problems

a(u, v) = 〈ϕ , v〉 ∀v ∈ V , a(uh, vh) = 〈ϕ , vh〉 ∀vh ∈ Vh.

It holds|u− uh| ≤ C inf

vh∈Vh

|u− vh| ,

where C > 0 does not depend on h.

It remains to establish that the latter infimum converges to 0 as h goes to 0. This propertycan be established in the present situation thanks to the H2 regularity of the solution.

Definition 9 (Regular sequence of triangulations)For a simplex K, we denote by hK its diameter, and by ρK the diameter of the largest ballincluded in K. The maximum of hK over all elements of a given triangulation Th is called thediameter of the triangulation, and it is simply1 denoted by h. A sequence (Th)h is said tobe regular if the ratio hK/ρK is bounded uniformly with respect to all the triangulations of thesequence.

Considering regular families of triangulation consists in ruling out the possibility that simplicesmay degenerated (i.e. become flat).

Proposition 13 Let u ∈ H2(Ω)∩H1(Ω) be given. We denote by Ih the interpolation operator,which maps any function in H2 to the unique element in Vh which takes the same values2 at thevertices of the triangulation Th. It holds

|u− Ihu| ≤ Ch |u|2 .

Convergence of uh toward u (for the H1 norm) is now a direct consequence of Proposition 13and Lemma 1.

Finite element method for constrained problems. Handling constraints in the finiteelement framework is a delicate matter. Consider Problem (A.3, under assumptions (A.2). Itis natural to introduce discretization spaces Vh ⊂ V and Λh ⊂ Λ of the primal and dual spaces,respectively, and to compute the minimum of the same functional

v 7−→ J(v) =1

2a(v, v) − 〈ϕ , v〉,

over the the subspace of Vh of all elements that satisfy the discrete counterpart of the constraint,i.e. which belong to

Kh = vh ∈ Vh , (Bvh, µh) = 0 ∀µh ∈ Λh .

The discrete counterpart of Problem (A.5) writes, in a variational form,

a(uh, vh) + (Bvh, λh) = 〈ϕ , vh〉 ∀vh ∈ Vh,(Buh, µh) = 0 ∀µh ∈ Λh.

(A.8)

1Committing here a common abuse of notations, we denote by h both the index (i.e. the label) and thediameter (which is a positive number).

2For the physical dimensions d = 1, 2, or 3, functions of the Sobolev space H2(Ω) can be identified withcontinuous functions, so that pointwise values are well-defined.

Page 71: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

A.3. DIFFERENTIAL CALCULUS. INTEGRATION BY PARTS 71

The choice of Λh is obviously related to Vh. If Λh it is too poor (i.e. if its dimension istoo small compared to that of Vh), it might harm the convergence of λh toward the exactLagrange multiplier λ. Even if one is interested in the primal part uh only, the problem mightbe underconstrained, and the solution uh might converge to something which does not verify theconstraint. On the other hand, if Λh is too rich, a first consequence can be the non uniqueness ofthe discrete Lagrange multiplier λh. Besides, the discrete problem can become overconstrained,reducing the discrete constrained space Kh to 0 in some situations. The perfect balance ismet whenever the so called inf-sup condition is verified.

Definition 10 (Inf-sup condition)The sequence of discretization spaces (Vh,Λh)h is said to verify the inf-sup condition (also calledLadyzenskaya-Babuska-Brezzi, or LBB condition) there exists C > 0 such that

infµh∈Λh

supvh∈Vh

(Bvh, µh)

|vh| |µh|≥ C ∀h. (A.9)

Note that the surjective character of an operator B ∈ L(V,Λ) is equivalent to

infµ∈Λ

supv∈V

(Bv, µ)

|v| |µ|> 0.

Inf-sup condition (A.9) can therefore be seen as a discrete counterpart of this characterization.

When such a condition is met, convergence of primal and dual components of the solutioncan be proven

Proposition 14 Under assumptions (A.2), we assume that B is surjective, and we denote by(u, λ) the solution to Problem (A.5). Considering now a sequence (Vh,Λh) which verifies inf-supcondition (A.9), and (uh, λh) the solution to Problem A.8, there exists C > 0 such that

|u− uh|+ |λ− λh| ≤ C

(

infvh∈Vh

|u− vh|+ infµh∈Λh

|λ− µh|

)

.

A.3 Differential calculus. Integration by parts

Notations.

Let q be a scalar field. Its gradient is the vector

∇q =

∂q

∂x1∂q

∂x2

Let u = (u1, u2)T be a vector field. Its divergence is

∇ · u =

∂x1∂

∂x2

·

(u1

u2

)

=∂u1∂x1

+∂u2∂x2

.

Page 72: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

72 APPENDIX A. APPENDIX

Let u = (u1, u2)T be a vector field. Its gradient is the matrix

∇u =

∂u1∂x1

∂u1∂x2

∂u2∂x1

∂u2∂x2

For any vector n, we have

∇u · n =

∂u1∂x1

∂u1∂x2

∂u2∂x1

∂u2∂x2

(n1

n2

)

=

∂u1∂x1

n1 +∂u1∂x2

n2

∂u2∂x1

n1 +∂u2∂x2

n2

,

which is the derivative of u in the n direction, so that

u(x+ εn) = u(x) + ε∇u · n+ o(ε).

If n a unit vector, we write

∇u · n =∂u

∂n.

Let u be a vector field. Its Laplacian ∆u is the vector

∆u =

(

∆u1

∆u2

)

.

For A = (aij) and B = (bij) two square matrices, A : B denotes the scalar

A : B =∑

i,j

aijbij .

Note that |A| = (A : B)1/2 is a Euclidean norm on the space of matrices (called Frobenius norm).For u and v two vector fields

∇u : ∇v =

∂u1∂x1

∂u1∂x2

∂u2∂x1

∂u2∂x2

:

∂v1∂x1

∂v1∂x2

∂v2∂x1

∂v2∂x2

=

2∑

i=1

2∑

j=1

∂ui∂xj

∂vi∂xj

.

The notation |∇u|2 is used to denote ∇u : ∇u.

Let σ be a matrix field. Its divergence is a vector, each component of which is the divergence(in the usual sense) of the corresponding matrix line :

∇ · σ = ∇ ·

(σ11 σ12

σ21 σ22

)

=

∂σ11∂x1

+∂σ12∂x2

∂σ21∂x1

+∂σ22∂x2

Let u = (u1, u2)T be a vector field. The matrix u⊗ u is the matrix (ui uj)i,j.

Page 73: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

A.3. DIFFERENTIAL CALCULUS. INTEGRATION BY PARTS 73

If ∇ · u = 0, then

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

u1∂u1∂x1

+ u2∂u1∂x2

u1∂u2∂x1

+ u2∂u2∂x2

Still under the condition that ∇ · u = 0,

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

(

|u|2

2u

)

.

If ∇ · u = 0, then∇ · t∇u = 0.

As a consequence, if ∇ · u = 0, then

∇ ·(∇u+ t∇u

)= ∇ · ∇u = ∆u.

Integration by parts.Let v be a vector field. It holds (Divergence Theorem)

Ω∇ · v =

Γv · n (A.10)

Let σ be a matrix field. It holds (Divergence Theorem for a matrix)

Ω∇ · σ =

Γσ · n (A.11)

Let q be a scalar field. It holds ∫

Ω∇q =

Γqn. (A.12)

Let v be a vector field, and q a scalar field. It holds

Ωq∇ · u+

Ωu · ∇q =

Γqu · n. (A.13)

Let u and v be scalar fields. It holds (Green’s identity for scalar functions)

Ωv∆u =

Ω∇u · ∇v +

Γv∂u

∂n, (A.14)

where n is the outward normal vector.

Let u and v be vector fields. It holds (Green’s identity)

Ω∆u · v +

Ω∇u : ∇v =

Γv ·

∂u

∂n. (A.15)

And, if ∇ · u = 0,

0 +

Ω

t∇u : ∇v =

Γv ·(t∇u · n

)(A.16)

Page 74: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

74 APPENDIX A. APPENDIX

As a consequence, if ∇ · u = 0, then∫

Ω∆u · v +

Ω∇u : (∇v + t∇v) =

Γv ·(∇u+ t∇u

)· n. (A.17)

(note that extra parentheses are not necessary in the boundary integral above, since (c ·σ) ·n =c · (σ · n) as soon as σ is symmetric, which is the case here).

For any two vector fields u and v, we have∫

Ω∇u : t∇v =

Ω

t∇u : ∇v, (A.18)

so that ∫

Ω∇u : (∇v + t∇v) =

1

2

Ω(∇u+ t∇u) : (∇v + t∇v) (A.19)

Let ω be a material system advected by the velocity field u(x, t), and F (x, t) a scalar function.It holds

d

dt

ω(t)F (x, t) =

ω(t)

∂F

∂t−

∂ω(t)F (x, t)u · n. (A.20)

Proposition 15 Soient u et v deux champs de vecteurs reguliers definis sur Ω. On supposeque u est a divergence nulle. On a alors

0 = −

ω

t∇u : ∇v +

∂ωv ·(t∇u · n

)

Proof :On ecrit∫

∂ωv ·(t∇u · n

)=

∂ωn · (∇u · v) =

ω∇ · (∇u · v)

=∑

i

∂i∑

j

vj∂jui =∑

i

j

∂ivj∂jui +∑

j

vj∂j∑

i

∂iui.

Le second terme ci-dessus est nul car u est a divergence nulle, d’ou l’on deduit l’identite annoncee.

Proposition 16 Soient u et : v deux champs rguliers sur Ω. On a∫

Ω∇u : t∇v =

Ω(∇ · u) (∇ · v) +

Γ(∇ · u)v · n−

Γ(∇u · v) · n

Proof : On a∫

Γ(∇u · v) · n =

Ω∇ · (∇u · v)

=

Ω

i

∂i∑

j

vj∂jui

=

Ω

i

j

((∂i∂jui)vj + ∂jui∂ivj)

=

Ωv (∇∇ · u) +

Ω∇u : t∇v

=

Ω(∇ · u)v · n−

Ω(∇ · u) (∇ · v) +

Ω∇u : t∇v

Page 75: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

Bibliography

[1] Gregoire Allaire, Analyse numerique et optimisation, Eds de l’Ecole Polytechnique.

[2] F. Boyer and P. Fabrie, Elements d’analyse pour l’etude de quelques modeles d’ecoulementsde fluides visqueux incompressibles, Mathematiques et Applications, vol. 52, Springer.

[3] D. Braess, Finite elements, Theory, fast solvers ans applications in solid mechanics, Cam-bridge University Press, third edition.

[4] S.C. Brenner, R. Scott, The Mathematical Theory of Finite Element Methods (Texts inApplied Mathematics), Springer 2007.

[5] H. Brezis, Analyse fonctionnelle, Masson Eds.

[6] G. Duvaut and J.-L. Lions, Les inquations en mcanique et en physique, Dunod, Paris, 1972.

[7] A. Ern and J.-L. Guermond, Theory and Practice of Finite Elements, vol. 159 of AppliedMathematical Series, Springer, New York, 2004.

[8] FreeFem++ reference manual

[9] J.F. Gerbeau, C. Le Bris,T. Lelievre, Mathematical Methods for the Magnetohydrodynam-ics of Liquid Metals, Oxford Science Publications, 2006.

[10] V. Girault, P.A. Raviart, Finite Element Methods for Navier-Stokes Equations. Theory andAlgorithms. Berlin-Heidelberg-New York-Tokyo, Springer-Verlag 1986.

[11] J. Hadamard, Sur le principe de Dirichlet, Bull. de la SMF, 34 (1906), pp 135–138.

[12] J. Happel and H. Brenner, Low Reynolds number hydrodynamics: with special applicationsto particulate media, Kluwer ed.

[13] J. Leray Essai sur le mouvement d’un liquide visqueux emplissant l’espace, Acta Math. 63(1933), p. 193?248.

[14] J.L. Lions, Quelques mthodes de rsolution des problmes aux limites non linaires, Gauthier-Villars ed., 1969.

[15] A. Miranville and R. Temam, Modelisation mathematique et mecanique des milieux conti-nus, Scopos, Springer.

[16] A. Quarteroni, A. Valli, Numerical Approximation of Partial Differential Equations,Springer Series in Computational Mathematics, Springer, 2nd edition 2008.

75

Page 76: Variational Methods for Computational Fluid … › ~neela › CIMPA › notes › variational...Chapter 1 Models for incompressible fluids 1.1 Some basics on viscous fluid models

76 BIBLIOGRAPHY

[17] P. A. Raviart, J. M. Thomas, Introduction l’analyse numrique des quations aux drivespartielles, Dunod 2004.

[18] L. Schwartz, Theorie des distributions, Hermann 1997.

[19] R. Temam, Navier-Stokes equations, Theory and numerical analysis, American Mathemat-ical Society, 3rd edition 2000.