MAIA bb96820c
Multiphysics at AIA
|
Subsonic fully reflecting characteristic inflow condition - cut off.
writes the resulting cut surfacs (polygons) as .vtk-file
MBool FvBndryCndXD::m_complexBoundaryMB
default = 0
This property triggers if complex boundaries should be considered in MB solver, i.e., cut cells are based on information from multiple level-set functions
possible values are:
Keywords: MOVING BOUNDARY, MULTIPLE LEVEL SET FUNCTIONS
MFloat FvBndryCndXD::m_Bc3011WallTemperature
default = (1 + 0.5(gamma - 1) * M_infinity^2)^(-1)
This property sets the wall temperature T/T_0 of the finite-volume isothermal wall boundary codition 3011:
Keywords: FINITE VOLUME, BOUNDARY CONDITIONS
MBool FvBndryCndXD::m_sigmaNonRefl
default = 1.0
Damping coefficient for partially reflecting boundary conditions cbc3091a, cbc1099_1091_local possible values are:
Keywords: FV, BOUNDARY, BC, NONREFLECTING
MBool FvBndryCndXD::m_sigmaNonReflInflow
default = 1.0
Damping coefficient for subsonic partially reflecting characteristic turbulent inflow condition cbc3091a possible values are:
Keywords: FV, BOUNDARY, BC, NONREFLECTING
MBool FvBndCnd::m_createBoundaryAtCutoff
default = false
Enables/Disables the use of cutoff boundaries; if true, the ids of the cutoff Boundarys have to be set (cutOffBndryIds)
Possible values are:
Keywords: FINITE_VOLUME, CUTOFF, BOUNDARIES
MBool FvBndCnd::m_volumeLimitWall
default = false
Check the small cell clusters. If a cluster has a volume big enough to be computed as a regular cell (security factor: 2 * volumeLimitWall), the biggest cell will be the master and looses its small state. Possible values are:
Floating point value above 0.0
Keywords: FINITE_VOLUME, CUTOFF, BOUNDARIES
MBool FvBndCnd::m_smallCellRHSCorrection
default = false
Activates the newly developed smallCellRHSCorrection method and deactivates the previous small cell correction method
Floating point value above 0.0
Keywords: FINITE_VOLUME, CUTOFF, BOUNDARIES
MInt FvBndryCndXD::m_multipleGhostCells
default = 0
The property is used to trigger the boundary handling for complex boundaries. Basically, a zero value indicates that only one ghost cell per cut cell is allowed. For other values, see below (more than one cut surface per boundary cell -> multiple ghost cells are used).
possible values are:
0
(only one ghost cell per cut cell -> original formulation (see Hartmann papers)) 1
(complex boundaries with multiple ghost cells (simple formulation, see Eccomas paper Claudia Guenther) <- do not use this!) 2
(complex boundaries with multiple ghost cells (MGC formulation, see Eccomas presentation Claudia Guenther) <- use this!) Keywords: FINITE_VOLUME, COMPLEX_BOUNDARIES
MInt FvBndryCndXD::m_ipVariableIterative
default = 0
The property is used to control the boundary handling (only valid with multipleGhostCells == 2). If zero, the image point variables in multiple ghost cells formulation are not computed iteratively, otherwise, they are computed iteratively. The max. number of iterations is given in noImagePointIterations.
possible values are:
0
(not iterative) 1
(iterative) Keywords: FINITE_VOLUME, COMPLEX_BOUNDARIES
MInt FvBndryCndXD::m_noImagePointIterations
default = 10
The property is used to control the max. number of iterations if ipVariableIterative is turned on (=1). See ipVariableIterative.
possible values are:
Keywords: FINITE_VOLUME, COMPLEX_BOUNDARIES
MInt FvBndryCndXD::m_surfaceGhostCell
default = 0
The property is used to control the location of the ghost cell on the boundary surface or away from it (mirroring). Only valid with multipleGhostCells == 2. See also multipleGhostCells.
possible values are:
0
(ghost cell is located as usual (away from the surface)) 1
(ghost cell is located on the surface) Keywords: FINITE_VOLUME, COMPLEX_BOUNDARIES
MInt FvBndryCndXD::m_surfaceGhostCell
default = 0
The property is used to trigger if imagePoints and ghostPoints are plotted as .vtk-file. Only valid with multipleGhostCells == 2. See also multipleGhostCell.
possible values are:
0
(off) 1
(on) Keywords: FINITE_VOLUME, COMPLEX_BOUNDARIES, INPUT_OUTPUT
MInt FvCartesianSolverPar::m_maxNoBndryCells
default = ""
Maximum number of boundary cells to be allocated. (Used for the cut-cell computation and the small- and sorted boundary-cell allocation)
Keywords: FINITE_VOLUME, ALLOCATION, GENERAL
MInt FvBndryCndXD::m_maxNoBndryCndIds
default = 0
Maximum number of boundary condition Ids, mainly used to allocate memory related to boundary conditions
Keywords: FINITE_VOLUME, BOUNDARY CONDITION
MInt FvBndryCndXD::m_cellMerging
Activates Cell Merging but is used everywhere as if (!m_cellMerging)...
default = 0
Keywords: FINITE_VOLUME, BOUNDARY CONDITION
MInt FvBndryCndXD::m_secondOrderRec
default = 1 (true)
Activates the second order reconstruction Keywords: FINITE_VOLUME, BOUNDARY CONDITION
MInt FvBndryCndXD::m_noFluxRedistributionLayers
Number of cell layers across which to redistribute the flux imbalance of small cut-cells when noCellMergin = 1. default = 2
Keywords: FINITE_VOLUME, BOUNDARY CONDITION
MBool FvBndryCnd::m_jetInletTurbulence
default = false
Activates jet inlet turbulence for random-eddy inflow boundary conditions, which introduces velocity fluctuations at the boundary. Keywords: FINITE_VOLUME, BOUNDARY CONDITION
cutOffBndryIds
default = none
Create cut off boundary with the respective bndryId. Only works together with property cutOffDirections
Keywords: FINITE_VOLUME, CUTOFF
cutOffDirections
default = none
Create cut off boundary at the respective border of the domain (0: create cut off bndry in -x direction, and so on). Only works together with property cutOffBndryIds
Keywords: FINITE_VOLUME, CUTOFF
MInt FvBndryCndXD<nDim,SysEqn>::m_clusterCutOffBcs
default = 0
Enables/Disables the clustering of the boundary conditions
Possible values are:
Keywords: FINITE_VOLUME, BOUNDARIES
MFloat Bc1601Class::m_bc1601Lb
no default
Length scale L_b for random-eddy inflow bc1601
Keywords: FINITE_VOLUME
MFloat Bc1601Class::m_noOfModes
default = 0
Sets the number of random modes for random-eddy inflow bc1601
Keywords: FINITE_VOLUME
MFloat Bc1601Class::m_oldMode
default = 0
Sets old mode for random-eddy inflow bc1601
Keywords: FINITE_VOLUME
MBool FvBndryCndXD::bc1601CommValues
default = false
In the boundary condition 1601, in case of multisolver,
the random numbers from solver 0 are broadcast to all solvers
Keywords: FINITE_VOLUME
MInt FvBndryCndXD::m_useUnif
default = 0 (false)
In the boundary condition 1601 use the value of U_infinity as reference velocity. Keywords: FINITE_VOLUME
MInt Bc1601Class::m_regenerateSeeding
Controls the generation and communication of random numbers. default = 0
Keywords: FINITE_VOLUME, RANDOM SEEDS
MInt Bc1601Class::m_regenerationInterval
default = 10
interval to regenerate random number for bc1601 Possible values are:
Keywords: bc1601
MFloat Bc1601Class::uuref
default = 0.0
for all
These values represent constant reference values for the Reynolds stress tensor
in the random-eddy inflow bc1601.
Keywords: FINITE_VOLUME
MInt FvBndryCndXD::Bc1601Class::smirnov
default = 0
Defines if Shin method is used for turbulence injection.
Possible values are;
Keywords: FINITE_VOLUME, SYNTHETIC TURBULENCE, BC1601
MInt* FvBndrycndXd::m_modeType
default = none
A list of integers defining disturbances, i.e., plane entropy or acoustic waves, superimposed to the freestream
Possible values are:
Keywords: TUNNEL NOISE, RECEPTIVITY, bc2800
MFloat* FvBndrycndXd::m_modeAmp
default = none
A list of doubles defining the amplitude of the disturbances in modeType, must have the same length as modeType
Possible values are:
Keywords: TUNNEL NOISE, RECEPTIVITY, bc2800
MFloat* FvBndrycndXd::m_modePhi
default = none
A list of phase differences of the disturbances in modeType with respect to the lowest argument found in the computational domain, must have the same length as modeType
Possible values are:
Keywords: TUNNEL NOISE, RECEPTIVITY, bc2800
MFloat** FvBndrycndXd::m_modeK
default = none
A list of angles for the plane waves of modeType with respect to the x axis (as angle for the flow), must have twice the length as modeType
Possible values are:
Keywords: TUNNEL NOISE, RECEPTIVITY, bc2800
MInt* FvBndrycndXd::m_nmbrOfModes
default = none
A list of number of oscillations (0 to 2*pi) of the plane waves from modeType, must have the same length as modeType
Possible values are:
Keywords: TUNNEL NOISE, RECEPTIVITY, bc2800
MInt* FvBndrycndXd::m_modeSr
default = none
In case of cartesian periodicity, a List of integers defining the number of wave length to fit into the width of the periodic domain for the plane waves of modeType, must have the same length as modeType, see modeSr
Possible values are:
Keywords: TUNNEL NOISE, RECEPTIVITY, bc2800
MFloat* FvBndrycndXd::m_modeSr
default = none
List of Strouhal numbers (nondimensional frequency build with the freestream velocity and m_referenceLength) for the plane waves of modeType, must have the same length as modeType
In case of cartesian periodicity, the Strouhal numbers are calculated from the wave vector and the width of the periodic domain
Possible values are:
Keywords: TUNNEL NOISE, RECEPTIVITY, bc2800
MFloat** FvBndrycndXd::m_modeK
default = none
A list of angles for the plane waves of modeType with respect to the x axis (as angle for the flow)
Possible values are:
Keywords: TUNNEL NOISE, RECEPTIVITY, bc2800
MBool MGCPreferWallBoundaries
default = false
For MGC, enables/disables preferring Wall boundary surfaces when determining the master cell to which the current small cut-cell should be linked.
Possible values are:
Keywords: FINITE VOLUME, BOUNDARY CONDITIONS, MGC, TINA, SUZI
void FvBndryCndXD::computeCutPoints
default = 0
This trigger enables a cut point correction for grid refinement jumps along boundaries. Split cells and multiple ghost cells are not supported. Possible values are:
Keywords: CUT_POINTS, BOUNDARY_REFINEMENT
FvBndryCnd3D::bc10910::bcProperty
default = none
Boundaries for which special cut cells should be computed where
a sharp edge should be preserved.
Keywords: FINITE_VOLUME, BOUNDARY
FvBndryCnd3D::bc10910:referencePointProperty
default = none
inflow correction centers for boundaries for which special
cut cells should be computed where
a sharp edge should be preserved.
Keywords: FINITE_VOLUME, BOUNDARY
MInt FvBndryCnd3D::m_bc1601MoveGenOutOfSponge
default = 0 (false)
Moves the bc1601 by the spongeLayerThickness into the domain. Keywords: FINITE_VOLUME
MInt FvCartesianSolver::m_besselModes
default = 0
switches from plane incident waves to oblique axisymmetric waves
possible values are:
Keywords: RECEPTIVITY, TUNNEL NOISE,
MInt FvBndryCndXD::m_noShockBcCells>
default = 21
Number of cells for the shock solution at the boundary, in BC-2770.
Keywords: FINITE_VOLUME, BOUNDARY CONDITION
MBool FvBndryCndPar::m_shockFromInnerSolution
default = "0"
Triggers whether the solution is copied from an inner shock region (=1) or the boundary shock region (=0) at cut off cells with shock regions.
Keywords: FINITE_VOLUME, BOUNDARY CONDITION
MFloat FvBndryCnd2/3D::m_sigmaShock
default = none
Defines the value of the shock angle at the boundary in [deg].
Possible values are:
Keywords: FINITE VOLUME, BOUNDARY CONDITION, SHOCK WAVE
MFloat FvBndryCnd2/3D::m_ys
default = none
y-coordinate of an oblique shock wave imposed at the boundary of the domain.
Possible values are:
Keywords: FINITE VOLUME, BOUNDARY CONDITION, SHOCK WAVE
MFloat FvBndryCndXD::m_srf
default = 4
shock region factor defining the compression factor from the analytic shock to m_noShockBcCells cells.
srf = 1 is all over m_noShockBcCells, srf = 2 is m_noShockBcCells/2 and so on.
Possible values are:
Keywords: FINITE VOLUME, BOUNDARY CONDITION, SHOCK WAVE
MInt zCoordFor2DInterpolation
default = 0
BlaBlaBlub.
Possible values are:
Keywords: INTERPOLATION, IO, FINITE_VOLUME
no 2D-version available yet! moved here from fvmbbndrycnd3d!
MInt FvBndryCnd3D::interpolationFactor
default =
Sets the inOutInterpolationFactor
Possible values are:
Keywords: FINITE VOLUME, MOVING BOUNDARY,
void FvBndryCnd3D::createCutFace
default = 0
This trigger enables a cut point correction for grid refinement jumps along boundaries. Split cells and multiple ghost cells are not supported. Possible values are:
Keywords: CUT_POINTS, BOUNDARY_REFINEMENT
needs the fvlookuptable.h cell structure is determined based on a modified marching cubes algorithm
is able to handle split cells and cells with ambiguous MC states if compiled with #define plotall, the complete surface is plottet otherwise, only the cells with ambigous states are plotted
IMPORTANT: after this method is called, the cells can not be processed further! Program has to be stopped!
featureEdges has stored length 2*noFeatureEdges points (each edge has start and end point)
writes a .vtk file of the points in intersectionPoints
noIntersectionPoints is an array where the entry [i] gives the number of intersectionPoints on the i-th face of a cell intersectionPoints is an array which holds the intersectionPoints; first index: face, second index: i-th intersection Point on this face
writes the nodes in nodeList in a .stl file
writes the triangle given by A, B, C and normal in the stl-format in the ofstream
subtracts vector b from vector a and returns the result in vector res
multiplies vector a with the scalar value s and returns the result in res
computes area and centroid of a triangle given by the points abc
computes area, centroid and normal of a triangle given by the points abc
normal is -((b-a) x (c-a)) -> careful!
computes area, centroid and normal of a trapezoid given by the points abcd
normal is -((b-a) x (c-a)) -> careful!
order of the points should be in the mathematically correct sense of rotation if the normal defined by -((b-a)x(c-a)) points in the computational (fluid) domain
computes area, centroid and normal of a 3-point polygon given by the points abc
normal is -((b-a) x (c-a)) -> careful!
order of the points should be in the mathematically correct sense of rotation if the normal defined by -((b-a)x(c-a)) points in the computational (fluid) domain
computes area, centroid and normal of a 4-point polygon given by the points abcd
normal is -((b-a) x (c-a)) -> careful!
order of the points should be in the mathematically correct sense of rotation if the normal defined by -((b-a)x(c-a)) points in the computational (fluid) domain
computes area, centroid and normal of a 5-point polygon given by the points abcde
normal is -((b-a) x (c-a)) -> careful!
order of the points should be in the mathematically correct sense of rotation if the normal defined by -((b-a)x(c-a)) points in the computational (fluid) domain
computes area, centroid and normal of a 6-point polygon given by the points abcdef
normal is -((b-a) x (c-a)) -> careful!
order of the points should be in the mathematically correct sense of rotation if the normal defined by -((b-a)x(c-a)) points in the computational (fluid) domain
computes the volume and centroid of a tetrahedron given by the points abcd
computes the volume and centroid of a pyramid build of a base face (area, center base_centroid) and a point M
corrects area and centroid of a cut face; area_0 and centroid_0 correspond to the original, non-cut face
returns area and centroid of the "other" part of the original cartesian face; input parameters: area and centroid of the first part of the cut face area0 and centroid0 of the non-cut face return parameters: area and centroid of the second part of the cut face (overwritten)
corrects volume and centroid of a cut cell; volume_0 and centroid_0 correspond to the original, non-cut cell
returns volume and centroid of the "other" part of the original cartesian cell; input parameters: volume and centroid of the first part of the cut cell volume0 and centroid0 of the non-cut cell return parameters: volume and centroid of the second part of the cut cell (overwritten)
returns the input vector pointing in the opposite direction
corrects cells located on interface bcId/wall such that bcId plane is conserved
needs the normal of the bcId surface (should be planar in original geometry description!) and a point located in this plane (basePoint).
cutCells have to be previously computed with createCutFaceMGC
method is based on createCutFaceMGC if volume of corrected cells should be decreased, variables 'inside' has to be changed to false (see initialization)
"hull" method for correctInflowBoundary(MInt, MFloat*&, MFloat*&) when meanNormal and basePoint are not previously known
computes the mean normal to the surface with the boundary condition bcId (surface should be planar in .stl geometry
description!) and a reference point located in this plane (should correspond to the midpoint) and then calls correctInflowBoundary(MInt, MFloat*&, MFloat*&) with these parameters
computes the intersection points of the feature edges with the target face (normal to dir)
input: target: three points that span the face which should be examined featureEdges: the feature edges identified for the respective cell (contains 2*noFeatureEdges entries, each edge needs start and end point) noFeatureEdges: the number of edges in featureEdges dir: the direction normal to which target is aligned return: intersectionPoints: here, the identified intersectionPoints are stored noIntersectionPoints: here, the number of intersection points found is returned
computes a list of .stl triangle edges which are adjacent to an inlet/outlet and a wall boundary condition
input: noWallNodes: number of nodes in wallNodes wallNodes: a list of the numbers of the nodes which are wall nodes meanNormal: the normal which defines the plane of the inflow/outflow boundary surface basePoint: a point in the inflow/outflow normal, preferably the midpoint
return: noFeatureEdges: the number of identified feature edges is returned featureEdges: the feature edges identified for this set are stored here (contains 2*noFeatureEdges entries, each edge has start and end point) a feature edge belongs to a node which is not aligned to the plane normal to meanNormal but the feature edge itself is contained in this plane
computes a list of .stl triangle edges which are adjacent to an inlet/outlet and a wall boundary condition
input: bcId: the boundary condition id which should be conserved as a planar surface (inflow/outflow id) noNodes: number of nodes in nodeList nodeList: list of nodes which should be sorted
return: wallNodes: a list of the numbers of the nodes which are wall nodes noWallNodes: number of nodes in wallNodes inflowNodes: a list of the numbers of the nodes which belong to bcId noInflowNodes: number of nodes in inflowNodes
Computes the reconstruction constants for the interpolation of the image point variables with MGC formulation
If the multiple ghost cells formulation is used where the ghost cells are located normal to the boundary surfaces from the surface centroids, this function is needed to provide the reconstruction stencil for the first interpolation on the image point variables. This interpolation uses the slopes computed on the boundary cell which is based only on regular cells surrounding the respective boundary cell without the ghost cells.
Reconstruction constants are saved per boundary cell in the memory corresponding to the boundary cell/ bndryCondition solver
ONLY 2D VERSIONS
computes centroid and area of a N-point polygon
Initiates CBC boundary conditions
Initialize the small-cell RHS correction for the RHS interpolation method The cell vars are computed using a weighted least squares approach For details see Schneiders,Hartmann,Meinke,Schröder, J.Comput.Phys. 235 (2013) For more details see the dissertation of Lennart Schneiders, "Particle-Resolved Analysis of Turbulent Multiphase Flow by a Cut-Cell Method" Chapter 3.4 If bndryCndId is specified (standard value=-1) only boundary cells corresponding to the stated boundary are initialized
MFloat FvCartesianSolver::cbc1099_1091_engine::dirNormal
default = -2
Specify the vector of the cut-Off bndry Normal, if the bndry does not align with the cartesian direction!
Keywords: CBC, ENGINE, CHARACTERISTIC BNDRY-CONDITION
MBool FvCartesianSolver::m_multilevel
default = 0
Indicates that this solver is part of a multilevel execution. Possible values are:
Keywords: FINITE_VOLUME, MULTILEVEL, MULTIGRID
MBool FvCartesianSolverXD::m_isEEGas
default = false
Enable the FV-component of the coupled LB-FV Euler-Euler method for bubbly flows.
Keywords: EEMultiphase, FINITE_VOLUME
MBool FvCartesianSolver::m_dualTimeStepping
default = false
Activates the dual-time stepping
Possible values are:
0, 1
Keywords: GENERAL
MBool FvCartesianSolver::m_calcSlopesAfterStep
default = 0
Calculate the cell center slopes at the end of each Runge-Kutta stage and not at the start of the next one. This should be activated if the slopes are used outside of the FV time-step loop in order to have the correct derivatives belonging to the current primitive variables. Possible use cases are: averaging of derivatives/vorticity/..., calculation of acoustic source terms for the APE. Possible values are:
Keywords: FINITE_VOLUME, POSTPROCESSING, COUPLING
MBool FvCartesianSolver::m_rotAxisCoord
default = 0.0
Coordinates of the rotational axis for azimuthal perodicity Possible values are:
Keywords: FINITE_VOLUME, FAN, AZIMUTHAL PERIODICITY
MInt FvCartesianSolver::m_maxNoPeriodicCells
default = 0
Maximum number of periodic cells. Used to allocate memory for the periodic cells. Possible values are:
Keywords: FINITE_VOLUME, PERIODIC, MAXIMUM
MBool FvCartesianSolver::m_maxIterations
default = 1
Sets the number of maximum iterations in solutionStep
Possible values are:
Keywords: FINITE_VOLUME
default = 0
Chooses the method in which cells are identified in the azimuthal periodicity concept.
Possible values are:
Keywords: FINITE_VOLUME
MFloat FvCartesianSolver::m_Pr
default = 1.0
WARNING: Do NOT use any value different than 1.0 - The correct implementation of this is not checked, so it probably will not do what you think it does/should do. Don't use it unless you REALLY know what you are doing. Reference Length L - The length = 1.0 of the grid is scaled with L. Possible values are:
Keywords: FINITE_VOLUME, VARIABLES
MFloat FvCartesianSolver::m_Re
default = no default value
Reynolds number is defined with your infinity variables.
In the code the Reynolds number is nondimensionalized to a Reynolds number based on the stagnation variables a_0, mu_0, rho_0
\( Re_{0} = Re_{\infty} \frac{\mu_{\infty}}{\rho_{\infty} Ma \sqrt{T_{\infty}} } = \frac{\rho_0 a_0
l}{\mu_{0}}\):
possible values are:
Keywords: FINITE_VOLUME, VARIABLES
MFloat FvCartesianSolver::m_Pr
default = 0.72
Prandtl number - non-dimensionalized with stagnant flow conditions \( \mu_{0}, \lambda_{0}, c_{p} \): possible values are:
Keywords: FINITE_VOLUME, VARIABLES
MFloat FvCartesianSolver::m_Ma
default = no default value
Mach's number - \( M_{\infty} = \frac{u_\infty}{a_\infty} \): possible values are:
Keywords: FINITE_VOLUME, VARIABLES
MFloat* FvCartesianSolver::m_angle
default = no default value
m_angle[nDim] - Angles of rotation around the z, and y axes. possible values are:
Keywords: FINITE_VOLUME,BOUNDARY CONDITION
MFloat FvCartesianSolver::m_gamma
default = 1.4
Ratio of specific heats - \( \gamma = c_p / c_v \) possible values are:
Keywords: FINITE_VOLUME, VARIABLES
MBool FvCartesianSolver::m_considerVolumeForces
default = false
Enables volume forces, possible values are: true/false
Keywords: FINITE_VOLUME, VARIABLES
MBool FvCartesianSolver::m_considerRotForces
default = false
Incorporate centrifugal and coriolis forces for computations in a rotationg frame of reference.
Possible values are:
0
(off) 1
(on) Keywords: FINITE_VOLUME, FORCES, ROTATION
MInt FvCartesianSolver::m_initialCondition
default = no default value
Selects the initial condition. possible values are:
Keywords: INITIAL_CONDITION, FINITE_VOLUME
default = NAVIER_STOKES
Choose between Navier-Stokes and Euler equation. Possible values are:
Keywords: FINITE_VOLUME
MFloat FvCartesianSolver::m_gasConstant
default = 8.314472 J/K/mol
Universal Gas Constant - \( R = c_p - c_v = (\gamma - 1) c_v \) possible values are:
Keywords: FINITE_VOLUME, VARIABLES
MFloat FvCartesianSolver::m_referenceTemperature
default = 273.15
Reference temperature \( T_{\mathrm{ref}}\) Used to scale the Sutherland's constant as follows: \( S/T_{\mathrm{ref}} \) Also used for the computation of the reference sound speed and combustion (TF) related quantities possible values are:
Keywords: FINITE_VOLUME, VARIABLES
MFloat FvCartesianSolver::m_sutherlandConstant
default = 110.4 K
Sutherland's constant. Used by Sutherland's law. possible values are:
Keywords: FINITE_VOLUME, VARIABLES
MFloat FvCartesianSolver::m_sutherlandConstantThermal
default = 110.4 K
Sutherland's constant for thermal conductivity. Recommended value: 194.0. See 'Viscous Fluid Flow' by F.M. White. possible values are:
Keywords: FINITE_VOLUME, VARIABLES
MBool FvCartesianSolver::m_changeMa
default = 0
Used to change the Ma number without generating a wave at the inlet the primitive restart variables are converted possible values are:
Keywords: RESTART, VARIABLES
MFloat FvCartesianSolver::m_previousMa
default = m_Ma
Used to change the Ma number without generating a wave at the inlet needed for the conversion that is activated with the changeMa property possible values are:
Keywords: RESTART, VARIABLES
MBool FvCartesianSolver::m_useCreateCutFaceMGC
default = 0
enables the usage of createCutFaceMGC without setting m_mutipleGhostCells, only matters for 3D possible values are:
Keywords: MGC, CutFace
MFloat FvCartesianSolver::m_strouhal
default = 2 * pi
Set the Strouhal number needed for certain combustion related cases.
Possible values are:
Keywords: FINITE_VOLUME, COMBUSTION, STROUHAL
MFloat FvCartesianSolver::m_forcingAmplitude
default = 0.5
Sets the forcing amplitude.
Possible values are:
Keywords: FINITE_VOLUME, COMBUSTION, STROUHAL
MInt FvCartesianSolver::m_noForcingCycles
default = 5
sets the number of forcing cycles possible values are:
Keywords: FINITE_VOLUME, FORCING, INFLOW
MInt FvCartesianSolver::m_cutOffInterface
default = none
Takes ids of cut off boundary conditions that are applied to interface cells. These interface cells are excluded from m_bndryCells.
Keywords: FINITE_VOLUME, CUTOFF
MInt FvCartesianSolver::m_testCaseName
default = none
Read test case identifier (used for some ugly hardcoded parts of the code, mainly with the MGC Method... (claudia) Keywords: FINITE_VOLUME, CUTOFF
MBool FvCartesianSolver::m_weightBndryCells
default = true
Enable weighting of boundary cells for balancing or when setting new grid partition workloads.
Keywords: FINITE_VOLUME, WEIGHTING, BALANCE
MBool FvCartesianSolver::m_weightCutOffCells
default = true
Enable weighting of cut off cells for balancing or when setting new grid partition workloads.
Keywords: FINITE_VOLUME, WEIGHTING, BALANCE
MBool FvCartesianSolver::m_weightBc1601
default = true
Enable weighting of Bc1601 cells for balancing or when setting new grid partition workloads.
Keywords: FINITE_VOLUME, WEIGHTING, BALANCE
MBool FvCartesianSolver::m_weightInactiveCell
default = true
Enable weighting of inactive fv-cells for balancing or when setting new grid partition workloads.
Keywords: FINITE_VOLUME, WEIGHTING, BALANCE
MBool FvCartesianSolver::m_weightLvlJumps
default = false
Enable weighting of cells at a Level-Jump for balancing or when setting new grid partition workloads.
Keywords: FINITE_VOLUME, WEIGHTING, BALANCE
MBool FvCartesianSolver::m_weightNearBndryCells
default = false
Enable weighting of near bndry cells for balancing or when setting new grid partition workloads.
Keywords: FINITE_VOLUME, WEIGHTING, BALANCE
MBool FvCartesianSolver::m_weightSmallCells
default = false
Enable weighting of FV small cut cells at the bndry for balancing or when setting new grid partition workloads.
Keywords: FINITE_VOLUME, WEIGHTING, BALANCE
MBool FvCartesianSolver::m_limitWeights
default = false
Limit weight of fv-cells by a factor of the largest weight, due to ensure a more even distribution of solver memory across ranks. Keywords: FINITE_VOLUME, WEIGHTING, BALANCE
MFloat FvCartesianSolver::m_weightBaseCell
default = 0.0
Weight applied for any fv-cell during static weight computation for domain decomposition during balance. Keywords: FINITE_VOLUME, WEIGHTING, BALANCE
MFloat FvCartesianSolver::m_weightLeafCell
default = 0.05
Weight applied for any fv leaf-cell during static weight computation for domain decomposition during balance. Keywords: FINITE_VOLUME, WEIGHTING, BALANCE
MFloat FvCartesianSolver::m_weightActiveCell
default = 0.1
Weight applied for any active fv leaf-cell during static weight computation for domain decomposition during balance. Keywords: FINITE_VOLUME, WEIGHTING, BALANCE
MFloat FvCartesianSolver::m_weightBndryCell
default = 0.0
Weight applied for all bndry-cells during static weight computation for domain decomposition during balance. Keywords: FINITE_VOLUME, WEIGHTING, BALANCE
MFloat FvCartesianSolver::m_weightNearBndryCell
default = 0.0
Weight applied for all near bndry-cells during static weight computation for domain decomposition during balance. Keywords: FINITE_VOLUME, WEIGHTING, BALANCE
MFloat FvCartesianSolver::m_weightMulitSolverFactor
default = 1.0
Mutli-solver weight factor applied to all fv-cell weights for static weight computation for domain decomposition during balance. 1.0 for single solver application, otherwise setup dependent. Keywords: FINITE_VOLUME, WEIGHTING, BALANCE
MFloat FvCartesianSolverXD::m_EEGas.RKSemiImplicitFactor
default = 0.5
This factor determines the weighting of the classical RK-scheme (0.0) and the semi-implicit scheme (1.0) for the E-E method. Keywords: EEMultiphase, FINITE_VOLUME
MFloat FvCartesianSolverXD::m_EEGas.dragModel
default = 0
Set the drag model for EEGas.
possible values are:
Keywords: EEMultiphase, FINITE_VOLUME
MFloat FvCartesianSolverXD::m_EEGas.CD
default = 1.0
Coefficient of drag.
Only used in EEGasDragModel 2! Keywords: EEMultiphase, FINITE_VOLUME
MFloat FvCartesianSolverXD::m_EEGas.Eo0
default = 2.24
The Eötvös (or Bond) number of the bubbles.
Keywords: EEMultiphase, FINITE_VOLUME
MFloat FvCartesianSolverXD::m_EEGas.bubbleDiameter
default = 0.001
Bubble diameter in dimensionless units (/ physicalReferenceLength).
Keywords: EEMultiphase, FINITE_VOLUME
MFloat FvCartesianSolverXD::m_EEGas.liquidDensity
default = 774
density of liquid in dimensionless units (/ rho_0).
Keywords: EEMultiphase, FINITE_VOLUME
MFloat FvCartesianSolverXD::m_EEGas.eps
default = 1.0e-10
eps used as minimum rhoAlpha for calculation of primitive variables u, alpha, etc.
Keywords: EEMultiphase, FINITE_VOLUME
MFloat FvCartesianSolverXD::m_EEGas.CL
default = 0.288
Lift coefficient used in the E-E method.
Keywords: EEMultiphase, FINITE_VOLUME
MInt FvCartesianSolverXD::m_EEGas.gasSource
default = 0
Gas Source method used for the E-E method.
0 : no gas sources 9 : gas sources in used defined boxes Keywords: EEMultiphase, FINITE_VOLUME
MFloat FvCartesianSolverXD::m_EEGas.gasSourceMassFlow
default = 0.0
Mass flow of gass added in the gas sources.
Keywords: EEMultiphase, FINITE_VOLUME
std::vector<MFloat> FvCartesianSolverXD::m_EEGas.gasSourceBox
Boxes in which gas is added.
Keywords: EEMultiphase, FINITE_VOLUME
MBool FvCartesianSolverXD::m_EEGas.bubblePathDispersion
default = true
Enable bubblePathDispersion
Keywords: EEMultiphase, FINITE_VOLUME
MFloat FvCartesianSolverXD::m_EEGas.initialAlpha
default = 0.0
Initial value of alpha in the domain.
Keywords: EEMultiphase, FINITE_VOLUME
MFloat FvCartesianSolverXD::m_EEGas.alphaInf
default = m_EEGas.initialAlpha
Infinity value of alpha.
Keywords: EEMultiphase, FINITE_VOLUME
MFloat FvCartesianSolverXD::m_EEGas.alphaIn
default = m_EEGas.initialAlpha
Value of alpha at the inflow BC.
Keywords: EEMultiphase, FINITE_VOLUME
MFloat FvCartesianSolverXD::m_EEGas.schmidtNumber
default = 1.0
The Schmidt number of the bubbles.
Keywords: EEMultiphase, FINITE_VOLUME
MBool FvCartesianSolverXD::m_EEGas.uDLimiter
default = true
Enable the limiter for u_d.
Keywords: EEMultiphase, FINITE_VOLUME
MFloat FvCartesianSolverXD::m_EEGas.uDLim
default = 0.2
Maximum u_d, if the uDLimiter is active.
Keywords: EEMultiphase, FINITE_VOLUME
MFloat FvCartesianSolverXD::m_EEGas.interpolationFactor
default = 0.5
This factor determines to which point in time the values of the other phase are inter/extrapolated.
0.0 is the level of the old timestep, 1.0 is the level of the new timestep. Keywords: EEMultiphase, FINITE_VOLUME
MBool FvCartesianSolverXD::m_EEGas.depthCorrection
default = true
Use the depthCorrection mechanism for the E-E method.
This means, that the effects of buoyancy are not added to the bubbles through a pressure gradient. Instead a momentum source is applied.
The density is corrected to reflect the pressure gradient. Keywords: EEMultiphase, FINITE_VOLUME
std::vector<MFloat> FvCartesianSolverXD::m_EEGas.gravityRefCoords
Reference Coordinates for density correction as a function of depth below the surface Keywords: EEMultiphase, FINITE_VOLUME
std::vector<MFloat> FvCartesianSolverXD::m_EEGas.depthCorrectionCoefficients
The depthCorrectioncoefficients are dimensionless coefficients for the change in density as a function of depth They are defined as (g L_ref)/(R T) with the compontents of the gravity vector g, the specific gas constant R (=287.06 J/kgK for air) and the Reference Temperature Keywords: EEMultiphase, FINITE_VOLUME
std::vector<MFloat> FvCartesianSolverXD::m_EEGas.gravity
gravity Vector for calculation of the static pressure from the liquid phase Keywords: EEMultiphase, FINITE_VOLUME
MFloat FvCartesianSolver::m_molecularWeight
default = none
molecular weight of species possible values are:
Keywords: FINITE_VOLUME, VARIABLES, SPECIES
MFloat FvCartesianSolver::m_referenceComposition
default = 0
Reference species composition possible values are:
Keywords: FINITE_VOLUME, VARIABLES, SPECIES
MFloat FvCartesianSolver::m_secondaryReferenceComposition
default = 0
Reference species composition possible values are:
Keywords: FINITE_VOLUME, VARIABLES, SPECIES
MFloat FvCartesianSolver::m_referenceDensityTF
default = 1.25
Reference density for thickened flame model possible values are:
Keywords: FINITE_VOLUME, VARIABLES, TODO
MFloat FvCartesianSolver::m_heatReleaseReductionFactor
default = 1.0
The heat release is reduced by this factor (currently not in use)
Possible values are:
floating-point values
Keywords: FINITE_VOLUME, COMBUSTION
MFloat FvCartesianSolver::m_thickeningFactor
default = 1.0
Set the thickening factor of (probably ?) a flame.
Value is currently not used ?
possible values are:
Keywords: FINITE_VOLUME, VARIABLES, FLAME
MFloat FvCartesianSolver::reactionScheme
default = METHANE_2_STEP
Set the reactionScheme
possible values are:
Keywords: FINITE_VOLUME, VARIABLES, FLAME
MFloat FvCartesianSolver::m_spongeLayerThickness
default = 0.0
The property controls the thickness of the sponge layer in which the sponge layer forcing is applied. The sponge forcing term added to the rhs of a cell inside the sponge layer is given by
\( \Delta L(\phi) = V \sigma
\frac{\Delta x_{sp}^2}{L_s^2} \Delta \phi \),
where \( V \) is the cell volume, \( \sigma \) is the forcing amplitude, \( x_{sp} \) is the inner sponge layer boundary, \( L_{sp} \) is the sponge layer thickness and \( \Delta \phi = \phi - \phi_{target} \) is the difference between the local and the freesteam values of \(
\phi \).
See also spongeLayerLayout and spongeFactor.
possible values are:
Keywords: FINITE_VOLUME, SPONGE
MFloat FvCartesianSolver::m_spongeLayerThickness
default = 0.0
The property controls the thickness of the sponge layer in which the sponge layer forcing is applied. See spongeLayerThickness. The thickness is given as a multiple of the cell length of the maximum geometrical refinement level
possible values are:
Keywords: FINITE_VOLUME, SPONGE
MBool FvCartesianSolver::m_createSpongeBoundary
default = 0
The property controls the use of sponge zones for specific boundaries, defined by the boundary Ids in your geometry file geometry.cdl, spongeBndryCndIds. If the property is set to zero the sponge zones are defined at the domain boundaries, see readSpongeDomainBoundaries().
possible values are:
Keywords: FINITE_VOLUME, SPONGE, SPECIFIC, BOUNDARIES, BOUNDARY, ID
MFloat FvCartesianSolver::m_cfl
default = no default
Courant number C - Factor of the CFL condition
possible values are:
Keywords: FINITE_VOLUME, STABILITY, TIME_INTEGRATION
MFloat FvCartesianSolver::m_cflViscous
default = 1/4
Quasi-Courant number C_vis - Factor of the viscous "CFL condition"
The time-step restriction for the stability of an explicity Euler-forward step for the diffusion equation is $\Delta t <= C_{vis} \frac{\Delta x^2}{\nu}$ where $C_{vis} \in (0, 1/4]. For the Enthalpy solver $\nu$ is the diffusion coefficient, that is, the thermal diffusivity. For compressible-flow at constant Prandtl' number $\nu$ is the specific viscosity. Note that the unsteady diffusion equation is a parabolic problem, and although explicit schemes can be used to solve it stably, the restriction on the time-step increases with the square of the mesh size, so refining the grid makes the number of time-steps required to solve the problem explode. Keywords: FINITE_VOLUME, STABILITY, TIME_INTEGRATION
MFloat FvCartesianSolver::m_orderOfReconstruction
default = 1
Sets the order of the reconstruction
possible values are:
Keywords: FINITE_VOLUME, STABILITY, HIGHER_ORDER
MInt FvCartesianSolver::m_limiter
default = 0
Does nothing
possible values are:
Keywords: FINITE_VOLUME, STABILITY, LIMITER
MInt FvCartesianSolver::m_surfaceValueReconstruction
default = HOCD
Selects the reconstruction method.
possible values are:
Keywords: FINITE_VOLUME, STABILITY, LIMITER
MInt FvCartesianSolver::m_limitedSlopesVar
default = -1
possible values for each entry are:
Keywords: FINITE_VOLUME, LIMITED, SLOPES, VARIABLES
MString FvCartesianSolver::m_viscousFluxScheme
default = FIVE_POINT
Scheme for the calculation of the viscous flux
Possible values are:
Keywords: FINITE VOLUME, NUMERICS, FLUX
MFloat FvCartesianSolver::m_enhanceThreePointViscFluxFactor
default = 0.1
FIVE_POINT_STABILIZED combines the THREE_POINT stencil and the FIVE_POINT stencil for the viscous flux computation
This property provides further control and the final stencil of the viscous flux is (1-enhanceThreePointViscFluxFactor)*FIVE_POINT + * enhanceThreePointViscFluxFactor*THREE_POINT
Possible values are:
between 0 and 1 Keywords: FINITE VOLUME, NUMERICS, FLUX
MString FvCartesianSolver::m_gridInterfaceFilter
default = False
Switches on/off a filter of the conservative variables at
coarse/fine grid interfaces.
Possible values are:
Keywords: FINITE VOLUME, NUMERICS, INTERFACE, FILTER
MBool FvCartesianSolver::m_force1DFiltering
default = False
Sets x-velocity to 0.
Possible values are:
Keywords: FINITE VOLUME
MFloat FvCartesianSolver::m_physicalTimeStep
default = no default value
The property is the "external" time increment used for dualtimestepping, usually reads from restart file. m_physicalTimeStep=m_timeStep*m_timeRef. possible values are:
Keywords: Timestep
MInt FvCartesianSolver::m_timeStepMethod
default = -1
Specifies the time step method
Keywords: FINITE_VOLUME
MInt FvCartesianSolver::m_timeStepNonBlocking
default = 0
If activated, the timeStep is reduced using non-blocking communication
Keywords: FINITE_VOLUME, TIME
MInt FvCartesianSolver::m_timeStepComputationInterval
default = -1
Specifies on which interval the time-step will be recomputed.
Keywords: FINITE_VOLUME
MInt FvCartesianSolver::m_timeStepVolumeWeighted
default = 0 (false)
When enabled includes the boundary cells in the time-step computation and weights it using the cell volume (the smaller the cell, the smaller the time-step). Keywords: FINITE_VOLUME
MInt FvCartesianSolver::m_globalUpwindCoefficient
default = 0
Set the upwind coefficient for the pressure splitting
Keywords: FINITE_VOLUME, NUMERICS, AUSM
MInt MAIAFvCartesianSolver::m_reConstSVDWeightMode
default = 0/1
Selects the weight mode for the weights in the reconstruction Constant computation in SVD for cells near the moving bndry!
possible values are:
Keywords: FINITE_VOLUME, SVD, reconstructionConstants
MInt FvCartesianSolver::m_convergenceCriterion
default = 1e-12
Sets the convergence criterion for the residuals of the time step loop.
Keywords: FINITE_VOLUME, NUMERICS
MInt solver::m_solutionOffset
default = 0
which time step to start writing out solution Possible values are:
Keywords: output
MInt solver::m_outputPhysicalTime
default = false
Write m_physicalTime in all time-outputs instead of m_time Keywords: output
MInt solver::noSolutionTimeSteps
default =
Sets the solution time step Possible values are:
Keywords: output
MBool FvCartesianSolver::m_surfDistParallel
default = false
write out the distribution of the force coefficients into one file during a parallel run in computeForceCoefficients() (unsorted)
possible values are:
Keywords: FINITE_VOLUME, OUTPUT
MBool FvCartesianSolver::m_surfDistCartesian
default = false
write out the distribution of the force coefficients in Cartesian coordinates (instead of angle)
Keywords: FINITE_VOLUME, OUTPUT
MBool FvCartesianSolver::m_saveVorticityToRestart
default = false
Save vorticity to restart file.
possible values are:
Keywords: FINITE_VOLUME, OUTPUT
MBool FvCartesianSolverPar::m_qCriterionOutput
default = ""
Triggers whether the q-criterium is calculated and written to all output files.
Keywords: FINITE_VOLUME, OUTPUT, GENERAL
MBool FvCartesianSolverPar::m_vtuWritePointData
default = false
Triggers whether the vtu point data is written
Keywords: FINITE_VOLUME, OUTPUT, GENERAL
MBool FvCartesianSolver::m_vtuCutCellOutput
default = false
Contorols the output in vtu file format. If activated (=1), the cut faces are included in the output.
possible values are:
Keywords: FINITE_VOLUME, OUTPUT
MBool FvCartesianSolver::m_vtuGeometryOutput
default = false
Enables/disables writing geometry output to VTU files. Keywords: FINITE_VOLUME, IO, VTU
MBool FvCartesianSolver::m_vtuGeometryOutputExtended
default = false
Enables/disables writing extended geometry output to VTU files. Keywords: FINITE_VOLUME, IO, VTU
MBool FvCartesianSolver::m_vtuGlobalIdOutput
default = false
Enables/disables writing global cell Ids to VTU files. Keywords: FINITE_VOLUME, IO, VTU
MBool FvCartesianSolver::m_vtuDomainIdOutput
default = false
Enables/disables writing the domain Id of the cells to VTU files. Keywords: FINITE_VOLUME, IO, VTU
MBool FvCartesianSolver::m_vtuDensityOutput
default = false
Enables/disables writing the cell density to VTU files. Keywords: FINITE_VOLUME, IO, VTU
MBool FvCartesianSolver::m_vtuLevelSetOutput
default = false
Enables/disables writing the cell level-set value to VTU files. Keywords: FINITE_VOLUME, IO, VTU
MBool FvCartesianSolver::m_vtuQCriterionOutput
default = false
Enables/disables writing of the Q vortex criterion to VTU output files. See: Hunt, J.C.R., Wray, A.A., Moin, P., Eddies, stream, and convergence zones in turbulent flows. Center for Turbulence Research Report CTR-S88, pp. 193–208, 1988. Keywords: FINITE_VOLUME, IO, VTU
MBool FvCartesianSolver::m_vtuLambda2Output
default = false
Enables/disables writing of the $\lambda_2$ vortex criterion to VTU output files. See: J. Jeong and F. Hussain. On the Identification of a Vortex. J. Fluid Mechanics, 285:69-94, 1995. Keywords: FINITE_VOLUME, IO, VTU
MBool FvCartesianSolver::m_vtuVorticityOutput
default = false
Enables/disables writing the cell vorticity to VTU files. Keywords: FINITE_VOLUME, IO, VTU
MBool FvCartesianSolver::m_vtuvelocityGradientOutput
default = false
Enables/disables writing the cell velocity gradients to VTU files. Keywords: FINITE_VOLUME, IO, VTU
MBool FvCartesianSolver::m_vtuSaveHeaderTesting
default = false
Outputs to stdout when a vtu file is written.
Keywords: FINITE_VOLUME, I/O
MInt FvCartesianSolver::m_vtuLevelThreshold
default = maxRefinementLevel()
Optionally specifies the maximum cell level to be saved
Possible values are:
Keywords: FINITE_VOLUME, I/O
MFloat FvCartesianSolver::m_vtuCoordinatesThreshold
default = none
Specify a bounding box to which the output domain is truncated when writing VTU output.
Possible values are:
Keywords: FINITE_VOLUME, IO, VTU
MString FvCartesianSolver::m_outputFormat
default = levelSetMb ? "VTU" : "NETCDF"
Defines the output file format of the finite volume solver
Possible values are:
Keywords: FINITE VOLUME, FILE FORMAT, NETCDF, VTU
MBool FvCartesianSolver::m_writeOutData
default = none
Controls the centerline data writeOut.
possible values are:
Keywords: FINITE_VOLUME, OUTPUT
MBool FvCartesianSolver::m_recordBodyData
default = none
If enabled (set to 1), extra output is generated with e.g. the body position.
possible values are:
Keywords: FINITE_VOLUME, OUTPUT, MOVING_BOUNDARY
MBool FvCartesianSolver::m_recordWallVorticity
default = false
Determine minimum and maximum wall vorticity (for boundary condition 3006, not covered in testcases).
Possible values are:
0
(off) 1
(on) Keywords: FINITE_VOLUME, I/O, WALL, BOUNDARY, VORTICITY
MBool FvCartesianSolver::m_writeCutCellsToGridFile
default = 0
If enabled (set to 1), all cut cell information necessary for visualizing the cut cells in Paraview is written to the grid file.
possible values are:
Keywords: FINITE_VOLUME, OUTPUT, CUT_CELLS
MBool FvCartesianSolver::m_restartBc2800
default = 0
restarts the boundary condition bc2800 (actually all boundary conditions that call FvBndryCndXD::initModes(MInt)).
Start: inserts plane waves starting smoothly with zero amplitude at the lowest argument found in the computational domain.
Restart: reads the lowest argument from the restart file and continues the continuous insertion of plane waves
possible values are:
Keywords: TUNNEL NOISE, RECEPTIVITY, bc2800
MInt FvCartesianSolver::m_restartBackupInterval
default = 25000
Defines the interval in which restart backup files are created
Possible values are:
Keywords: FINITE_VOLUME, RESTART, I/O
MBool FvCartesianSolver::m_restartOldVariables
default = false
If enabled, oldVariables are saved to and restored from restart files.
Possible values are:
Keywords: FINITE_VOLUME, RESTART, OUTPUT, OLD_VARIABLES
MBool FvCartesianSolver::m_restartOldVariablesReset
default = false
If enabled, oldVariables are initialized with the current variables and not loaded from a restart file. To be used if one wants to enable restartOldVariables at a restart.
Possible values are:
Keywords: FINITE_VOLUME, RESTART, OUTPUT, OLD_VARIABLES
MBool FvCartesianSolver::checkCellSurfaces
default = none
If enabled, cell surfaces are checked for consistency.
Possible values are:
Keywords: FINITE_VOLUME, SURFACES
MBool FvMbSolver::m_bodyIdOutput
default = !m_constructGField
Determines whether the additionale bodyIdOutput output should be written! Default is !m_constructGField, but the output is not necessary for a restart and should be set to false for large applications, to reduce the amount of data! Keywords: LEVELSET, MOVING BOUNDARY
MBool FvMbSolver::m_levelSetOutput
default = !m_constructGField
Determines whether the additional levelset values output should be written! Default is !m_constructGField, but the output is not necessary for a restart and should be set to false for large applications, to reduce the amount of data! Use isActiveOutput instead, which is just a bool and more accurate! Keywords: LEVELSET, MOVING BOUNDARY
MBool FvMbSolver::m_isActiveOutput
default = false
Default is false, but the output is not necessary for a restart and should be set to false for large applications, to reduce the amount of data! IsActiveOutput can be used, to limit the visualization to the valid fluid domain in moving-boundary applications. Keywords: FINITE_VOLUME, MOVING BOUNDARY
MBool FvMbSolver::m_domainIdOutput
default = false
Determines whether the domainId should be written to the file. The output is not necessary for a restar and only useful to display the current partitioning. Keywords: FINITE_VOLUME, OUTPUT
MFloat FvCartesianSolver::m_sampleRate
default: 0.000001
Determines how often sampling is performed.
Keywords: FINITE_VOLUME
MFloat FvCartesianSolver::m_samplingTimeBegin
default: infinity
Set beginning of sampling time
Keywords: FINITE_VOLUME
MFloat FvCartesianSolver::m_samplingTimeEnd
default: 0.0
Determines the time step at which sampling will be deactivated.
Keywords: FINITE_VOLUME, SAMPLE
MFloat FvCartesianSolver::m_samplingStartCycle
default: -1
Sets the first cycle that is sampled in the 17511 2D_steady_bunsen_flame test-case starts.
Keywords: FINITE_VOLUME, SAMPLE
MInt FvCartesianSolver::m_samplingEndCycle
default: -1
Sets the last cycle that is sampled in the 17511 2D_steady_bunsen_flame test-case starts.
Keywords: FINITE_VOLUME, SAMPLING
MFloat FvCartesianSolver::m_samplesPerCycle
default: 100
Sets the number of samples per cycle in the 17511 2D_steady_bunsen_flame test-case starts.
Keywords: FINITE_VOLUME, SAMPLE
MFloat FvCartesianSolver::m_samplingStartIteration
default: -99999.0
Determines at which time-step the sampling for the 17511 2D_steady_bunsen_flame test-case starts.
Keywords: FINITE_VOLUME, SAMPLING
MInt FvCartesianSolver::m_noSamplingCylces
default: 2
Determines how many sampling cycles are performed.
Keywords: FINITE_VOLUME, SAMPLING
MFloat FvCartesianSolver::m_marksteinLength
default = 0.1
controls the flame curvature effects on the flame. The local flame speed is corrected by the local curvature \( s_{l} = s_{l,0} (1 - l_{c}*\kappa) \):
possible values are:
Keywords: MARKSTEIN, COMBUSTION, LEVELSET, CURVATURE, FLAME
MFloat FvCartesianSolver::m_marksteinLengthPercentage
default = 1
controls wether a neutrally stable flame (m_marksteinLengthPercentage = 1), stable (>1) or instable (<1) is computed, see also marksteinLength :
values are:
Keywords: MARKSTEIN, LENGTH, PERCENTAGE, COMBUSTION, LEVELSET, CURVATURE, FLAME
MBool FvCartesianSolver::m_zeroLineCorrection
default = 0
controls the correction of the grwoth rate computation.
possible values are:
Keywords: MARKSTEIN, COMBUSTION, LEVELSET, ZERO, LINE, CORRECTION
MFloat FvCartesianSolver::m_inletTubeAreaRatio
default = 1
this property depends on your geometry and is used for the calculation of the pressure loss caused by the area change inlet-tube.
possible values are:
Keywords: COMBUSTION, INLET, TUBE, AREA, RATIO
MFloat FvCartesianSolver::m_inletOutletAreaRatio
default = 1
this property depends on your geometry and is used for the calculation of the outlet velocity needed for the sponge zone at the outlet. The property is only needed if there are no slip walls used in the outlet plenumWall
possible values are:
Keywords: COMBUSTION, INLET, TUBE, AREA, RATIO
MFloat FvCartesianSolver::m_flameOutletAreaRatio
default = 1
this property depends on your geometry and is used for the calculation pressure loss, needed for the sponge zone at the outlet. The property is only needed if there are no slip walls used in the outlet plenumWall
possible values are:
Keywords: COMBUSTION, INLET, TUBE, AREA, RATIO
MBool FvCartesianSolver::m_massFlux
default = 0
this property triggers the calculation of the mass flux at the inlet and outlet of your geometry but only if the inlet boundary condition 17514 (17614,17714) and the outlet condition 1753 (1743,1763,1773). Only meaningful if the inflow conditions 17514 (17614,17714) and the outflow conditions 1753 (1743,1763,1773) and if no slip walls are used at the outlet plenumWall
to do!!: general mass flux function should be implemented.
possible values are:
Keywords: COMBUSTION, INLET, OUTLET, MASS, FLUX
MBool FvCartesianSolver::m_confinedFlame
default = 0
this property triggers the use of higher pressure in the inlet tube section because of the pressure differences induced by the flame and the walls in the outlet
possible values are:
Keywords: COMBUSTION, OUTLET, CONFINED, FLAME, WALL
MBool FvCartesianSolver::m_plenum
default = 0
this property triggers the use of the averaged variables in the flame tube if a plenum as inlet is used. And is automatically turned on for the use of a plenum with walls in the outlet, see plenumWall
possible values are:
Keywords: COMBUSTION, OUTLET, TUBE, WALL
MBool FvCartesianSolver::m_plenumWall
default = 0
this property triggers an additional pressure loss because of the no slip walls used in the outlet, needed for the sponge zone at the outlet. The property is only needed if there are no slip walls used in the outlet plenumWall
possible values are:
Keywords: COMBUSTION, OUTLET, TUBE, WALL
MInt FvCartesianSolver::m_useCorrectedBurningVelocity
default = 0
this property triggers the use of the corrected burning velocity which is calculated via the hyperbolic extension extVelCFL, extVelBC, hyperbolicCurvature, needed for the heat release source term and for the total mass consumption. See also the Paper from Peng, Journal of Computational Physics 155, 410-438 (1999)
possible values are:
Keywords: COMBUSTION, CORRECTED, BURNING, VELOCITY, HEAT, RELEASE, SOURCE, TERM, HYPERBOLIC, EXTENSION
MBool FvCartesianSolver::m_filterFlameTubeEdges
default = 0
temporarly trigger for second order filtering of the fourth order discretization (normal and curvature computation) at the flame tube edges dependent on the dampingDistanceFlameBase
. possible values are:
Keywords: COMBUSTION, FILTERING, FLAME, BASE
MFloat FvCartesianSolver::m_filterFlameTubeEdgesDistance
default = -9999.9
Up to this distance relative to the flame tube edges the second order filtering (normal and curvature computation) is applied filterFlameTubeEdges
. possible values are:
Keywords: COMBUSTION, FILTERING, FLAME, BASE
MBool FvCartesianSolver::m_totalDamp
default = 0
temporarly trigger for testing the damping at the flame base the curvature or corrected burning velocity, dampingDistanceFlameBase
possible values are:
Keywords: COMBUSTION, DAMPING, FLAME, BASE
MInt FvCartesianSolver::m_heatReleaseDamp
default = 0
temporarly trigger for testing the damping at the flame base the heat release, dampingDistanceFlameBase
possible values are:
Keywords: COMBUSTION, DAMPING, FLAME, BASE
MBool FvCartesianSolver::m_modelCheck
default = 0
temporarly trigger for testing the model
possible values are:
Keywords: COMBUSTION, PROGRESS, MODEL, CHECK
MFloat FvCartesianSolver::m_flameSpeed
no default value
This variable defines the constant flame speed of an uncurved flat flame. The local flame speed is corrected by the local curvature \( \kappa \) in the code \( s_{l} = s_{l,0} (1 - l_{c}*\kappa) \).
This correction is controlled by the markstein length \( l_{c} \) marksteinLength.
possible values are:
Keywords: COMBUSTION, LEVELSET, CURVATURE, FLAME, SPEED, MARKSTEIN, LENGTH
MFloat FvCartesianSolver::m_analyticIntegralVelocity
no default value
This variable defines the integral velocity of the inflow profile determined by matlab or other tools. possible values are:
Keywords: COMBUSTION, INTEGRAL, VELOCITY
MFloat FvCartesianSolver::m_meanVelocity
no default value
This variable defines the integral velocity of the inflow profile determined by matlab or other tools. possible values are:
Keywords: COMBUSTION, INTEGRAL, VELOCITY
MInt FvCartesianSolver::m_pressureLossFlameSpeed
default = 0
possible values are:
Keywords: COMBUSTION, LEVELSET, FLAME, SPEED, PRESSURE, LOSS
MFloat FvCartesianSolver::m_pressureLossCorrection
pressure loss correction. default = 0.0
possible values are:
Keywords: COMBUSTION, LEVELSET, PRESSURE, LOSS
MInt FvCartesianSolver::m_constantFlameSpeed
default = 0
possible values are:
Keywords: COMBUSTION, LEVELSET, CONSTANT, FLAME, SPEED, MARKSTEIN, LENGTH
MFloat FvCartesianSolver::m_neutralFlameStrouhal
default = -1.0
This variable defines a flame strouhal number based on length one, needed for comparison to neutral markstein length computations.
possible values are:
Keywords: COMBUSTION, FLAME, STROUHAL, NUMBER, NEUTRAL, MARKSTEIN, LENGTH
MFloat FvCartesianSolver::m_noReactionCells
default = 4
This variable controls the number of reaction cells which are used for the heat release calculation. This is applied for the initial condition 17516 via a tanh-function
\[ (((F1/m_noReactionCells)*m_FgCellDistance )) *(F1-tanh(a_levelSetFunction[ IDX_LSSET(gc , 0) ] (F1/m_noReactionCells) * m_FgCellDistance )) \]
with
possible values are:
Keywords: COMBUSTION, REACTION, LEVELSET, HEAT, RELEASE, SOURCE, TERM, FLAME
MFloat FvCartesianSolver::m_MaFlameTube
default = Ma
Mach number defined with the averaged velocity and the averaged speed of sound at the flame tube. Depends on your geometry and the infinity values at the inlet.
possible values are:
Keywords: COMBUSTION, MACH, NUMBER, FLAME, TUBE, SPEED OF SOUND, VELOCITY
MBool FvCartesianSolver::m_recordPressure
default = 0
controls output of ascii file pressureSensor, with output of:
possible values are:
Keywords: COMBUSTION, FLAME, FRONT, SURFACE, AREA, FILE, ASCII, OUTPUT
MBool FvCartesianSolver::m_recordFlameFrontPosition
default = 0
controls output of ascii file flameFrontData, with output of:
possible values are:
Keywords: COMBUSTION, FLAME, FRONT, SURFACE, AREA, FILE, ASCII, OUTPUT
MBool FvCartesianSolver::m_structuredFlameOutput
default = 0
controls the structured output of a 2D flame geometry possible values are:
Keywords: COMBUSTION, FLAME, STRUCTURED, OUTPUT
MInt FvCartesianSolver::m_structuredFlameOutputLevel
default = 0
controls the structured output of a 2D flame geometry possible values are:
Keywords: COMBUSTION, FLAME, STRUCTURED, OUTPUT, LEVEL
MBool FvCartesianSolver::m_twoFlames
default = 0
trigger for computation of two bunsen flames. Only meaningful if the initial condition 17516 initialCondition is used.
possible values are:
Keywords: COMBUSTION, TWO, FLAMES
MFloat FvCartesianSolver::m_dampingDistanceFlameBase
default = 0.259
damps out the heat release at the flame base. Only meaningful if the initial condition 17516 initialCondition is used.
possible values are:
Keywords: COMBUSTION, FLAME, BASE, DAMPING, DISTANCE, EXTENSION, VELOCITY
MFloat FvCartesianSolver::m_dampingDistanceFlameBase
default = 0.259
damps out the heat release at the flame base. Only meaningful if the initial condition 17516 initialCondition is used.
possible values are:
Keywords: COMBUSTION, FLAME, BASE, DAMPING, DISTANCE
MFloat FvCartesianSolver::m_initialFlameHeight
default = 1.0
initial flame height. Used for initial conditions initialCondition:
possible values are:
Keywords: COMBUSTION, FLAME, TUBE, HEIGHT
MFloat FvCartesianSolver::m_radiusFlameTube
default = 0.5
flame tube radius of a bunsen flame or used as radius for first flame of a multiple flame configuration. Used for initial conditions initialCondition:
possible values are:
Keywords: COMBUSTION, FLAME, TUBE, RADIUS
MFloat FvCartesianSolver::m_radiusVelFlameTube
default = 0.5
flame tube radius of a bunsen flame used as radius for velocity profile.
possible values are:
Keywords: COMBUSTION, FLAME, TUBE, RADIUS
MFloat FvCartesianSolver::m_radiusOutlet
default = 0.5
flame tube radius of a bunsen flame used as radius for velocity profile.
possible values are:
Keywords: COMBUSTION, FLAME, TUBE, RADIUS
MFloat FvCartesianSolver::m_realRadiusFlameTube
default = radiusFlameTube
flame tube radius of a bunsen flame or used as radius for first flame of a multiple flame configuration. Used for initial conditions initialCondition: possible values are:
Keywords: COMBUSTION, FLAME, TUBE, REAL, RADIUS
MFloat FvCartesianSolver::m_radiusFlameTube2
default = m_radiusFlameTube
flame tube radius of a second flame for a multiple flame configuration. Used for initial condition initialCondition:
possible values are:
Keywords: COMBUSTION, MULTIPLE, FLAMES, TUBE, RADIUS
MFloat FvCartesianSolver::m_radiusInjector
default = 2.0
injector radius (SFB686 Bielefeld burner).
possible values are:
Keywords: COMBUSTION, INJECTOR, RADIUS
MFloat FvCartesianSolver::m_yOffsetInjector
default = 2.0
injector radius (SFB686 Bielefeld burner).
possible values are:
Keywords: COMBUSTION, INJECTOR, RADIUS
MFloat FvCartesianSolver::m_yOffsetFlameTube
default = 0.04
flame tube offset of a bunsen flame in y - direction. Used for initial conditions initialCondition:
possible values are:
Keywords: COMBUSTION, FLAME, TUBE, OFFSET
MFloat FvCartesianSolver::m_yOffsetFlameTube2
default = m_yOffsetFlameTube
flame tube offset of a second flame in y - direction. Used for initial condition initialCondition:
possible values are:
Keywords: COMBUSTION, SECOND, FLAME, TUBE, OFFSET
MFloat FvCartesianSolver::m_xOffsetFlameTube
default = 0.0
flame tube offset of a flame in x - direction. Used for initial condition initialCondition:
meaningful values are:
Keywords: COMBUSTION, SECOND, FLAME, TUBE, OFFSET
MFloat FvCartesianSolver::m_xOffsetFlameTube2
default = -m_xOffsetFlameTube
flame tube offset of a second flame in x - direction. Used for initial condition initialCondition:
meaningful values are:
Keywords: COMBUSTION, SECOND, FLAME, TUBE, OFFSET
MFloat FvCartesianSolver::m_tubeLength
default = -m_xOffsetFlameTube
flame tube offset of a second flame in x - direction. Used for initial condition initialCondition:
meaningful values are:
Keywords: COMBUSTION, SECOND, FLAME, TUBE, OFFSET
MFloat FvCartesianSolver::m_outletLength
default = -m_xOffsetFlameTube
flame tube offset of a second flame in x - direction. Used for initial condition initialCondition:
meaningful values are:
Keywords: COMBUSTION, SECOND, FLAME, TUBE, OFFSET
MFloat FvCartesianSolver::m_laminarFlameThickness
default = smallest cell distance
controls the flame thickness which should be caluclated via \( l_{f} = D_{flame}/(Re_{flame} * Pr * s_{l,0} )
\).
possible values are:
Keywords: COMBUSTION, LAMINAR, FLAME, THICKNESS
< for filtering of the laminar flame thickness
MFloat FvCartesianSolver::m_subfilterVariance
default = 1.0
the subfilter variance \( /sigma \) controls the Gaussian sub-filter distribution within the flame model, see thesis D.Hartmann: "A level-Set Based Method for Premixed Combustion in Compressible Flow", p.17.
In the corrguted Flamelet regime \( l_{f} < l_{Kolm}\) there are two different model cases, see V.Moureau (2009) "A
level set formulation for premixed combustion les considering the turbulent flame structure":
Case 1 - \(\sigma < l_{f}\):
Case 2 - \( \sigma > l_{f}\):
possible values are:
Keywords: COMBUSTION, FLAMELET, REGIME, SUBFILTER, VARIANCE, FLAME, THICKNESS
MFloat FvCartesianSolver::m_c0
default = 0.5
c0 is a contour of the progress variable \( c = [0,1] \) which could be interpreted as the flame surface contour. /n possible values are:
Keywords: COMBUSTION, FLAME, PROGRESS, VARIABLE, SURFACE, CONTOUR
MFloat FvCartesianSolver::m_rhoUnburnt
default = 1
Controls the unbunrt density for the DL instability for restart simulations. Has to be set otherwise the restart will produce wrong solutions. /n possible values are:
Keywords: COMBUSTION, DENSITY, UNBURNT
MFloat FvCartesianSolver::m_burntUnburntTemperatureRatio
default = 1
Controls the ratio between the burnt and unburnt gas temperature \( \frac{T_{burnt}}{T_{unburnt}} \). /n possible values are:
Keywords: COMBUSTION, TEMPERATURE, BURNT, UNBURNT, RATIO
MInt FvCartesianSolver::m_temperatureChange
default = 0
Controls whether temperature adaption should be activated. /n possible values are:
Keywords: COMBUSTION, TEMPERATURE, BURNT, UNBURNT, RATIO
MFloat FvCartesianSolver::m_burntUnburntTemperatureRatioStart
default = 1
Controls the ratio between the burnt and unburnt gas temperature \( \frac{T_{burnt}}{T_{unburnt}} \). /n possible values are:
Keywords: COMBUSTION, TEMPERATURE, BURNT, UNBURNT, RATIO
MFloat FvCartesianSolver::m_burntUnburntTemperatureRatioEnd
default = 1
Controls the ratio between the burnt and unburnt gas temperature \( \frac{T_{burnt}}{T_{unburnt}} \). /n possible values are:
Keywords: COMBUSTION, TEMPERATURE, BURNT, UNBURNT, RATIO
MFloat FvCartesianSolver::m_targetDensityFactor
default = 1/m_burntUnburntTemperatureRatio
The property controls the Intensity of the sponge layer correction regarding the density forcing term for some values of the spongeLayerType. The sponge forcing term added to the rhs of a cell inside the sponge layer is given by
\( \Delta L(\phi) = V \sigma \frac{\Delta x_{sp}^2}{L_s^2} \Delta \phi \),
where \( V \) is the cell volume, \( \sigma \) is the forcing amplitude, \( x_{sp} \) is the inner sponge layer boundary, \( L_{sp}
\) is the sponge layer thickness and \( \Delta \phi = \phi - \phi_{target} \) is the difference between the local and the freesteam values of \( \phi \).
The targetDensityFactor should be chosen to the inverse of the burnt unburnt temperature ratio for a combustion simulation.
The density target value is in these cases given as:
deltaRho =a_pvariable( cellId , PV->RHO ) - m_rhoInfinity * m_targetDensityFactor;
See also spongeLayerType. Only meaningful and required with certain values for spongeLayerType and if both spongeLayerThickness and sigmaSponge are specified and nonzero! !
possible values are:
Keywords: FINITE_VOLUME, SPONGE
MFloat FvCartesianSolver::m_deltaXtemperatureProfile
default = 0.02
Controls the temperature profile of the isothermal boundary conditions 4905 (bcNeumannIsothermalBurntProfile). In between this distance the temperature is rising from the unburnt temperature at the tube edges, see radiusFlameTube, up to the burnt temperature controlled by the burntUnburntTemperatureRatio /n possible values are:
Keywords: COMBUSTION, TEMPERATURE, BURNT, UNBURNT, PROFILE, THERMAL, BOUNDARY, CONDITION
MFloat FvCartesianSolver::m_deltaYtemperatureProfile
default = 0.01
Controls the temperature profile of the isothermal boundary conditions 3909 (bcNeumannIsothermalUnburntProfile). In between this distance the temperature is rising from the unburnt temperature in the inflow tube up to the burnt temperature controlled by the burntUnburntTemperatureRatio /n possible values are:
Keywords: COMBUSTION, TEMPERATURE, BURNT, UNBURNT, PROFILE, THERMAL, BOUNDARY, CONDITION
MFloat FvCartesianSolver::m_thermalProfileStartFactor
default = 1.0
Controls the temperature profile starting point of the isothermal boundary conditions 4905 (bcNeumannIsothermalBurntProfile). /n possible values are:
Keywords: COMBUSTION, TEMPERATURE, BURNT, UNBURNT, PROFILE, THERMAL, BOUNDARY, CONDITION
MFloat FvCartesianSolver::m_flameRadiusOffset
default = 0.0
Controls the temperature profile of the isothermal boundary conditions 4905 (bcNeumannIsothermalBurntProfile). In between this distance the temperature is rising from the unburnt temperature at the tube edges, see radiusFlameTube, up to the burnt temperature controlled by the burntUnburntTemperatureRatio /n possible values are:
Keywords: COMBUSTION, TEMPERATURE, BURNT, UNBURNT, PROFILE, THERMAL, BOUNDARY, CONDITION
MFloat FvCartesianSolver::m_shearLayerStrength
default = 50.0
Controls the boundary layer thickness of the velocity top hat profile of a bunsen flame with the cut off boundary condition 17515 and the corresponding sponge layer type 17515, spongeLayerType /n possible values are:
Keywords: COMBUSTION, VELOCITY, TOP, HAT, PROFILE, STRENGTH
MFloat FvCartesianSolver::m_inflowTemperatureRatio
default = 1
Controls the inflow temperature ratio. /n possible values are:
Keywords: COMBUSTION, TEMPERATURE, BURNT, UNBURNT, RATIO
MFloat FvCartesianSolver::m_lambdaPerturbation
default = 1
Controls ?? /n possible values are:
Keywords: COMBUSTION, TEMPERATURE, BURNT, UNBURNT, RATIO
MFloat FvCartesianSolver::m_perturbationAmplitude
default = 0.001
Perturbation amplitude of a flame surface. /n possible values are:
Keywords: COMBUSTION, TEMPERATURE, BURNT, UNBURNT, RATIO
MFloat FvCartesianSolver::m_perturbationAmplitudeCorr
default = 0.001
Code calculated perturbation amplitude of a flame surface. Used for exact growth rate computations. /n possible values are:
Keywords: COMBUSTION, TEMPERATURE, BURNT, UNBURNT, RATIO
MBool FvCartesianSolver::m_divergenceTreatment
default = false
Sets the divergency to zero in the flame tube area, needed if there is a defined velocity profile /n possible values are:
Keywords: COMBUSTION, DIVERGENCE, TREATMENT, VELOCITY, PROFILE
MBool FvCartesianSolver::m_acousticAnalysis
default = false
Sets the acoustic analysis /n possible values are:
Keywords: COMBUSTION, ACOUSTIC, ANALYSIS
MFloat FvCartesianSolver::m_ScT
default = 0.4
Turbulent Schmidt number. /n possible values are:
Keywords: COMBUSTION, SCHMIDT, NUMBER, TURBULENT
MFloat FvCartesianSolver::m_NuT
default = 0.0017169
Turbulent viscosity. /n possible values are:
Keywords: COMBUSTION, TURBULENT, VISCOSITY
MFloat FvCartesianSolver::m_integralAmplitude
default = 0.0155
Integral amplitude evaluated at integral length scale. /n possible values are:
Keywords: COMBUSTION, INTEGRAL, AMPLITUDE
MFloat FvCartesianSolver::m_integralLengthScale
default = 0.3
Integral length scale. /n possible values are:
Keywords: COMBUSTION, INTEGRAL, LENGTH, SCALE
MBool FvCartesianSolverXD<nDim_,SysEqn>::m_jet
default = false
Sets the problem to be a "jet" problem.
Possible values are:
Keywords: FINITE VOLUME, JET
MBool FvCartesianSolver::m_chevron
default = false
Enables some specifications for jet physics with chevron nozzles.
Keywords: FINITE_VOLUME, JET, NOZZLE
MFloat FvCartesianSolver::m_maNozzleExit
default = none
Desired Mach number of the jet at the exit of the nozzle (see chevron).
Keywords: FINITE_VOLUME, JET, NOZZLE
MFloat FvCartesianSolver::m_inletRadius
default = none
Inlet radius of the nozzle (see chevron).
Keywords: FINITE_VOLUME, JET, NOZZLE
MFloat FvCartesianSolver::m_outletRadius
default = none
Outlet radius of the nozzle (see chevron).
Keywords: FINITE_VOLUME, JET, NOZZLE
MFloat FvCartesianSolver::m_normJetTemperature
default = 1.0
Normalized jet temperature at the nozzle exit. E.g. Xia et. al. 2009, Int.J.Heat&Fluid: m_normJetTemperature = T_jet/T_infinity = 0.84
Keywords: FINITE_VOLUME, JET, NOZZLE
MBool FvCartesianSolverXD<nDim_,SysEqn>::m_jetForcing
default = false
Jet forcing switch for a jet associated with property jet and boundary condition bc18516.
Possible values are:
Keywords: FINITE VOLUME, JET, FORCING
MFloat FvCartesianSolverXD<nDim_,SysEqn>::m_shearLayerThickness
default = 0
Shear layer thickness of a jet associated with property jet.
Possible values are:
Keywords: FINITE VOLUME, JET, SHEAR LAYER
MFloat FvCartesianSolverXD<nDim_,SysEqn>::m_MaCoflow
default = 0
Mach number of the co flow.
Possible values are:
Keywords: FINITE VOLUME, JET, SHEAR LAYER
MFloat FvCartesianSolverXD<nDim_,SysEqn>::m_jetHeight
default = 0.5
Radial extend of a jet associated with property jet. Used in bc19516 with reference to "Effects of Inflow Conditions and Forcing on Subsonic Jet Flows and Noise AIAA 2005" Bogey and Bailly.
Also used for jet forcing in FvCartesianSolver3D::updateJet() for the jet forcing in case 19516.
Possible values are:
Keywords: FINITE VOLUME, JET, RADIAL EXTEND
MFloat FvCartesianSolver::m_primaryJetRadius
default = 0.25
Radius of core jet in a coaxial configuration. Therewith it is the inner radius of the outer jet.
Possible values are:
Keywords: FINITE_VOLUME, VARIABLES, JET
MFloat FvCartesianSolver::m_secondaryJetRadius
default = 0.5
Outer radius of outer jet in a coaxial configuration.
Possible values are:
Keywords: FINITE_VOLUME, VARIABLES, JET
MFloat FvCartesianSolver::m_targetVelocityFactor
default = 0.5
no use. should be removed.
Possible values are:
Keywords: FINITE_VOLUME, VARIABLES, JET
MFloat FvCartesianSolver::m_jetForcingPosition
default = 0.5
Defines the x-location where the jet forcing is applied. Only relevant for 3D jet with vortex ring forcing.
possible values are:
Keywords: FINITE_VOLUME, JET, FORCING
MFloat FvCartesianSolver::m_jetRandomSeed
default = 1
Defines random number seed for jet vortex ring forcing. Only relevant for 3D jet with vortex ring forcing.
possible values are:
Keywords: FINITE_VOLUME, JET, FORCING
MInt FvCartesianSolver::m_modeNumbers
default = 0
Defines number of modes to be considered for 3D jet with vortex ring forcing.
possible values are:
Keywords: FINITE_VOLUME, FORCING, MODES
MFloat FvCartesianSolver::m_momentumThickness
default = 0.025
Momentum thickness for non-dimensionalization in (coaxial) jet initial condition/boundary conditions.
Possible values are:
Keywords: FINITE_VOLUME, VARIABLES, JET
MInt FvCartesianSolver::jetType
default = 0
Type of jet case volume forcing,
possible values:
Keywords: FV, JET, FORCING
MFloat FvCartesianSolver::m_forceCoefficient
default = 0.007
Force coefficient for calculation of uy11 and ur by
Choose forceCoefficient 0.007 for Bogey&Bailly reference
uy11 = (m_forceCoefficient * az * uy1)
and
ur = (m_forceCoefficient * az * ur0)
Keywords: FINITE_VOLUME
MFloat FvCartesianSolver::m_jetConst
default = None
Set jet constants.
Possible values are:
Keywords: FINITE_VOLUME, VARIABLES, JET
MFloat FvCartesianSolver::m_spongeFactor
default = 1.0, ... , 1.0
The property controls on which boundaries a sponge layer is active. Each entry corresponds to the respecive sponge boundary Id spongeBndryCndIds and controls the specific sponge layer thickness on this specific boundary. If a factor is zero, no sponge layer is generated at this boundary. Only meaningful and required if both spongeLayerThickness and sigmaSponge are specified and nonzero!
possible values for each entry are:
Keywords: FINITE_VOLUME, SPONGE, FACTOR
MString FvCartesianSolver::m_spongeDirections
no default values used, the values are dependent on your sponge boundaries
The property should be specified so that the Each entry corresponds to the respecive sponge boundary Id specified in your properties as spongeBndryCndIds (Id_1, Id_2, ..., Id_n) and controls the specific sponge layer thickness on this specific boundary. If a factor is zero, no sponge layer is generated at this boundary. Only meaningful and required if both spongeLayerThickness and sigmaSponge are specified and nonzero!
possible values for each entry are:
Keywords: FINITE_VOLUME, SPONGE, DIRECTION
MInt FvCartesianSolver::m_spongeBndryCndIds
no defalut value
The property controls on which boundaries a sponge layer is active. Each entry corresponds to a boundary Id of your geometry (Id_1, Id_2, ..., Id_n)
possible values for each entry are:
Keywords: FINITE_VOLUME, SPONGE, BOUNDARY, ID, GEOMETRY
MInt FvCartesianSolver::m_sigmaSpongeBndryId
no defalut value
The property controls the sigma sponge at the corresponding sponge boundary Id, see spongeBndryCndIds
possible values for each entry are:
Keywords: FINITE_VOLUME, SIGMA, SPONGE
MInt FvCartesianSolver::m_sigmaEndSponge
no defalut value
The property controls the sigma end sponge factor at the corresponding time dependent sponge boundary Id, see spongeBndryCndIds, spongeTimeDep.
This property should be set if the sponge time dependent function 3 is used, see spongeTimeDependent.
possible values for each entry are:
Keywords: FINITE_VOLUME, SIGMA, TIME, DEPENDENT, SPONGE
MInt FvCartesianSolver::m_spongeStartIteration
no defalut value
The property controls the start of a increasing or decreasing sponge factor triggered with spongeTimeDependent
possible values for each entry are:
Keywords: FINITE_VOLUME, TIME, DEPENDENT, SPONGE, LAYER, START, ITERATION
MInt FvCartesianSolver::m_spongeEndIteration
no defalut value
The property controls the end of a increasing or decreasing sponge factor triggered with spongeTimeDependent
possible values for each entry are:
Keywords: FINITE_VOLUME, TIME, DEPENDENT, SPONGE, LAYER, END, ITERATION
MInt FvCartesianSolver::m_spongeTimeDependent
no defalut value
The property controls the use of a time dependent sponge layer at the corresponding sponge boundary Id, see spongeBndryCndIds.
possible values for each entry are (only implemented for\ref spongeLayerTpe 17515 (should be general implemented via function pointers in the boundary solver):
Keywords: FINITE_VOLUME, TIME, DEPENDENT, SPONGE, LAYER, END, ITERATION
MInt FvCartesianSolver::m_noMaxSpongeBndryCells
default = 0
The property should be specified so that there is enough memory for the total amount of founded sponge cells. Only meaningful and required if both spongeLayerThickness and sigmaSponge are specified and nonzero!
possible values for each entry are:
Keywords: FINITE_VOLUME, SPONGE, DIRECTION
MInt FvCartesianSolver::m_spongeLayerLayout
default = 0
The property controls the layout of the sponge layer. The sponge forcing term added to the rhs of a cell inside the sponge layer is given by
\( \Delta L(\phi) = V \sigma \frac{\Delta x_{sp}^2}{L_s^2} \Delta \phi \),
where \( V \) is the cell volume, \( \sigma \) is the forcing amplitude, \( x_{sp} \) is the inner sponge layer boundary, \( L_{sp} \) is the sponge layer thickness and \( \Delta \phi = \phi - \phi_{target} \) is the difference between the local and the freesteam values of \( \phi \).
Up to now, the user can choose only Cartesian layout for the new sponge layers. The inner sponge layer boundaries are interpreted as parallel to the Cartesian grid lines. That means, for the Cartesian layout, the effective sponge layer thickness is the maximum distance to the boundaries for which a cell is located in the sponge layer. Only meaningful and required if both spongeLayerThickness and sigmaSponge are specified and nonzero!
possible values are:
0
(Cartesian layout) Keywords: FINITE_VOLUME, SPONGE, LAYER. LAYOUT
MInt FvCartesianSolver::m_spongeLayerType
default = 0
The property controls the type of the sponge layer forcing. The sponge forcing term added to the rhs of a cell inside the sponge layer is given by
\( \Delta L(\phi) = V \sigma \frac{\Delta x_{sp}^2}{L_s^2} \Delta \phi \),
where \( V \) is the cell volume, \( \sigma \) is the forcing amplitude, \( x_{sp} \) is the inner sponge layer boundary, \( L_{sp} \) is the sponge layer thickness and \( \Delta \phi = \phi - \phi_{target} \) is the difference between the local and the freesteam values of \( \phi \).
This property controls which variables \( \phi \) will be forced and how the target value \( \phi_{target} \) is defined. For details, see the functions FvCartesianSolver3D::updateSpongeLayer() and FvCartesianSolver2D::updateSpongeLayer(). Only meaningful and required if both spongeLayerThickness and sigmaSponge are specified and nonzero!
possible values are:
Keywords: FINITE_VOLUME, SPONGE
MFloat FvCartesianSolver::m_targetDensityFactor
default = 1.0
The property controls the Intensity of the sponge layer correction regarding the density forcing term for some values of the spongeLayerType. The sponge forcing term added to the rhs of a cell inside the sponge layer is given by
\( \Delta L(\phi) = V \sigma \frac{\Delta x_{sp}^2}{L_s^2} \Delta \phi \),
where \( V \) is the cell volume, \( \sigma \) is the forcing amplitude, \( x_{sp} \) is the inner sponge layer boundary, \(
L_{sp} \) is the sponge layer thickness and \( \Delta \phi = \phi - \phi_{target} \) is the difference between the local and the freesteam values of \( \phi \).
The density target value is in these cases given as:
deltaRho =a_pvariable( cellId , PV->RHO ) - m_rhoInfinity * m_targetDensityFactor;
See also spongeLayerType. Only meaningful and required with certain values for spongeLayerType and if both spongeLayerThickness and sigmaSponge are specified and nonzero! !
possible values are:
Keywords: FINITE_VOLUME, SPONGE
MFloat FvCartesianSolver::m_spongeReductionFactor
default = 1.0
The property controls the intensity of the sponge layer velocity forcing. The sponge forcing term added to the rhs of a cell inside the sponge layer is given by
\( \Delta L(\phi) = V \sigma \frac{\Delta x_{sp}^2}{L_s^2} \Delta
\phi \),
where \( V \) is the cell volume, \( \sigma \) is the forcing amplitude, \( x_{sp} \) is the inner sponge layer boundary, \( L_{sp} \) is the sponge layer thickness and \( \Delta \phi = \phi -
\phi_{target} \) is the difference between the local and the freesteam values of \( \phi \).
The velocity target value is in these cases given as:
deltaV =a_pvariable( cellId , PV->VV[1] ) - velocity ) * m_rhoInfinity;
See also spongeLayerType. Only meaningful and required with certain values for spongeLayerType and if both spongeLayerThickness and sigmaSponge are specified and nonzero! !
possible values are:
Keywords: FINITE_VOLUME, SPONGE, REDUCTION, FACTOR
MBool FvCartesianSolver:: m_velocitySponge
default = 0
The property controls wether a velocity sponge is apllied or not
The velocity target value is in these cases depending on the spongeWeigth which is a local moving time averaging given as:
deltaV =a_pvariable( cellId , PV->VV[1] ) - velocityAv ) * m_rhoInfinity;
and velocityAv = (1-\alpha)*velocityOld + \alpha*velocityNew
with \alpha = 1/m_spongeWeight
Only applied for spongeLayerType = 17515. !
possible values are:
Keywords: FINITE_VOLUME, VELOCITY, SPONGE
MFloat FvCartesianSolver:: m_spongeWeight
default = 10
The property controls the strength of the time averaging sponge, see velocitySponge. It's actually the number of iteration to take into account for time averaging.
Only applied for spongeLayerType = 17515. !
possible values are:
Keywords: FINITE_VOLUME, VELOCITY, SPONGE
MFloat FvCartesianSolver:: m_spongeBeta
default = 0
The property controls the sponge function. Linear sponge spongeBeta = 1, quadratic spongeBeta = 2, etc.
possible values are:
Keywords: FINITE_VOLUME, SPONGE, BETA, PROFIL
MBool FvCartesianSolver::m_specialSpongeTreatment
default = false
Fixes the velocity profile instead of damping it to the desired profile, u component is set to zero /n possible values are:
Keywords: FINITE_VOLUME, SPONGE, TREATMENT, VELOCITY, PROFILE
MFloat FvCartesianSolver::m_sigmaSponge
default = nullptr
The property controls the amplitude of the forcing term \( \sigma \) for the sponge layer forcing. The sponge forcing term added to the rhs of a cell inside the sponge layer is given by
\( \Delta L(\phi) = V \sigma
\frac{\Delta x_{sp}^2}{L_s^2} \Delta \phi \),
where \( V \) is the cell volume, \( \sigma \) is the forcing amplitude, \( x_{sp} \) is the inner sponge layer boundary, \( L_{sp} \) is the sponge layer thickness and \( \Delta \phi = \phi - \phi_{target} \) is the difference between the local and the freesteam values of \(
\phi \).
possible values are:
Keywords: FINITE_VOLUME, SPONGE
MFloat FvCartesianSolver::m_sigmaSpongeInflow
default = nullptr
The property controls the amplitude of the forcing term \( \sigma \) for the sponge layer forcing at the inflow. The sponge forcing term added to the rhs of a cell inside the sponge layer is given by
\( \Delta L(\phi) = V
\sigma \frac{\Delta x_{sp}^2}{L_s^2} \Delta \phi \),
where \( V \) is the cell volume, \( \sigma \) is the forcing amplitude, \( x_{sp} \) is the inner sponge layer boundary, \( L_{sp} \) is the sponge layer thickness and \( \Delta \phi = \phi - \phi_{target} \) is the difference between the local and the freesteam values of \( \phi \).
possible values are:
Keywords: FINITE_VOLUME, SPONGE
MFloat FvCartesianSolver::m_spongeFactor
default = 1.0, 1.0, 1.0, 1.0 (2D)
default = 1.0, 1.0, 1.0, 1.0, 1.0, 1.0 (3D)
The property controls on which domain boundaries a sponge layer is active. 2 * nDim values are required. Each entry corresponds to the respecive direction (0: -x, 1: +x, 2: -y, ...) and controls the specific sponge layer thickness on this domain boundary. If a factor is zero, no sponge layer is generated in this direction. Only meaningful and required if both spongeLayerThickness and sigmaSponge are specified and nonzero!
possible values for each entry are:
Keywords: FINITE_VOLUME, SPONGE
MInt FvCartesianSolver::m_spongeLayerLayout
default = 0
The property controls the layout of the sponge layer. The sponge forcing term added to the rhs of a cell inside the sponge layer is given by
\( \Delta L(\phi) = V \sigma \frac{\Delta x_{sp}^2}{L_s^2} \Delta \phi \),
where \( V \) is the cell volume, \( \sigma \) is the forcing amplitude, \( x_{sp} \) is the inner sponge layer boundary, \( L_{sp} \) is the sponge layer thickness and \( \Delta \phi = \phi - \phi_{target} \) is the difference between the local and the freesteam values of \( \phi \).
Up to now, the user can choose between Cartesian and Zylindrical layout. The inner sponge layer boundaries are interpreted either as parallel to the Cartesian grid lines or cylinder surface. That means, for the Cartesian layout, the effective sponge layer thickness is the maximum distance to the domain boundaries for which a cell is located in the sponge layer. For the cylindrical layout (only meaningful if the domain boundaries are symmetrical in x and z, the sponge layer includes all cells with a (xz) radius bigger than the maximum x-domain boundary value minus the effective sponge layer thickness. In y-direction, this sponge layer layout is the same as the Cartesian layout. See also spongeLayerThickness and spongeFactor. Only meaningful and required if both spongeLayerThickness and sigmaSponge are specified and nonzero!
possible values are:
0
(Cartesian layout) 2
(layout in cylindrical coordinate system (streamwise direction is y, radial (xz))) Keywords: FINITE_VOLUME, SPONGE
MInt FvCartesianSolver::m_spongeLayerType
default = 0
The property controls the type of the sponge layer forcing. The sponge forcing term added to the rhs of a cell inside the sponge layer is given by
\( \Delta L(\phi) = V \sigma \frac{\Delta x_{sp}^2}{L_s^2} \Delta \phi
\),
where \( V \) is the cell volume, \( \sigma \) is the forcing amplitude, \( x_{sp} \) is the inner sponge layer boundary, \( L_{sp} \) is the sponge layer thickness and \( \Delta \phi = \phi -
\phi_{target} \) is the difference between the local and the freesteam values of \( \phi \).
This property controls which variables \( \phi \) will be forced and how the target value \( \phi_{target} \) is defined. For details, see the functions FvCartesianSolver3D::updateSpongeLayer() and FvCartesianSolver2D::updateSpongeLayer(). Only meaningful and required if both spongeLayerThickness and sigmaSponge are specified and nonzero!
possible values are:
Keywords: FINITE_VOLUME, SPONGE
template <MInt nDim_, class SysEqn> MFloat FvCartesianSolverXD<nDim_,SysEqn>::m_targetDensityFactor
default = 1.0
The property controls the Intensity of the sponge layer correction regarding the density forcing term for some values of the spongeLayerType. The sponge forcing term added to the rhs of a cell inside the sponge layer is given by
\(
\Delta L(\phi) = V \sigma \frac{\Delta x_{sp}^2}{L_s^2} \Delta \phi \),
where \( V \) is the cell volume, \(
\sigma \) is the forcing amplitude, \( x_{sp} \) is the inner sponge layer boundary, \( L_{sp} \) is the sponge layer thickness and \( \Delta \phi = \phi - \phi_{target} \) is the difference between the local and the freesteam values of \( \phi \).
The density target value is in these cases given as:
deltaRho =a_pvariable( cellId , PV->RHO ) - m_rhoInfinity * m_targetDensityFactor;
See also spongeLayerType. Only meaningful and required with certain values for spongeLayerType and if both spongeLayerThickness and sigmaSponge are specified and nonzero! !
possible values are:
Keywords: FINITE_VOLUME, SPONGE
MInt FvCartesianSolver::m_adaptationInterval
default = 0
Number of timesteps between adaptations. Possible values are:
Keywords: FINITE_VOLUME, ADAPTION
MFloat FvMbCartesianSolverXD::distFac
default = {18.0, 9.0}
Sets the distance factor which is used to calculate the inner (distFac[0]) and outer (distFac[1]) bandwidth.
Possible values are:
Keywords: MOVING BOUNDARY, FINITE_VOLUME
MBool FvCartesianSolver::m_refineDiagonals
default = true
Determines whether the diagonal cells for the interface sensor should be refined as well!
Keywords: SENSOR, ADAPTATION
MFloat FvCartesianSolver::m_fullRANS
default = 0
Trigger a zonal computation.
possible values are:
Keywords: RANS, ZONAL, STRUCTURED
MBool FvMbSolver::m_multipleFvSolver
default = false
Triggers if the solverId is added to the Fv-solution/restartFiles Keywords: FV, MULTI-SOLVER
MFloat FvCartesianSolver::m_stgIsActive
default = 0
Trigger the use of the STG BC.
possible values are:
Keywords: STG, FINITE_VOLUME
MInt FvCartesianSolver::m_bc7909RANSSolverType
default = nullptr
Solver type used for STG. Keywords: FINITE_VOLUME
MInt FvCartesianSolver::m_noRKSteps
default = 5
Number of steps in the Runge-Kutta time-stepping method. possible values are:
Keywords: FV, RUNGE KUTTA, TIME STEPPING
MFloat FvCartesianSolver::m_RKalpha[m_noRKSteps]
default = 0.25, 0.16666666666, 0.375, 0.5, 1
IF noRKSteps is 5.
Coeffients of the Runge-Kutta time-stepping method. possible values are:
Keywords: FV, RUNGE KUTTA, TIME STEPPING
MFloat FvCartesianSolver::m_rungeKuttaOrder
default = 2
Defines the runge kutta method (order). possible values are:
Keywords: TIME_INTEGRATION, RUNGE_KUTTA
MFloat range
default = 0.0001
Species concentration limit for adaptation.
Keywords: PARTICLE
MFloat FvBndryCnd::slipDirection
default: none
Changes the direction of your underwear
Possible values are:
Keywords: FINITE_VOLUME, BOUNDARY CONDITION, Dolce and Gabana, Gucci, Victoria Secret
MInt FvCartesianSolverXD::m_noSpongeZonesOut
default = 0
Used in sponge 51. Number of outflow sponge zones.
Possible values are:
Keywords: FINITE_VOLUME, SPONGE
MInt FvCartesianSolverXD::m_secondSpongeDirectionsIn
default = none
Used in sponge 51 (general averaging in time). Defines the Direction of the sponge for the second inflow. Keywords: FINITE_VOLUME, SPONGE, AVERAGING
MInt FvCartesianSolverXD::m_spongeDirectionsOut
default = none
Outward direction of the sponge layer.
Possible values:
0,1,2 Keywords: FINITE_VOLUME, SPONGE
MInt FvCartesianSolverXD::m_secondSpongeDirectionsOut
default = none
Used in sponge 51 (general averaging in time). Defines the Direction of the sponge for the second outflow. Keywords: FINITE_VOLUME, SPONGE, AVERAGING
MInt FvCartesianSolverXD::m_spongeAveragingOut
default = none
Used in sponge 51 (general averaging in time). Enables/disables averaging a particular "out" sponge region. Keywords: FINITE_VOLUME, SPONGE, AVERAGING
MInt FvCartesianSolverXD::m_timeOfMaxPdiff
default = 0.0
Used in sponge 51. Time in which the pressure is changed to final value.
Possible values are:
Keywords: FINITE_VOLUME, SPONGE
MInt FvCartesianSolverXD::refinementPatches
default = 0
Defines rectangular area for the computation of L and A, integral int l x nabla^2 omega dV and the body force components
Possible values are:
1211 ( xmax=10.0 xmin=-6.0 ymax=10.0)
1212 ( xmax=10.0 xmin=-20.0 ymax=10.0)
Keywords: FINITE_VOLUME, I/O
MInt limDist (local variable)
Threshold of zone of reduced order surface reconstruction for shock capturing. The threshold is the distance to the stl file slopeLimiterFilename measured in cell length of the cells cut by the surface. The associated surface reconstruction method is HOCD_LIMITED_SLOPES_MAN
default = none
Possible values are integers >= 0
Keywords: FINITE_VOLUME, SHOCK CAPTURING, SUPERSONIC FLOWS
MString filename (local variable)
default = none
Fileame of the file containing a surface, e.g. reprenting a discontinuity. The surface recontruction in the vicinity of the surface will be reduced in order. The associated surface reconstruction method is HOCD_LIMITED_SLOPES_MAN Possible value is some string
Keywords: FINITE_VOLUME, SHOCK CAPTURING, SUPERSONIC FLOWS
MFloat limDistF (local variable)
Threshold of zone of reduced order surface reconstruction for shock capturing. The threshold is the distance to outflow boundaries 27[12]? measured using floats. The associated surface reconstruction method is HOCD_LIMITED_SLOPES_MAN
default = 0
Possible values are floats >= 0.0
Keywords: FINITE_VOLUME, SHOCK CAPTURING, SUPERSONIC FLOWS
< Diffusion time (D) equals convection time (lambda) (mu=lambda)
MInt SA (local variable)
default = none
infinite oblique shock initial condition 77: how is the shock aligned in the grid? Possible values are:
Keywords: FINITE_VOLUME, INITIAL CONDITION, OBLIQUE SHOCK
MInt FvCartesianSolverXD::restartInterpolationFromStructured
default = 0
Restart the computation with an interpolated field from structured solver
from a given donorVars/Grid.
Possible values are:
Keywords: INTERPOLATION, IO, FINITE_VOLUME
MFloat shockCoord (local variable)
default = none
infinite oblique shock initial condition 77: position of the shock wave Possible value is a coordinate within the boundaries of the computational domain
Keywords: FINITE_VOLUME, INITIAL CONDITION, OBLIQUE SHOCK
MInt FvCartesianSolverXD::srcFileType
default = 0
Defines the srcFileType.
Possible values are:
Keywords: FINITE_VOLUME, INITIAL_CONDITION, ISOTROPIC, TURBULENCE
MFloat FvCartesianSolverXD::m_Re
default: NONE
Sets the restart Re-number and triggers the restart from the out/restartVariables_init.Netcdf file.
Keywords: FINITE_VOLUME, RESTART
MInt FvCartesianSolverXD::m_Re
default = none
Overwrite Reynolds number for FV isotropic turbulence spectrum initial condition (case 16).
Possible values are:
Keywords: FINITE_VOLUME, INITIAL_CONDITION, ISOTROPIC, TURBULENCE
MInt FvCartesianSolverXD::m_Re
default = none
Overwrite Reynolds number for FV isotropic turbulence spectrum initial condition (case 16).
Possible values are:
Keywords: FINITE_VOLUME, INITIAL_CONDITION, ISOTROPIC, TURBULENCE
MInt FvCartesianSolverXD::initialCondition()::fluctuations
default = 0
If enabled adds velocity perturbations to the pipe initial condition 34.
Possible values are:
0
(off) 1
(on) Keywords: FINITE_VOLUME, INITIAL_CONDITION
MFloat FvCartesianSolverXD::initialcondition::circulation (local)
default = none
circulation of spinning vortices in initial condition 361.
Possible values are:
Keywords: FINITE VOLUME, INITIAL CONDITION, SPINNING VORTEX
MFloat FvCartesianSolverXD::initialcondition::coreRadius (local)
default = none
Core radius of spinning vortices in initial condition 361.
Possible values are:
Keywords: FINITE VOLUME, INITIAL CONDITION, SPINNING VORTEX
SFB686 Bielefeld burner initial field
MFloat FvCartesianSolverXD::L
default = 1
Sets the length of the pressure drop
Also used in FvCartesianSolverXD.cpp
Possible values are:
Keywords: FINITE_VOLUME, PRESSURE
MFloat ReTau
default = no default value
ReTau \( \mathit{Re}_{\tau} \) is used to compute the pressure loss as \( \Delta_p = \frac{( \mathit{M} \mathit{Re}_{\tau} \sqrt{T_{\infty}})^{2}}{\mathit{Re}}
\frac{\rho_{\infty}}{ L_{\infty} } \) Possible values are:
Keywords: FINITE_VOLUME, VARIABLES
void FvCartesianSolverXD::computeSrfcs
default = 0
This trigger enables a cut point correction for grid refinement jumps along boundaries. Split cells and multiple ghost cells are not supported. Possible values are:
Keywords: CUT_POINTS, BOUNDARY_REFINEMENT
MFloat FvCartesianSolver::m_centralizeSurfaceVariablesFactor
default = 0
upwind factor computation based on this factor Keywords: FINITE_VOLUME, AUSM, NUMERICS