Theory and Background¶
HONEE solves the time-dependent Navier-Stokes equations of compressible gas dynamics in a static Eulerian three-dimensional frame using unstructured high-order finite/spectral element spatial discretizations and explicit or implicit high-order time-stepping (available in PETSc). Moreover, the Navier-Stokes example has been developed using PETSc, so that the pointwise physics (defined at quadrature points) is separated from the parallelization and meshing concerns.
Boundary Conditions¶
Synthetic Turbulence Generation (STG)¶
We use the STG method described in [SSST14]. Below follows a re-description of the formulation to match the present notation, and then a description of the implementation and usage.
Equation Formulation¶
Here, we define the number of wavemodes \(N\), set of random numbers \( \{\bm{\sigma}^n, \bm{d}^n, \phi^n\}_{n=1}^N\), the Cholesky decomposition of the Reynolds stress tensor \(\bm{C}\) (such that \(\bm{R} = \bm{CC}^T\) ), bulk velocity \(U_0\), wavemode amplitude \(q^n\), wavemode frequency \(\kappa^n\), and \(\kappa_{\min} = 0.5 \min_{\bm{x}} (\kappa_e)\).
where \(l_t\) is the turbulence length scale, and \(d_w\) is the distance to the nearest wall.
The set of wavemode frequencies is defined by a geometric distribution:
The wavemode amplitudes \(q^n\) are defined by a model energy spectrum \(E(\kappa)\):
\(\kappa_\eta\) represents turbulent dissipation frequency, and is given as \(2\pi (\nu^3/\varepsilon)^{-1/4}\) with \(\nu\) the kinematic viscosity and \(\varepsilon\) the turbulent dissipation. \(\kappa_\mathrm{cut}\) approximates the effective cutoff frequency of the mesh (viewing the mesh as a filter on solution over \(\Omega\)) and is given by:
The enforcement of the boundary condition is identical to the blasius inflow; it weakly enforces velocity, with the option of weakly enforcing either density or temperature using the -weakT
flag.
Initialization Data Flow¶
Data flow for initializing function (which creates the context data struct) is given below:
flowchart LR subgraph STGInflow.dat y lt[l_t] eps Rij[R_ij] ubar end subgraph STGRand.dat rand[RN Set]; end subgraph User Input u0[U0]; end subgraph init[Create Context Function] ke[k_e] N; end lt --Calc-->ke --Calc-->kn y --Calc-->ke subgraph context[Context Data] yC[y] randC[RN Set] Cij[C_ij] u0 --Copy--> u0C[U0] kn[k^n]; ubarC[ubar] ltC[l_t] epsC[eps] end ubar --Copy--> ubarC; y --Copy--> yC; lt --Copy--> ltC; eps --Copy--> epsC; rand --Copy--> randC; rand --> N --Calc--> kn; Rij --Calc--> Cij[C_ij]
This is done once at runtime. The spatially-varying terms are then evaluated at each quadrature point on-the-fly, either by interpolation (for \(l_t\), \(\varepsilon\), \(C_{ij}\), and \(\overline{\bm u}\)) or by calculation (for \(q^n\)).
The STGInflow.dat
file is a table of values at given distances from the wall.
These values are then interpolated to a physical location (node or quadrature point). It has the following format:
[Total number of locations] 14
[d_w] [u_1] [u_2] [u_3] [R_11] [R_22] [R_33] [R_12] [R_13] [R_23] [sclr_1] [sclr_2] [l_t] [eps]
where each [ ]
item is a number in scientific notation (ie. 3.1415E0
), and sclr_1
and sclr_2
are reserved for turbulence modeling variables.
They are not used in this example.
The STGRand.dat
file is the table of the random number set, \(\{\bm{\sigma}^n, \bm{d}^n, \phi^n\}_{n=1}^N\).
It has the format:
[Number of wavemodes] 7
[d_1] [d_2] [d_3] [phi] [sigma_1] [sigma_2] [sigma_3]
The following table is presented to help clarify the dimensionality of the numerous terms in the STG formulation.
Math |
Label |
\(f(\bm{x})\)? |
\(f(n)\)? |
---|---|---|---|
\( \{\bm{\sigma}^n, \bm{d}^n, \phi^n\}_{n=1}^N\) |
RN Set |
No |
Yes |
\(\bm{\overline{u}}\) |
ubar |
Yes |
No |
\(U_0\) |
U0 |
No |
No |
\(l_t\) |
l_t |
Yes |
No |
\(\varepsilon\) |
eps |
Yes |
No |
\(\bm{R}\) |
R_ij |
Yes |
No |
\(\bm{C}\) |
C_ij |
Yes |
No |
\(q^n\) |
q^n |
Yes |
Yes |
\(\{\kappa^n\}_{n=1}^N\) |
k^n |
No |
Yes |
\(h_i\) |
h_i |
Yes |
No |
\(d_w\) |
d_w |
Yes |
No |
Runtime Options¶
To use the STG boundary condition, the -bc_inflow
option should be set to the boundary faces that need the inflow (see Boundary conditions).
The -stg_use
flag is then used to enable/disable applying STG to those faces.
Option |
Description |
Default value |
Unit |
---|---|---|---|
|
Enable STG for |
|
|
|
Path to the STGInflow file |
|
|
|
Path to the STGRand file |
|
|
|
Growth rate of the wavemodes |
|
|
|
Convective velocity, \(U_0\) |
|
|
|
Only impose the mean velocity (no fluctutations) |
|
|
|
Strongly enforce the STG inflow boundary condition |
|
|
|
“Extrude” the fluctuations through the domain as an initial condition |
|
|
|
Set the element size in the x direction. Default is calculated for box meshes, assuming equispaced elements. |
|
|
|
Scale element size for cutoff frequency calculation |
\(1/p\) |
Internal Damping Layer (IDL)¶
Note
IDL is not a boundary condition, but it’s primary application is for use with STG.
The STG inflow boundary condition creates large amplitude acoustic waves. We use an internal damping layer (IDL) to damp them out without disrupting the synthetic structures developing into natural turbulent structures. This implementation was inspired by [SSST14], but is implemented here as a ramped volumetric forcing term, similar to a sponge layer (see 8.4.2.4 in [Col23] for example). It takes the following form:
where \(\bm{Y}' = [P - P_\mathrm{ref}, \bm{0}, 0]^T\), and \(\sigma(\bm{x})\) is a linear ramp starting at -idl_start
with length -idl_length
and an amplitude of inverse -idl_decay_rate
.
The damping is defined in terms of a pressure-primitive anomaly \(\bm Y'\) converted to conservative source using \(\partial \bm{q}/\partial \bm{Y}\rvert_{\bm{q}}\), which is linearized about the current flow state.
\(P_\mathrm{ref}\) has a default value equal to -reference_pressure
flag, with an optional flag -idl_pressure
to set it to a different value.
Option |
Description |
Default value |
Unit |
---|---|---|---|
|
Characteristic timescale of the pressure deviance decay. The timestep is good starting point |
|
|
|
Start of IDL in the x direction |
|
|
|
Length of IDL in the positive x direction |
|
|
|
Pressure used for IDL reference pressure |
|
|