You are on page 1of 115

Computational fluid dynamics

Martin Kronbichler
martin.kronbichler@it.uu.se

Applied Scientific Computing (Tillämpad beräkningsvetenskap)

February 11, 2010

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 1 / 72


Introduction

The Navier–Stokes equations


Conservation of mass
Conservation of momentum
Constitutive & kinematic relations
Conservation of energy
Equations of state & compressible Navier–Stokes equations
Incompressible Navier–Stokes equations

Discretization
Overview of spatial discretizations
The Finite Volume Method
Time discretization
Spatial discretization

Turbulence and its modeling

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 2 / 72


Introduction

What is CFD?

I Fluid mechanics deals with the motion of fluids (liquids and gases),
induced by external forces.
I Fluid flow is modeled by partial differential equations (PDE),
describing the conservation of mass, momentum, and energy.
I Computational Fluid Dynamics (CFD) is the discipline of
discretizing these PDE and solving them using computers.

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 3 / 72


Introduction

In which application fields is CFD used?

I Aerospace and aeronautical applications (airplanes, water and space


vehicles)
I Mechanical applications (gas turbines, heat exchange, explosions,
combustion, architecture)
I Biological applications (blood flow, breathing, drinking)
I Meteorological applications (weather prediction)
I Environmental applications (air and water pollution)
I and many more . . .

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 4 / 72


Introduction

Why to use CFD?

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 5 / 72


Introduction

Why to use CFD?

I Pre-design of components: simulation vs. experiment (simulations


are cheaper, faster, and safer, but not always reliable)
I vehicles with lower fuel consumption, quieter, heavier loads
I combustion engines
I oil recovery
I water and gas turbines (effectiveness)
I stress minimization

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 5 / 72


Introduction

Why to use CFD?

I Pre-design of components: simulation vs. experiment (simulations


are cheaper, faster, and safer, but not always reliable)
I vehicles with lower fuel consumption, quieter, heavier loads
I combustion engines
I oil recovery
I water and gas turbines (effectiveness)
I stress minimization
I Detection and prediction
I hurricanes, storms, tsunamis
I pollution transport
I diseases
I forces, stresses

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 5 / 72


Introduction

Visualization of CFD results

ONERA M6 wing optimization


O. Amoignon, M. Berggren

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 6 / 72


Introduction

Visualization of CFD results

Pipe flow, computer lab

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 7 / 72


Introduction

Requirements for industrial CFD

I Robustness — give a solution (for as many input cases as possible)


I Reliability — give a good solution
I Performance — give a good solution fast
I Geometries — give a good solution fast for real problems
I Automatic tool chain — reduce requirements of user interaction
Knowledgeable user controls and evaluates simulation outcomes!

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 8 / 72


Introduction

CFD Solution Tool Chain

I CAD description of geometry

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 9 / 72


Introduction

CFD Solution Tool Chain

I CAD description of geometry


I Grid generation from CAD model (usually the most time consuming
part)

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 9 / 72


Introduction

CFD Solution Tool Chain

I CAD description of geometry


I Grid generation from CAD model (usually the most time consuming
part)
I Problem set up - knowledgeable user needed
I Mathematical model to use
I Spatial and temporal discretization
I Available resources
I Much more . . .

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 9 / 72


Introduction

CFD Solution Tool Chain

I CAD description of geometry


I Grid generation from CAD model (usually the most time consuming
part)
I Problem set up - knowledgeable user needed
I Mathematical model to use
I Spatial and temporal discretization
I Available resources
I Much more . . .
I Preprocessing - parse configuration and prepare solver

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 9 / 72


Introduction

CFD Solution Tool Chain

I CAD description of geometry


I Grid generation from CAD model (usually the most time consuming
part)
I Problem set up - knowledgeable user needed
I Mathematical model to use
I Spatial and temporal discretization
I Available resources
I Much more . . .
I Preprocessing - parse configuration and prepare solver
I Solving - run the solver

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 9 / 72


Introduction

CFD Solution Tool Chain

I CAD description of geometry


I Grid generation from CAD model (usually the most time consuming
part)
I Problem set up - knowledgeable user needed
I Mathematical model to use
I Spatial and temporal discretization
I Available resources
I Much more . . .
I Preprocessing - parse configuration and prepare solver
I Solving - run the solver
I Post processing - extract and compute information of interest

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 9 / 72


Introduction

CFD Solution Tool Chain

I CAD description of geometry


I Grid generation from CAD model (usually the most time consuming
part)
I Problem set up - knowledgeable user needed
I Mathematical model to use
I Spatial and temporal discretization
I Available resources
I Much more . . .
I Preprocessing - parse configuration and prepare solver
I Solving - run the solver
I Post processing - extract and compute information of interest
I Visualization - often most important

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 9 / 72


Introduction

CFD Solution Tool Chain

I CAD description of geometry


I Grid generation from CAD model (usually the most time consuming
part)
I Problem set up - knowledgeable user needed
I Mathematical model to use
I Spatial and temporal discretization
I Available resources
I Much more . . .
I Preprocessing - parse configuration and prepare solver
I Solving - run the solver
I Post processing - extract and compute information of interest
I Visualization - often most important
I Interpretation - physics, mathematics, numerics, experiments

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 9 / 72


Introduction

CFD software

I Commercial: Fluent, Comsol, CFX, Star-CD


I In-house codes: Edge (FOI), DLR-Tau (German Aerospace Center),
Fun3D (NASA), Sierra/Premo (American Aerospace)
I Open Source: OpenFOAM, FEniCS, OpenFlower

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 10 / 72


Introduction

CFD links

I http://www.cfd-online.com
I http://www.fluent.com
I http://www.openfoam.org

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 11 / 72


The Navier–Stokes equations

A mathematical model for fluid flow

The Navier–Stokes equations

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 12 / 72


The Navier–Stokes equations

Navier–Stokes equations — an overview

I The governing equations of fluid dynamics are the conservation laws


of mass, momentum, and energy.
I In CFD, this set of conservation laws are called the
Navier–Stokes equations.
I Derive compressible Navier–Stokes equations first
I Simplify these equations to get the incompressible Navier–Stokes
equations

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 13 / 72


The Navier–Stokes equations

Notation

ρ density
u velocity, u = (u1 , u2 , u3 )
p pressure
T temperature
µ dynamic viscosity
ν kinematic viscosity,
 ν = µ/ρ 
∂ ∂ ∂
∇ nabla operator, ∇ = ∂x1 , ∂x2 , ∂x3
· inner product, a · b = a1 b1 + a2 b2 + a3 b3

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 14 / 72


The Navier–Stokes equations

General form of conservation laws


I Monitor the flow characteristics of a fixed control volume Ω.
I Rate of total change in the control volume:
I change in the interior,
I flow over boundary of control volume,

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 15 / 72


The Navier–Stokes equations

General form of conservation laws


I Monitor the flow characteristics of a fixed control volume Ω.
I Rate of total change in the control volume:
I change in the interior,
I flow over boundary of control volume,
expressed as
Z Z Z Z
D ∂q
q dΩ = dΩ + qu · n ds = S dΩ
Dt Ω(t) Ω ∂t ∂Ω Ω(t)

for some quantity q and a source term S (generation or elimination).


n denotes the outer normal on Ω. This is the Reynolds transport
theorem.
Note: Ω(t) is an ensemble of molecules, Ω is a fixed control volume.

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 15 / 72


The Navier–Stokes equations

General form of conservation laws


I Monitor the flow characteristics of a fixed control volume Ω.
I Rate of total change in the control volume:
I change in the interior,
I flow over boundary of control volume,
expressed as
Z Z Z Z
D ∂q
q dΩ = dΩ + qu · n ds = S dΩ
Dt Ω(t) Ω ∂t ∂Ω Ω(t)

for some quantity q and a source term S (generation or elimination).


n denotes the outer normal on Ω. This is the Reynolds transport
theorem.
Note: Ω(t) is an ensemble of molecules, Ω is a fixed control volume.
I Differential form:
Dq ∂q
= + u · ∇q = S.
Dt ∂t
Martin Kronbichler (TDB) FVM for CFD February 11, 2010 15 / 72
The Navier–Stokes equations Conservation of mass

Continuity equation I

The continuity equation describes the conservation of mass .


The mass M of the material in Ω(t) is constant (molecules cannot be
created/destroyed), that is M(t) = M(t + ∆t).
Z
DM D
= ρ dΩ = 0
Dt Dt Ω(t)
| {z }
M
ρ(t) denotes the fluid density.

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 16 / 72


The Navier–Stokes equations Conservation of mass

Continuity equation II

Rewritten for a stationary control volume by using the Reynolds transport


theorem:

rate of mass change in Ω + mass flow over ∂Ω = 0,


Z Z
∂ρ
dΩ + ρu · n ds = 0.
Ω ∂t ∂Ω

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 17 / 72


The Navier–Stokes equations Conservation of momentum

Momentum equation I

The momentum equation describes the conservation of momentum .


Newton’s second law of motion: the total rate of momentum m change in
Ω(t) is equal to the sum of acting forces K, i.e.,
Z
Dm D
= ρu d Ω = K,
Dt Dt Ω(t)

(interpretation: mass × acceleration = force).

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 18 / 72


The Navier–Stokes equations Conservation of momentum

Momentum equation II
Rewritten for a stationary control volume Ω:
Z Z
∂ρu
+ ρ(u ⊗ u) · n ds = K,
Ω ∂t ∂Ω

where u ⊗ u is a rank-2 tensor with entries ui uj .

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 19 / 72


The Navier–Stokes equations Conservation of momentum

Momentum equation II
Rewritten for a stationary control volume Ω:
Z Z
∂ρu
+ ρ(u ⊗ u) · n ds = K,
Ω ∂t ∂Ω

where u ⊗ u is a rank-2 tensor with entries ui uj .


Decompose force into surface forces and volume forces:

rate of momentum change in Ω + momentum flow over ∂Ω


= surface forces on ∂Ω + volume forces on Ω ,
Z Z Z Z Z
∂ρu
dV + ρ(u⊗u)·n ds = − pn ds + τ · n ds + ρf d Ω.
Ω ∂t ∂Ω
| ∂Ω {z ∂Ω } Ω
surface forces

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 19 / 72


The Navier–Stokes equations Conservation of momentum

Momentum equation III

I Surface forces acting on ds of ∂Ω:


I Pressure force p(−n) ds (analog to isotropic stress in structural
mechanics),
I Viscous force τ · n ds, τ is the Cauchy stress tensor (analog to
deviatoric stress in structural mechanics).

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 20 / 72


The Navier–Stokes equations Conservation of momentum

Momentum equation III

I Surface forces acting on ds of ∂Ω:


I Pressure force p(−n) ds (analog to isotropic stress in structural
mechanics),
I Viscous force τ · n ds, τ is the Cauchy stress tensor (analog to
deviatoric stress in structural mechanics).
I Volume forces ρf d Ω acting on small interior volume d Ω:
I Gravity force ρg d Ω, e.g., f = g,
I Other types of forces: Coriolis, centrifugal, electromagnetic, buoyancy

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 20 / 72


The Navier–Stokes equations Conservation of momentum

Newtonian fluid
Model that relates the stress tensor τ to the velocity u:
We consider so-called Newtonian fluids, where the viscous stress is
linearly related to strain rate, that is,
2   2
τ = 2µε(u) − µI tr ε(u) = µ ∇u + (∇u)T − µ(∇ · u)I,
3 3
(compare with constitutive and kinematic relations in elasticity theory).

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 21 / 72


The Navier–Stokes equations Conservation of momentum

Newtonian fluid
Model that relates the stress tensor τ to the velocity u:
We consider so-called Newtonian fluids, where the viscous stress is
linearly related to strain rate, that is,
2   2
τ = 2µε(u) − µI tr ε(u) = µ ∇u + (∇u)T − µ(∇ · u)I,
3 3
(compare with constitutive and kinematic relations in elasticity theory).
For Cartesian coordinates
  3
∂uj ∂ui 2 X ∂uk
τij = µ + − µ .
∂xi ∂xj 3 ∂xk
k=1

The dynamic viscosity is assumed constant

µ = µ(T , p) ≈ constant.

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 21 / 72


The Navier–Stokes equations Conservation of energy

Energy equation I

The energy equation describes the conservation of energy .


The first law of thermodynamics:
The total rate of total energy E changes in Ω(t) is equal to the rate of
work L done on the fluid by the acting forces K plus the rate of heat added
W , that is
DE D
Z
= ρE d Ω = L + W
Dt Dt Ω(t)
where ρE is the total energy per unit volume.

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 22 / 72


The Navier–Stokes equations Conservation of energy

Energy Equation II

Rewritten for a stationary control volume Ω, explicitly specifying the source


terms:

Rate of total energy change in Ω + Total energy flow over ∂Ω =


Rate of work of pressure and viscous forces on ∂Ω +
Rate of work of forces on Ω + Rate of heat added over ∂Ω
Z Z Z Z
∂ρE
dΩ + ρE u · n ds = − pu · n ds + (τ · u) · n ds
Ω ∂t ∂Ω Z∂Ω Z ∂Ω
+ ρf · u d Ω + k∇T · n ds
Ω ∂Ω

for the fluid temperature T and thermal conductivity k.

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 23 / 72


The Navier–Stokes equations Conservation of energy

Involved variables and equations

We have
I seven variables (ρ, u1 , u2 , u3 , p, T , E )
I five equations (continuity, 3×momentum, energy)

We need two more equations to close the system, the so-called equations
of state.

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 24 / 72


The Navier–Stokes equations Equations of state & compressible Navier–Stokes equations

Equations of state

Properties of a perfect gas:


internal energy
z }| {
1 2
p =(γ − 1)ρ E − |u|
2
 
1 1
T = E − |u|2
cv 2
c
where γ = cvp is the ratio of specific heats, and cp and cv are the specific
heats at constant pressure and volume.
A typical value for air at sea level pressure is γ = 1.4.

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 25 / 72


The Navier–Stokes equations Equations of state & compressible Navier–Stokes equations

The compressible Navier–Stokes equations in integral form


The equations of continuity, momentum, and energy can be combined into
one system of equations.
I Define compound variable U = (ρ, ρu1 , ρu2 , ρu3 , ρE ) (called
conservative variables)
I Define flux vectors
   
ρu · n 0
F · n =  ρ(u ⊗ u) · n + pI · n  −  τ ·n 
(ρE + p)u · n (τ · u) · n + k(∇T ) · n
| {z } | {z }
inviscid/convective viscous

and an external strength vector Fe = (0, f, f · u)T

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 26 / 72


The Navier–Stokes equations Equations of state & compressible Navier–Stokes equations

The compressible Navier–Stokes equations in integral form


The equations of continuity, momentum, and energy can be combined into
one system of equations.
I Define compound variable U = (ρ, ρu1 , ρu2 , ρu3 , ρE ) (called
conservative variables)
I Define flux vectors
   
ρu · n 0
F · n =  ρ(u ⊗ u) · n + pI · n  −  τ ·n 
(ρE + p)u · n (τ · u) · n + k(∇T ) · n
| {z } | {z }
inviscid/convective viscous

and an external strength vector Fe = (0, f, f · u)T


Compressible Navier–Stokes equations in integral form
Z Z Z
∂U
dΩ + F · n ds = ρFe d Ω
Ω ∂t ∂Ω Ω

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 26 / 72


The Navier–Stokes equations Equations of state & compressible Navier–Stokes equations

Compressible Navier–Stokes equations, differential form

Assume: flux tensor F is differentiable


Apply the Gauss theorem to the integral form and get
Z  
∂U
+ ∇ · F − ρFe d Ω = 0.
Ω ∂t

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 27 / 72


The Navier–Stokes equations Equations of state & compressible Navier–Stokes equations

Compressible Navier–Stokes equations, differential form

Assume: flux tensor F is differentiable


Apply the Gauss theorem to the integral form and get
Z  
∂U
+ ∇ · F − ρFe d Ω = 0.
Ω ∂t

Since the integral is zero for an arbitrary control volume Ω, we obtain the
differential form of the

Compressible Navier–Stokes equations


∂U
+ ∇ · F = ρFe .
∂t

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 27 / 72


The Navier–Stokes equations Incompressible Navier–Stokes equations

The incompressible Navier–Stokes equations

Motivation: we can use simpler equations if we have more information


I Incompressible fluid: density does not change with pressure, i.e.,
ρ = const.
I Energy equation decouples from the rest of the system; continuity and
momentum equations can be simplified.
I Many practically relevant flows are incompressible (e.g. air at speeds
up to 100 m/s) — predominant CFD model

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 28 / 72


The Navier–Stokes equations Incompressible Navier–Stokes equations

Continuity equation

The continuity equation,


∂ρ
+ ∇ · (ρu) = 0,
∂t
becomes for constant ρ simply
3
X ∂ui
∇ · u = 0, i.e., = 0.
∂xi
i=1

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 29 / 72


The Navier–Stokes equations Incompressible Navier–Stokes equations

Momentum equation
The momentum equation,
∂ρu
+ ∇ · (ρu ⊗ u) = −∇p + ∇ · τ + ρf,
∂t
can be simplified by using ∇ · u = 0,

∇ · (u ⊗ u) = (u · ∇)u + (∇ · u)u = (u · ∇)u


  2  
τ = µ ∇u + (∇u)T − µ(∇ · u)I = ∇u + (∇u)T
3

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 30 / 72


The Navier–Stokes equations Incompressible Navier–Stokes equations

Momentum equation
The momentum equation,
∂ρu
+ ∇ · (ρu ⊗ u) = −∇p + ∇ · τ + ρf,
∂t
can be simplified by using ∇ · u = 0,

∇ · (u ⊗ u) = (u · ∇)u + (∇ · u)u = (u · ∇)u


  2  
τ = µ ∇u + (∇u)T − µ(∇ · u)I = ∇u + (∇u)T
 3
T
= µ ∇2 u + ∇(∇ · u) = µ∇2 u.

∇ · τ = µ∇ · ∇u + (∇u)

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 30 / 72


The Navier–Stokes equations Incompressible Navier–Stokes equations

Momentum equation
The momentum equation,
∂ρu
+ ∇ · (ρu ⊗ u) = −∇p + ∇ · τ + ρf,
∂t
can be simplified by using ∇ · u = 0,

∇ · (u ⊗ u) = (u · ∇)u + (∇ · u)u = (u · ∇)u


  2  
τ = µ ∇u + (∇u)T − µ(∇ · u)I = ∇u + (∇u)T
 3
T
= µ ∇2 u + ∇(∇ · u) = µ∇2 u.

∇ · τ = µ∇ · ∇u + (∇u)

This gives the incompressible version of the momentum equation


∂u 1 µ
+ (u · ∇)u = − ∇p + ∇2 u + f
∂t ρ ρ

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 30 / 72


The Navier–Stokes equations Incompressible Navier–Stokes equations

The incompressible Navier–Stokes equations II

Since the energy equation does not enter the momentum and continuity
equation, we have a closed system of four equations:

Incompressible Navier–Stokes equations



 ∇ · u = 0,
∂u 1
 + (u · ∇)u = − ∇p + ν∇2 u + f,
∂t ρ

µ
where ν = ρ is the fluid kinematic viscosity.

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 31 / 72


The Navier–Stokes equations Incompressible Navier–Stokes equations

Equation in temperature

The energy equation can be expressed in terms of temperature by using the


equation of state. Transforming the integral form into differential form as
done before1 yields
 
∂T
ρcp + ∇ · (T u) = ∇ · (k∇T ) + τ : ∇u,
∂t

where
3 3
∂uj 2
 
X ∂uj X 1 ∂ui
τ : ∇u = τij =µ + ,
∂xi 2 ∂xj ∂xi
i,j=1 i,j=1

and is called a dissipative function.

1
for further reading, see e.g. J. Blazek: Computational Fluid Dynamics, Elsevier,
Amsterdam
Martin Kronbichler (TDB) FVM for CFD February 11, 2010 32 / 72
The Navier–Stokes equations Incompressible Navier–Stokes equations

Incompressible Navier–Stokes equations III


I Energy equation is decoupled from the continuity and momentum
equations ⇒
I first solve the continuity and momentum equations to get the velocity
and pressure.
I temperature (energy) equation can be solved for temperature using the
already computed velocity.

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 33 / 72


The Navier–Stokes equations Incompressible Navier–Stokes equations

Incompressible Navier–Stokes equations III


I Energy equation is decoupled from the continuity and momentum
equations ⇒
I first solve the continuity and momentum equations to get the velocity
and pressure.
I temperature (energy) equation can be solved for temperature using the
already computed velocity.
I Pressure level only defined up to a constant for incompressible
flow ⇒
I pressure level has to be fixed at one point in the flow.
I p yields then the relative pressure difference with respect to that
pressure level.

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 33 / 72


The Navier–Stokes equations Incompressible Navier–Stokes equations

Incompressible Navier–Stokes equations III


I Energy equation is decoupled from the continuity and momentum
equations ⇒
I first solve the continuity and momentum equations to get the velocity
and pressure.
I temperature (energy) equation can be solved for temperature using the
already computed velocity.
I Pressure level only defined up to a constant for incompressible
flow ⇒
I pressure level has to be fixed at one point in the flow.
I p yields then the relative pressure difference with respect to that
pressure level.
I No time derivative for the pressure ⇒
I mathematical difficulty of the incompressible Navier–Stokes equations.
I p is indirectly determined by the condition ∇ · u = 0 (p has to be such
that the resulting velocity is divergence free, Lagrange multiplier).

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 33 / 72


The Navier–Stokes equations Incompressible Navier–Stokes equations

Additional conditions

To complete the physical problem setup after having derived the


appropriate PDE, we have to define the
I domain
I initial conditions (velocity, temperature, etc at t = 0)
I boundary conditions (inflow, outflow, wall, interface, . . .)
I material properties

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 34 / 72


Discretization

Discretization

Numerical solution strategies for the


flow equations

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 35 / 72


Discretization

Solution Strategies Outline

Some points we will cover regarding solver strategies of CFD


I Pros and cons of various discretization methods
I Finite Volume Method (FVM)
I Turbulence and its modeling

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 36 / 72


Discretization Overview of spatial discretizations

Overview of Methods
Discretization methods for the CFD equations:
I Finite Difference Method (FDM)
+ efficiency, + theory, − geometries
I Finite Element Method (FEM)
+ theory, + geometries, − shocks, − uses no directional information
I Spectral Methods (Collocation, Galerkin, . . .)
+ accuracy, + theory, − geometries

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 37 / 72


Discretization Overview of spatial discretizations

Overview of Methods
Discretization methods for the CFD equations:
I Finite Difference Method (FDM)
+ efficiency, + theory, − geometries
I Finite Element Method (FEM)
+ theory, + geometries, − shocks, − uses no directional information
I Spectral Methods (Collocation, Galerkin, . . .)
+ accuracy, + theory, − geometries
I Finite Volume Methods (FVM)
+ robustness, + geometries, − accuracy
I Discontinuous Galerkin Methods (DGM)
+ geometries, + shocks, − efficiency (e.g. smooth solutions)

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 37 / 72


Discretization Overview of spatial discretizations

Overview of Methods
Discretization methods for the CFD equations:
I Finite Difference Method (FDM)
+ efficiency, + theory, − geometries
I Finite Element Method (FEM)
+ theory, + geometries, − shocks, − uses no directional information
I Spectral Methods (Collocation, Galerkin, . . .)
+ accuracy, + theory, − geometries
I Finite Volume Methods (FVM)
+ robustness, + geometries, − accuracy
I Discontinuous Galerkin Methods (DGM)
+ geometries, + shocks, − efficiency (e.g. smooth solutions)
I Hybrid Methods
+ versatile, − complex (not automatable)

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 37 / 72


Discretization The Finite Volume Method

Introduction

The Finite Volume Method (FVM) is based on the integral form of the
governing equations.
The integral conservation is enforced in so-called control volumes
( d Ω → ∆Ω) defined by the computational mesh.
The type of FVM is specified by
I the type of control volume
I the type of evaluation of integrals and fluxes

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 38 / 72


Discretization The Finite Volume Method

FVM derivation, introduction

Consider a general scalar hyperbolic conservation law:


∂u
+ ∇ · F(u) = 0 in Ω, (1)
∂t
with appropriate boundary and initial conditions.

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 39 / 72


Discretization The Finite Volume Method

FVM derivation, introduction

Consider a general scalar hyperbolic conservation law:


∂u
+ ∇ · F(u) = 0 in Ω, (1)
∂t
with appropriate boundary and initial conditions.
Compared to the compressible Navier–Stokes equations, we use a problem
where
I u replaces the vector of conservative variables (ρ, ρu, ρE ),
I F replaces the flux tensor as defined earlier,
I we have a scalar problem instead of a system.

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 39 / 72


Discretization The Finite Volume Method

FVM derivation, control volumes


Consider the equation in two dimensions, and we divide the domain Ω into
M non-overlapping control volumes Km ⊂ Ω.

Km

vertex-centered finite volume method

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 40 / 72


Discretization The Finite Volume Method

FVM derivation, discretized solution

In each control volume, Km , we store one value um , which is the average


of u in Km .
1
Z
um = u dΩ
|Km | Km

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 41 / 72


Discretization The Finite Volume Method

FVM derivation, integral form I


The FVM is based on the integral formulation of the equations.
We start by integrating (1) over one of the control volumes,
Z Z
∂u
dΩ + ∇ · F(u) d Ω = 0. (2)
Km ∂t Km

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 42 / 72


Discretization The Finite Volume Method

FVM derivation, integral form I


The FVM is based on the integral formulation of the equations.
We start by integrating (1) over one of the control volumes,
Z Z
∂u
dΩ + ∇ · F(u) d Ω = 0. (2)
Km ∂t Km

The first integral can be simplified by changing order of time derivative and
integration to get

d dum
Z Z
∂u
dΩ = u d Ω = |Km | . (3)
Km ∂t dt Km dt

Inserting (3) back into (2) yields

dum 1
Z
=− ∇ · F(u) d Ω.
dt |Km | Km

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 42 / 72


Discretization The Finite Volume Method

FVM derivation, time evolution

We need to propagate the solution um in time.


There are many possibilities for choosing a time integration method, for
example Runge–Kutta, multistep methods etc.
See some Ordinary Differential Equation (ODE) textbook for more
information.2

2
e.g., E. Hairer, S.P. Nørsett, G. Wanner: Solving Ordinary Differential Equations. I:
Nonstiff Problems. Springer-Verlag, Berlin, 1993.
Martin Kronbichler (TDB) FVM for CFD February 11, 2010 43 / 72
Discretization The Finite Volume Method

FVM derivation, time evolution

We need to propagate the solution um in time.


There are many possibilities for choosing a time integration method, for
example Runge–Kutta, multistep methods etc.
See some Ordinary Differential Equation (ODE) textbook for more
information.2
We will use forward Euler in all our examples, i.e.,

dum u n+1 − um
n
= m ,
dt ∆t
n = u (t ).
where um m n

2
e.g., E. Hairer, S.P. Nørsett, G. Wanner: Solving Ordinary Differential Equations. I:
Nonstiff Problems. Springer-Verlag, Berlin, 1993.
Martin Kronbichler (TDB) FVM for CFD February 11, 2010 43 / 72
Discretization The Finite Volume Method

FVM derivation, time evolution

Inserting the forward Euler time discretization into our system gives
Z
n+1 n ∆t
um = um − ∇ · F(u) d Ω.
|Km | Km

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 44 / 72


Discretization The Finite Volume Method

FVM derivation, integral form II

By integration by parts (Gauss divergence theorem) of the flux integral we


get the basic FVM formulation
Z
n+1 n ∆t
um = um − F(u) · n ds. (4)
|Km | ∂Km

The boundary integral describes the flux of u over the boundary ∂Km of
the control volume.
Note: Transforming the volume to a surface integral gets us back to the
form used for the derivation of the Navier–Stokes equations.

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 45 / 72


Discretization The Finite Volume Method

FVM derivation, integral form II

By integration by parts (Gauss divergence theorem) of the flux integral we


get the basic FVM formulation
Z
n+1 n ∆t
um = um − F(u) · n ds. (4)
|Km | ∂Km

The boundary integral describes the flux of u over the boundary ∂Km of
the control volume.
Note: Transforming the volume to a surface integral gets us back to the
form used for the derivation of the Navier–Stokes equations.
Different ways of evaluating the flux integral specify the type of FVM
(together with the control volume type).

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 45 / 72


Discretization The Finite Volume Method

FVM derivation, numerical flux

The integral in (4) is evaluated using a so-called numerical flux function.


I There are a lot of different numerical fluxes available for the integral
evaluation, each of them having its pros and cons.
Terminology: Riemann solvers (they are usually designed to solve the
Riemann problem which is a conservation law with constant data and
a discontinuity).

3
Contains only the inviscid terms from the compressible Navier–Stokes equations
Martin Kronbichler (TDB) FVM for CFD February 11, 2010 46 / 72
Discretization The Finite Volume Method

FVM derivation, numerical flux

The integral in (4) is evaluated using a so-called numerical flux function.


I There are a lot of different numerical fluxes available for the integral
evaluation, each of them having its pros and cons.
Terminology: Riemann solvers (they are usually designed to solve the
Riemann problem which is a conservation law with constant data and
a discontinuity).
I Both exact and approximate solvers (i.e., ways to evaluate the flux
integral (4)) have been developed, usually the latter class is used.
I E.g. exact solver for Euler3 equations developed by Godunov.
I Widely used approximate solvers: Roe, HLLC, central flux.

3
Contains only the inviscid terms from the compressible Navier–Stokes equations
Martin Kronbichler (TDB) FVM for CFD February 11, 2010 46 / 72
Discretization The Finite Volume Method

FVM derivation, numerical flux II

The numerical flux functions are usually denoted by F ∗ (uL , uR , n) where uL


is the left (local) state and uR is the right (remote) state of u at the
boundary ∂Km ,
Z XZ
F(u) · n ds = F(u) · nj ds
j
∂Km j ∂Km

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 47 / 72


Discretization The Finite Volume Method

FVM derivation, numerical flux II

The numerical flux functions are usually denoted by F ∗ (uL , uR , n) where uL


is the left (local) state and uR is the right (remote) state of u at the
boundary ∂Km ,
Z XZ
F(u) · n ds = F(u) · nj ds
j
∂Km j ∂Km
X
≈ |∂Kmj |F ∗ (uL , uR , nj )
j

and j denotes the index of each subboundary of ∂Km with a given normal
nj .

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 47 / 72


Discretization The Finite Volume Method

FVM derivation, full discretization

The full discretization for control volume Km is hence


∆t X
n+1
um n
= um − |∂Kmj |F ∗ (uL , uR , nj )
|Km |
j

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 48 / 72


Discretization The Finite Volume Method

FVM derivation, full discretization

The full discretization for control volume Km is hence


∆t X
n+1
um n
= um − |∂Kmj |F ∗ (uL , uR , nj )
|Km |
j

In one dimension, we have


Z
n+1 n ∆t
um = −
um F(u) · n ds
∆x ∂Km
n ∆t  n n

= um − F(um+1/2 ) − F(um−1/2 )
∆x

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 48 / 72


Discretization The Finite Volume Method

FVM derivation, full discretization

The full discretization for control volume Km is hence


∆t X
n+1
um n
= um − |∂Kmj |F ∗ (uL , uR , nj )
|Km |
j

In one dimension, we have


Z
n+1 n ∆t
um = −
um F(u) · n ds
∆x ∂Km
n ∆t  n n

= um − F(um+1/2 ) − F(um−1/2 )
∆x
∆t
n
F ∗ (umn n
, −1) + F ∗ (um
n n

= um − , um−1 , um+1 , 1)
∆x

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 48 / 72


Discretization The Finite Volume Method

FVM derivation, upwind scheme I


Get the information upwind, where the information comes from.

Image from http://en.wikipedia.org

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 49 / 72


Discretization The Finite Volume Method

FVM derivation, upwind scheme II


Example in one dimension
F(u) = βu,
where β is the direction of the flow. So in each control volume we compute
Z
βun ds.
∂Km

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 50 / 72


Discretization The Finite Volume Method

FVM derivation, upwind scheme II


Example in one dimension
F(u) = βu,
where β is the direction of the flow. So in each control volume we compute
Z
βun ds.
∂Km

Case β > 0 (information flows from left to right), equidistant mesh:

um−1/2 = um−1 , um+1/2 = um .

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 50 / 72


Discretization The Finite Volume Method

FVM derivation, upwind scheme II


Example in one dimension
F(u) = βu,
where β is the direction of the flow. So in each control volume we compute
Z
βun ds.
∂Km

Case β > 0 (information flows from left to right), equidistant mesh:

um−1/2 = um−1 , um+1/2 = um .

Hence, we get

n+1 n ∆t  n n

um = um − F(um+1/2 )nm+1/2 + F(um−1/2 )nm−1/2
∆x
n ∆t  n n

n ∆t n n

= um − β um+1/2 − um−1/2 = um − β um − um−1 .
∆x ∆x
Martin Kronbichler (TDB) FVM for CFD February 11, 2010 50 / 72
Discretization The Finite Volume Method

FVM derivation, upwind scheme (Roe flux)

Practical implementation of upwinding: construct it by the Roe Flux

n · F(uL ) + n · F(uR ) uL − uR
F ∗ (uL , uR , n) = + n · F 0 (ū)

.
2 2
Here, ū satisfies the mean value theorem,

n · F(uL ) = n · F(uR ) + n · F 0 (ū) (uL − uR ) .

and is called the Roe average (problem dependent).

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 51 / 72


Discretization The Finite Volume Method

FVM derivation, upwind scheme (Roe flux)

Practical implementation of upwinding: construct it by the Roe Flux

n · F(uL ) + n · F(uR ) uL − uR
F ∗ (uL , uR , n) = + n · F 0 (ū)

.
2 2
Here, ū satisfies the mean value theorem,

n · F(uL ) = n · F(uR ) + n · F 0 (ū) (uL − uR ) .

and is called the Roe average (problem dependent).


Upwinding is first order accurate.

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 51 / 72


Discretization The Finite Volume Method

FVM derivation, central scheme I


For F(u) = βu on a equidistant mesh, the central scheme approximation is
um−1 + um um + um+1
um−1/2 = , um−1/2 = .
2 2

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 52 / 72


Discretization The Finite Volume Method

FVM derivation, central scheme I


For F(u) = βu on a equidistant mesh, the central scheme approximation is
um−1 + um um + um+1
um−1/2 = , um−1/2 = .
2 2
Hence,

n+1 n ∆t  n n

um = um − F(um+1/2 )nm+1/2 + F(um−1/2 )nm−1/2
∆x
n ∆t  n n

= um − β um+1/2 − um−1/2
∆x 
n + un
um n
um−1 n 
+ um
n ∆t m+1
= um − β −
∆x 2 2
 n n
um+1 − um−1

n ∆t
= um − β .
∆x 2

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 52 / 72


Discretization The Finite Volume Method

FVM derivation, central scheme II

Possibilities for evaluating the central flux:


1. F ∗ (uL , uR , n) = n · F uL + uR − d ,
 
2
n · F(uL ) + n · F(uR )
2. F ∗ (uL , uR , n) = 2 − d.

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 53 / 72


Discretization The Finite Volume Method

FVM derivation, central scheme II

Possibilities for evaluating the central flux:


1. F ∗ (uL , uR , n) = n · F uL + uR − d ,
 
2
n · F(uL ) + n · F(uR )
2. F ∗ (uL , uR , n) = 2 − d.

The central scheme is second order accurate.


But:
I the central scheme gives rise to unphysical oscillations around steep
gradients (shocks)
I the central scheme ignores the direction of the flow
I choice of artificial dissipation d can reduce accuracy

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 53 / 72


Discretization The Finite Volume Method

FVM derivation, second derivatives

Flux tensor F contains terms with first derivatives in u for the


Navier–Stokes equations (corresponding to second derivatives in the
differential form of the equations).
Need to approximate these terms before evaluating the flux function.

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 54 / 72


Discretization The Finite Volume Method

FVM derivation, second derivatives

Flux tensor F contains terms with first derivatives in u for the


Navier–Stokes equations (corresponding to second derivatives in the
differential form of the equations).
Need to approximate these terms before evaluating the flux function.
Usually, apply central differences of the kind
 
∂u um − um−1
= .
∂x m−1/2 ∆x

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 54 / 72


Discretization The Finite Volume Method

Higher order discretization schemes for FVM

There are a number of higher order schemes for orders of accuracy ≥ 2,


like
I MUSCL (Monotone Upstream-centered Schemes for Conservation
Laws)
I ENO (Essentially Non-Oscillatory)
I WENO (Weighted ENO)
I RDS (Residual Distribution Scheme)

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 55 / 72


Discretization The Finite Volume Method

Higher order discretization schemes for FVM

There are a number of higher order schemes for orders of accuracy ≥ 2,


like
I MUSCL (Monotone Upstream-centered Schemes for Conservation
Laws)
I ENO (Essentially Non-Oscillatory)
I WENO (Weighted ENO)
I RDS (Residual Distribution Scheme)
They combine different techniques to attain a high-order solution without
excessive oscillations, for example so called flux limiters (reducing artificial
oscillations), wider stencils over several control volumes, different
weightings, reconstruction, and adding degrees of freedom in each control
volume.

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 55 / 72


Discretization The Finite Volume Method

Choosing the discretization parameters

A necessary condition for stability of the time discretization is the CFL


condition (depends on the combination of space and time discretization).
For the one dimensional upwind discretization

n+1 n ∆t n n

um = um − β um − um−1 ,
∆x
we require
∆t
∆x β ≤ 1.

Interpretation: The difference approximation (which only uses information


from one grid point to the left/right) can only represent variations in the
solution up to β/∆x from one time step to the next → time step size has
to be smaller than that limit

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 56 / 72


Discretization The Finite Volume Method

Steady state calculations


For certain computations, the time-dependance is of no importance.
Sought: steady state solution. when the solution has stabilized, the
change in time will go to zero,
∆t X
n+1
um n
= um − |∂Kmj |F ∗ (uL , uR , nj ) = um
n
, ∀m.
|Km |
j
| {z }
residual

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 57 / 72


Discretization The Finite Volume Method

Steady state calculations


For certain computations, the time-dependance is of no importance.
Sought: steady state solution. when the solution has stabilized, the
change in time will go to zero,
∆t X
n+1
um n
= um − |∂Kmj |F ∗ (uL , uR , nj ) = um
n
, ∀m.
|Km |
j
| {z }
residual

Measure whether steady state has been achieved: residual gets small.
To reach steady state, many different acceleration techniques can be used,
for example local time stepping and multigrid.

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 57 / 72


Discretization The Finite Volume Method

Steady state calculations


For certain computations, the time-dependance is of no importance.
Sought: steady state solution. when the solution has stabilized, the
change in time will go to zero,
∆t X
n+1
um n
= um − |∂Kmj |F ∗ (uL , uR , nj ) = um
n
, ∀m.
|Km |
j
| {z }
residual

Measure whether steady state has been achieved: residual gets small.
To reach steady state, many different acceleration techniques can be used,
for example local time stepping and multigrid.
Two examples of steady state:
I computation of the drag and lift around an airfoil,
I mixing problem considered in the computer lab.
Martin Kronbichler (TDB) FVM for CFD February 11, 2010 57 / 72
Discretization The Finite Volume Method

FVM for the incompressible Navier–Stokes equations

I The incompressible Navier–Stokes equations are a system in five


equations (u, p, T ), so go through them one by one according to the
above procedure
I Need to take special care of p, since it does not involve a time
derivative
I Computational domain Ω and material parameters ρ, ν specified from
application
I Initial and boundary conditions complete the formulation

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 58 / 72


Discretization The Finite Volume Method

Initial condition

The state of all variables at time t0 has to be defined in order to initiate


the solution process.
For example
u|t=0 = u0 .

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 59 / 72


Discretization The Finite Volume Method

Boundary conditions, inflow


The inflow is the part of the domain ∂Ω where u · n < 0.

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 60 / 72


Discretization The Finite Volume Method

Boundary conditions, inflow


The inflow is the part of the domain ∂Ω where u · n < 0.
Setting an inflow Dirichlet boundary condition, that is u = uin on ∂Kin :
I strongly imposed, set the inflow boundary node values to the
respective value

Um = Uin for all faces ∂Km on ∂Kin .

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 60 / 72


Discretization The Finite Volume Method

Boundary conditions, inflow


The inflow is the part of the domain ∂Ω where u · n < 0.
Setting an inflow Dirichlet boundary condition, that is u = uin on ∂Kin :
I strongly imposed, set the inflow boundary node values to the
respective value

Um = Uin for all faces ∂Km on ∂Kin .

I weakly imposed, use the numerical flux,

F ∗ (Um , Uin , n).

The inflow data can be viewed as given in a ghost point; boundary


treated as the interior.

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 60 / 72


Discretization The Finite Volume Method

Boundary conditions, outflow

The outflow is the part of the domain ∂Ω where u · n > 0.


Treating outflow boundaries is more complicated than inflow parts.
Usually one does a weak formulation such that
1. F ∗ (UL , UL , n) is used as flux function,
2. F ∗ (UL , U∞ , n) is used as flux function with U∞ a far-field
velocity/pressure/temperature.
There are also strong formulations.

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 61 / 72


Discretization The Finite Volume Method

Boundary conditions, outflow

The outflow is the part of the domain ∂Ω where u · n > 0.


Treating outflow boundaries is more complicated than inflow parts.
Usually one does a weak formulation such that
1. F ∗ (UL , UL , n) is used as flux function,
2. F ∗ (UL , U∞ , n) is used as flux function with U∞ a far-field
velocity/pressure/temperature.
There are also strong formulations.
Beware of artificial back flows!
A common trick is to make the domain big enough to avoid distorting the
solution in the domain of interest.

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 61 / 72


Discretization The Finite Volume Method

Boundary conditions, solid walls

The solid wall is the part of the domain ∂Ω where u · n = 0.


For viscous (Navier–Stokes) flow we apply a no-slip condition

u = 0.

These boundary conditions are usually imposed strongly.

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 62 / 72


Discretization The Finite Volume Method

Heat transfer

When considering heat transfer for the incompressible Navier–Stokes


equations, we also need to assign a BC for the temperature T . Two
mechanisms can be applied:
I specify temperature with a Dirichlet BC, T = Tw , or
I specify heat flux with a Neumann BC, ∂T /∂n = −fq /κ.

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 63 / 72


Discretization The Finite Volume Method

Turbulence

Turbulence

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 64 / 72


Turbulence and its modeling

Introduction, dimensionless form


In CFD, a scaled dimensionless form of the Navier–Stokes equation is often
used.
We introduce new variables
xi ui p ∂ 1 ∂ ∂ U ∂
xi∗ = , ui∗ = , p∗ = , = , = ,
L U U 2ρ ∂xi L ∂xi∗ ∂t L ∂t ∗

in which the incompressible Navier–Stokes equations read

∇∗ · u∗ = 0,
∂u∗ ν
+ (u∗ · ∇∗ )u∗ = −∇∗ p ∗ + ∇2 u∗ .
∂t ∗ UL
|{z}
Re−1

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 65 / 72


Turbulence and its modeling

Reynolds number and turbulence

The Reynolds number is defined as

UL Inertial forces
Re = = ,
ν Viscous forces
where U, L, ν are the characteristic velocity, characteristic length, and the
kinematic viscosity, respectively.
Fluids with the same Reynolds number behave the same way.

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 66 / 72


Turbulence and its modeling

Reynolds number and turbulence

The Reynolds number is defined as

UL Inertial forces
Re = = ,
ν Viscous forces
where U, L, ν are the characteristic velocity, characteristic length, and the
kinematic viscosity, respectively.
Fluids with the same Reynolds number behave the same way.
When the Reynolds number becomes larger than a critical value, the
formerly laminar flow changes into turbulent flow, for example at
Re ≈ 2300 for pipe flows.

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 66 / 72


Turbulence and its modeling

Characterization of turbulence

Turbulent flows are


I time dependent
I three dimensional
I irregular
I vortical (ω = ∇ × u)

Image from http://en.wikipedia.org

Describing the turbulence can be done in many ways, and the choice of the
method depends on the application at hand and on computational
resources.
Martin Kronbichler (TDB) FVM for CFD February 11, 2010 67 / 72
Turbulence and its modeling

Direct Numerical Simulation (DNS)

I All scales in space and time are resolved.


I No modeling of the turbulence.
I Limited to small Reynolds numbers, because extremely fine grids and
time steps are required, O(Re3 ) spatial and temporal degrees of
freedom.

Applications of DNS:
I Turbulence research.
I Reference results to verify other turbulence models.

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 68 / 72


Turbulence and its modeling

Large Eddie Simulation (LES)

Only the large scales are resolved, and small scales are modeled.
Active research.
LES quite popular in certain industries, but still very costly.

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 69 / 72


Turbulence and its modeling

Reynolds-Averaged Navier–Stokes (RANS) I

Concept introduced by Reynolds in 1895. The most commonly used


approach in industry. Only time averages are considered, nonlinear effects
of the fluctuations are modeled.
Use the decomposition

u(x, t) = ū(x, t) + u0 (x, t) ,


| {z } | {z }
time average fluctuation

where the time average is


t+δ
1
Z
ū(x, t) = u(x, τ ) d τ,
δ t

(spatial averaging or ensemble averaging can otherwise be used).

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 70 / 72


Turbulence and its modeling

Reynolds-Averaged Navier–Stokes (RANS) II

Continuity equation for averaged quantities:

∇ · u = 0.

Momentum equations:
∂u 1
+ (u · ∇)u + (u0 · ∇)u0 = − ∇p + ν∇2 u + f,
∂t ρ

or, equivalently,
 
∂u 1 0 0
+ (u · ∇)u = ∇ · − pI + ν∇u − u ⊗ u + f,
∂t ρ

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 71 / 72


Turbulence and its modeling

Reynolds-Averaged Navier–Stokes (RANS) III

 
∂u 1
+ (u · ∇)u = ∇ · − pI + ν∇u − u0 ⊗ u0 + f,
∂t ρ
∇ · u = 0.

The Reynolds stress term −u0 ⊗ u0 contains fluctuations, and its effect
needs to be modeled.
Examples are Spalart-Allmaras, K − ε, K − ω, and SST.

Martin Kronbichler (TDB) FVM for CFD February 11, 2010 72 / 72

You might also like