PIC

Quasi-3D Computation of the Taylor-Green Vortex Flow

Department of Aeronautics, Imperial College London, UK
Scientific Computing and Imaging Institute, University of Utah, USA

November 12, 2021

Tutorials

1 Introduction
2 Background
3 Configuring and Running the Solver
4 Simulation Results

Chapter 1
Introduction

This tutorial describes the use of the spectral/hp element framework Nektar++ to explore one of the classical and canonical problems of fluid dynamics: the Taylor-Green Vortex (TGV). Information on how to install the libraries, solvers, and utilities on your own computer is available on the webpage www.nektar.info.

Task: 1.1 Prepare for the tutorial. Make sure that you have:

The TGV flow case has analytical initial conditions and its exact solution is known from direct numerical simulation (DNS) using incompressible Navier-Stokes solvers. For this reason it is often used for code validation. Moreover, the TGV flow problem is a very instructive analysis case: through its numerical simulation, it is possible to study turbulent transition and decay, vortex dynamics and energy dissipation mechanisms 1. In this tutorial we will focus on the solution of the TGV flow case in a 3D cube region within a time frame of 20 seconds, which is usually sufficient to observe the aforementioned phenomena. For now, we will restrict ourselves to a resolution of 643 degrees of freedom using p = 8 order interpolants in a Continuous Galerkin (CG) projection. We will also have a look at the temporal evolution of the kinetic enery and its dissipation rate in the flow domain. The case with 1283 degrees of freedom is left as an optional exercise for the user.

The necessary files to complete this tutorial are included in the .zip folder downloaded using the link in Task 1.1. Under the folder tutorial, the user will find four subfolders, two for each resolution (64 or 128):

The folder completed that can also be found in the .zip contains the filled .xml files to be used as a check in case the user gets stuck, or to verify the correctness at the end of the tutorial.

Tip:

Because the test case can take some time to complete, you may want to run the solver with the completed configurations files available in the folder completed. To do so, in the folder completed/solver64, type the following command on the command line:

$NEK/IncNavierStokesSolver TGV64_mesh.xml TGV64_conditions.xml

Note that this is entirely optional as output files are already provided in the same folder, i.e. completed/solver64.

Chapter 2
Background

The TGV is an exact solution of the incompressible Navier-Stokes equations:

∂V--
∂t + V ⋅∇V = -∇P + ν∇2V,
∇⋅V = 0,

where V = (u,v,w) is the velocity of the fluid in the x, y and z directions respectively, P is the pressure, ρ is the density and ν is the kinematic viscosity. Note that the absence of a forcing function (body force) will result in viscosity dissipating all the energy in the fluid, which will then eventually come to rest.

In order to simulate the flow, the Velocity Correction Scheme will be used to evaluate the Navier-Stokes equations. This scheme uses a projection in which the velocity matrix and pressure are decoupled. For detailed information on the method, you can consult the User-Guide.

Quasi-3D Approach

Instead of constructing a 3D mesh of the domain and applying a spectral/hp discretisation in all three directions, it is more computationally efficient to use a quasi-3D approach. This approach allows the use of a spectral/hp expansion on a 2D mesh and to extend the computation in the third direction (typically the z-direction) using a simpler purely spectral harmonic discretisation (classically a Fourier expansion), if that direction is geometrically homogeneous. The user needs only specify the number of modes and basis type for the discretisation and the length along the z-direction.

Mesh and Boundary Conditions

The mesh we will use for the TGV flow is periodic in nature. It is therefore defined as -πL ≤ x,y,z ≤ πL, where L is the inverse of the wavenumber of the minimum frequency that can be captured on our mesh, i.e the largest length scale of our flow, known as the integral scale. It represents the size of the large, energy-carrying eddies responsible for most of the momentum transport. Given that the smallest length scale we can capture on our mesh Δx = (2πL ∕N )1D in one direction, it is clear that decreasing the integral scale L (for a periodic mesh, by decreasing its size) or increasing the number of mesh points N, allows us to capture smaller and smaller flow scales.

Since the TGV flow transitions to turbulence at a certain time, we would hope to capture the smallest turbulent length scales with our mesh. The smallest length scale η in one direction, as defined by Kolgomorov is:

-η ≈ Re- 3∕4
L
(2.1)

Then the number of points required for a homogeneous mesh in 3D to capture the Kolgomorov scales is (with L = O(1)):

       (L )3   (   3∕4)3      9∕4
N3D  =  -η   =  Re      = Re
(2.2)

Thus, for flow simulations of the TGV, which are usually run at Re = 1600, the number of uniform mesh points required to capture the smallest turbulent length scales is 16,190,861. The discretisation used in the current tutorial of N3D = 643 = 262,144 points does not have enough resolution to resolve these scales, and neither does the case with N3D = 1283 = 2,097,152 points, left as an exercise. The case with N3D = 2563 = 16,777,216 points would be sufficient but to simulate the flow with such a fine mesh requires the aid of a larger parallel computer, given the much larger memory requirements of the computation. When the flow is underresolved some stabilisation is typically required and this is why we will use a technique known as spectral vanishing viscosity for the lower resolution runs.

As mentioned above, the mesh used in this tutorial is a uniform square mesh of length -π ≤ x,y ≤ π (L = 1) containing 64 square elements, each with a spectral/hp expansion basis of order 8. This 2D mesh is then expanded in the z-direction to compute the quasi-3D flow. The homogeneous z-direction will be discretised using 64 planes. Boundary and initial conditions are also applied. The latter will be described in the following section. As for the former, given the periodic nature of the flow, periodic boundary conditions are applied on all edges of the mesh. The 2D meshes 64 and 128, showing all quadrature points, are shown in Fig. 2.1:


PIC
PIC

Figure 2.1 642 and 1282 element meshes.


Initial Conditions

We are solving an initial value problem and in order to march the problem forward in time we need to prescribe initial conditions for all variables. For this case the initial conditions correspond to the TGV flow, given by:

u(x,y,z,t = 0) = V 0 sin (x )
 L-cos( y)
  L-cos(z )
 L-,
v(x,y,z,t = 0) = -V 0 cos( x )
  --
  Lsin (y )
 --
 Lcos( z)
  --
  L
 w(x,y,z,t = 0) = 0,
P(x,y,z,t = 0) = 0.


PIC PIC

Figure 2.2 u and v velocity components on the z = 0 plane at t = 0 using the 643 elements mesh.



PIC PIC

Figure 2.3 z-vorticity on the surface z = 0 at t = 0 and vorticity iso-surfaces at t = 0 on the 643 volume domain.


The u and v velocity components of the vector field are shown in Fig 2.2. Note how these fields are formed by contiguous patches of velocity of same magnitude and opposed direction. The resulting flow, when both velocity fields are combined, is presented in Fig. 2.3 as vorticity contours. The vortical flow is formed by contiguous pairs of counter-rotating vortices, with strength Γ and -Γ.

Chapter 3
Configuring and Running the Solver

We will now proceed to set up the .xml file with the solver characteristics and parameters to run the simulation, using the case with 643 as guidance. The settings for the 1283 are very similar, and it will be specified if otherwise.

The files required can be found under the folder $NEKTUTORIAL/solver64. The file TGV64_conditions.xml must be modified to set up the solver. Also in the same folder, TGV64_mesh.xml contains the definition of the mesh and the expansion bases that will be used for the computation.

Tip: The geometry contained in TGV64_mesh.xml under the section GEOMETRY is compressed in binary Base64 format. In case the user wants to see its definition, the file must be converted to an uncompressed format by the command:

$NEK/NekMesh TGV64_mesh.xml TGV64_mesh.xml:xml:uncompress

The tag EXPANSIONS defines the type of polynomial expansions to be used on each element, and their order (NUMMODES= p + 1) as well as the FIELDS and COMPOSITES to which they are applied (in this case the whole domain C[0]).

The following sections all refer to modifications in the file TGV64_conditions.xml.

Parameters

The TGV case will be run at Re = 1600 with integral length scale L = 1 and initial velocity V 0 = 1 so that the kinematic viscosity ν = 1∕1600. The temperature field is not included in the computations since it doesn’t influence the dynamics of the fluid. The physical time of the computation is based on the convective time scale tc = L∕V 0 = 1 and will be τ = 20tc, with the first turbulent structures starting to build up at τ = 8tc = 8.

Task: 3.1 In the file TGV64_conditions.xml under the tag PARAMETERS, define all the flow parameters for the TGV flow as described above. These are declared as: Re, Kinvis, V0, L and FinalTime. Define the number of steps NumSteps as the ratio of the FinalTime to the time-step TimeStep.

These parameters apply for both 643 and 1283. Remember to set the parameters following the typical XML syntax:

1<PARAMETERS> 
2   <P> [KEY] = [VALUE] </P> 
3   ... 
4</PARAMETERS>

Note that expressions using a previously defined KEY can be inputted as a VALUE.

Once the flow parameters have been defined, we must define the discretisation in the homogeneous z-direction. Since we are interested in determining the flow on a cubic mesh, the length of the domain along the z-direction will also be Lz = 2π (not to be confused with the integral length scale, L). We must also specify the number of Fourier planes we are going to discretise our z-direction into. For a fully uniform mesh, we then choose Nz = 64 or 128, depending on the case that we are running. This corresponds to 32 or 64 complex Fourier modes, respectively.

Additionally, we also enable the spectral vanishing viscosity (SVV) feature which acts to dampen high-frequency oscillations in the solution which would otherwise introduce numerical instability.

Task: 3.2 In the file TGV64_conditions.xml under the tag PARAMETERS, define all the solver parameters for the homogeneous z-direction discretisation as described above. These include:

These parameters also apply for both 643 and 1283, except for Nz which must be set to 128 instead for the latter case. Note that π can be used directly with the keyword PI.

Solver Properties

We now declare how the flow will be solved. We will use the Velocity Correction Scheme (VCS) to solve the components of the unsteady Navier-Stokes equations separately, rather than as one single system. We must also specify the time integration method, which will be explicit-implicit of order 2, and the approach to be used when solving linear matrix systems of the form Ax = b that arise from the VCS scheme. Finally, we must describe how the homogeneous z-direction will be treated in the quasi 3D approach.

Task: 3.3 In the file TGV64_conditions.xml under the tag SOLVERINFO, define all the solver properties. These include:

These properties apply for both 643 and 1283 cases. Remember to set the property/value pairs following the typical XML syntax:

1<SOLVERINFO> 
2   <I PROPERTY="[STRING]" VALUE="[STRING]" /> 
3   ... 
4</SOLVERINFO>

Boundary and Initial Conditions

The periodic boundary conditions for the domain are already defined for the user in the .xml file, under the tag BOUNDARYCONDITIONS. The initial conditions can be prescribed to the solver by means of a standard function.

Task: 3.4 In the file TGV64_conditions.xml, within the CONDITIONS section, create a function named InitialConditions where the initial conditions for the variables u, v, w and P are defined. Go back to Chapter 1 if you don’t remember the expressions for the initial conditions.

Multi-variable functions such as initial conditions and analytic solutions may be specified for use in, or comparison with, simulations. These may be specified using expressions (<E>)

1<FUNCTION NAME="[NAME]"> 
2   <E VAR="[VARIABLE_1]" VALUE="[EXPRESSION]"/> 
3   <E VAR="[VARIABLE_2]" VALUE="[EXPRESSION]"/> 
4   ... 
5</FUNCTION>

Filters

Turbulent flows, as is the TGV flow, have very high diffusivity. The random and chaotic motion of the fluid particles results in an increased momentum and mass convection as well as heat transfer, with the flow composed of fluid structures with a wide range of length scales. The large, energy-containing fluid structures inertially break down into smaller and smaller structures by vortex stretching, with an associated kinetic energy transfer between the scales. When these small fluid structures are of the size of the Kolgomorov length scales η, molecular viscosity becomes substantial and dissipates the kinetic energy into heat. As such, a good way of characterising turbulent flows is via the evolution of the kinetic energy or, more appropriately, via its dissipation rate.

Task: 3.5 In the file TGV64_conditions.xml, within the FILTERS section, create two filters:

1<FILTER TYPE="TypeName"> 
2   <PARAM NAME="OutputFile">FileName</PARAM> 
3   <PARAM NAME="OutputFrequency">10</PARAM> 
4</FILTER>

Running the Solver

If you have not completed Task 1.2 or would like to test your configuration, the IncNavierStokesSolver can now be run with the XML files above to solve the TGV problem.

Task: 3.6 Run the solver by typing the following command on the command line:

$NEK/IncNavierStokesSolver TGV64_mesh.xml TGV64_conditions.xml

Tip: To reduce the solution time on computers with multi-core, or multiple, processors, MPI can be used to run the simulation in parallel. Note that, for binaries compiled from source, the CMake option NEKTAR_USE_MPI must have been set to ON. To run in parallel, prefix the command in the previous task with mpirun -np X, replacing X by the number of parallel processes to use. For example, to use two processes:

mpirun -np 2 $NEK/IncNavierStokesSolver TGV64_mesh.xml TGV64_conditions.xml

Additionally, setting GlobalSysSoln to XxtMultiLevelStaticCond (Task 3.3) will specify that a parallel Cholesky factorisation will be used to directly solve the global linear systems using the XXT library.

Chapter 4
Simulation Results

You will now have to post-process the files in order to see the results of the simulation. You may either use output files of your recent run or those provided in the folder completed/solver64. Amongst the output files, you can find the checkpoint files .chk and final file .fld that contain the state of the simulation at each time step; the modal energy file .mdl containing the energy spectrum of the Fourier modes; and the energy file .eny with the evolution of the kinetic energy and the enstrophy. Note that the folder completed/solver64 does not contain .chk files.

Both energy files are easily post-processed and can be converted to the MATLAB readable format .dat, just by changing the file extension. The checkpoint files however, must be converted to a standard visualisation data format so that they are readable with Paraview or other visualisation software.

Task: 4.1 In the folder solver64, which contains the checkpoint files, type the command:

$NEK/FieldConvert -m vorticity TGV64_mesh.xml TGV64_mesh_0.chk TGV64_mesh_0.vtu

This command will convert the file to the VTK visualisation format and will also calculate the vorticity throughout the volume. Note that it only converts one checkpoint file at a time. A shell script could be used to convert as many files as desired. This command may also be used on the .fld file.

The evolution of the kinetic energy of the flow is obtained by integrating the square of the velocity norm over the domain. Similarly, the enstrophy is calculated by integrating the square of the vorticity norm over the domain:

            ∫                                   ∫
      --1---      2                       --1---      2
Ek  = 2μ(Ω ) Ω ∥u∥ dx                ζ =  2μ(Ω)  Ω∥ω ∥ dx
(4.1)

The enstrophy is a measure of the intensity of the vorticity and is related to dissipation effects of the flow. More precisely, under the assumption of incompressible flow, the enstrophy is related to the kinetic energy dissipation rate, ϵ, via the equation on the left. It is also defined as the rate of change of the kinetic energy, the equation on the right:

                             dEk-
ϵ = 2νζ                 ϵ = - dt
(4.2)

Therefore, the dissipation rate can be calculated both from the enstrophy and numerically from the evolution of the kinetic energy. From the modal energy file, it is possible to evaluate the energy spectrum of the Fourier modes. This will in turn be helpful to identify what length scales carry the most energy. After post-processing the energy files on MATLAB, you should be able to produce the following figures, which depict the time evolution of the kinetic energy and enstrophy of the flow, as well as the evolution of the dissipation rate (both computed and enstrophy-based) and the energy spectrum:


PIC PIC

Figure 4.1 Time evolution of the kinetic energy (left) and enstrophy (right).



PIC PIC

Figure 4.2 Time evolution of numerically computed and enstrophy-based dissipation rates (left) and time evolution of the energy spectrum of the fourier modes (right).


Tip:

The data may be plotted using the freely available gnuplot package, widely available on Linux systems. Example gnuplot files are provided in the folders completed/solver64 and completed/solver164. Such files can be run with the simple command:

gnuplot TGV64Energy.gnuplot

The time evolution of the kinetic energy is well predicted by the spectral, quasi-3D computation. Since no force is applied to the fluid, the initial kinetic energy in the flow is progressively dissipated, with the dissipation rate peaking at around τ ≈ 9 when the turbulent fluid structures are formed. This is consistent with the enstrophy. The enstrophy, which is a measure of how vortical the flow is, peaks at the same time as the dissipation rate, τ ≈ 9: vortex stretching increases vorticity in the stretching direction and reduces the length scale of the fluid structures. Hence, when vorticity is at its highest, the flow is dominated by these small structures, which are responsible for the main viscous dissipation effects. The discrepancy between the numerically computed and enstrophy-based dissipation rates is directly related to the resolution of the mesh. The enstrophy-based dissipation rate being lower than the numerically calculated one means that, in the simulation, not all of the dissipation is due to the vorticity present in the flow. The low resolution of the mesh accentuates the numerical diffusion present in the spectral/hp element method and is the reason for the discrepancy.

Finally, from the evolution of the energy spectrum of the Fourier modes it is possible to infer how the flow behaves. Initially, all the energy is contained in the smallest wavenumbers, meaning that the flow is dominated by the large length scales. As time passes, the energy is progressively transferred to smaller and smaller scales (larger wavenumber). This energy in the small scales peaks between τ = 8 and τ = 10, when the flow is fully turbulent, and then dies out for all wavenumbers due to dissipation. This process is depicted in the figures below, through the z-component of the vorticity.


PIC (a) τ=3, Laminar vortex sheets

PIC (b) τ=5, Vortex stretching

PIC (c) τ=7, Rearrangement

PIC (d) τ=8, Breakdown

PIC (e) τ=9, Fully turbulent

PIC (f) τ=12, Dissipation and decay

Figure 4.3 Time evolution of z-vorticity isosurfaces


Advanced Task: 4.2 Running the simulation with a mesh of 1283 is a bit more computationally expensive and it is left as an optional exercise. If you do run this simulation, extract the information from the energy files and plot the time evolution of the kinetic energy, enstrophy and dissipation rate for both cases under the same graphs. Establish a qualitative and quantitave comparison between the results of using different resolutions to resolve the Taylor-Green Vortex flow.

This completes the tutorial.