Sie sind auf Seite 1von 16

Chapter 2

Conservation Laws of Fluid Motion


Julaporn Benjapiyaporn
Mechanical Engineering, KKU.

2.1 Governing equations of fluid flow and heat transfer


Three fundamental physical principles
Mass is conserved.
Newtons second law.
Energy is conserved.
All of CFD is based on the fundamental governing equations of fluid dynamics
the continuity, momentum and energy equations.
If you do not physically understand the meaning and significance of each term
in these equationsthen how can you even hope to properly interpret the CFD
results obtained by numerically solving these equations?

analysis of fluid flows at macroscopic length scale (1m and larger)

macroscopic properties; velocity ( u = u i + v j + w k ), pressure (p),



density (), temperature (T ), their space and time derivatives ( , , , )
x y z t

( x, y , z , t )

p ( x, y , z , t ) p
all fluid properties are functions of space and time: T ( x, y, z , t ) T
u ( x, y , z , t ) u

The element under consideration is so small that fluid properties at the faces
can be expressed accurately enough by means of the first two terms of Taylor
series expansion:

( x 12 x) = ( x)

1
2 ( 1 x) 2 3 ( 12 x)3
3
+ ...
( 2 x) + 2 2
x
x
x
2!
3!
truncation error

Where is a property of such an element.

Models of the Flow


1. Choose the appropriate fundamental physical principles from the law of
physics,
2. Apply these to a suitable model of the flow.
3. Extract the mathematical equations which embody such physical principles.

Finite Control Volume

CV1. Finite CV fixed in space with the


fluid moving through it (conservation
form): fixed volume and vary mass.

CV2. Finite CV moving with the


fluid (non-conservation form):
fixed mass and vary volume.

Infinitesimal Fluid Element

Inf1. Inf. FE fixed in space with the


fluid moving through it (conservation
form): fixed volume and vary mass.

Inf2. Inf. FE moving with the


fluid (non-conservation form):
fixed mass and vary volume.

2.1.1 The Substantial Derivative


Derive by considering an infinitesimally fluid element moving with the flow.
D

=
+u
+y
+w
Dt
z
t
x
y

= + (u ) Substantial Derivative: the time rate of change following


Dt t
a moving fluid element

local derivative: the time rate of change at a fixed point


t

(u ) convective derivative: the time rate of change due to the movement


of the fluid element
Substantial derivative is the same as the total from calculus.

= ( x, y , z , t )

d
=
+u
+y
+w
t
x
y
dt
z

For an arbitrary conserved property:


( )


+ ( u ) =
+
+ ( u + ( u ))
t
t
t

= + u + + ( u ) =
Dt
t

Thus, the rate change of x-, y- and z-momentum and energy per unit volume can be
defined by substitution by u, v, w and E, respectively.

Du
( u )
+ (u u ) =
Dt
t
Dw
( w)
+ (w u ) =
Dt
t

Dv
( v )
+ (v u ) =
Dt
t
and

DE
( E )
+ ( E u ) =
Dt
t

2.1.2 The Divergence of the Velocity


Derive by considering a finite control volume moving with the flow.
The change in the volume in the CV: V = [(ut ) n]dS = (ut ) dS
The time rate of change of the CV:

Applying the divergence theorem:

DV
1
(ut ) dS = u dS
=
Dt
t
S
S

DV
= ( u )dV
Dt
V

Let the moving CV is shrunk to a very small V :

D(V )
= ( u )dV
Dt
V

Assuming that V is small enough such that u is the same value throughout V .
Then the integral, in the limit as V shrinks to zero, is ( u )V :
D(V )
= ( u )V
Dt
u =

1 D(V )
V Dt

u : The divergence of the velocity is physically the time rate of change of the
volume of a moving fluid element, per unit volume

Mathematical meaning: u =

u v w
+
+
x y z

2.1.3 Continuity Equation


Physical principle: Mass is conserved.

CV1: Model of the Finite CV Fixed in Space (fixed volume and vary mass)
Net mass flow out of CV through surface S = Time rate of decrease of mass inside CV

u dS = t dV
S

dV + u dS = 0 : The conservation form of an integral form of the


t
V
S
continuity equation: fixed CV.

CV2: Model of the Finite CV Moving with the Fluid (fixed mass and vary volume)
D
dV = 0 : The nonconservation form of an integral form of the continuity
Dt
V
equation: moving CV.

Inf1: Model of an Inf. Small Element Fixed in Space (fixed volume and vary mass)
Net mass flow out of CV through surface S = Time rate of decrease of mass inside CV

Fig. 2.1 Mass flows in and out of fluid element

Mass
balance:

*Rate of increase of mass in


fluid element

*Rate of increase of mass in fluid element:

*Net rate of flow of mass


into fluid element

( x y z ) =
x y z
t
t

*Net rate of flow of mass into fluid element:

( u ) 1
( u ) 1
( v) 1

y x z
u
2 x y z u +
2 x y z + v
x
x
y 2

( v) 1
( w) 1
( w) 1

v +
z x y
2 y x z + w
2 z x y w +
y
z
z 2

( u ) ( v) ( w)
=
+
+
x y z = i( u) x y z
t
t
t

( u ) ( v) ( w)

x + y + z dxdydz = t (dxdydz )

+ ( u ) = 0 : The conservation form of a partial differential equation of the


t
continuity equation: fixed inf. small element.
For an incompressible fluid (i.e. a liquid), = const. and u = 0.
Inf2: Model of an Inf. Small Element Moving with the Fluid (fixed mass and vary volume)

m = V
D( dV )
D
D( dV )
= dV
+
=0
Dt
Dt
Dt
D
1 D(V )
=0
+
Dt
V Dt
D
+ u = 0 : The nonconservation form of a partial differential equation of
Dt
the continuity equation: moving inf. small element.
All the Equations are One

dV + u dS = 0 CV1, conservation form, fixed CV


t
V
S

Since the CV is fixed, the limits of integration are constant:

dV + u dS = 0

t
V
S
Applying the divergence theorem:

t dV + ( u ) dV = 0
V

or

t
V

+ ( u ) dV = 0

+ ( u ) = 0 Inf1, conservation form, fixed inf. small element


t
5

( u )

+ u + u = 0
t

D
+ u = 0 Inf2, nonconservation form, moving inf. small element.
Dt
Integral versus Differential Form of the Equations

The integral form of the equations allows for the presence of


discontinuities inside the fixed CV

The differential form of the governing equations assumes the flow


properties are differentiable, hence continuous.

The integral form of the equations is considered more fundamental


than the differential form.

This consideration becomes of particular importance when calculating


a flow with real discontinuities, such as shock waves.

2.1.4 Momentum equation


Physical principle: Newtons second law ( F = m a )
Newtons
second law:

*Rate of increase of momentum of


fluid element

*Rate of increase of x-, y- and z-momentum per unit volume:

*Sum of forces on
fluid element
Du
Dv Dw
,
,
Dt
Dt
Dt

*Forces:

surface forces: act directly on the surface of the fluid element

- pressure forces, p (an inviscid fluid: the only surface force is due to the
pressure)

p p p
, ,
x y z

- viscous forces, ij: the stress component acts in the j-direction on a


surface normal to the i-direction
* normal stress: time rate of change of volume of the fluid element
xx yy zz
,
,
x y z

* shear stress: time rate of change of the shearing deformation of the fluid
element
yx zx xy zy

,
,
,
y z x z

xz yz
,

,
x y

In most viscous flow, normal stresses are much smaller than shear stresses and
many times are neglected.
Normal stresses become important when the normal velocity gradients are very
large such as inside a shock wave.

body forces: act directly on the volumetric mass of the fluid element or
act at a distance
- gravity force
- centrifugal force
- Cariolis force
- electromagnetic force

include as source terms, S M ( )

Fig. 2.2 Stress components on three faces of fluid element

Fig. 2.3 Stress components in the x-direction


Example of the net surface force in the x-direction per unit volume:
( p + xx ) yx zx
+
+
x
y
z
Momentum equations for a viscous flow (Navier-Stokes equations) in
nonconservation form.

Du ( p + xx ) yx zx
=
+
+
+ S Mx
Dt
x
y
z

(2.2a)

Dv xy ( p + yy ) zy
=
+
+
+ S My
Dt
x
y
z

(2.2b)

Dw xz yz ( p + zz )
=
+
+
+ S Mz
x
y
z
Dt

(2.2c)

Example of body force: S Mx = 0, S My = 0, S Mz = g

Navier-Stokes equations in conservation form: substitution these terms in the left side
of the equations

Du (u )
Dv (v )
Dw ( w)
=
+ (u u ) ,
=
+ (v u ) ,
=
+ ( w u )
Dt
t
Dt
t
Dt
t

Newtonian fluids: the viscous stresses are proportional to the rates of


deformation (velocity gradients) fluid in all aerodynamic problems.
Non-newtonian fluids blood flow
For newtonian fluid: ij is expressed as functions of the linear and volumetric
deformation rates.
linear deformation rate: exx =

u
,
x

1 u v
exy = eyx = + ,
2 y x

e yy =

v
,
y

ezz =

w
z

1 u w
exz = ezx = +
,
2 z x

volumetric deformation rate: u =

1 v w
eyz = ezy = +

2 z y

u v w
+
+
x y z

Two constants of proportionality:


the (first) dynamic viscosity, -- to relate stresses to linear deformations, and
the second viscosity, -- to relate stresses to the volumetric deformation.

xx = 2

u
+ u ,
x
u

xy = yx = + ,
y x
For gases, = 23

yy = 2

v
+ u ,
x
u

xz = zx = + ,
z x

zz = 2

w
+ u
x
v

yz = zy = +
z y

For incompressible liquid: u = 0

Substitution ij into the momentum equations yields the Navier-Stokes equations:

u v w
p
Du
= + ( u ) + + +

+ ( u) + S Mx (2.4a)
x
Dt
x x y x w x x

u v w
Dv
p
= + ( v) + + +

+ ( u) + S My (2.4b)
Dt
y
x y y y w y y

u v w
p
Dw
= + ( w) + + +
+ ( u) + S Mz (2.4c)
z
Dt
x z y z z z z

The complete Navier-Stokes equations in conservation form:


( u ) ( u 2 ) ( uv) ( uw)
p
u
+
+
+
= + u + 2
t
x
y
z
x x
x
v u u w
+ + + +
+ S Mx
y x y z z x
( v) ( uv) ( v 2 ) ( vw)
p v u
+
+
+
= + +
t
x
y
z
y x x y

v w v
+ u + 2 +
+ + S My
y
y z y z

( w) ( uw) ( vw) ( w2 )
p u w
+
+
+
= + +

t
x
y
z
z x z x
w v
w
+
+ + u + 2
+ S Mz
y y z z
z

(2.4aa)

(2.4bb)

(2.4cc)

2.1.5 Energy equation


Physical principle: Energy is conserved.
*Rate of increase
first law of
of energy of
thermodynamics:
fluid

*Net rate of work *Net rate of heat


done on
added to
+
=
fluid element
fluid element

*Rate of increase of energy of fluid particle:

DE
Dt

Net rate of work done by surface forces acting on x-, y- and z-direction are:
[u ( p + xx )] (u yx ) (u zx )
+
+
x
y
z
(v xy ) [v( p + yy )] (v zy )
+
+
y -direction:
x
y
z
( w xz ) ( w yz ) [ w( p + zz )]
+
+
z -direction:
x
y
z
x-direction:

*Total rate of work done on the fluid particle by surface forces:


(u xx ) (u yx ) (u zx ) (v xy ) (v yy ) (v zy )
+
+
+
+
+
x
y
z
x
y
z

)
w
( w xz )
( w zz )
yz
+
+
+
x
y
z

( pu) +

Energy flux due to heat conduction:

q q q

= q
x y z

& by Fouriers law: q = k T


*Net rate of heat added to fluid particle due to heat conduction: q = (k T )
Energy equation in nonconservation form:
(u xx ) (u yx ) (u zx ) (v xy ) (v yy ) (v zy )
DE

= ( pu) +
+
+
+
+
+
x
y
z
x
y
z
Dt

)
w
( w xz )
( w zz )
yz
+
+
+
+ ( k T ) + S E
(2.3a)
x
y
z
Where E = i + 12 (u 2 + v 2 + w2 ) and the gravitational potential energy is included in SE.
Energy equation in conservation form by substitution these terms in the left side of the
DE ( E )
equations :
=
+ ( E u)
t
Dt
By multiplying the x-, y- and z-momentum equation (2.2a-2.2c) by u, v and w,
Respectively, adding the results together, and subtracting from (2.3), energy equation
in terms of internal energy only, the kinetic energy term has dropped out:
Di
u
u
u
v
v
v

= p u + (k T ) + xx
+ yx
+ zx
+ xy
+ yy
+ zy
Dt
x
y
z
x
y
z
w
w
w
+ xz
+ yz
+ zz
+ SE u SM
x
y
z
Si

For an incompressible fluid, i = cT and u = 0 .


For Newtonian model for viscous stress, the energy equation completely in terms of
the flow field variables by repressing the viscous stresses in terms of the velocity
gradients:
Di

= p u + (k T ) + + Si (2.5)
Dt
u 2 v 2 w 2 u v 2 u w 2 v w 2
2
= 2 + +
+ ( u)
+ + + +
+ +
x y z y x z x z y
Where is the dissipation function, arises from irreversible viscous work, represents
a source of internal energy due to deformation work on the fluid particle.

2.2 Conservative form of the governing equation of fluid flow


Incompressible -- density constant
Compressible -- density varies
Equations for Viscous Flow (the Navier-Stokes Equations) include the dissipative,
transport phenomena of friction, thermal conduction, and/or mass diffusion.

10

For an unsteady, three-dimensional, compressible viscous flow:

+ i( u ) = 0
mass:
t

(2.1)

x-momentum:

( u)
p
+ i( uu) = + i( u ) + S x + S Mx
t
x

(2.4a)

y-momentum:

( v)
p
+ i( vu) = + i( v) + S y + S My
t
y

(2.4b)

z-momentum:

( w)
p
+ i( wu) = + i( w) + S x + S Mz
t
z

(2.4c)

u v w
e.g., S x = + +

+ (iu)
x x y x w x x
internal energy:

( i)
+ ( i u ) = piu + i(k T ) + + Si
t

(2.5)

Equation of state p = p ( , T ) and i = i ( , T ) , e.g., perfect gas p = RT and i = CvT


Equations for Inviscid Flow (the Euler Equations) Exclude the dissipative, transport
phenomena of friction, thermal conduction, and/or mass diffusion.
For an unsteady, three-dimensional, compressible inviscid flow:

mass:
+ i( u ) = 0
t

(2.1)

x-momentum:

( u)
p
+ i( uu) = + S Mx
t
x

(2.4a)

y-momentum:

( v)
p
+ i( vu) = + S My
t
y

(2.4b)

z-momentum:

( w)
p
+ i( wu) = + S Mz
t
z

(2.4c)

( i)
+ ( i u ) = piu + Si
t
Comments on the Governing Equations

(2.5)

internal energy:

Very difficulty to solve analytically a coupled system of nonlinear PDEs.


Difference between conservation&nonconservation forms is just the LHS.
Conservation form called divergence form, due to ( u) or ( uu) .
Normal and shear stresses are functions of velocity gradients.
Five equations. of six unknowns (, p, u, v, w, e); use a perfect gas
assumption in aerodynamics: p = RT
seventh unknown (T ), need the caloric equation of state ( e = cvT )
6. In modern CFD, Navier-Stokes equations. means a solution of a viscous flow
problem using the full governing equations.
7. Euler equations. means a solution of a inviscid flow problem using the full
governing equations.

1.
2.
3.
4.
5.

11

2.3 Boundary and initial conditions


* Although the governing equations are the same, the flow fields are quite different
due to the boundary conditions (include initial conditions).
* The real driver for any particular solution is the boundary condition.
* Any numerical solution of the governing flow equations must be made to see a
strong and compelling numerical representation of the proper boundary conditions.
Auxiliary conditions are specified in three ways:
1) Dirichlet condition

( x, y ) = f ( x, y ) or ( x, y ) = constant
2) Neumann condition
d
dn

= f ( x, y )
x, y

or

d
dn

= constant
x, y

3) Mixed condition
d
dn

+ c ( x, y ) = f ( x, y )

or

x, y

d
dn

+ c ( x, y ) = constant
x, y

Proper boundary conditions for a viscous flow:

boundary layer flow viscosity important close to surface

separated flow viscosity important everywhere

No-slip condition at the stationary surface with the moving flow


*Velocity: u = v = w = 0 (at the surface)
*Temperature:
1. Fixed wall temperature; T = Tw (at the wall)
T
2. Instantaneous heat flux to the wall; qw = k
(at the wall)
n w
T
3. Adiabatic wall;
= 0 (at the wall)
n w

The no-slip conditions for a continuum viscous flow are associated with velocity and
temperature at the wall.
Pressure and density at the wall, fall out as part of the solution.
Proper boundary conditions for an inviscid flow:
There is no friction at the surface to promote its sticking.
Hence, the flow velocity at the wall is nonzero value.
For a nonporous wall (no mass flow into or out of the wall), the flow at the surface is
tangent to the wall: u n = 0 (at the surface)

12

The magnitude of the velocity, temperature, pressure and density at the wall, fall out
as part of the solution.
Various types of BCs:
- Duct flow inflow & outflow boundaries (Fig. 2.4)
- Aerodynamic body freestream conditions (upstream, downstream, above, below)
(Fig. 2.5)
Initial conditions for unsteady flow

Everywhere in the solution region , u and T must be given at time t = 0

Boundary conditions for unsteady and steady flows

On solid wall,

u = uw (no-slip condition)

T = Tw (fixed temperature) or k T n = qw (fixed heat flux)

On fluid boundaries, inlet: , u and T must be known as a function of


position
outlet: p + un n = Fn and ut n = Ft (stress continuity)

The subject of proper numerical implementation of the physical boundary


conditions in CFD is very important and is the subject of much current CFD
research.

Fig. 2.4 Boundary conditions for an internal flow problem (Duct flow)

13

Fig. 2.5 Boundary conditions for an external flow problem (Aerodynamic body)
Special geometrical features of the solution region (Fig. 2.6):

Symmetry boundary condition: /n = 0

Cyclic boundary condition: 1 = 2

Fig. 2.6 Examples of flow boundaries with symmetry and cyclic conditions

14

2.4 Differential and integral forms of the general transport equations


Let is a general variable, the conservative form of all fluid flow equations are
( )
+ i( u) = i( ) + S
t

(2.6)

( is a diffusion coefficient)

rate of change + convection = diffusion + source


Finite volume method: the integration of the governing equations over a control
volume CV:
( )
dV + i( u)dV = i( )dV + S dV
t
CV
CV
CV
CV

Using Gauss divergence theorem:

iadV = niadA

CV

Unsteady problem:

t ( )dV dt + ni( u)dAdt = ni( )dAdt + S dV dt

t A

CV

t A

t CV

Steady state problem: ni( u) dA = ni( ) dA +


A

S dV

CV

2.5 Classification for simple partial differential equations


Consider a general second-order PDE in 2-D co-ordinates x and y.
A

2
2
2

B
C
+
+
+D
+E
+ F + G = 0
2
2
x
xy
y
x
y

(2.7)

Where A to G are constant coefficients.


elliptic PDE:
B 2 4 AC < 0

Three categorised of PDE: parabolic PDE: B 2 4 AC = 0


hyperbolic PDE: B 2 4 AC > 0

The classification depends only on the highest-order derivatives in each independent


variable.
Example:
elliptic equation: steady conduction problem: (1-D)

boundary-value problem

parabolic equation: unsteady conduction (1-D)

2T
2T 2T
=
0,
(2-D)
+
=0
x 2
x 2 y 2

2T 2T
T
2T
T
= 2 , (2-D)
= 2 + 2
t
x
t
y
x

initial-boundary-value problem
15

hyperbolic equation: vibration problem

2
2T
2 T
=
c
t 2
x 2

initial-boundary-value problem

Steady inviscid compressible flow past a slender body:

(1 M 2 )

2T 2T
+
=0
x 2 y 2

M <0
elliptic:
=0
parabolic:
M

>0
hyperbolic:
M

Applications: the flow about an aerofoil or turbine


The governing equation can change its type in different parts of the computational
domain is one of the major complicating factors in computing transonic flow, with
the occurrence of regions of subsonic (M < 1) and supersonic (M > 1) flow.

2.6 Dynamic similarity


Two flow are dynamically similar if the non-dimensional numbers that govern the
flows have the same value.
Consider the wave motion generates by a ship of length L traveling at a speed U,
start with z-momentum equation:
w
w
w
w
1 p 2 w 2 w 2 w
+u
+v
+w
=
+
+
+
g
z x 2 y 2 z 2
t
x
y
z

Non-dimensional variables are introduced as: x* = x / L,


t * = U t / L,

u* = u / U , v* = v / U , w* = w / U

y* = y / L,

z* = z / L ,

and p* = ( p p ) / U 2 .

w *
w *
w *
w *
p * 2 w 2 w 2 w gL
+u*
+ v*
+ w*
=
+
+
+

t *
x *
y *
z *
z * U L x 2 y 2 z 2 U 2

There are two non-dimensional groups: Re =

U L
U
and Fr =
1/ 2

( gL )

Reynolds number indicates the relative magnitude of the inertia and viscous
forces.

Froude number provides a measure of the relative importance of inertia and


gravity forces.

Two incompressible viscous flows involving free surfaces are dynamically


similar if they have the same values of Re and Fr even though the values of
U or L or / are different for the two flows.

References
Versteeg, H. K. and Malalasekera, W. (1995), An introduction to Computational Fluid
Dynamics, Longman, Malaysia.
Anderson, J. D., Jr. (1995), Computational Fluid Dynamics, The basics with
applications, International Edition, McGraw-Hill, Singapore.

16

Das könnte Ihnen auch gefallen