The zero-equation turbulence model

To simulate room airflow quickly, Chen and Xu [6] developed a zero-equation turbulence model by directly numerical simulation data. The model uses a single algebraic equation to express the turbulent viscosity

\[ \mu_t = 0.03874\rho U l,\]

where \(l\) is the distance to the nearest closure and \(U\) is the local mean velocity.

Based on this equation, the Reynolds averaged Navier-Stokes equations are closed. The governing equations of mass, momentum and energy for indoor can be written as follows:

\[ \phantom{long space}\left\{\begin{aligned} \displaystyle\rho\frac{\partial u}{\partial t} + \rho(u\cdot\nabla)u - \nabla\cdot\sigma &= \rho \beta(T_0 - T)g \phantom{very long space}&(1.1) \\ \nabla \cdot u &= 0 &(1.2) \\ \displaystyle\rho\frac{\partial T}{\partial t} + \rho u\cdot\nabla T - \nabla\cdot(\Gamma_{T,eff}\nabla T) &= \frac{J}{C_p} &(1.3) \\ \mu_{eff} &= \mu_l + \mu_t &(1.4) \end{aligned}\right.\]

Where

  • \(\rho =\) air density (\(\mathrm{kg.m^{-3}}\))

  • \(u =\) velocity (\(\mathrm{m.s^{-1}}\))

  • \(\mu_l\), \(\mu_t\), \(\mu_{eff} =\) laminar, turbulence and effective viscosity, respectively (\(\mathrm{kg.m^{-1}.s^{-1}}\))

  • \(p =\) pressure (\(\mathrm{kg.m^{-1}.s^{-2}}\))

  • \(\beta =\) thermal expansion coefficient of air (\(\mathrm{K^{-1}}\))

  • \(T_0 =\) temperature in a reference point (\(\mathrm{K}\))

  • \(T =\) temperature (\(\mathrm{K}\))

  • \(g =\) gravity acceleration (\(\mathrm{m.s^{-2}}\))

  • \(\Gamma_{T, eff} =\) effective turbulent diffusion coefficient for \(T\) (\(\mathrm{kg.m^{-1}.s^{-1}}\))

  • \(J =\) thermal source (\(\mathrm{J.m^{-3}.s^{-1}}\))

  • \(C_p =\) specific heat (\(\mathrm{J.kg^{-1}.K^{-1}}\))

In their work Chen and Xu [6] have estimated the effective diffusive coefficient for temperature in Equation (1.3), \(\Gamma_{T, eff}\), by:

\[ \Gamma_{T, eff} = \frac{\mu_{eff}}{\mathrm{Pr}_{eff}}\]

where the effective Prandtl number [7], \(\mathrm{Pr}_{eff}\), is \(0.9\).

The internal forces of the fluid are represented by the stress tensor \(\sigma\) defined by the following expression:

\[ \sigma = -p\mathrm{Id} + 2 \mu_{eff} \boldsymbol{D}(u)\]

In this last relation, one reveals the tensor of the strains \(\boldsymbol{D}\) chosen by the following form:

\[ \boldsymbol{D}(u) = \frac{1}{2}\left(\nabla u + (\nabla u)^T\right)\]

We can rewrite the equation \((1.3)\) as

\[ \frac{\partial T}{\partial t} + u\cdot\nabla T - \nabla\cdot(\kappa\nabla T) = \frac{J}{\rho C_p}\]

where \(\displaystyle\kappa = \frac{\mu_{eff}}{\rho \mathrm{Pr}_{eff}}\) is the thermal diffusitivity (\(\mathrm{m^2.s^{-1}}\)).

1. Strong formulation \(^7\)

We obtain a non-linear system of three coupled equations

\[ \phantom{very long space}\left\{\begin{aligned} \displaystyle\rho\frac{\partial u}{\partial t} + \rho(u\cdot\nabla)u - \nabla\cdot\sigma &= \rho \beta(T_0 - T)g &\phantom{very long space}(2.1) \\ \nabla \cdot u &= 0 &(2.2) \\ \displaystyle\frac{\partial T}{\partial t} + u\cdot\nabla T - \nabla\cdot(\kappa\nabla T) &= \frac{J}{\rho C_p} &(2.3) \\ \end{aligned}\right.\]

This system is supplemented with boundary conditions and initial values for the different fields of interest. These closure conditions will be detailed for each model and test case studied but we can already enumerate some usual boundary conditions and notations.

We consider the problem on a domain \(\Omega \in \mathbb{R}^d\), \(d = 2\), \(3\), with a sufficiently smooth boundary, \(\partial \Omega = \Gamma\). This boundary is partitioned (in two different ways) to settle the different boundary conditions

\[ \phantom{verery very long space} \Gamma = \Gamma_D^F\cup\Gamma_N^F = \Gamma_D^T\cup\Gamma_N^T\cup\Gamma_R^T, \phantom{verery very long space}(2.4)\]

where the exponents \(F\) and \(T\) stand for fluid or temperature and the indices \(D\), \(N\) and \(R\) stand for Dirichlet, Neumann and Robin conditions. On these subsets of \(\Gamma\), the boundary conditions can be described as

\[ \begin{aligned}[t] u &= u_D &\text{on }\Gamma_D^F, &\phantom{ii}\text{Dirichlet condition on Fluid} \\ \sigma n &= 0 &\text{on }\Gamma_N^F, &\phantom{ii}\text{Neumann condition on Fluid} \\ \phantom{line} \\ T &= T_D &\text{on }\Gamma_D^T, &\phantom{ii}\text{Dirichlet condition on Temperature} \\ \kappa\nabla T\cdot n &= \phi_{\Gamma} &\text{on }\Gamma_N^T, &\phantom{ii}\text{Neumann condition on Temperature} \\ \kappa\nabla T\cdot n &= \kappa_{\Gamma}(T_R-T) &\text{on }\Gamma_R^T, &\phantom{ii}\text{Robin condition on Temperature} \\ \end{aligned}\]

where \(u_D\), \(T_D\), \(\phi_{\Gamma}\) and \(\kappa_{\Gamma}\) are at least \(\mathcal{L}^2\) functions on \(\Gamma\).

2. Variational formulation

In order to write the variational formulation, we now introduce definite function spaces \(\forall t\).
We have the solution function spaces associated respectively with the speed and pressure:

\[ \begin{aligned}[t] V &= H^1_{(u_D, \Gamma_D^F)}(\Omega) \\ Q &= \mathcal L^2(\Omega) \end{aligned}\]

as well as the space of the fluid velocity test functions:

\[ W = H^1_{(0, \Gamma_D^F)}(\Omega)\]

Then, we multiply equation \((2.1)\) (respectively \((2.2)\)) with a test function \(v \in W\) (respectively \(q \in Q\)). We then integrate each of the equations on the domain \(\Omega\), and we perform an integration by part of the term containing the stress tensor \(\sigma\), which gives us:

\[ \begin{aligned} \rho \int_{\Omega} \frac{\partial u}{\partial t} \cdot v + \rho \int_{\Omega} (u \cdot \nabla)u \cdot v + \int_{\Omega} \sigma : \nabla v - \int_{\Gamma} \sigma n \cdot v &= \int_{\Omega} \rho\beta(T_0-T)g \cdot v \\ \int_{\Omega} q \nabla \cdot u &= 0 \end{aligned}\]

We now introduce the solution space assiociated with the temperature:

\[ X = H^1_{(T_D, \Gamma_D^T)}(\Omega)\]

as well as the space of the temperature test functions:

\[ Y = H^1_{(0, \Gamma_D^T)}(\Omega)\]

Then, we multiply equation \((2.3)\) with a test function \(r \in Y\). We then integrate each of the equations on the domain \(\Omega\), and we perform an integration by part of the term containing the stress tensor \(\sigma\), which gives us:

\[ \int_{\Omega}\frac{\partial T}{\partial t} r + \int_{\Omega} (u \cdot \nabla T)r + \int_{\Omega} \kappa \nabla T \cdot \nabla r - \int_{\Gamma} \kappa(\nabla T\cdot n)r= \int_{\Omega} \frac{J}{\rho C_p} r\]

Finally, we must take into account the boundary conditions. Thus, we obtain the incompressible Navier-Stokes variational formulation for the problem we have considered:
Find \((u, p, T) \in V \times Q \times X\) such that \(\forall (v, q, r) \in W \times Q \times Y\) we have:

\[ \left\{\begin{aligned} \rho\!\int_{\Omega}\!\frac{\partial u}{\partial t} \cdot v + \rho\!\int_{\Omega}\!(u \cdot \nabla)u \cdot v + \int_{\Omega}\!\sigma : \nabla v &= \int_{\Omega}\!\rho\beta(T_0-T)g \cdot v \\ \int_{\Omega}\!q \nabla \cdot u &= 0 \\ \int_{\Omega}\!\frac{\partial T}{\partial t}r + \!\int_{\Omega}\!(u \cdot \nabla T)r + \!\int_{\Omega}\!\kappa\nabla T \cdot\nabla r &= \!\int_{\Omega}\!\frac{J}{\rho C_p}r + \!\int_{\Gamma_N^T}\!\phi_{\Gamma}r + \!\int_{\Gamma_R^T}\!\kappa_{\Gamma}(T_R-T)r \end{aligned}\right.\]

3. Discretization \(^8\)

We will start by introducing some notations associated with the geometrical discretization. Let \(\mathcal{T}_{\delta}\) be the mesh resulting from the discretization of the field \(\Omega\) and thus forming the computational field of reference \(\Omega_{\delta}\). We also set \(\Gamma_{D,\delta}^F, \Gamma_{N,\delta}^F, \Gamma_{D,\delta}^T, \Gamma_{N,\delta}^T\) and \(\Gamma_{R,\delta}^T\) the discrete borders associated respectively with \(\Gamma_D^F, \Gamma_N^F, \Gamma_D^T, \Gamma_N^T\) and \(\Gamma_R^T\).
We sample the time dimension in \(N_T\) time steps, noted \(\{t_n\}_{1\leqslant n\leqslant N_T}\). Let \(t_i\) and \(t_f\) be the initial and final times respectively. We then have \(t_i\leqslant t_n\leqslant t_f,\) \(\forall n\in \{0,\dots,N_T\}\) and \(t_a<t_b\) if and only if \(a<b\). We note \(u_{\delta}^n\), \(p_{\delta}^n\) and \(T_{\delta}^n\) the discrete speed, pressure and temperature fields at time \(t_n\).

4. Spatial discretization

We start by describing the approximation spaces that we will use to write the discrete variational formulation. Let:

\[ \begin{aligned} V_{\delta} &= H^1_{(u_D, \Gamma_D^F)}\cap[P_c^M(\Omega_{\delta})]^d \\ Q_{\delta} &= P_c^N(\Omega_{\delta}) \\ X_{\delta} &= H_{(T_D, \Gamma_D^T)}^1\cap[P_c^K(\Omega_{\delta})]^d \end{aligned}\]

be the discrete spaces associated respectively with the velocity, the pressure and the temperature. The polynomial degrees \(M\) and \(N\) cannot be chosen freely, because the discrete problem obtained from the continuous variational formulation will not necessarily be well posed according to this choice. This discrete problem is of the saddle point type, the approximation spaces must then check a compatibility condition to ensure the existence and uniqueness of the problem. We can find for example the mathematical details in [10]. In the literature, this condition is often referred to as the Babuška – Brezzi condition or the Ladyshenskaya – Babuška – Brezzi condition. This condition states that the discrete problem is well posed if and only if the spaces \(V_{\delta}\) and \(Q_{\delta}\) are such that there exists a constant \(\beta_{\delta}\) such that:

\[ \inf_{q_{\delta}\in Q_{\delta}} \sup_{v_{\delta}\in V_{\delta}} \frac{\int_{\Omega_{\delta}}q_{\delta}\nabla\cdot v_{\delta}}{\lVert q_{\delta}\rVert_{\mathcal L^2(\Omega_{\delta})}\rVert v_{\delta} \lVert_{H^1(\Omega_{\delta})}} \geqslant \beta_{\delta}\]

If this constraint is not checked, the numerical solution can reveal instabilities. This is the case when \(M = N\). Solutions exist to solve this problem. They consist in adding stabilization terms to the equations. Several examples of stabilization exist, we can cite for example the PSPG [11], SUPG [12], GLS [13] and CIP [14] methods. We choose to use one of the more common finite element choices, the Taylor-Hood elements [9, 14]. The polynomial orders are then connected by \(N = M - 1\).

Since we have non-homogeneous Dirichlet conditions, we also need to introduce the discrete spaces of test functions associated respectively with the speed and temperature:

\[ \begin{aligned} W_{\delta} &= H^1_{(0,\Gamma_{D,\delta}^F)}(\Omega_{\delta}) \cap [P_c^N(\Omega_{\delta})]^d \\ Y_{\delta} &= H^1_{(0,\Gamma_{D,\delta}^T)}(\Omega_{\delta}) \cap [P_c^K(\Omega_{\delta})]^d \end{aligned}\]

The discrete variational formulation results in the following problem:
Find \((u_{\delta}, p_{\delta}, T_{\delta}) \in V_{\delta} \times Q_\delta \times X_\delta\) such that \(\forall (v, q, r) \in W_\delta \times Q_\delta \times Y_\delta\) we have:

\[ \left\{\begin{aligned} \rho\!\int_{\Omega}\!\frac{\partial u_\delta}{\partial t} \cdot v + \rho\!\int_{\Omega}\!(u_\delta \cdot \nabla)u_\delta \cdot v + \int_{\Omega}\!\sigma_\delta : \nabla v &= \int_{\Omega}\!\rho\beta(T_0-T_\delta)g \cdot v \\ \int_{\Omega}\!q \nabla \cdot u_\delta &= 0 \\ \int_{\Omega}\!\frac{\partial T_\delta}{\partial t}r + \!\int_{\Omega}\!(u_\delta \cdot \nabla T_\delta)r + \!\int_{\Omega}\!\kappa\nabla T_\delta \cdot\nabla r &= \!\int_{\Omega}\!\frac{J}{\rho C_p}r + \!\int_{\Gamma_N^T}\!\phi_{\Gamma}r + \!\int_{\Gamma_R^T}\!\kappa_{\Gamma}(T_R-T_\delta)r \end{aligned}\right.\]

5. Time discretization

We will now approach the derivatives in time using implicit schemes called backward differentiation formulation \((\mathrm{BDF})\). These schemes can be written for an arbitrary order \(q\) and they are thus denoted by \(\mathrm{BDF_q}\). We will present \(\mathrm{BDF_q}\) diagrams up to order 4 in the following. Let \(\Delta t\) be the time step assumed to be constant over time, we have \(t_0=t_i\) and \(t_n = t_0 + n\Delta t\).

Table 1. Coefficients of \(\mathrm{BDF_q}\) schemes up to order 4.
\(\boldsymbol{q}\) \(\boldsymbol{\beta_{-1}}\) \(\boldsymbol{\beta_0}\) \(\boldsymbol{\beta_1}\) \(\boldsymbol{\beta_2}\) \(\boldsymbol{\beta_3}\)

1

1

1

2

3/2

2

-1/2

3

11/6

3

-3/2

1/3

4

25/12

4

-3

4/3

-1/4

The following formula describes the approximation of the \(q\)-order time derivative of the speed using the \(\beta_j\) coefficients described in Table 1:

\[ \frac{\partial u^{n+1}}{\partial t} \approx \frac{\beta_{-1}(q)}{\Delta t}u^{n+1}_\delta - \sum_{j=0}^{q-1}\frac{\beta_j(q)}{\Delta t}u_\delta^{n-j}\]

This expression is made up of two terms. The first contains the unknown \(u^{n+1}_\delta\). The second shows the solutions of the previous time steps, that is to say that they are known.
We define:

\[ \begin{aligned} f^{n+1} &= \rho\beta(T_0-T_\delta^{n+1})g + \rho\sum_{j=0}^{q^F-1}\frac{\beta_j(q^F)}{\Delta t}u_\delta^{n-j} \\ g^{n+1} &= \frac{J}{\rho C_p} + \sum_{j=0}^{q^T-1}\frac{\beta_j(q^T)}{\Delta t}T_\delta^{n-j} \end{aligned}\]

where \(q^F\) and \(q^T\) are diagram orders for speed and temperature, respectively.
We finish the temporal discretization by adding the initial conditions necessary to be able to correctly construct the temporal derivatives. If we use a \(\mathrm{BDF_1}\) diagram, only one initial condition is necessary \(u^0_\delta = u_0\) in \(\Omega_\delta\), where \(u_0=u(x, t_0)\). We can then calculate the solutions at the following time step \(t_n\) for \(n > 1\). When we use a \(q\) diagram of order greater than 1, we have two possibilities. Either we use \(q\) initial conditions, which represents the mathematically cleanest solution, but this information is not always accessible in practice. Either we gradually increase the order of the diagram, i.e. for the first time step we use a \(\mathrm{BDF_1}\) scheme which was initialized with a single initial condition \(u^0_\delta\), then for the second time step we use \(\mathrm{BDF_2}\) until reaching the desired order. However, this method can have the disadvantage of creating discontinuities at this start if the simulated phenomena are important.

Finally, the discrete variational formulation of our standard problem is given by the following problem:
Find \((u_{\delta}, p_{\delta}, T_{\delta}) \in V_{\delta} \times Q_\delta \times X_\delta\) such that \(\forall (v, q, r) \in W_\delta \times Q_\delta \times Y_\delta\) we have:

\[ \left\{\begin{alignedat}{5} &&\rho\frac{\beta_{-1}(q^F)}{\Delta t}\!\int_{\Omega}\!\frac{\partial u_\delta^{n+1}}{\partial t} \cdot v + \rho\!\int_{\Omega}\!(u_\delta^{n+1} \cdot \nabla)u_\delta^{n+1} \cdot v \\ & &+ \int_{\Omega}\!\sigma_\delta^{n+1} : \nabla v &= \int_{\Omega}\!f^{n+1}\cdot v \\ & &\int_{\Omega}\!q \nabla \cdot u_\delta^{n+1} &= 0 \\ &&\frac{\beta_{-1}(q^T)}{\Delta t}\int_{\Omega}\!\frac{\partial T_\delta^{n+1}}{\partial t}r + \!\int_{\Omega}\!(u_\delta^{n+1} \cdot \nabla T_\delta^{n+1})r \\ & &+ \!\int_{\Omega}\!\kappa\nabla T_\delta^{n+1} \cdot\nabla r &= \!\int_{\Omega}\!g^{n+1}r + \!\int_{\Gamma_N^T}\!\phi_{\Gamma}r + \!\int_{\Gamma_R^T}\!\kappa_{\Gamma}(T_R-T_\delta^{n+1})r \end{alignedat}\right.\]

6. Extrapolation

In order to simplify and speed up the calculations, we will use an extrapolation [16] of the velocity and separate the equations.
Let \(u^*\) be the extrapolation of \(u_\delta^{n+1}\), the problem becomes:

  • Find \(T_{\delta} \in X_\delta\) such that \(\forall r \in Y_\delta\) we have:

\[ \frac{\beta_{-1}(q^T)}{\Delta t}\int_{\Omega}\!\frac{\partial T_\delta^{n+1}}{\partial t}r + \!\int_{\Omega}\!(u^* \cdot \nabla T_\delta^{n+1})r + \!\int_{\Omega}\!\kappa\nabla T_\delta^{n+1} \cdot\nabla r = \!\int_{\Omega}\!g^{n+1}r + \!\int_{\Gamma_N^T}\!\phi_{\Gamma}r + \!\int_{\Gamma_R^T}\!\kappa_{\Gamma}(T_R-T_\delta^{n+1})r\]
  • Turbulence viscosity is

\[ \mu_t = 0.03874\rho U^* l,\]

where \(l\) is the distance to the nearest closure and \(U^*\) is the extrapolated local mean velocity.

  • Find \((u_{\delta}, p_{\delta}) \in V_{\delta} \times Q_\delta\) such that \(\forall (v, q) \in W_\delta \times Q_\delta\) we have:

\[ \left\{\begin{alignedat}{5} \rho\frac{\beta_{-1}(q^F)}{\Delta t}\!\int_{\Omega}\!\frac{\partial u_\delta^{n+1}}{\partial t} \cdot v + \rho\!\int_{\Omega}\!(u^* \cdot \nabla)u_\delta^{n+1} \cdot v + \int_{\Omega}\!\sigma_\delta^{n+1} : \nabla v &= \int_{\Omega}\!f^{n+1}\cdot v \\ \int_{\Omega}\!q \nabla \cdot u_\delta^{n+1} &= 0 \end{alignedat}\right.\]

References

  • [6] Chen Qingyan, Xu Weiran. A zero-equation turbulence model for indoor air flow simulation. Energy and Building 1998;28(2):137–44.

  • [7] Wikipedia: «Prandtl number»

  • [8] Wahl Jean-Baptiste. The Reduced Basis Method Applied to Aerothermal Simulations. Ph.D. thesis, Université de Strasbourg, 2018.

  • [9] Vincent Chabannes. Vers la simulation des écoulements sanguins. Médecine humaine et pathologie. Université de Grenoble, 2013. Français. NNT : 2013GRENM061. tel-00923731v2

  • [10] F.(Franco) Brezzi and M. Fortin. Mixed and hybrid finite element methods. Springer-Verlag, 1991.

  • [11] Tayfun E Tezduyar. Stabilized finite element formulations for incompressible flow computations. Advances in applied mechanics, 28(1) :1–44, 1992.

  • [12] Thomas JR Hughes and Alec Brooks. A multidimensional upwind scheme with no crosswind diffusion. Finite element methods for convection dominated flows, AMD, 34 :19–35, 1979.

  • [13] Thomas JR Hughes, Leopoldo P Franca, and Gregory M Hulbert. A new finite element formulation for computational fluid dynamics : Viii. the galerkin/least-squares method for advective-diffusive equations. Computer Methods in Applied Mechanics and Engineering, 73(2) :173–189, 1989.

  • [14] E. Burman and M.A. Fernández. Continuous interior penalty finite element method for the time-dependent Navier–Stokes equations : space discretization and convergence. Numerische Mathematik, 107(1) :39–77, 2007.

  • [15] A. Ern and J.L. Guermond. Theory and practice of finite elements, volume 159. Springer Verlag, 2004.

  • [16] Wikipedia - «Extrapolation»