You are on page 1of 10

Finite Element Simulation of Turbulent Flow Using k  Model and Rans

Equations

Aleksandar Nikolić1*, Nenad Filipović1, MarkoTopalović1, Miroslav Živković1


1
Faculty of Engineering, University of Kragujevac, Serbia
e-mail:dziga@kg.ac.rs

*corresponding author

Abstract

Turbulent flow is largely unstable and divergent. For this reason, the turbulent problems are
treated through statistical rather than deterministic methods. Analysis of turbulent fluid flow in
this paper is performed using two-equation statistical model that can calculate values in the
viscous sublayer. Implicit integration of the equations is used for determining the fluid velocity,
pressure, turbulence, kinetic energy, and dissipation of turbulent kinetic energy. These values are
calculated in the finite element nodes for each step of incremental-iterative procedure. Turbulent
model is verified on an example of fluid flow in backward facing step channel. Analysis results
correspond well with the experimental results from the literature and developed model can be
used for more complex problems that are experiencing turbulent flow.

Keywords:fluid flow, turbulent flow, FEM, simulation, k  

1. Introduction

Turbulence in the computational fluid dynamics (CFD) constitutes an improper swirling flow,
which occurs when the flow velocity exceeds a certain threshold, or when the flow slows down
due to the interactions with the solids. Typical engineering applications of turbulence analysis
have been focused on the determination of basic variables of the fluid flow, such as shear stress
at the wall, field of pressure or flow velocity. Fluid flow in nature can occur as laminar or
turbulent flow. Laminar flow is characterized as a flow in which fluid layers move parallel to
each other. In this case, adjacent layers do not interfere with each others.
On the other hand, there are several approaches for a description and study of turbulent fluid
flow. Turbulent model that is studied in this paper is based on statistical modeling of turbulence.
This approach involves approximation of the velocity of the fluid that can be determined as the
sum of the average values of velocity and velocity fluctuations around that value. Reynolds
equations are obtained by applying this method to the Navier-Stokes equations. Average values
of velocity and pressure are specified in these equations rather than the current values. In these
equations, there are new members that are called turbulent stresses or Reynolds stresses. The
problem of determining these stresses leads to the introduction of turbulence models.
The development of model for turbulent fluid flow calculation in this paper is based on Finite
Element Method (FEM). For calculation of the basic physical quantities that characterize the fluid

1
flow implicit integration of equations is applied for description of the problem. In each step of
incremental-iterative procedure, determinnation of the fluid velocity, field of pressure, turbulence
kinetic energy and dissipation of turbulent kinetic energy is done for all finite element nodes.
This paper first provides basic mathematical relations that characterize the turbulent flow.
Afterwards Reynolds equations and k   turbulent model are coupled together within the finite
element method. The incremental-iterative equations for solving turbulent problems are shown.
The verification example of the flow in a channel with backward facing step is shown in the last
chapter, and comparison with the experimental results from the literature shows that the analysis
with k   model correspond well with the experimental results.

2. Mathematical relations of turbulent flow

Turbulent models are principally comprised of the Reynolds equations and are generally in the
form of one-equation or two-equations models based on Boussinesq approximation (Boussinesq
(1877), McDonough (2007)). This approximation implies that a member of the Reynolds
equations containing turbulent stresses is approximated through turbulent dynamic viscosity.
Two-equation turbulent models are based on the two equations, one of which is the equation for
kinetic energy of turbulence and the second equation represents a variable of dissipation or
specific dissipation of kinetic energy of turbulence.
Turbulent model k   is one of the standard two-equation models used for modeling the
turbulent problems. This model was referred for the first time in the papers of Wilcox, (Wilcox
(1988), Wilcox (1994). Since then, this model was not significantly modified.Turbulent model
consists of equations for the kinetic energy of turbulence and specific dissipation of the kinetic
energy of turbulence. A model is created so that it can be integrated in the entire viscous sub-
layer and do not require additional wall logarithmic functions for defining the flow close to the
walls (Wilcox (1994), Wilcox (2006)).
This model can be applied in practice without any modification for the analysis of most turbulent
issues. For this model theory of the flow with low Reynolds number is developed in many cases.
In papers following Bassiet et al. (2005) and Bassiet et al. (2014) numerical algorithms for
discretization by the discontinuous Galerkin method are discussed. Special emphasis is placed on
discretization for viscous part of turbulent model k   .
The Reynolds Averaged Navier-Stokes (RANS) equations are based on the Navier-Stokes
equation, and the equation of continuity. RANS are the first step in the statistical modeling of
turbulence. Navier-Stokes equation for incompressible viscous fluid flow in a tensor notation
following Kojić et al. (1998), Bathe (2006), Kojić M (2008) and Filipović (1999) are represented
as:
 vi v  p   vi v j 
  vj i        i  1, 2,3; sum on j : j  1, 2,3 (1)
 t x j xi x j
   x j xi 

herein the member that represent an external force is omitted. Other members in the equation (1)
are:  - fluid density, t - time, vi , v j - velocity components of fluid, p - pressure in fluid and 
is dynamic viscosity. The equation of continuity, if it is considered that the fluid is
incompressible, can be written in the following form:

vi
0 (2)
xi

2
If the fluid flow is observed by statistically averaged parameters, each variable can be represented
as the sum of the time averaged value for that parameter and the fluctuation about this value
(McDonough (2007) and Ferziger et al. (2002)):

vi  xi , t   vi  xi   vi'  xi , t  (3)

where vi  xi  is respresented as:


T
1
vi  xi   lim vi  xi , t  dt
T  T 
(4)
0

In the equations (3) and (4) following parameters are used: vi' - velocity fluctuations around a
mean value, vi  xi  - the averaged value of velocity. Substitution of previous equations into
equation (1) and (2) gives the following equation:
 vi vi 

 t
 vj 
x j 
p


xi x j

2 Sij   vi' v 'j  (5)

A member on the right side of equation (5) vi' v 'j is nonlinear member created due to inertial forces
that occur in the fluid. By introducing Boussinesq approximation (Boussinesq (1877),
McDonough (2007)) for turbulent viscosity, this member can be represented as:
2
  vi' v'j  2T Sij   ij k (6)
3

where the term   vi' v'j represents Reynolds stresses. Other parameters are: T - dynamic
turbulent viscosity (eddy viscosity), k - kinetic energy of turbulence,  ij - Kronecker delta
2
symbol. Member  ij k is required for correct contraction equation on the left and right hand side
3
of equation (Jovičić(2006)). When analyzing the flow of an incompressible fluid it is considered
that this member is not required to determine the velocity field so it can be ignored. With this
statement, the equation (5) gets the following form:
 v v  p    v v j  
  i  vj i      eff   i    (7)

 t x j  xi x j   x j xi  
In equation (7) member eff is the effective dynamic viscosity which is sum of dynamic viscosity
and turbulent dynamic viscosity:
eff    T (8)
If we average the equation of continuity with previously described process we obtain the
following expression:
vi
0 (9)
xi

3
Equations (7) and (9) represent the Reynolds averaged Navier-Stokes equations (RANS).The
turbulent dynamic viscosity within k   model is calculated as the ratio of the kinetic energy
of turbulence k and specific dissipation of the kinetic energy of turbulence  :
k
T   * (10)

Specific dissipation of the kinetic energy of turbulence  is variable characterizing the scale of
turbulence. The kinetic energy of the turbulence k may be represented following Jovičić (2006)
by equation:
 k k    k 
  vj       T    Pk   k  k
*
 t (11)
 x j  x j  x j 
where Pk represents the effect of kinetic energy of turbulence and is defined as:
 v v j  vi
Pk  T  i   (12)
 x j xi  x j
 
Specific dissipation of the kinetic energy of turbulence  is calculated by using the following
equation:
        
  vj      T     k Pk   
2
 t (13)
 x j  x j 
 x j 
 k
In equations (11) и (13) constants  * ,  ,   ,  k ,  и  * have following values:

5 3 9 1 1
 *  1,  k  ,   , k  ,   , *  (14)
9 40 100 2 2

3. Reynolds equations and k   model in finite element method

Basic equations that are solved for turbulent fluid flow are the Reynolds equation represented by
the expressions (7) and (9).
Applying a Galerkin method (Kojić et al. (1998), Kojić M (2008) to the equation (7), (9), (11)
and (13) and implementing the interpolation functions for fluid velocity, the pressure, kinetic
energy of turbulence and specific dissipation of the kinetic energy of turbulence given with:
vi  hI Vi I (15)

pi  hˆI PI (16)
k  hI k I (17)
  hI I (18)
the following equations are obtained in the matrix form:
M 0  V  K vv  K  vt K vp   V  Fv  Fs 
 0 0     K T 
0   P   0 
(19)
  P  vp

MK  k   K VK  K MK  K βk  k   K VV1 V   FSK2 (20)

4
MK ω  K VK  K Mω  K βω  ω  K VV2 V   FSω (21)
If Reynolds equations (19) are coupled with equations (20) and (21) we have the following system
of matrix equations:
M V 0 0 0   V  K vv  K  vt K vp 0 0   V  Fv  Fs 
 0       
0   P   K vp
T
0 0 0 0 0  P   0 
  (22)
 0 0 MK 0   k   K VV1 0 K VK  K MK  K βk 0   k   FSK2 
       
 0 0 0 M K  ω   K VV2 0 0 K VK  K Mω  K βω  ω   FSω 

3.1 Incremental-iterative method for solving equations


The system of equations (19) is nonlinear, because of the velocity that appear in the convection
member, so for solving these equations incremental-iterative procedure is used. The kinetic energy
of turbulence, the specific dissipation of turbulent kinetic energy and the velocity of fluid at the end
of the time step can be calculated as the values from the previous iteration and the increment from
current iteration, so we have following iterative equations:
1 
 t M v 
t t
K vvi 1  t t K  vt i 1  t t J vvi 1 K vp    i    t t  i 1 
V   FB 
    i
   t t i 1  (23)
T 
 P   
 FP  
 K vp 0 
where above menitioned matrices and vectors are calculated as:

 Mv IJ    hI hJ dV (24)
V

i 1 
   hI hK  V jI
t t
K 
t t i 1
 hJ, j dV (25)
 
vv IJ
V

K       t t T (i 1)  hI, j hJ, j dV


t t  i 1
 vt IJ (26)
V

i 1 
   hI hK, j  Vi I
t t
J 
t t i 1
 hJ dV (27)
 
vv IJ
V

K  vp IJ   hI,i hJ dV (28)
V

t t
FB i 1  t t
Fv  t t Fs i 1 
1
t
 M v IJ  t t
V i 1  t V  
 
(29)
K  V i 1   K vp 
 i 1
K 
t t  i 1 t t
 vv IJ   vt IJ
t t t t
P i 1
IJ

FP i 1    K vp  V  i 1
t t T t t
IJ
(30)

t t
Fv    hI t t fiV dV (31)
V

  i 1  
Fsi 1   hI   t t pi 1 ni     T   V jI
t t
t t
 n j  dS (32)
S   i . j 
Equations (20) и (21) in matrix expressions can be written as:

5
 
 0 0 0  ΔV  i    t t R  i 1 
   
V

 t t K  i 1  t t K i 1 1
M K  t t K VK    t t K MK    t t K βk  
i 1 i 1 i 1  i   i 1 
Δk      t t R K   
 KV VVK
t
0
   i    i 1 
(33)
  Δω   R ω  t t

  t t K ωV  i 1  t t K VVω i 1 1    


0 M K + t t K VK i 1 + t t K Mω i 1 + t t K βω i 1 
 t 
where matrices are defined as:

 MK IJ    hI hJ dV (34)
V

 i 1 
   hI hJ 
t t
 K VK IJ
t t i 1
Vi I hI, j dV (35)
V  

 K MK IJ       * t t T (i 1) hI, j hJ, j dV


t t i 1
(36)
V

K 
i 1
  dV
t t
k J
i 1
βk IJ  2 k t t (i 1)  hI hK hJ t t
(37)
V

 K Mω IJ       t t T (i 1) hI, j hJ, j dV


t t i 1
(38)
V

K 
i 1
 
t t
βω IJ  2   hI hK hJ t t
 J i 1 dV (39)
V

t t
 K KV IJ
i 1
   hI hJ, j
V
 t t

k Ii 1 hK dV (40)

i 1 
 4 t t T (i 1) hI hJ, j  Vi I
t t
 K VVK IJ
t t i 1
 hK, j dV (41)
V  
t t
 K ωV IJ
i 1
   hI hJ, j
V
 t t

 Ii 1 hK dV (42)

i 1 
 4 k  t t (i 1) t t T (i 1) hI hJ, j  Vi I
t t
 K VVω IJ
t t i 1
 hK, j dV (43)
V  

t t
R K i 1  t t
FSK2i 1 
1
t
 M K IJ  t t
  1 
k i 1  t k   t t K VK i 1  t t K MK i 1  t t K βk i 1  t t k i 1
 2 
(44)

t t
R ω i 1  t t
FSω i 1 
1
t
 M K IJ  t t 


ωi 1  t ω   t t K VK i 1 + t t K Mω i 1 +
1
2
t t 
K βω i 1  t t ωi 1

(45)

t t
R Vi 1   t t
K VV1i 1 + t t K VV2i 1  t t 
Vi 1 (46)

 FSK2 I      * t t T (i 1)   hI k, j n j dS


t t i 1
(47)
S

 FSω I      t t T (i 1)   hI  t t (i 1)  n j dS


t t i 1
,j (48)
S

6
i 1 
 2 t t T (i 1) hI hJ, j  Vi I
t t
 K VV1 IJ
t t i 1
 hK, j dV (49)
V  

i 1 
 2 k  t t (i 1) t t T (i 1) hI hJ, j  Vi I
t t
 K VV2 IJ
t t i 1
 hK, j dV (50)
V  

4. Test example – fluid flow in backward facing step channel

A module for turbulent flow was tested on a benchmark example that has been widely used –fluid
flow in backward facing step channel (Creech et al. (2016),Younget et al. (2006),Codinaet et al.
(1999)). The geometry of the problem and the finite element model are shown in Figure 1.

(a) (b)
Fig. 1. Fluid flow in backward facing step channel, a) Geometry of the problem(Creech et al.
(2016)), b) Finite element model

As can be seen from Fig. 1 step height is H with length 4H . Width of channel is 5H . The total
length of the channel is 20H . Result that is mostly considered for this problem is the length after
which the fluid impinges on the bottom of the channel (on Fig. 1 denoted as X r ). This length is
determined by the experiments in references as X r  6 H .
Flow simulation is performed in a channel using 2D and 3D models. The fluid is considered a
Newtonian fluid with unit density and dynamic viscosity (   1 ,   1 ). The problem is
simulated with more values of input velocity, with emphasis on velocity at which Reynolds
number is greater than 2300 and turbulent flow appears. One such case is for the inlet fluid
velocity vinlet  2000 and Reynolds number Re  6000 .
The boundary conditions for the problem are as follows: fluid flow on the walls of the channel is
equal to zero, and forces are equal to zero at the channel exit. For 2D problem finite element
model consist of 7600 elements and 7841 nodes.

4.1 2D case model of fluid flow in backward facing step channel


Simulation of fluid flow in case of 2D model was carried out as stationary in a single step of 0.5
seconds. The results of the simulation (velocity, pressure and streamlines field) are given in the
Fig. 2. If we take a deeper analysis on the results of velocity field, it can be seen that a point of
contact with the bottom of the channel after the step is located between 6H and 7H , which is
consistent with the literature data.
The results of the velocity field can be shown on the chart for a certain position of the point of
the fluid contact with the bottom wall after the step ( X r ). The first distance X r  0 is the distance
that coincides with the end of the step.

7
(a) (b)
Fig. 2. Results of 2D model: (а) velocity field, (b) field of pressure drop

After the length 6H fluid velocity is greater than zero, while before 6H velocity have a negative
value in the part of channel after the step (Fig. 3). The reason for this is a vortex that occurs in
the part of the channel immediately after the end of the step and on that part fluid velocity actually
have the negative value. Velocity of fluid flow is normalized for easy display in the diagram (Fig.
3).

Fig. 3. Fluid velocity rates for a variety of touch lengths after the step X r

4.2 3D case model of fluid flow in backward facing step channel


Analysis of channel fluid flow in the case of 3D model, is implemented as a transient in 500 steps
of 0.0001 seconds. Analysis results are shown for velocity field, pressure drop and streamlines
field for steps 100 and 150. After step 200 simulation satisfy the steady-state condition so the
results after 200 steps are ommited. Geometry is created as a half of the model due to symmetry,
and the finite element model contains 7600 elements and 9097 nodes.

(а) (b)
Fig. 4. Velocity field, 3D model: (а) step 100, (b) step 150

8
(а) (b)
Fig. 5. Field of pressure drop, 3D model: (а) step 100, (b) step 150

(a) (b)
Fig. 6. Streamlines field, 3D model: (а) step 100, (b) step 150

4. Conclusions

In turbulent fluid flow transfer of momentum leads to the turbulent stresses that are not present
in a laminar flow. There are several approaches for a description and study of turbulent fluid flow.
In this paper two-equation statistical turbulent model k   is used because it can be integrated
across the viscous sublayer so that the introduction of wall function is not necessary. In the
calculation of the basic physical quantities that characterize turbulent flow implicit integration of
equations is used for the problem description. Determining the velocity field, the pressure drop,
kinetic energy of turbulence and specific dissipation of kinetic energy of turbulence in the finite
element nodes is defined at the end of each step of incremental-iterative procedure. The analysis
results correspond well with the experimental results given in literature. Further research could
go in the direction of varying finite element mesh in order to obtain more precise results of the
velocity field and in the development of other turbulent models using finite element method.

Acknowledgements The part of this research is supported by Ministry of Education, Science and
Technological Development of Republic of Serbia, Grants TR32036, III41007 and OI175082.

9
References

Bathe K J, Finite Element Procedures, 2nd ed, K.J. Bathe, Watertown, MA, USA.
Bassi F, Crivellini A, Rebay S and Savini M (2005). Discontinuous Galerkin solution of the
Reynolds-averaged Navier–Stokes and k–w turbulence model equations, Computers &
Fluids,34, 507–540
Bassi F, Ghidoni A, Perbellini A, Rebay S, Crivellini A, Franchina Nand Savini M (2014). A
high-order Discontinuous Galerkin solver for the incompressible RANS and k–w turbulence
model equations,Computers & Fluids, 98, 54–68.
Boussinesq J (1877). Essai sur la théorie des eaux courantes, Mémoires présentés par divers
savants à l'Académie des Sciences.
Codina R, Soto O (1999), Finite Element Implementation of Two-equation and Algebraic Stress
Turbulence Models for Steady Incompressible Flows, Int. J. Numer. Meth. Fluids, 30, 309–
333.
Creech A, Jackson A, Maddison J, Percival J and BruceTom (2016), Efficient Large Eddy
Simulation for the Discontinuous Galerkin Method, Computers and Fluids, In preparation.
Ferziger J and Peric M (2002), Computational Methods for Fluid Dynamics, 3rd ed., Springer-
Verlag Berlin Heidelberg.
Filipović N (1999), Numerical Analysis of Coupled Problems: Deformable Body and Fluid Flow,
Ph. D. Thesis, Faculty of Mechanical Engineering, Kragujevac, Serbia.
Jovičić N (2006), Modeling and simulation of work processes in hydraulic turbomachinery,
Monograph, Legenda, Čačak, Serbia.
Kojić M, Slavković R, Živković Mand Grujović N (1998). Finite element analysis I, Linear
analysis, Faculty of Mechanical Engineering, Kragujevac, University of Kragujevac, Serbia.
Kojić M, Filipović N, Stojanović B. and Kojić N (2008), Computer Modeling in Bioengineering,
Chichester: John Wiley & Sons Ltd.
McDonough J M (2007). Introductory Lectures on Turbulence, Physics, Mathematics and
Modeling, Departments of Mechanical Engineering and Mathematics, University of
Kentucky.
Young D L, Eldho T I, Chang J T (2006), Large eddy simulation of turbulent flows in external
flow field using three-step FEM–BEM model, Engineering Analysis with Boundary
Elements, 30, 564–576.
Wilcox D C (1988).Reassessment of the scale-determining equation for advanced turbulence
models, AIAA Journal, 11, 1299-1310.
Wilcox D C (1994). Turbulence Modeling for CFD, DCW Industries, Inc.
Wilcox D C (2006). Turbulence Modeling for CFD, 3rd edition, La Canada, CA: DCW
Industries, Inc.

10

You might also like