Sunteți pe pagina 1din 132

NED UNIVERSITY OF

ENGINEERING & TECHNOLOGY


DEPARTMENT OF CHEMICAL ENGINEERING
Computational Fluid Dynamics (CH-515)
by
Prof. Dr. Shazia F. Ali
Lecture no. 2 & 3 (Governing Equations) 3 hrs
2
Introduction
CV, or integral, forms of equations are useful for
determining overall effects.
However, detailed knowledge about the flow field
inside the CV cannot be obtain. (motivation for
differential analysis)
Application of differential equations of fluid
motion to any and every point in the flow field or
flow domain
3
Description of fluid motion
FLUID KINEMATICS - the study of how fluids flow
andhowto describe fluid motion.
There are two distinct ways to describe motion.
Lagrangian description of fluid motion: Individual
objects or individual fluid particles are tracked (function of
time) as they move through the flowfield.
Eulerian description of fluid flow: A finite volume called a
flow domain or control volume (CV) is defined, through
which fluid flows in and out and a track of the position and
velocity of a mass of fluid particles is not made. Instead,
field variables, are defined as functions of space and time,
within the control volume.
4
Description of fluid motion
5
Lagrangian Description
Named after Italian mathematician J oseph Louis
Lagrange (1736-1813).
Lagrangian description of fluid flow tracks the
positionand velocity of individual particles.
Basedupon Newton's laws of motion.
Difficult to use for practical flowanalysis.
Fluids are composedof billions of molecules.
Interactionbetween molecules hard to describe/model.
However, useful for specializedapplications
Sprays, particles, bubble dynamics, rarefiedgases.
CoupledEulerian-Lagrangian methods.
6
Eulerian Description
Named after Swiss mathematician Leonhard Euler (1707-
1783).
Euleriandescription of fluid flow: a flow domain or control
volume is defined by which fluid flows in and out.
Field variables are define which are functions of space
and time.
Velocity,
Acceleration,
These (and other) field variables define the flow field.
Well suited for formulation of initial boundary-value
problems (PDE's).
( ) ( ) ( )
, , , , , , , , , V u x y z t i v x y z t j w x y z t k = + +

( ) ( ) ( )
, , , , , , , , ,
x y z
a a xyzt i a xyzt j a xyzt k = + +

( )
, , , a a x y z t =

( )
, , , V V x y z t =

7
Governing Equations for CFD
Governing equations based on
Mass Conservation
Momentum Conversation
Energy Conversation
Additional equations such as equation of state, thermodynamics
relation, turbulence Equations (if flow is turbulent), multiple
species, chemical reaction equations etc.
On local basis
in a finite volume
shrink volume to zero
partial differential (governing) equations
8
What information we need?
Spatial Variation (x,y,z) & Time (t) of variables e.g.
Velocity (V)
Pressure (P)
Density
Temperature (T)
Concentration of Chemical Species (C)
Turbulence
Etc.
We need to above, from conservation equations, that can be derived
either for a fluid particle that is moving with the flow(Lagrangian) or for a
fluid element that is stationary in space (Eulerian).
For CFD purposes - Eulerian form, but (books) they are somewhat
easier to derive in Lagrangian form.
Luckily, when we derive equations for a property | in one form, we can
convert themto the other formusing the relationship.
9
Conservation of Mass (Differential CV & Taylor series)
First, define an
infinitesimal control
volume dx x dy x dz
Next, we approximate the
mass flow rate into or out
of each of the 6 faces
using Taylor series
expansions around the
center point, e.g., at the
right face
Ignore terms higher than order
dx
Conservation of Mass (Differential CV & Taylor series)
Infinitesimal CV
of dimensions
dx, dy, dz Area of right
face =dy dz
Mass flow rate through
the right face of the
control volume
Conservation of Mass (Differential CV & Taylor series)
Now, sum up the mass flow rates into and out of
the 6 faces of the CV
Plug into integral conservation of mass equation.
After substitution,
Net mass flow rate into CV:
Net mass flow rate out of CV:
Conservation of Mass (Differential CV & Taylor series)
Dividing through by volume dxdydz
Or, if we apply the definition of the divergence of a vector
Use product rule on divergence term
or
Where, D/Dt is
material or total
derivative
Total or Material derivative
The total derivative operator (d/dt) is also given special notation,
D/Dt.
Remember D/Dt (or d/dt) and c/ct are physically and numerically
different quantities, The former is the time rate of change
following a moving fluid particle while later is the time rate of
change at fixedlocation.
Provides ``transformation'' between Lagrangian and Eulerian
frames.
Other names for the material derivative include: total, particle,
Lagrangian, Eulerian, and substantial derivative.
It can be applied to any fluid properties, both scalars and vectors
(e.g. V, , p etc.). For example, the material derivative of
velocity & pressure can be written as:
Conservation of Mass (Cylindrical coordinates)
In general, continuity equation cannot be used by
itself to solve for flowfield, however it can be used to:
1. Determine if velocity field is incompressible.
2. Find missing velocity component.
Conservation of Mass (Special Cases)
Cartesian
Cylindrical
Incompressible flow: =constant
Steady compressible flow:
0

Also D /Dt =0
Where n is unit normal vector. By applying Gauss
divergence theorem , volume integral of divergence of
vector can be equated to area integral over the surface that
defines the volume,
Continuity Equations - integral
} }
=
S V
ndS V dV
dt
d
.
} }
=
S V
ndS V dV V div
dt
d
.
0 ) (
}
=
(

V +
c
c
V
dV V
t

Any size of volume, V


0 ) ( = V +
c
c
V
t

Mass conservation
equation
In Cartesian coordinate system, it
expressed as:
( ) ( ) ( )
0 =
c
c
+
c
c
+
c
c
+
c
c
z
w
y
v
x
u
t

17
Momentum Equation
Consider a fluid particle and Newton's second law,
Acceleration Field - The acceleration of the particle is the
time derivative of the particle's velocity.
However, particle velocity at a point is the same as the fluid
velocity,
To take the time derivative of, chain rule must be used.
particle particle particle
F m a =


particle
particle
dV
a
dt
=

( ) ( ) ( ) ( )
, ,
particle particle particle particle
V V x t y t z t =

particle particle particle
particle
dx dy dz
V dt V V V
a
t dt x dt y dt z dt
c c c c
= + + +
c c c c

18
Acceleration Field
Since
In vector form, the acceleration can be written as
The total or material derivative operator d/dt ( or D/Dt)
emphasize that it is formed by following a fluid particle as it
moves through the flow field.
First termis called the local acceleration and is nonzero
onlyfor unsteadyflows.
Second term is called the advecti ve acceleration and
accounts for the effect of the fluid particle moving to a new
locationin the flow, where the velocity is different.
( )
( )
, , ,
dV V
a x y z t V V
dt t
c
= = + V
c

particle
V V V V
a u v w
t x y z
c c c c
= + + +
c c c c

, ,
particle particle particle
dx dy dz
u v w
dt dt dt
= = =
.
Again a word about . Material Derivative
The total derivative operator (d/dt) is call the material
derivative and is oftengiven special notation, D/Dt.
Remember D/Dt and c/ct are physically and numerically
different quantities, The former is the time rate of change
following a moving fluid particle while later is the time rate of
change at fixedlocation.
Advective acceleration is nonlinear: source of many
phenomenon and primary challenge in solving fluid flow
problems.
Provides ``transformation'' between Lagrangian and Eulerian
frames.
Other names for the material derivative include: total, particle,
Lagrangian, Eulerian, and substantial derivative.
( )
D V d V V
V V
D t d t t
c
= = + V
c

.
20
Momentum Equation
The Newton's second law application to differential fluid
element in a CV is given by:
Total forces on differential fluid element:
While body forces are analyzed by simple relation such as:
Surface forces are not as simple to analyze as above since
they consist of both normal and tangential components.
(1)
Forces acting on CV consist of body forces that act
throughout the entire body of the CV (such as gravity,
electric, and magnetic forces) and surface forces that
act on the control surface (such as pressure and viscous
forces, andreaction forces at points of contact).
Body forces act on each
volumetric portion dV of
the CV.
Surface forces act on each
portiondA of the CS.
Momentum Equations
22
Body Forces (gravity, electric and magnetic forces)
The most common body force
is gravity, which exerts a
downward force on every
differential element of the CV.
Total body force acting on CV:
The differential body force:
Typical convention is that
gravity acts in the negative
(e.g. z-direction):
Surface Force
Surface forces are not simple to analyze
as they include both normal &tangential
components, i.e. the description of the
force in terms of its coordinate changes
with orientation.
Second-order tensor called the stress
tensor o
ij
is used in order to adequately
describe the surface stresses at a point
in the flow.
Diagonal components
xx
,
yy

zz
are
called normal stresses and are due to
pressure andviscous stresses.
Off-diagonal components
xy
,
xz
etc.,
are called shear stresses & are due
solelyto viscous stresses.
Total surface force actingon CS:
Surface integrals are
cumbersome to solve
24
Momentum Equation
For brevity, here we consider on only x-component of Total
forces acting on differential element to simplify the diagram.
Thus, the body force and the net surface force due to
stresses in the xdirection can be given as:
Combining equations above, equating to Total forces in x-
direction(eq. 1) &dividing by dxdydz becomes:
(2)
Momentum Equation
Thus the differential forms for y and z- direction momentum
equations :
Or equations 1, 2, 3 & 4 are combine to give equations
below:
Cauchys
Equation
(3)
(4)
26
Momentum Equation
In Cartesian coordinates, the Cauchy Equation are:
Cannot use this equation in fluid mechanics because
stress tensor (o
ij
) needs to be expressed in terms of
primaryunknowns namely density, pressure and velocity.
Need some relations to resolve stress tensor in terms of
velocity and pressure field!
(5a, b & c)
27
Momentum Equations (integral)
Body Force Surface Force

ij
= stress tensor
Substituting volume integrals gives,
Recognizing that this holds for any CV, the integral may be
dropped
Cauchys
Equation
28
The Navier-Stokes Equation
As seen, Cauchy's equation is not useful in its present form, there are ten
(10) unknowns:
6 independent component of stress tensor (
ij
)
1 Density ()
3 independent Velocity components (V)
4 equations (continuity +momentum)
Thus in order to resolve flowfield, 6 more equations are required to close
problem!
Thus,
ij
is separated into pressure and viscous stresses terms:

ij
=

xx

xy

xz

yx

yy

yz

zx

zy

zz
|
\



|
.
|
|
|
=
p 0 0
0 p 0
0 0 p
|
\



|
.
|
|
|
+

xx

xy

xz

yx

yy

yz

zx

zy

zz
|
\



|
.
|
|
|
Viscous Stress Tensor
When fluid is at rest p acts & this p always
acts inward & normal to surface
When fluid is in motion p still acts inward &
but viscous stress may also exist
The Navier-Stokes Equation
Situation not yet improved, 6 unknowns in
ij
6
unknowns in
ij
& 1 in P, which means one more is added!
Reduction in the number of variables is achieved by relating
shear stress to strain-rate tensor (as it can be related to
velocity and material property).
For Newtonian fluid with constant properties (e.g. & T =
const.).
Substituting Newtonian closure into stress tensor gives:
Using the definition of
ij
:
Shear strain rate can be expressed in Cartesian coordinates
as:
, ,
xx yy zz
u v w
x y z

c c c
= = =
c c c
1 1 1
, ,
2 2 2
xy zx yz
u v w u v w
y x x z z y

| | | | c c c c c c
| |
= + = + = +
| | |
c c c c c c
\ .
\ . \ .
The Navier-Stokes Equation
Combine linear strain rate and shear strain rate into one
symmetric second-order tensor called the strain-rate tensor.
Upon Substitution:
Substituting
ij
into Cauchys equation below gives us the N-S
eqns:
(6)
The Navier-Stokes Equation
Substitute equation (6) into three Cartesian coordinate of
Cauchy's equation (5), taking x-direction
Similar expression can be arrived for y and z directions.
Also note that as long as velocity components are smooth
function, the order of differentiation is irrelevant, thus
This is from x-component
This is from z-component
For Incompressible, the
term in parentheses =0
The Navier-Stokes Equation
Thus equation becomes .. the Navier Stokes eqns:
This results in a closed system of equations!
4 equations (continuity and momentum equations)
4 unknowns (U, V, W, p)
Note: Above is unsteady, nonlinear, second order partial differential eqn.
Incompressible NSE
written in vector form
Advection
Pressure gradient Body force Diffusion
The Navier-Stokes Equation
Continuity
X-momentum
Y-momentum
Z-momentum
34
The Navier-Stokes Equation
In the field of CFD, the conservation of mass, momentum,
(and/or energy) equations are collectively referred to as
the Navier-Stokes Equations.
The Navier-Stokes equations are a coupled set of non-
linear partial differential equations for five unknowns: r, u,
v, w, E.
Additional thermodynamic relations (equation of state,
etc.) are needed to relate pressure and temperature to
other thermodynamic variables.
Transport properties (mand k) must also be specified.
May also be functions of pressure and temperature
Note:
The N-S equations (inviscid flow) have been simplified tremendously; however, still cannot be
solvedduetothenonlinear terms(i.e., uu/x, vu/y, wu/z, etc.).
Numerical methods such as the finite element and finite difference methods are often used to
approximatethefluidflowproblems.
The Navier-Stokes Equation
For frictionless or inviscid flows ( 0, t 0 &
xx
=
yy
=

zz
= - p), the momentum equation reduces to Eulers
equation:
35
36
Energy Equation
First law of thermodynamics: rate of change of energy of a
fluid particle is equal to the rate of heat addition plus the rate
of work done.
Rate of increase of energy is DE/Dt.
Energy E =i +(u
2
+v
2
+w
2
)
i =internal thermal energy.
(u
2
+v
2
+w
2
) is the kinetic energy.
Potential energy (gravitation) is usually treated separately
andincluded as a source term(g).
The total derivative equal to the change in energy as a
result of work done by viscous stresses and the net heat
conduction.
Subtract the kinetic energy equation to arrive at a
conservationequation for the internal energy.
37
Energy Equation
Work done by surfaces
forces on the CS of CV.
Heat added to fluid CV
Summing all terms of heat added and dividing by dxdydz gives
the net rate of heat transfer to the fluid particle per unit volume:
Fouriers law of heat conduction relates the heat flux to the local
temperature gradient:
The total rate of work done by surface stresses can be
calculated, however for brevity we only consider x-components
of stresses.
Rate of work done (x-direction), normal =
Rate of work done (x+ x), normal =
38
Energy Equation
q div
z
q
y
q
x
q
z
y
x
=
c
c
=
c
c
=
c
c

z
T
k q
y
T
k q
x
T
k q
z y x
c
c
=
c
c
=
c
c
=
z y u
xx
A A .
z y x
x
u
u
xx
xx
A A
(

A
c
c
+

.
.
Total of work done (x-direction), tangential =
Note that equation for stresses is similar to momentum term,
taking similar form:
Where vicious terms can be given as dissipation function u, any
body forces by S & heat flux can be replaced by temperature
gradients, hence
39
Energy Equation
( ) ( )
( )
(

c
c
+
c
c
+
c
c
z
w
y
v
x
u
zx
yx xy


.
. .
This far E has not been defined, but this E could be
defined as Internal energy, kinetic energy etc. Note S
E
is
source term.
Example: For 2D incompressible flow, neglecting KE so h
can be reduced to C
p
T, also for most fluid engineering
problems local time derivative of p and dissipation function
is neglected, hence equation derived becomes:
Local acceleration
Advection
Diffusion
41
Energy Equation
Equation of State
) , ( T P =
( )
( ) T C C
T k k
T
p p
=
=
= ) (
Property Relations
This far E has not been defined, but this E could be
defined as Internal energy, kinetic energy and gravitational
energy (body forces & includes effect of potential energy)
Energy Equation
As done for E, similar expression can be derived for:
Kinetic energy, note
includes u, Source
term, u.S
M
Internal energy, note
includes u, Source
term, S
i
43
Summary of Equations
The system of equations is now closed, with seven equations
for seven variables: pressure, three velocity components (u,v,
w), enthalpy, temperature, and density.
Under
Source term
A Generic Form of Basic Equations
Note significant commonalities
between the various equations.
Turbulence equations
(Not derived ) see it
takes same form.
A Generic Form of Basic Equations
If Energy: specific heat generation

0 =
c
c
+
c
c
+
c
c
z y x
u w v
1 =
If mass:
If V momentum:
V =
+
c
c
=
u
x
p
S

1
= I
T =
k = I
q S
T
=
Using a general variable u, the conservative form of all fluid
flow equations can usefully be written in the following form:
46
The Problem with the Navier-Stokes Equations
Napier-Stokes equations are non-linear PDEs --- no general
solutions.
Onlya fewsimple problempermit an exact analytical solution.
What can we do?
Simplify the equations
obtain exact solutions to simpler equations
Use numerical techniques (CFD)
obtain approximate solutions to the full Navier-Stokes
equations
may also need numerical techniques for simplified equations
(e.g. Euler equations)
Whichever route we take, we will need to impose reasonable
engineeringassumptions as part of the solution process.
Approximate solutions should always be examined closely to
make sure that they ``faithfully model the real flowfield!
Exact Solutions of the NSE
Solutions can also be
classified by type or
geometry
1. Couette shear flows
2. Steady duct/pipe flows
3. Flows with moving
boundaries
4. Similarity solutions
5. Asymptotic suction flows
6. Wind-driven Ekmanflows
There are about 80
known exact solutions
to the NSE
The can be classified
as:
Linear solutions where
the convective
term is zero
Nonlinear solutions
where convective term
is not zero
Exact Solutions of the NSE
1. Set up the problem and geometry, identifying all
relevant dimensions and parameters
2. List all appropriate assumptions,
approximations, simplifications, and boundary
conditions
3. Simplify the differential equations as much as
possible
4. Integrate the equations
5. Apply BC to solve for constants of integration
6. Verify results
Procedure for solving continuity and NSE
49
Boundary Conditions
In order to solve the Navier-Stokes equations, we must supply
appropriate boundary conditions/initial conditions for the
fluiddomain.
Boundary conditions at walls (solid surfaces)
fluid sticks to the walls (no-slip condition)
thermal boundary conditions at walls
constant temperature
constant heat flux
others (convection, radiation, etc.)
Inflow/Outflow boundary conditions
Where fluid enters the domain, appropriate inflow
conditions must be specified
velocity components total pressure and flow direction
scalar variables e.g. temperature
50
Boundary Conditions
Where fluid exits the domain, assumptions must be
made about flow conditions at the outlet
static pressure is known
flow is fully-developed
Other boundary conditions
Symmetry
Periodic
Far-field
Example exact solution
Fully Developed Couette Flow
For the given geometry and BCs, calculate the velocity
and pressure fields, and estimate the shear force per
unit area acting on the bottom plate
Step 1: Geometry, dimensions, and properties
51
Example exact solution
Fully Developed Couette Flow
Step 2: Assumptions and BCs
Assumptions
1. Plates are infinite in x and z
2. Flow is steady, c/ct =0
3. Parallel flow, V
y
=0
4. Incompressible, Newtonian, laminar, constant properties
5. No pressure gradient
6. 2D, W=0, c/cz =0
7. Gravity acts in the -z direction,
Boundary conditions
1. Bottom plate (y=0) : u=0, v=0, w=0
2. Top plate (y=h) : u=V, v=0, w=0
52
Example exact solution
Fully Developed Couette Flow
Step 3: Simplify
3 6
Note: these numbers refer
to the assumptions on the
previous slide
This means the flow is fully developed
or not changing in the direction of flow
Continuity
X-momentum
2 Cont. 3 6 5 7
Cont. 6
53
Example exact solution
Fully Developed Couette Flow
Step 3: Simplify, cont.
Y-momentum
2,3
3 3 3,6 7
3
3
3
Z-momentum
2,6 6
6 6
7
6 6 6
54
Example exact solution
Fully Developed Couette Flow
Step 4: Integrate
Z-momentum
X-momentum
integrate integrate
integrate
55
Example exact solution
Fully Developed Couette Flow
Step 5: Apply BCs
y=0, u=0=C
1
(0) + C
2
C
2
= 0
y=h, u=V=C
1
h C
1
= V/h
This gives
For pressure, no explicit BC, therefore C
3
can remain
an arbitrary constant (recall only VP appears in NSE).
Let p =p
0
at z =0 (C
3
renamed p
0
)
1. Hydrostatic pressure
2. Pressure acts independently of flow
56
Example exact solution
Fully Developed Couette Flow
Step 6: Verify solution by back-substituting into
differential equations
Given the solution (u,v,w)=(Vy/h, 0, 0)
Continuity is satisfied
0 +0 +0 =0
X-momentum is satisfied
57
Boundary conditions
Finally, calculate shear force on bottom plate
Shear force per unit area acting on the wall
Note that t
w
is equal and opposite to the
shear stress acting on the fluid t
yx
(Newtons third law).
58
59
Steady 2D incompressible, laminar flow between two
stationary parallel infinite plates with height = H
Example
Assumptions: Assumptions:
AIR AIR (Working fluid), Laminar (Working fluid), Laminar
L = 1.0 m L = 1.0 m H = 0.1 m H = 0.1 m
U = 0.01 m/s U = 0.01 m/s = 1.2 kg/m = 1.2 kg/m
33
air air
= 2 x 10 = 2 x 10--5 kg/m 5 kg/m--ss
60
Steady 2D incompressible, laminar flow between
two stationary parallel plates with H= 0.1 m and
L=0.5m
(a) Velocity vector plot (a) Velocity vector plot
CFD simulation CFD simulation
results results -- the flow the flow
field along channel field along channel
length changes from length changes from
uniform at inlet uniform at inlet
surface to parabolic surface to parabolic
profile as it travels profile as it travels
downstream. downstream.
61
Results CFD
(b) U velocity contour plot (b) U velocity contour plot
(c) V velocity contour plot (c) V velocity contour plot
In hydrodynamic entrance In hydrodynamic entrance
region (x<3H), the u (x) region (x<3H), the u (x)
decreases along channel decreases along channel
length or close length or close
to the wall (no slip near to the wall (no slip near
wall, hence wall, hence
0 <
c
c
x
u
0 >
c
c
y
v
In fully developed In fully developed
hydrodynamic region hydrodynamic region
(x (x3H), the u (x) does not 3H), the u (x) does not
change long channel change long channel
length so length so 0 =
c
c
x
u
0 =
c
c
y
v
61
Results CFD
(d) Static Temperature contour plot (d) Static Temperature contour plot
62
63
Physical Interpretation Continuity Eqn.
Continuity equation applied to infinitesimal small control volume for
2Dcase of the fluidflowbetween two parallel stationary plates.
Consider , then u(x+x) >u(x), since more fluid is
physically leaving the CV then entering along the x direction, there
should be more fluid entering than leaving y direction. Here
andthe v (y+y) <v(y)
0 >
c
c
x
u
0 <
c
c
y
v
Next. , then u(x+ x) < u(x), since more fluid is
physically entering the CV then entering along the x direction,
there should be more fluid leaving than entering y direction. Here
and the v (y+ y) > v(y). (CONTINUTIY EQ.
SATISFIED)
0 <
c
c
x
u
0 >
c
c
y
v
64
Turbulence and its modelling
All flows become unstable above a certain Reynolds
number.
At lowReynolds numbers flows are laminar.
For high Reynolds numbers flows are turbulent.
The transition occurs anywhere between 2000 and 1E6,
dependingon the flow.
For laminar flow problems, flows can be solved using the
conservation equations developed previously.
For turbulent flows, the computational effort involved in
solving those for all time and length scales is prohibitive.
An engineering approach to calculate time-averaged flow
fields for turbulent flows will be developed.
65
Turbulence and its modelling
66
Examples of simple turbulent flows
67
Turbulence and its modelling
68
Turbulence and its modelling
69
Turbulence and its modelling
70
Turbulence and its modelling
71
Turbulence and its modelling
72
Turbulence and its modelling
73
Turbulence and its modelling
As air flows over andaroundobjects inits
path, spiraling eddies, known as Von
Karmanvortices, may form.
The vortices in this image were created
when prevailing winds sweeping east
across the northern Pacific Ocean
encounteredAlaska'sAleutianIslands
Weddell sea in southern Atlantic
areanear Antarctica,.
74
Flow transitions around a cylinder
74
75
Turbulence
. occurs at high Re
. are chaotic
75
76
Turbulence
. are disspative
. are diffusive
76
77
Turbulence ..
. rotation and
vorticity
78
What is turbulence?
79
What is turbulence?
80
Energy Cascade
The continual transfer of energy from larger eddy to smaller and
smaller eddy is termed as Energy cascade .
Larger eddies highl y anisotropic (varying in all directions),
inertial effect dominates viscous effect.
Smaller eddies isotropic, viscous effect dominates and smears
out the directionality of flow.
Sources
Pope, Stephen B. Turbulent Flows.
Cambridge University Press
2000.
Tennekes H., Lumley J .L. A First Course
in Turbulence. The
MIT Press 1972.
81
Turbulence
82
Turbulence modelling objective
83
Example: flow around a cylinder at Re=1E4
The figures show:
An experimental
snapshot.
Streamlines for time
averaged flowfield.
Note the difference
between the time
averaged and the
instantaneous flowfield.
Effective viscosity
used to predict time
averaged flowfield.
84
Turbulence and its modelling
Fortunately!
The Engineers are often interested in time average
properties of the flow(mean v, mean p, mean stress etc.)
Thus by adopting suitable time averaging operator details
concerning to the instantaneous fluctuations can be
discarded.
To illustrate the above influences of turbulent fluctuations
on the mean flow, instantaneous continuity and Navier
Stokes equations for an incompressible flowwith constant
viscosity is produced (time averaging governing
equations), this more popularly known as Reynolds
Average Navier-Stokes (RANS) equations.
85
Turbulence and its modelling
[I]
[II]
[IV]
[V]
86
Turbulence and its modelling
To investigate the effects of fluctuations, we replace the
flowvariables:
87
Turbulence and its modelling
Considering the x-direction, the time average x-direction
momentumequations terms becomes:
Considering the y & z direction , the time average momentum
equationsbecomes:
88
Turbulence and its modelling
Note that I, II, IV &V are same as those of laminar flowbut
time averaging has introduced term[III],.
This term involves products of fluctuating velocities and
constitute convective momentum transfer due to velocity
fluctuations.
They are placed on LHS to reflect their role as additional
turbulent stresses on the meanvelocity components.
89
Turbulence and its modelling
These terms are extra stresses terms ( 9 in all, 3 normal
stresses and 6 tangential stresses) and are called
REYNOLD STRESSES
90
REYNOLD STRESSES
91
Turbulence and its modelling
92
Turbulence and its modelling
93
Turbulence closure modelling
Turbulence models
94
Turbulence models
Note Turbulence models are developed that close the
systemof meanflowequations (Table presentedearlier).
In most engineering application the only the effects of
turbulence of mean flow is sought hence and details of
turbulent fluctuations are not resolved.
These models uses
the Reynolds
Average
Equations and
forms the basis of
turbulence
calculations in
many CFD codes
Requires Time dependent flow equations solved
for mean flow and largest eddies and effects of
smaller eddies are modelled
95
Turbulence models
96
Turbulence models
97
Boussinesq hypothesis
98
Turbulent viscosity
99
Turbulent Diffusivity
100
Predicting the turbulent viscosity
101
Mixing length model
102
Mixing length model
103
Spalart-Allmaras one-equation model
104
The k- model
105
Mean flow kinetic energy K
106
Turbulent kinetic energy k
Model equation for k
108
Turbulent dissipation
109
Dissipation rate - analytical equation
110
Model equation for
111
Calculating the Reynolds stresses from k &
112
k- model discussion
113
More two-equation models
114
115
Improvement: RNG k-
116
RNG k- equations
117
Improvement: realizable k-
118
Realizable k- equations
119
Realizable k- C

equations
120
Realizable k- positivity of normal stresses
121
k- model
122
Algebraic stress model
123
Non-linear models
124
Reynolds Stress Model
125
Reynolds stress transport equation
126
Reynolds stress transport equation
127
RSM equations
128
RSM equations continued
129
Setting boundary conditions
130
Comparison of RANS turbulence models
131
Recommendation
132

S-ar putea să vă placă și