MAIA bb96820c
Multiphysics at AIA
Loading...
Searching...
No Matches
propertyPage1

Initialize the FV-multilevel coupler.

Generates a velocity field from Fourier-modes using FFTW.

Analytic motion equations for forced motions.

Return the input file name with given id, overwrite in derived class if points are generated.

Allocate memory for cells located at an interface.

Prepares the communication.

C'tor for the interface class.

Special initialization for boundary conditions only for 3D!

Contructor for the nDim/nDist specific boundary conditions.

This function calculates member vectors.

This function initializes member vectors.

Reads the number of spatial dimensions from the property file.

update proxy cutOff information

Create grid map and partition file if requested by user.

reads the segments in parallel

reads lslb-coupling-specific data

Initialize coupling-class-specific Data.

returns the current position of the body center(s) in bodyCenter used to provide a unique function for both level-set and moving boundary code if invoked with moving boundary code (m_levelSetMb is true), the respective mb function is called!

Checks Propertty-Data which is read in by both ls-and Fv-Solver.

Read coupler properties.

Calculates the conversion factor for different non-dimensionalisations in the LB and LPT solvers.

reads lsfvmb-coupling-specific data

prolongationMethod

MInt CouplerFvMultilevel::m_prolongationMethod
possible values:
0: simple injection (first-order accuracy) 1: bilinear interpolation (second-order accuracy) 2: slope interpolation (second-order accuracy) default = 0

Possible values are:

  • false (off)
  • true (on)

Keywords: FV, MULTILEVEL, COUPLING

correctCoarseBndry

MBool CouplerFvMultilevel::m_correctCoarseBndry
default = false

Possible values are:

  • false (off)
  • true (on)

Keywords: FV, MULTILEVEL, COUPLING

alphaConvergenceCheck

MInt CouplerLbFvEEMultiphase::m_alphaConvergenceCheck
default = 0

Method to check for alpha convergence.
0 : don't check for convergence 1 : check if max diff between alphaOld and alphaNew is smaller the epsAlpha Keywords: EEMultiphase

maxNoAlphaIterations

MInt CouplerLbFvEEMultiphase::m_maxNoAlphaIterations
default = 4

Maximum number of iterations for alpha convergence.
Keywords: EEMultiphase

epsAlpha

MFloat CouplerLbFvEEMultiphase::m_epsAlpha
default = 1.0e-6

The eps for the alpha convergence check.
Keywords: EEMultiphase

alphaFloor

MFloat CouplerLbFvEEMultiphase::m_alphaFloor
default = 0.0

Minimum acceptable value of alpha.
Keywords: EEMultiphase

alphaCeil

MFloat CouplerLbFvEEMultiphase::m_alphaCeil
default = 1.0

Maximum acceptable value of alpha.
Keywords: EEMultiphase

initAlphaMethod

MInt CouplerLbFvEEMultiphase::m_initAlphaMethod
default = 0

Method for the initial distribution of alphaGas.
0 : initialize alphaGas to be zero everywhere 1 : initialize alphaGas to a constant value given in m_initialAlpha 2 : initialize alphaGas to a constant value given in m_initialAlpha in a sphere with radius 0.5 around the origin, else alphaInf Keywords: EEMultiphase

initialAlpha

MFloat CouplerLbFvEEMultiphase::m_initialAlpha
default = 0.0

Initial value of alpha in the domain.
Keywords: EEMultiphase

alphaInf

MFloat CouplerLbFvEEMultiphase::m_alphaInf
default = m_initialAlpha

Infinity value of alpha.
Keywords: EEMultiphase

redistributeAlpha

MBool CouplerLbFvEEMultiphase::m_redistributeAlpha
default = true

Redistribute invalid values for alpha.
Keywords: EEMultiphase

disableSubstepAlphaRedist

MBool CouplerLbFvEEMultiphase::m_disableSubstepAlphaRedist
default = true

Disable the redistribution of alpha in the RK-substeps.
Keywords: EEMultiphase

updateAfterPropagation

MBool CouplerLbFvEEMultiphase::m_updateAfterPropagation
default = true

Update the LB solver after propagation.
Keywords: EEMultiphase

EEMultiphaseInterpolationFactor

MFloat CouplerLbFvEEMultiphase::m_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

EEMultiphaseUpdateFVBC

MBool CouplerLbFvEEMultiphase::m_updateFVBC
default = false

Update the FV BCs after transfer of the variables.
Keywords: EEMultiphase

gravityRefCoords

MFloat CouplerLbFvEEMultiphase::m_gravityRefCoords[nDim]
Reference Coordinates for density correction as a function of depth below the surface
Keywords: EEMultiphase

depthCorrectionCoefficients

MFloat CouplerLbFvEEMultiphase::m_depthCorrectionCoefficients[nDim]
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

lbBox

MFloat CouplerLbLb::m_transferBox
This box defines the volume in which the cell values are transfered from one LB solver to the other.
Keywords: LbLb

meanDataFileName

MString CouplingDgApe::m_meanDataFileName
default = none

Name of the file containing the mean velocities and vorticities.
Keywords: COUPLING, I/O, MEAN_DATA

sourceTerms

vector<MInt> CouplingDgApe::m_activeSourceTerms
default = none

Names of the coupling source terms to use.
The possible source term names are stored in s_sourceTermNames.
Keywords: COUPLING, PHYSICS, SOURCE_TERM

saveSourceTermsInterval

MInt CouplingDgApe::m_saveSourceTermsInterval
default = -1

Interval at which the source terms are stored to disk. If the value is < 1, no source term files are created.
Possible values are:

  • any integer

Keywords: COUPLING, SPATIAL_INTERPOLATION, SOURCE_TERMS, I/O

saveSourceTermsDonorGrid

MBool CouplingDgApe::m_saveSourceTermsDonorGrid
default = false

Enable/disable the saving of the source terms on the donor grid as well. Property is only relevant if "saveSourceTermsInterval" is > 0.
Keywords: COUPLING, SPATIAL_INTERPOLATION, FILTERING, I/O

fixedTimeStep

MInt CouplingDgApe::m_fixedTimeStep
default = none

Use this fixed time step size when using offline coupling.
Keywords: COUPLING, TIME_STEP

applySourceFilterDonor

MBool CouplingDgApe::m_applySourceFilterDonor
default = false

Enable/disable the application of the source term filter on the donor cells instead of on the DG elements after spatial projection of the source terms.
Keywords: COUPLING, SPATIAL_INTERPOLATION, FILTERING, I/O

saveSourceTermFilter

MBool CouplingDgApe::m_saveSourceTermFilter
default = false

Enable/disable the saving of the spatial source term filter values to a file during the initialization phase.
Keywords: COUPLING, SPATIAL_INTERPOLATION, FILTERING, I/O

checkConservation

MBool CouplingDgApe::m_checkConservation
default = false

Select if for each Galerkin projection the conservation error is calculated. If the error exceeds a certain threshold the simulation will abort.
Keywords: COUPLING, SPATIAL_INTERPOLATION, CONSERVATION_ERROR

calcProjectionError

MBool CouplingDgApe::m_calcProjectionError
default = false

Select if for each Galerkin projection the interpolation error in the L2-norm is calculated. The maximum global projection error is written to the m_log at the end of the simulation.
Keywords: COUPLING, SPATIAL_INTERPOLATION, PROJECTION_ERROR

sourceFactor

MFloat CouplingDgApe::m_sourceFactor
default = 1.0

Set a factor by which all source terms are scaled.
Keywords: COUPLING, SOURCE_TERM, SCALING

noCutModesLowPass

MFloat CouplingDgApe::m_noCutModesLowPass
default = 0

Allows to specify a low-pass filter for the source terms.
Keywords: COUPLING, SOURCE_TERM, FILTER

projectionFilter

MBool CouplingDgApe::m_projectionFilter
default = false

Enables a projection filter box to exclude a region from using mean/node varibles from the mean file. Specify box via projectionFilterBox property.
Keywords: COUPLING, MEAN_VARIABLES, FILTER

projectionFilterBox

std::vector<MFloat> CouplingDgApe::m_projectionFilterBox
Projection filter box to exclude a region from using mean/node varibles from the mean file.
Keywords: COUPLING, MEAN_VARIABLES, FILTER

zonal

MBool FvZonal::m_nonZonalRestart
default = 0
Triggers loading of restartFile of nonZonalRestartSolver Keywords: FINITE_VOLUME, FV_ZONAL_STG

Author
Tim Wegmann

cutOffMethod

MString zonalMethod
default = ""

Specifies the zonal method to be used.
Any method which is also specified as a cutOff-method is possible. Currently however only the following are implemented yet:

  • B - box cut-off
  • P - plane cut-off

Keywords: ZONAL

cutOffMethod

MBool zonalDualTimeStepping
default = "false"

Allow for different time-Steps in the different Fv-Mb zones. Keywords: ZONAL

outsideDefault

MFloat* CouplerFvMbZonal::zonalCoordinate
Set the zonal coordinate

  • any float number

Keywords: ZONAL, FVMB-COUPLING

outsideDefault

MInt* CouplerFvMbZonal::zonalDir
Set the zonal direction, must be a cartesian direction!

  • 0 : x-dir
  • 1 : y-dir
  • 2 : z-dir

Keywords: ZONAL, FVMB-COUPLING

zonal

MInt FvZonal::m_zonalAveragingTimeStep
default = NONE

Time step at which the zonal averaging starts. Keywords: FINITE_VOLUME, FV_ZONAL_STG

zonal

MInt FvZonalSTG::m_zonalTransferInterval
default = 0

Time step interval at which the zonal values are exchanged. Keywords: FINITE_VOLUME, FV_ZONAL_STG

zonal

MInt FvZonalRTV::m_restartLESAverage
default = False
Triggers loading of LES Average Keywords: FINITE_VOLUME, FV_ZONAL

zonal

MBool FvZonal::m_cylindricCommunication
default = 0
Triggers communication from sector RANS to full-360 degree LES Keywords: FINITE_VOLUME, FV_ZONAL_STG

zonal

MInt FvZonalRTV::m_rntStartTimeStep
default = False
Triggers reconstruction of LES Average values form nut after nonZonalRestart Keywords: FINITE_VOLUME, FV_ZONAL

zonal

MInt FvZonalRTV::m_reconstructAverageFromNut
default = False
Triggers reconstruction of LES Average values form nut after nonZonalRestart Keywords: FINITE_VOLUME, FV_ZONAL

zonal

MInt FvZonalRTV::m_reconstructNut
default = False
Triggers reconstruction of LES Average values form nut after nonZonalRestart Keywords: FINITE_VOLUME, FV_ZONAL

zonal

MFloat FvZonalRTV::m_turbulentIntensity
default = 0

Turbulent intensity of the free stream. Keywords: FINITE_VOLUME, FV_ZONAL

zonal

MFloat FvZonalSTG::m_uvRANSFactor
default = 0
scale uv of RANS solution Keywords: FINITE_VOLUME, FV_ZONA_STGL

Author
Johannes Grafen, adapted from FV MFloat lengthFactor
default = 1

Set L_refLB/L_refLPT the conversion between different reference length used in the non-dimensionalisation and the calculation of the solver specific Re-number in the LB and LPT solver.
Keywords: PARTICLE, LATTICE BOLTZMANN

MFloat velocityFactor
default = 1

Set u_refLB/u_refLPT the conversion between different velocities used in the non-dimensionalisation and the calculation of the solver specific Re-number in the LB and LPT solver.
Keywords: PARTICLE, LATTICE BOLTZMANN

MFloat viscosityFactor
default = 1.0

The conversion-factor for LB reference viscosity (mu_ref at T_ref) to LPT viscosity (mu_ref at T_ref) as used in the solver-specific Re-numbers. The viscosityFactor itself is non-dimensional!
Keywords: PARTICLE, LATTICE BOLTZMANN

Author
Julian Vorspohl j.vor.nosp@m.spoh.nosp@m.l@aia.nosp@m..rwt.nosp@m.h-aac.nosp@m.hen..nosp@m.de
Date
May 2021

cfl

MFloat COUPLER::m_forceLbTimeStep
default = true

Specify whether the LB-solver alone should force the time-step in the LB-LPT coupling! Otherwise, the minimum timestep of LPT and LB solver is computed and enforce! This however requires a sub-coupling!

,false Keywords: LPT, LB, COUPLING

Author
Tim Wegmann

maxLevelsetVelocityForTimestep

MFloat LsCartesianSolver::computeGCellTimeStep()::maxVelocity
default = 14.5

Set maximum velocity used to compute m_timeStep if m_timeStepMethod == 7.

Possible values are:

  • any positive floating point value

Keywords: LEVELSET, TIMESTEP

bandWidthRefMax

MFloat CouplingLsFv::bandWidthRef
default = 4/5

Defines the number of cells (on all levels and on the maxRefinementLevel) which will be refined around the G0-cells

  • any positive floating point value

Keywords: LEVELSET, Refinement

Author
Claudia Guenther
Date
03/2011

amplitudes

MFloat* LsCartesianSolver::m_static_computeBodyProperties_amplitude
default = none

Amplitude for body motion of embedded bodies.
NOTE: also used in FV-MB solver for some special cases.

Possible values are:

  • list of floating point numbers

Keywords: LEVELSET, MOVING, BODY, BODY_MOTION

freqFactors

MFloat* LsCartesianSolver::m_static_computeBodyProperties_freqFactor
default = none

Set the frequency factors for prescribing body motion for all embedded bodies.
NOTE: also used in FV-MB solver for some special cases.

Possible values are:

  • list of positive floating point numbers

Keywords: LEVELSET, MOVING, BODY, BODY_MOTION

bodyMovementFunctions

MInt* LsCartesianSolver::m_static_computeBodyProperties_bodyToFunction
default = 1

Prescribes the functions for the body movement. Check the switch case in computeBodyProperties() for what each case actually does.

Possible values are:

  • integer from 1 to 7

Keywords: LEVELSET, BODY, BODY_MOTION, MOVING

initialBodyCenters

MFloat LsCartesianSolver::initialBodyCenter
For each body, nDim Float values. With this property, one can move an STL around to its initial position. In initialInsidePoints is the "real" center of the stl files. This property, is the movement from the "real" center to the initial center used during calculation.

Keywords: LEVELSET, MULTILEVELSET, MB

liftStartAngles1

MFloat LsCartesianSolver::liftStartAngle1
default = 0.0

For each body, sets the start angle of the translation. The translation is described by a:

  • bodyToFunction case 1: cosine function
  • bodyToFunction case 2: valve lift shifted quadratic sine function (first angle)
    • Between 0 and 4.0 * PI
    Keywords: LEVELSET, MULTILEVELSET, MB

liftStartAngles2

MFloat LsCartesianSolver::liftStartAngle2
default = 3.0 * PI

For each body, sets the start angle of the translation. The translation is described by a:

  • bodyToFunction case 2: valve lift shifted quadratic sine function (second angle)
    • Between 0 and 4.0 * PI
    Keywords: LEVELSET, MULTILEVELSET, MB

liftEndAngles1

MFloat LsCartesianSolver::liftEndAngle1
default = PI

For each body, sets the end angle of the translation.

  • Between 0 and 4.0 * PI

Keywords: LEVELSET, MULTILEVELSET, MB

liftEndAngles2

MFloat LsCartesianSolver::liftEndAngle2
default = 4.0 * PI

For each body, sets the end angle of the translation.

  • Between 0 and 4.0 * PI

Keywords: LEVELSET, MULTILEVELSET, MB

circleStartAngles

MFloat LsCartesianSolver::circleStartAngle
default = 0.0

For each body, sets the start angle for the circular motion case. (i.e. bodyToFunction case 5).

  • Between 0 and 4.0 * PI

Keywords: LEVELSET, MULTILEVELSET, MB

rotAngle

MFloat LsPar::rotAngle
default = "0.0"

Used to rotate the primary direction of the body movement. information in the property-file is expected in degree!

  • Any positive Float

Keywords: LEVELSET EMBEDED BOUNDARY, MOVEMENT FUNCTIONS

transferRegion

MFloat LsLb::m_transferRegion
default =

Set the region in which the LS values are transferred to the LB solver.
The array is filled by the following convention: -x, -y, -z, x, y, z
Keywords: LATTICE_BOLTZMANN, LEVEL-SET

outsideDefault

MBool* LsLb::outsideDefault
default = true

A trigger which determines the default levelset values of a lb-cell if no connection a ls-cell can be found! This is the case if the ls-domain is smaller than the lb-domain! Possible values are:

  • true: possitive outsideGValue
  • false: negative outsideGValue

Keywords: LEVELSET, MULTIPLE LEVEL SET FUNCTIONS

maxNoCells

MInt maxNoCells
default = nullptr

How many cells are maximal allowed, memory issue!
Keywords: GENERAL

scratchSize

MInt Scratch::m_number_of_elements
default = 1.0

Defines size of the scratch space in bytes: m_number_of_elements = scratchSize*maxNoCells*sizeOf(MFloat) bytes
Keywords: GENERAL

kFactor

MInt FcBndryCnd::m_kFactor
default = 1e+12

Factor to set for fixation bndry conditions
Keywords: FINITE_CELL

subCellLayerDepth

MInt FcBndryCnd::m_subCellLayerDepth
default = 0

Subcell layer depth for sub cell integration for each bndry
Keywords: FINITE_CELL

multiBC

MBool FcBndryCnd::multiBCTreatment
default = true

This property defines if cells can have multiple BCs

  • true all BCs are applied to the cell
  • I-P-W only the first/last BC is applied to the cell //TODO: Check if first or last


Keywords: FINITE_CELL

bndryNormalMethod

MString FcBndryCnd::bndryNormalMethod
default = calcNormal

This property defines the way segment normals are calculated.

  • read reads the normals from the property file (bndryNormalVectors) TODO:
  • calcNormal calculates the normals based on triangle information and averages them TODO:
  • fromSTL reads the normals from STL and averages them


Keywords: FINITE_CELL

isThermal

MBool FcSolver::m_isThermal
default = false

Do thermal stresses exist.
Keywords: FINITE CELL

polyDegree

MInt FcSolver::m_polyDeg
default = 0

Specifies the polynominal degree
Keywords: FINITE CELL

testRun

MBool FcSolver::m_testRun
default = false

Enables extra debug output.
Keywords: FINITE CELL

analyticSolution

MFloat FcSolver::m_analyticSolution
default = F1

Keywords: FINITE CELL

printEigenValues

MBool FcSolver::m_printEigenValues
default = false

Keywords: FINITE CELL

EModule

MFloat FcSolver::m_E
default = 100000.0

Defines the E-Module of the material.
Keywords: FINITE CELL

epsBiCG

MFloat FcSolver::m_eps
default = 1e-12

Defines the limit for the iterative solver.
Keywords: FINITE CELL

alpha

MFloat FcSolver::m_alpha
default = 1e-14

Defines the penalty factor for sub cell integration.
Keywords: FINITE CELL

noIterations

MInt FcSolver::m_maxNoIterations
default = 10000

Specifies the maximum number of iterations.
Keywords: FINITE CELL

noLoadSteps

MInt FcSolver::m_noLoadSteps
default = 10

Specifies the maximum number of sub steps for iterative calculation of displacements.
Keywords: FINITE CELL

solveSoEIteratively

MInt FcSolver::m_solveSoEIteratively
default = true

Specifies if the SoE is solved iteratively using BiCGStab or directly using Eigen SuperLU.
Keywords: FINITE CELL

fcInterpolationMethod

MString FcSolver::m_fcInterpolationMethod
default = LAGRANGE_INTERP

Specifies interpolation method used.
Keywords: FINITE CELL

filterShape

MString Filter::filterShape
default = none

Specify shape of filter.
Possible values are:

  • "sphere"
  • "cylinderzaxis"
  • "box"
  • "multibox"

Keywords: FILTER

filterSlopeType

MString Filter::filterSlopeType
default = none

Specify slope type of filter.
Possible values are:

  • "linear"
  • "cos"

Keywords: FILTER

filterCenter

MFloat DgCcApeSourceFiles::m_filterCenter
default = none

The centor of the sphere that specifies the source term region.
Keywords: COUPLING, SOURCE_TERM, FILTER ‍/ m_filterCenter[i] = Context::getSolverProperty<MFloat>("filterCenter", m_solverId, AT_, i); } /*!

filterRadius

MFloat DgCcApeSourceFiles::m_filterRadius
default = none

The radius of the sphere that specifies the source term region.
Keywords: COUPLING, SOURCE_TERM, FILTER ‍/ m_filterRadius = Context::getSolverProperty<MFloat>("filterRadius", m_solverId, AT_); } else { read properties of box filter for(MInt i = 0; i < nDim; i++) { /*!

filterRegionMin

MFloat DgCcApeSourceFiles::m_filterRegionMin
default = none

The coordinates of the lower left corner of the source term region.
Keywords: COUPLING, SOURCE_TERM, FILTER ‍/ m_filterRegionMin[i] = Context::getSolverProperty<MFloat>("filterRegionMin", m_solverId, AT_, i);

/*!

filterRegionMax

MFloat DgCcApeSourceFiles::m_filterRegionMax
default = none

The coordinates of the upper right corner of the source term region.
Keywords: COUPLING, SOURCE_TERM, FILTER ‍/ m_filterRegionMax[i] = Context::getSolverProperty<MFloat>("filterRegionMax", m_solverId, AT_, i); } }

Initialization is done! m_isInitialized = true; }

/**Calculates filter vaule for a given coordinates and returns it

\author Marcus Wiens (marcus) <m.wiens@aia.rwth-aachen.de>
\date 2016-07-16 

zonal

MBool MAIAFvCartesianSolver::m_restartLESAverage
default = False
Triggers loading of LES Average Keywords: FINITE_VOLUME, FV_ZONAL

referenceTemperature

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:

  • Non-negative floating point values

Keywords: FINITE_VOLUME, VARIABLES

sutherlandConstant

MFloat FvCartesianSolver::m_sutherlandConstant
default = 110.4 K

Sutherland's constant. Used by Sutherland's law. possible values are:

  • Non-negative floating point values

Keywords: FINITE_VOLUME, VARIABLES

sutherlandConstantThermal

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:

  • Non-negative floating point values

Keywords: FINITE_VOLUME, VARIABLES

viscousFluxScheme

MString FvCartesianSolver::m_viscousFluxScheme
default = FIVE_POINT
Scheme for the calculation of the viscous flux
Possible values are:

  • THREE_POINT
  • FIVE_POINT
  • FIVE_POINT_STABILIZED

Keywords: FINITE VOLUME, NUMERICS, FLUX

viscousFluxScheme

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

stgSubSup

MFloat FvStructuredSolver::m_stgSubSup
default = 0

Use mixed subsonics/subsonic formulation
of the STG boundary.
possible values are:

  • true/false

Keywords: STG, STRUCTURED

stgSupersonic

MFloat FvStructuredSolver::m_stgSupersonic
default = 0

Use supersonic STG boundary formulation.
possible values are:

  • true/false

Keywords: STG, STRUCTURED

BLT1

MFloat FvStructuredSolver::m_stgBLT1
default = 1.0

Defines the size of the STG virtual box
in the x-direction as a fraction of the
delta0 specified.
possible values are:

  • Floating point > 0.0

Keywords: STG, STRUCTURED

BLT2

MFloat FvStructuredSolver::m_stgBLT2
default = 2

Defines the size of the STG virtual box
in the y-direction as a fraction of the
delta0 specified.
possible values are:

  • Floating point > 0.0

Keywords: STG, STRUCTURED

BLT3

MFloat FvStructuredSolver::m_stgBLT3
default = 1.1

Defines the size of the STG virtual box
in the z-direction as a fraction of the
delta0 specified.
possible values are:

  • Floating point > 0.0

Keywords: STG, STRUCTURED

stgLengthFactors

MFloat FvStructuredSolver::m_stgLengthFactors
default = 1.0, 0.6, 1.5

The factor to scale the length scales
in each coordinate direction with. For higher
Reynolds number the values [1.0, 0.5, 1.4]
produce better results.
possible values are:

  • Float<3> > 0.0

Keywords: STG, STRUCTURED

stgRSTFactors

MFloat FvStructuredSolver::m_stgRSTFactors
default = 1.0, 0.4, 0.5

The factor to scale the length scales
in each coordinate direction with. For higher
Reynolds number the values [1.0, 0.4, 0.5]
produce better results.
possible values are:

  • Float<3> > 0.0

Keywords: STG, STRUCTURED

stgMaxNoEddies

MFloat FvStructuredSolver::m_stgMaxNoEddies
default = 200

Number of Eddies in the STG virtual box.
possible values are:

  • Integer > 0

Keywords: STG, STRUCTURED

stgExple

MFloat FvStructuredSolver::m_stgExple
default = 0.5

Exponent of the STG LengthScale law.
possible values are:

  • Floating point > 0.0

Keywords: STG, STRUCTURED

stgEddieDistribution

MFloat FvStructuredSolver::m_stgEddieDistribution
default = 1.0

Shift die eddie distribution more to the wall
or boundary layer edge.
possible values are:

  • Floating point > 0.0

Keywords: STG, STRUCTURED

stgCreateNewEddies

MFloat FvStructuredSolver::m_stgCreateNewEddies
default = 0

Enforces the creation of all new eddies in STG virtual box
or boundary layer edge.
possible values are:

  • true/false

Keywords: STG, STRUCTURED

stgInitialStartup

MFloat FvStructuredSolver::m_stgInitialStartup
default = 0

Initialize STG Method at Startup
possible values are:

  • true/false

Keywords: STG, STRUCTURED

stgEddieLengthScales

MFloat FvStructuredSolver::m_stgEddieLengthScales
default = 0

Connect length scales to eddies, not cells.
possible values are:

  • true/false

Keywords: STG, STRUCTURED

stgShapeFunction

MFloat FvStructuredSolver::m_stgFunction
default = 4

Shape function to be used in STG method.
possible values are:

  • Integer >= 0

Keywords: STG, STRUCTURED

zCoordFor2DInterpolation

MInt zCoordFor2DInterpolation
default = 0

BlaBlaBlub.
Possible values are:

  • Float

Keywords: INTERPOLATION, IO, FINITE_VOLUME

stgIOCoordinates

MInt stgIOCoordinates
default = false

....

0 Possible values are:

  • 0,1,2

Keywords: FINITE_VOLUME, STG

stgIOCoordinates

MInt stgIOCoordinates
default = false

....

Possible values are:

  • 0,1,2

Keywords: FINITE_VOLUME, STG

waveTemporalTransition

MInt FvStructuredSolver::m_waveOutEndTransition
default = 500.0

Acoustic time for wave actuation to transiate from flat plate
to fully extended.
Possible values are:

  • Float

Keywords: WAVE, MOVING, STRUCTURED

waveLength

MInt FvStructuredSolver::m_waveLength
default = 1.0

Wavelength of the traveling wave.
Possible values are:

  • Float > 0.0

Keywords: WAVE, MOVING, STRUCTURED

waveAmplitudeSuction

MInt StrctrdBlck::m_waveAmplitudeSuction
default = 1.0

Amplitude of the traveling wave on the airfoil suction side.
Possible values are:

  • Float > 0.0

Keywords: WAVE, MOVING, STRCTRD

waveAmplitudePressure

MInt StrctrdBlck::m_waveAmplitudePressure
default = 1.0

Amplitude of the traveling wave on the airfoil suction side.
Possible values are:

  • Float > 0.0

Keywords: WAVE, MOVING, STRCTRD

waveTime

MInt FvStructuredSolver::m_waveTime
default = 1.0

Period time of the traveling wave.
Possible values are:

  • Float > 0.0

Keywords: WAVE, MOVING, STRUCTURED

waveBeginTransition

MInt FvStructuredSolver::m_waveBeginTransition
default = 1.0

Start of the transition from flat to wave in x-dir.
Possible values are:

  • Float

Keywords: WAVE, MOVING, STRUCTURED

waveEndTransition

MInt FvStructuredSolver::m_waveEndTransition
default = 1.0

End of the transition from flat to wave in x-dir.
Possible values are:

  • Float

Keywords: WAVE, MOVING, STRUCTURED

waveOutBeginTransition

MInt FvStructuredSolver::m_waveOutBeginTransition
default = 1.0

Start of the transition from wave to flat in x-dir.
Possible values are:

  • Float

Keywords: WAVE, MOVING, STRUCTURED

waveOutEndTransition

MInt FvStructuredSolver::m_waveOutEndTransition
default = 1.0

End of the transition from wave to flat in x-dir.
Possible values are:

  • Float

Keywords: WAVE, MOVING, STRUCTURED

wavePressureBeginTransition

MInt FvStructuredSolver::m_wavePressureBeginTransition
default = 1.0

Start of the transition from flat to wave in x-dir.
Possible values are:

  • Float

Keywords: WAVE, MOVING, STRUCTURED

wavePressureEndTransition

MInt FvStructuredSolver::m_wavePressureEndTransition
default = 1.0

End of the transition from flat to wave in x-dir.
Possible values are:

  • Float

Keywords: WAVE, MOVING, STRUCTURED

wavePressureOutBeginTransition

MInt FvStructuredSolver::m_wavePressureOutBeginTransition
default = 1.0

Start of the transition from wave to flat in x-dir.
Possible values are:

  • Float

Keywords: WAVE, MOVING, STRUCTURED

wavePressureOutEndTransition

MInt FvStructuredSolver::m_wavePressureOutEndTransition
default = 1.0

End of the transition from wave to flat in x-dir.
Possible values are:

  • Float

Keywords: WAVE, MOVING, STRUCTURED

waveYBeginTransition

MInt FvStructuredSolver::m_waveYBeginTransition
default = 1.0

End of the transition from wave to flat in x-dir.
Possible values are:

  • Float

Keywords: WAVE, MOVING, STRUCTURED

waveYEndTransition

MInt FvStructuredSolver::m_waveYEndTransition
default = 1.0

End of the transition from wave to flat in x-dir.
Possible values are:

  • Float

Keywords: WAVE, MOVING, STRUCTURED

parallelGeometry

MInt Geometry::m_parallelGeometry
default = 0

Test if point is inside or outside of stl.
possible values are:

  • STD: Standard ?
  • SAT: Separation Access Theorem

Keywords: GRID, GENERATOR, PARALLEL, MASSIVE, TRIGGER, GEOMETRY

parallelGeometry

MBool Geometry::m_parallelGeometry
default = 0

Trigger the use of parallel geometry.
possible values are:

  • 0 : deactivated
  • 1 : activated

Keywords: GRID, GENERATOR, PARALLEL, MASSIVE, TRIGGER, GEOMETRY

debugParGeom

MBool Geometry::m_debugParGeom
default = 0

Trigger the debug mode of the parallel geometry.
possible values are:

  • 0 : deactivated
  • 1 : activated

Keywords: GRID, GENERATOR, PARALLEL, MASSIVE, TRIGGER, GEOMETRY

parallelGeomFileName

MString Geometry::m_parallelGeomFileName
default = no default

defines new name for parallely generated 3D geometry
possible values are:

  • any string

Keywords: PARALLEL, GEOMETRY

parGeomMemFactor

MString Geometry::m_parGeomMemFactor
default = 1.0

Can be increased to increase the number of cells the collector is allocated with.
possible values are:

  • any double > 1.0

Keywords: PARALLEL, GEOMETRY

communicateSegmentsSerial

MBool Geometry3D::m_communicateSegmentsSerial
default = true

If enabled the geometry files are read only on rank 0 and the geometry information is broadcasted to all other ranks, since on a large number of ranks the parallel read of the geometry files from all ranks at the same time can be very slow.
Keywords: GEOMETRY, IO

inputDir

MString Geometry2/3D::Geometry2/3D()::inputDir
default = "./"

Specify input path for geometry property file relative to testcaseDir.

Possible values are:

  • relative path

Keywords: GENERAL, IO, GEOMETRY, DIRECTORY

geometryInputFileName

MString geometry3d::tmpFileName
default = no default value

Name of the geometry property file possible values are:

  • string

Keywords: geometry

gridCutTest

MString Geometry3D::m_gridCutTest
default = SAT

Method to use for checking if a cell is intersected by a geometry element.
Possible values are:

  • "SAT"
  • something else

Keywords: GEOMETRY, TRIANGLES, CUT CELLS

Author
Andreas Lintermann
Date
17.09.2015

This function only reads the triangles that really belong to this domain. The algorithm does the folloeing:

  1. Read the workload from the grid file. This is necessary to do the same decompositioning on the triangls as on the mesh.
  2. Read basic geometry information, i.e., this reads the array containing the number of triangles contained in the according partitionCell. The size is the same as the partitionCellList. 2.1 Count all local elements and exchange. This is necessary to determine the offsets for reading the triangles. 2.2 Read the original triangle ids based on the offsets from 2.1, which are required to detect double entries. A set is created holding the real number of triangles, excluding multiple entries. This is the real number of triangles a domain has to add.
  3. Init the collector holding the triangles base on the number obtained in 2.2
  4. Read the triangles and skip those that have already been read before. Use a temporary binary array to determine if an entry has already been read. Use the original triangle id to determine such cases. 4.1 Calculate the segment offsets. 4.2 Get the segment ids and write the to the geometry using the offsets from 4.1 4.3 Get the normals. 4.4 Get the vertices.
  5. Calculate the bounding box for all triangles

startTime

MInt* Geometry::m_allBCs
default = no default

Is used to set the Boundary condition for a segment.

Possible values are:

  • Positive Integer values associated with a boundary condition ID.

Keywords: GENERAL, BNDRY, GEOMETRY

partitionCellMaxNoOffspring

MInt CartesianGrid::m_partitionCellOffspringThreshold
default = 50000

controls the filtering of cells in massive parallel file writing
possible values are:

  • Non-negative int value of the order less than number of cells on each domains

Keywords: GRID, GENERATOR, PARALLEL, OUTPUT, FILTER, MAX, MINCELL, SIZE

partitionCellWorkloadThreshold

MFloat CartesianGrid::m_partitionCellWorkloadThreshold
default = 50000

controls the filtering of cells in massive parallel file writing
possible values are:

  • Non-negative int value of the order less than number of cells on each domains

Keywords: GRID, GENERATOR, PARALLEL, OUTPUT, FILTER, MAX, MINCELL, SIZE

periodicCartesianDir

MInt CartesianGrid::m_newMinLevel
default = 0

Specify a new minLevel to which the grid will be raised when writing the new restartGrid file!

  • Any integer between the old minLevel and the m_maxUniformRefinementLevel!

Keywords: GRID

periodicCartesianDir

MFloat CartesianGrid::m_periodicCartesianDir
default = 0

Space direction in which the grid should be periodic.
possible values are:

  • Array with three true/false entries for each Cartesian direction

Keywords: GRID, GENERATOR, PERIODIC

outputDir

MInt CartesianGrid::m_outputDir
default =

Sets the name of the output directory. possible values are:

  • Strings

Keywords: GRID, OUTPUT

restartDir

MInt CartesianGrid::m_outputDir
default = m_outputDir

Sets the name of the directory that is used to restart. possible values are:

  • Strings

Keywords: GRID, RESTART

noHaloLayers

MInt CartesianGrid::m_noHaloLayers
default = 2

number of halo layers possible values are:

  • any non negative integer value

Keywords: GRID, GENERATOR, FLOW, SOLVER, PARALLEL, HALO, LAYER

loadGridPartition

MBool CartesianGrid::m_loadGridPartition
default = 0

enables/disables that a specific grid partitioning is loaded (old concept with two separate grids)
possible values are:

  • 0 (off), 1 (on)

Keywords: GRID, GENERATOR, FLOW, SOLVER, PARALLEL, PARTITIONING

loadPartition

MBool CartesianGrid::m_loadPartition
default = false

enables/disables that a specific grid partitioning is loaded Keywords: GRID, PARALLEL, PARTITIONING

partitionParallelSplit

MBool CartesianGrid::m_partitionParallelSplit
default = false

enables/disables the partitioning with a parallel splitting method possible values are:

  • false (off), true (on)

Keywords: GRID, PARALLEL, PARTITIONING

maxNoSurfaces

MInt CartesianGrid::offset
default = 0

Set the offset for globalIds to 2,147,483,647 (32Bit). This is necessary to facilitate testcases for global Ids exceeding 2,147,483,647 (32Bit). Otherwise testcases would be unreasonably large. Possible values are:

  • 0 - start counting globalIds with 0.
  • 1 - start counting globalIds with 2,147,483,647

Keywords: 32Bit

lebmGridChecks

MBool CartesianGrid::m_lbGridChecks
default = false

switch for using extra grid checks for LB.
Keywords: GRID, LB, ADAPTATION

coarseRation

MFloat CartesianGrid::coarseRatio
default = 0.2

adjusts the factor between refinement and coarsening threshold.
(See BA Philipp Brokof, Implementation of a sensor based adaptive mesh refinement ..., variable K_c)
Keywords: GRID, LB, ADAPTATION

coarseRation

MFloat CartesianGrid::allowCoarsening
default = true

Allow coarsening of cells, during adaptation, otherwise cells are only added!)
Keywords: GRID, ADAPTATION

cells

MBool MAIACartesianGrid::updatePartitionCellsOnRestart
default = true

Sets whether partition cells shall be updated when writing a restart file. Default triggers a new partition when restarting, when setting to false, the partition cells are not re-computed when writing the restart file. Should be set to FALSE, for LPT applications, as the particle offset is based on the current partitioncells and is not recomputed. Keywords: GRID, PARTITION

haloMode

haloMode
default = 0

Possible values are:

  • 0 Just takes all window/halo cells created by raw grid without accounting for varying # of haloLayers (deprecated)
  • 1 Creates solver specific #halos
  • 2 Same as 1, but addiditionally checks connectivity on leaf level and deletes unecessary cells on all lower levels(recommended)

Keywords: GRID, WINDOW/HALO

checkRefinementHoles

MBool* CartesianGrid::m_checkRefinementHoles
default = nullptr

Set bool for each solver to check for refinement holes and islands If activated less level-Jumps are created by the solution-adaptive mesh-refinement! Keywords: GRID, ADAPTATION

checkRefinementHoles

MBool* CartesianGrid::m_diagSmoothing
default = nullptr

Set bool for each solver to check for refinement holes and islands If activated less level-Jumps are created by the solution-adaptive mesh-refinement! Keywords: GRID, ADAPTATION

Author
Michael Schlottke-Lakemper (mic) mic@a.nosp@m.ia.r.nosp@m.wth-a.nosp@m.ache.nosp@m.n.de
Date
2016-07-07

If donorGridFileName is set and createGridMap is true, create grid map. If grid map already exists, regenerate unless forceGridMapGeneration is false (default: true). If saveDonorGridPartition is true (default: false), also create and store donor grid partition by calling saveDonorGridPartition.

createGridMap

default = None

Create grid map.
Possible values are:

  • 0 Deactivated
  • 1 Activated

Keywords: ALL

forceGridMapGeneration

default = 1

Forces a regeneration of grid map, even if a grid map already exists.
Possible values are:

  • 0 Deactivated
  • 1 Activated

Keywords: ALL

saveDonorGridPartition

MBool CartesianGrid::savePartition
default = false

Triggers if the donor grid partition is created and stored.

  • 0 (false-deactivated)
  • 1 (true-activated)

Keywords: OUTPUT,

initialGeometricalRfnLvl

MInt GridGenPar::m_initialRefinementLevelSerial
default = n/a

Specifies the coarsest refinement level that is retained and where ordering by the Hilbert curve takes place (deprecated).
Possible values are:

  • Non-negative int value

Keywords: GRID GENERATOR, PARALLEL, REFINEMENT

minLevel

MInt GridGenPar::m_initialRefinementLevelSerial
default = n/a

Specifies the coarsest refinement level that is retained and where ordering by the Hilbert curve takes place.
Possible values are:

  • Non-negative int value

Keywords: GRID GENERATOR, PARALLEL, REFINEMENT

weightMethod

MInt GridGenPar::m_weightMethod
default = 0

Specifies the weight method that should be used to partition the grid.
Possible values are:

  • 0: all cells have the same weight (= 1.0)
  • N: different weight methods are supported (see setCellWeights() method)
  • 3: set specific weight for each level (using 'setWeightValue' from max to min level)

Keywords: GRID GENERATOR, PARALLEL, CELL WEIGHTS

reductionFactor

MFloat GridGenPar::m_reductionFactor
default = 1.0

Factor by which the length of the level-0 cell is multiplied. This can be used to obtain cells of a different cell length, independent of the largest extent of the bounding box.
Possible values are:

  • 1.0 <= reductionFactor < 2.0

Keywords: GRID GENERATOR, PARALLEL, GEOMETRY, LENGTH

gridOutputFileName

MString GridGenPar::m_gridOutputFileName
default = n/a

Name of the grid file that is generated.
Possible values are:

  • any valid file name

Keywords: GRID GENERATOR, PARALLEL, FILENAME

writeCoordinatesToGridFile

MString GridGenPar::m_writeCoordinatesToGridFile
default = false

Write all cell coordinates to the grid file, e.g. for external processing without the grid reader.
Keywords: GRID, GENERATOR, OUTPUT, COORDINATES

partitionCellOffspringThreshold

MInt GridGenPar::m_partitionCellOffspringThreshold
default = 50000

controls the filtering of cells in massive parallel file writing
possible values are:

  • Non-negative int value of the order less than number of cells on each domains

Keywords: GRID, GENERATOR, PARALLEL, OUTPUT, FILTER, MAX, SIZE

partitionCellWorkloadThreshold

MFloat GridGenPar::m_partitionCellWorkloadThreshold
default = 50000

controls the filtering of cells in massive parallel file writing
possible values are:

  • Non-negative int value of the order less than number of cells on each domains

Keywords: GRID, GENERATOR, PARALLEL, OUTPUT, FILTER, MAX, SIZE

targetGridFileName

MString GridGenPar::m_targetGridFileName
default = ""

If non-empty, use target grid center of gravity and lengthLevel0 when ordering cells by Hilbert id.
possible values are:

  • Full path to target grid file.
  • "" (empty string)

Keywords: GRID, GENERATOR, PARALLEL, COUPLING

multiSolverBoundingBox

std::vector<MFloat> CartesianGrid::m_multiSolverBoundingBox
default = none

Defines the global bounding box by two points for a (multisolver) grid. To be used in combination with 'multiSolverMinLevel'. Specifying both parameters allows to create a corresponding single solver grid that is ordered by the same Hilbert curve such that single solver restart/mean-vars files can be used in a coupled multisolver simulation.

Keywords: GRID, HILBERT, MULTISOLVER, COUPLING

multiSolverMinLevel

MInt CartesianGrid::m_multiSolverMinLevel
default = none

Defines the global min-level for a (multisolver) grid. See 'multiSolverBoundingBox'. Keywords: GRID, HILBERT, MULTISOLVER, COUPLING

testcaseDir

MString testcaseDir
default = "./"

Main directory where MAIA runs.
Possible values are:

  • any valid directory name

Keywords: GRID, GENERATOR, PARALLEL, DIRECTORY

outputDir

MString GridgenPar::m_outputDir
default = n/a

Directory where the generated grid is placed (relative to testcaseDir).
Possible values are:

  • any valid directory name

Keywords: GRID, GENERATOR, PARALLEL, DIRECTORY

checkGridLbValidity

MString GridgenPar::m_checkGridLbValidity
default = true

Enable/disable the grid LB validity check in the grid generator to detect errorneous cells for LB computations.
Keywords: GRID, GENERATOR, PARALLEL, VALIDITY, CHECK, LB,

ggp_keepOutsideBndryCellChildren

MInt GridgenPar::m_keepOutsideBndryCellChildren
default: 0

  • 0 (delets all outside boundary children)
  • 1 (keep outside boundary children, if the outside-cell's parent has a boundary-cell-neighbor without children)
  • 2 (keep outside boundary children, if the outside-cell's parent is a boundary-cell)

Triggers whether and which outside boundary children are keept or deleted.
Keywords: FINITE_VOLUME, GRID GENERATION, BOUNDARY

localRfnMethods

MInt GridgenPar::localRfnMethods
default = 0

Sets the local refinement method

  • 0 (no local refinement)
  • 1 (patch refinement)
  • 2 (boundary refinement)
  • 3 (patch and boundary refinement)

Keywords: FINITE_VOLUME, GRID GENERATION

localRfnLvlMethods

MInt GridgenPar::localRfnLevelMethods
default = 0

Sets the local refinement level method

Keywords: FINITE_VOLUME, GRID GENERATION

weightPatchCells

MInt GridGenPar::m_weightPatchCells
default = 0

Controls the initial static load balancing of patch cells. It improves the initial cell distribution.

  • 0 - Inactive
  • 1 - Active

Keywords: GRID, GENERATOR, PARALLEL, LOAD BALANCING

localRfnLevelProperties

MInt gridgenpar::property
default = no default value

List of floating numbers to define the parameters of the chosen localRfnLvlMethods. For example for BR-B one would need to give the following list of values: corner_point1 + corner_point2 + center_point + radius + corner_point3 + corner_point4 Possible values are:

  • Coordinates of a box patch (xmin, ymin, zmin, xmax, ymax, zmax).

Keywords: Grid generation

weightBndCells

MInt gridgenpar::m_weightBndCells
default = 0

If true, compute cell weights and the sum of the weights in ParallelizeGrid() Possible values are:

  • 0 or 1

Keywords: Grid generation

localBndRfnMethod

MInt gridgenpar::m_localBndRfnMethod
default = 0

the method to determine distance of all levels in markComputationalGridBndRfn Possible values are:

  • 0: refinment distance = level_0*localMinBoundaryThreshold. smoothDistance based on level_0
  • 1: refinment distance = level_0/localMinBoundaryThreshold. smoothDistance based on current lvl
  • 2: localBndRfnDistance represents refinement distance. smoothDistance based on current level

Keywords: Grid generation

localMinBoundaryThreshold

MInt GridGenPar::m_localMinBoundaryThreshold
default = ""

Distance in cell units on the current level, which should be further refined.

  • Any positive integer

Keywords: GRID, GENERATOR, BOUNDARY, REFINEMENT,

localBndRfnDistance

default = ""

Distance in STL units to refine first layer around boundary.

  • Array of positive floating point numbers. Last one is taken as default value if entries are missing.

Keywords: GRID, GENERATOR, BOUNDARY, REFINEMENT,

localBndRfnMinLvlDiff

default = ""

Min target level to refine down from boundary level. Useful to avoid further refinement than p.e. provided by already existing patch.

  • Positive integer number.

Keywords: GRID, GENERATOR, BOUNDARY, REFINEMENT,

smoothDistance

MInt GridGenPar::property
default = 1

The property defines how many cells should be inbetween the refinement levels.

  • Integer values larged than 1.

Keywords: GRID, CUTOFF

localRfnLvlDiff

MInt GridGenPar::m_localRfnLvlDiff
default = [0,0,...]

Level difference between maxBoundaryRfnLvl and the level at the corresponding entry in localRfnBoundaryIds. Last value holds for non-specified level differences. Keywords: GRID, BOUNDARY REFINEMENT

cutOff

MBool GridGenPar::m_cutOff
default = 0

defines if a cutoff is applied to the grid and if so, at which levels

  • 0 - no cutOff
  • 1 - cutOff at initialLevel
  • 2 - cutOff at levels <= initialLevel
  • 3 - cutOff at levels >= initialLevel
  • 34- cutOff at all levels

Keywords: GRID, CUTOFF

cutOffMethod

MInt GridGenPar::readSolverProperties::cutOffMethod
default = ""

Specifies the cutoff method to be used.

  • B - box cut-off
  • iB- inverse box cut-off (keep everything outside box)
  • P - plane cut-off
  • C - cylindrical slice cut-off (azimuthal Periodicity)

Keywords: GRID, CUTOFF

cutOffCoordinates

MFloat GRIDGENPAR::cutOffCoordinates
no default

Coordinates for the cut off (box,plane)
Keywords: GRID

cutOffCoordinates

MFloat GRIDGENPAR::cutOffNmbrLayers
default: 0

Allow for additional layers around the cutOff. These additional cells are remaining in the grid! This is very useful for all zonal methods!
Keywords: GRID, CUTOFF, ZONAL

weightCoordinates

MFloat CartesianGrid::m_weightCoordinates
default = 0

defines the weighht coordinates -x,+x,-y,+y,-z,+z direction:

  • Any non-negative floating point value smaller than the extent of the domain in the respective direction.

Keywords: WEIGHT, COORDINATES

setWeightValue

MFloat GridGenpar::setWeightValue
default = 1

defines the weight values for the levels:

  • Any non-negative floating point value.

Keywords: WEIGHT, VALUE

Author
: Tim Wegmann
Date
: the day before yesterday

cutOffDirections

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

  • 0, 1, 2, 3, 4 (2D), 5 (3D)

Keywords: FINITE_VOLUME, CUTOFF

Creates an object of the specified filetype to open the property file

propertyFilename

MString Context::m_propertyFileOutputName
default = "access_properties"

name of the file, in which the Property accesses are logged during the solver run and in which a property table is printed at the end.
Keywords: INPUT_OUTPUT

nDim

MInt MAIA::nDim
default = -1

Number of space dimensions, possible values:

  • 2
  • 3

Keywords: GLOBAL

spaceDimensions

MInt MAIA::nDim
default = -1

Old property for number of space dimensions,
DON'T USE ANYMORE, possible values:

  • 2
  • 3

Keywords: GLOBAL

interpolationDistMethod

MString LbBndCnd::m_interpolationDistMethod
default = perpOp

This property defines the way the distances to the STL are calculated.

  • sphere analytically defined sphere
  • perpOp uses the perpendicular operator
  • pipe analystically defined cylinder
  • STD old standard method (replaced by perpOp)


Keywords: LATTICE_BOLTZMANN

outputWallDistanceField

MString LbBndCnd::m_outputWallDistanceField
default = false

This property defines, whether the isFluid state and the wall distance fields are dumped in a file. Keywords: LATTICE_BOLTZMANN

multiBCTreatment

MString LbBndCnd::multiBCTreatment
default = I-W-P

This property defines the way BCs are treated for cells being part of multiple BCs

  • I-W-P order: in/oultet - wall - periodic
  • I-P-W order: in/outlet - periodic - wall
  • W-P-I order: wall - periodic - in/outlet
  • W-I-P order: wall - in/outlet - periodic
  • P-W-I order: periodic - wall - in/outlet
  • P-I-W order: periodic - in/outlet


Keywords: LATTICE_BOLTZMANN

lbNoMovingWalls

MInt LbBndCndDxQy::m_lbNoMovingWalls
default = 0

Number of walls with a wall velocity abs(u_w) > 0.

  • any integer >= 0 (on)


Keywords: LATTICE_BOLTZMANN

segIdMovingWalls

MInt LbBndCndDxQy::m_segIdMovingWalls
default = 0

Segment id of walls with a wall velocity abs(u_w) > 0.

  • integer >= 0 (on)


Keywords: LATTICE_BOLTZMANN

lbWallVelocity

MFloat LbBndCndDxQy::m_lbWallVelocity
default = 0.0

Velocity components of each wall with a velocity abs(u_w) > 0.

  • any float (on)


Keywords: LATTICE_BOLTZMANN

calcWallForces

MBool LbBndCnd::m_calcWallForces
default = false

Activates the calculation of wall forces

  • false
  • true


Keywords: LATTICE_BOLTZMANN

calcWallForcesInterval

MInt LbBndCnd::m_calcWallForcesInterval
default = 1

Determine the update interval for wall force calculation

  • Any integer number > 0


Keywords: LATTICE_BOLTZMANN

forceFileName

MInt LbBndCnd::m_forceFile
default = 1

Determine the output file name for wall force calculation

  • Any valid file name


Keywords: LATTICE_BOLTZMANN

calcBcResidual

MInt LbBndCnd::m_calcBcResidual
default = false

Determine whether residuals for BC are written out

  • false off
  • true on


Keywords: LATTICE_BOLTZMANN

lbNoHeatedWalls

MInt LbBndCndDxQy::m_lbNoHeatedWalls
default = 0

Number of walls with a wall temperature abs(T) > 0.

  • any integer >= 0 (on)


Keywords: LATTICE_BOLTZMANN

segIdHeatedWalls

MInt LbBndCndDxQy::m_segIdHeatedWalls
default = 0

Segment id of walls with a wall temperature abs(T) > 0.

  • integer >= 0 (on)


Keywords: LATTICE_BOLTZMANN

lbWallTemperature

MFloat LbBndCndDxQy::m_lbWallTemperature
default = 0.0

Velocity components of each wall with a temperature abs(T) > 0.

  • any float (on)


Keywords: LATTICE_BOLTZMANN

latentHeat

MBool LbBndCnd::latentHeat
default = 1

This property activates latentHeat calculation

  • 0 off
  • 1 on


Keywords: LATTICE_BOLTZMANN, THERMAL, TRANSPORT

calcSubLayerDist

MBool LbBndCnd::calcSublayerDist
default = 1

This property activates the calculation of wall distances to a second wall, not given by an STL, along the direction of the PPDFs. This is required if sublayers outside of the STL are used. For example, it is used for the calculation of heat conduction in the solid domain.

  • false off
  • true on


Keywords: LATTICE_BOLTZMANN, THERMAL, TRANSPORT

Author
Andreas Lintermann
Date
17.07.2015

bndNormalMethod

MString LbBndCnd::bndNormalMethod
default = calcNormal

This property defines the way normals for in- and outlets are treated.

  • read reads the normals from the property file (bndNormalVectors)
  • calcNormal calculates the normals based on triangle information and averages them
  • fromSTL reads the normals from STL and averages them


Keywords: LATTICE_BOLTZMANN

initVelocityMethod

MString LbBndCnd::initVelocityMethod
default = calcNormal

This property defines the way initial velocity vectors for in- and outlets are treated. In general, if the nmormals point outward, such that the according velocity vectors should point inside.

  • read reads the vectors from the property file (initialVelocityVectors)
  • calcNormal vectors are set to bndNormalVectors
  • fromSTL vectors are set to -1*bndNormalVectors


Keywords: LATTICE_BOLTZMANN

fastParallelGeomNormals

MInt LbBndCnd::fastParallelGeomNormals
default = 0

This property defines how normals are calculated for a parallel geometry.

  • 0 normals are calucated for each processor participating in a BC and then the average is calculated; involves inside/outsie detection on all processes.
  • 1 normals are calculates on only one process in the BC communicator, only one inside-outside detetction is performed.


Keywords: LATTICE_BOLTZMANN

Author
Andreas Lintermann
Date
17.07.2015

bndNormalVectors

MFloat** LbBndCnd::bndNormalVecs
This property defines the boundary normal vectors per in/outlet BC in the format x,y,z.
Keywords: LATTICE_BOLTZMANN

initialVelocityVectors

MFloat** LbBndCnd::initialVelocityVecs
This property defines the velocity vectors per in/outlet BC in the format x,y,z.
Keywords: LATTICE_BOLTZMANN

Parameters
solverLB solver to be manipulated by the boundary condition

lbControlInflow

MInt LbBndCndDxQy::m_lbControlInflow
default = 0

Controls, if a non-rectangular profile is prescribed at an in/ouflow BC.

  • 0 (off)
  • 1 (on)


Keywords: LATTICE_BOLTZMANN

lbZeroInflowVelocity

MFloat LbBndCndDxQy::m_lbZeroInflowVelocity
default = 1.0

Sets the inflow velocity to 0.0

  • 0.0
  • 1.0


Keywords: LATTICE_BOLTZMANN

bounceBackSchemeMb

MFloat LbBndCndDxQy::bounceBackSchemeMb
default = BOUZIDI_QUADRATIC

Controls the used bounce back scheme for moving boundaries.

  • BOUZIDI_LINEAR
  • BOUZIDI_QUADRATIC
  • YU_QUADRATIC


Keywords: LATTICE_BOLTZMANN

lbRefillMethodOrder

MInt LbBndCndDxQy::m_lbRefillMethodOrder
default = 2

Determines order of normal extrapolation for refill method of emerged cells (moving boundaries)

  • 1 (linear)
  • 2 (quadratic)


Keywords: LATTICE_BOLTZMANN

For each cell in the desired segment(s) the smalles distance to the rim of the boundary is determined.

Parameters
[in]indexBoundary index

inflowSegmentIds

MFloat LbBndCndDxQy::m_inflowSegmentIds
This defines the inflow segments to control the flow for (lbControlInflow) Keywords: LATTICE_BOLTZMANN

Lattice Boltzmann enhanced no slip (bounce back) condition for inclined walls with the Dirichlet condition for the thermal LBGK. Mode = 0 is a 2D/3D cylinder flow. Mode = 1 is a 2D/3D channel flow. Mode = 2 is a 2D channel flow.

Author
Shota Ito
Date
11.09.2022
Parameters
[in]indexBoundary index bcMode type of bc (see above)

Lattice Boltzmann boundary condition for modelling nasal mucosa layer. Two ideas are implemented:

  1. Additional artificial sublayer is created which models the heat conduction inside the mucous layer with a constant organ-side temperature.
  2. Latent heat of evaporation is introduced to model cooling/heating effects depending on the humidity flux across the boundary.

    This is a coupled Dirichlet-type boundary condition for the scalar transport of the humidity concentration and temperature. The Dirichlet condition is modelled by the idea of the interpolated bounce back for scalar transport problems as introduced in the paper Li et al. (2013).

    This version of the boundary condition calculates the latent heat term with the temperature of the previous time step.

Author
Shota Ito
Date
28.09.2022
Parameters
[in]indexBoundary index

Initialize bc20501.

Initialize bc20501. The parameters of the nasal mucosa model can be defined/adjusted here. They are used to transform the simulation variables into dimensionalized variables in the calculateWallInterface function. The fluid-side and mucosa-side distances are also calculated by the calculateSublayerDistances function.

Author
Shota Ito
Date
07.09.2022
Parameters
[in]indexBoundary index

m_plugFlow

MInt LbBndCndDxQy::plugFlow
Initiates a plugFlow. Used for testing and validation Keywords: LATTICE_BOLTZMANN

referenceLengthSegId

MInt LbBndCndDxQy::segmentId
This property is mandatory if property referenceLengthLB is not given. Defines the segment id to be used for the calculation of the characteristic length in cell units. Keywords: LATTICE_BOLTZMANN

conductivity

MInt LbBndCndDxQy::conductivity
default = 0

Provides the dimensional conductivity Keywords: LATTICE_BOLTZMANN

density

MInt LbBndCndDxQy::density
default = 0

Provides the dimensional density Keywords: LATTICE_BOLTZMANN

viscosity

MInt LbBndCndDxQy::viscosity
default = 0

Provides the dimensional viscosity Keywords: LATTICE_BOLTZMANN

mucosaConductivity

MInt LbBndCndDxQy::mucosaConductivity
default = 0

Provides the dimensional mucosaConductivity Keywords: LATTICE_BOLTZMANN

organSideTemp

MInt LbBndCndDxQy::organSideTemp
default = 0

Provides the temperature of the interior of the mucosa in Celsius Keywords: LATTICE_BOLTZMANN

mucosaThickness

MInt LbBndCndDxQy::mucosaThickness
default = 0

Provides the thickness of the mucosa layer in meter Keywords: LATTICE_BOLTZMANN

mucosaDiffusivity

MInt LbBndCndDxQy::mucosaDiff
default = 0

Provides the dimensional diffusivity of the mucosa layer Keywords: LATTICE_BOLTZMANN

bndryDiffusivity

MInt LbBndCndDxQy::bndryDiff
default = 0

Provides the dimensional diffusivity of the bndry layer Keywords: LATTICE_BOLTZMANN

deltaRho

MFloat LbBndCndDxQy::m_deltaRho
default = 1.0 - m_lRho

This is the inital step size for the adaptive BC 4073.
Keywords: LATTICE_BOLTZMANN

Storing some pointers to the solvers interface cell structures

Parameters
solver

interfaceMethod

MInt LbInterface::m_interfaceMethod
default = "FILIPPOVA"

Selects interface method for locally refined meshes.

  • FILIPPOVA: Spatial and temporal interpolation of variables, rescaling of non-eq components
  • ROHDE: Volumetric formulation (no interpolation, no rescaling)

    Possible values are:
    • "FILIPPOVA" (off)
    • "ROHDE" (on)

    Keywords: LATTICE_BOLTZMANN, NUMERICAL_SETUP, REFINEMENT

[Splitt] The following is part of a first step to splitt CartesianGrid from the inheritance hierarchy:

  • in order to avoid renaming a lot of access to CartesianGrid data members, references are introduced. These references must be initialized in the solver's constructor.
Todo:
labels:LB this references will be removed in future commits

EELiquid

MBool LbSolver::m_isEELiquid
default = false

Enable the LB-component of the coupled LB-FV Euler-Euler method for bubbly flows.
Keywords: LATTICE_BOLTZMANN, EEMultiphase

LBRestartWithoutAlpha

MBool LbSolver::m_EELiquid.restartWithoutAlpha
default = false

Restart an E-E simulation from a restart file without alpha.
Keywords: LATTICE_BOLTZMANN, EEMultiphase

updateAfterPropagation

MBool LbSolver::updateAfterPropagation
default = false

Update the macroscopic variables at the end of the timestep.
Keywords: LATTICE_BOLTZMANN

adaptation

MBool LbSolver::adaptation
default = false

Switch for using adaptation.
Keywords: LATTICE_BOLTZMANN, ADAPTATION

singleAdaptation

MBool LbSolver::singleAdaptation
default = true

Switch for single adaptation in one adaptation run.
Keywords: LATTICE_BOLTZMANN, ADAPTATION

adaptationInitMethod

MString LbSolver::adaptationInitMethod
default =

Defines the method for initializing newly created cells after adaptation.
Keywords: LATTICE_BOLTZMANN

noSpecies

MInt LbSolver::noSpecies
default = 0

Defines the number of species.
Keywords: LATTICE_BOLTZMANN

nonBlockingComm

MInt LbSolver::m_nonBlockingComm
default = 0

This property is a switch for using non-blocking commuication

  • 0 (off)
  • 1 (on)


Keywords: LATTICE_BOLTZMANN

solutionOffset

MInt solver::m_solutionOffset
default = 0

which time step to start writing out solution Possible values are:

  • Int

Keywords: output

initMethod

MString LbSolver::m_initMethod
default = 0

This property describes the initialization procedure.
Initial variables and distribution functions are set accordingly (in 3d m_initMethodPtr is set)
Additionally the pressure force depends on this setting.

Possible values are:

  • "LB_FROM_ZERO_INIT"
  • "LB_LAMINAR_INIT_PX"
  • "LB_LAMINAR_INIT_MX"
  • "LB_LAMINAR_INIT_PY"
  • "LB_LAMINAR_INIT_MY"
  • "LB_LAMINAR_INIT_PZ"
  • "LB_LAMINAR_INIT_MZ"
  • "LB_LAMINAR_PIPE_INIT"
  • "LB_VORTEX_INIT"
  • "LB_LAMINAR_CHANNEL_INIT"
  • "LB_TURBULENT_CHANNEL_INIT"
  • "LB_TURBULENT_MIXING_INIT"
  • "LB_TURBULENT_MIXING_FILTER_INIT"
  • "LB_TURBULENT_BOUNDARY"
  • "LB_TURBULENT_PIPE_INIT"
  • "LB_TURBULENT_DUCT_INIT"
  • "LB_SOUND_PULSE_INIT"
  • "LB_SPINNING_VORTICIES_INIT"
  • "LB_VORTEX_INIT"


Keywords: LATTICE_BOLTZMANN, INITILIZATION

interpolationType

MString LbSolver::m_interpolationType
default = "LINEAR_INTERPOLATION"

This property sets the interpolation type at grid-refinement interfaces.

Possible values are:

  • "LINEAR_INTERPOLATION"
  • "QUADRATIC_INTERPOLATION"
  • "CUBIC_INTERPOLATION"


Keywords: LATTICE_BOLTZMANN, INITILIZATION, NUMERICAL_SETUP

CouettePoiseuilleRatio

MFloat LbSolver::m_CouettePoiseuilleRatio
default = 0

Sets the ratio of Couette and Poiseuille flow in a channel.
If m_CouettePoiseuilleRatio = 0 the flow is a Couette flow.
If m_CouettePoiseuilleRatio = inf the flow is a Poiseuille flow.
The equations are implemented in MAIA_LAMINAR_CHANNEL_INIT and bc1002 and bc1022.
Possible values are:

  • any positive float


Keywords: LATTICE_BOLTZMANN, NUMERICAL_SETUP, INITILIZATION

calcTotalPressureGradient

MFloat LbSolver::m_calcTotalPressureGradient
default = 0

Derivative of rho is calculated by default. If calcTotalPressureGradient is on the derivative of the total pressure is calculated Possible values are:

  • 0, 1


Keywords: LATTICE_BOLTZMANN, NUMERICAL_SETUP, INITILIZATION

densityFluctuations

MBool LbSolver::m_densityFluctuations
default = 0

Switch for use of density fluctuations.
If turned on the mean density is zero. This reduces the round-off error.
Some collision steps and boundary conditions are not prepared for this yet.

Possible values are:

  • 0 (off)
  • 1 (on)


Keywords: LATTICE_BOLTZMANN, NUMERICAL_SETUP, INITILIZATION

calculateDissipation

MBool LbSolver::m_calculateDissipation
default = 0

Switch for calculation of dissipation.
Values of dissipation and energy are written to dissipation.dat in each timestep.
This may slow down the solver severely!

Possible values are:

  • 0 (off)
  • 1 (on)


Keywords: LATTICE_BOLTZMANN, INPUT_OUTPUT

FFTInit

MInt LbSolver::m_FftInit
default = false

This property is a switch for Fourier-transform initialization.

Possible values are:

  • 0 (off)
  • 1 (on)


Keywords: LATTICE_BOLTZMANN, INITILIZATION

domainSize

MInt LbSolver::m_arraySize
default = -

Array size for FFTInit given on the highest level of refinement.
Values must not be odd numbers!

Possible values in 3d are:

  • 24,64,30


Keywords: LATTICE_BOLTZMANN, NUMERICAL_SETUP, INITILIZATION

noPeakModes

MInt LbSolver::m_noPeakModes
default = 1

Defines how often the FFT-mode with the highest energy fits into the x-length of the domain.

Keywords: LATTICE_BOLTZMANN, INITILIZATION

smagorinskyConstant

MFloat LbSolver::m_Cs
default = 0.1

This property defines the Smagorinsky constant for LES computations.
Keywords: LATTICE_BOLTZMANN

filterWidth

MFloat LbSolver::m_deltaX
default = 1.0

This property defines the Smagorinsky filter width for LES computations.
Keywords: LATTICE_BOLTZMANN

Pr

MFloat LbSolver::m_Pr
default = 0.72

This property defines the Prandtl number, which is required to calculate the heat coefiicient k. Example numbers are:

  • Air: 0.7-0.8
  • Water: 7

Keywords: THERMAL_LATTICE_BOLTZMANN

initTemperatureKelvin

MFloat LbSolver::m_initTemperatureKelvin
default = 1.0546

This property defines the dimensionless temperature in Kelvin.

Keywords: THERMAL_LATTICE_BOLTZMANN

blasiusPos

MFloat LbSolver::m_blasiusPos
default = 0.5

This property defines the position on a flat plate where to evaluate a Blasius solution for the inflow condition.

Keywords: THERMAL_LATTICE_BOLTZMANN

Pe

MFloat LbSolver::m_Pe
default = 100

This property defines the Peclet number, which is used to compute the diffusivity. Keywords: TRANSPORT_LATTICE_BOLTZMANN

initCon

MFloat LbSolver::m_initCon
default = 1.0

This property defines the dimensionless concentration of the passively transported media.

Keywords: TRANSPORT_LATTICE_BOLTZMANN

alpha

MFloat LbSolver::m_alpha
default = 0.0

This property defines the Womerleynumber for unsteady flow.

Keywords: LATTICE_BOLTZMANN

saveDerivatives

MBool LbSolver::m_saveDerivatives
default = 0

This property defines if derivatives should be additionally stored.

Keywords: LATTICE_BOLTZMANN

tanhInit

MBool LbSolver::m_tanhInit
default = 0

This property defines if the Reynolds number should be increased according to a tanh-function.
Keywords: LATTICE_BOLTZMANN

initRe

MFloat LbSolver::m_initRe
This property defines if the Reynolds number to start with for tanh-function increase Keywords: LATTICE_BOLTZMANN

initTime

MInt LbSolver::m_initTime
This property defines the number of LB iterations for Reynolds number tanh-function increase.
Keywords: LATTICE_BOLTZMANN

initStartTime

MInt LbSolver::m_initStartTime
This property defines the LB iteration number to start a Reynolds number tanh-function increase.
Keywords: LATTICE_BOLTZMANN

Ma

MFloat LbSolver::m_Ma
default = 0.1

This property defines the Mach number of the LB simulation. Note that due to the LB's quadi-incompressibility, only Mach numbers of up to Ma=0.3 should be used. Keywords: LATTICE_BOLTZMANN

Re

MFloat LbSolver::m_Re
default = 100.0

This property defines the Reynolds number of the LB simulation. The Reynolds number, together with the velocity that is calculated from the Mach number, and the reference length are used to calculate the viscosity of the fluid in the LB. Keywords: LATTICE_BOLTZMANN

rho1

MFloat LbSolver::m_rho1
default = 1.0

This property defines the reference density rho1.
Keywords: LATTICE_BOLTZMANN

rho2

MFloat LbSolver::m_rho2
default = 1.0

This property defines the reference density rho2.
Keywords: LATTICE_BOLTZMANN

referenceLength

MFloat LbSolver::m_referenceLength
This property sets the reference length in stl units, whereas internally the reference length is converted to LB units. Keywords: LATTICE_BOLTZMANN

referenceLengthLB

MFloat LbSolver::m_referenceLength
default = is calculated by calculateReferenceLength based on the reference length

This property overrides the reference length in cell units. Keywords: LATTICE_BOLTZMANN

referenceLengthSegId

MFloat LbSolver::m_referenceLengthSegId
This property is mandatory if property referenceLengthLB is not given. Defines the segment id to be used for the calculation of the characteristic length in cell units. Keywords: LATTICE_BOLTZMANN

domainLength

MFloat LbSolver::m_domainLength

This property overrides the maximum length in stl units. Internally the domain length is converted to LB units. Keywords: LATTICE_BOLTZMANN

domainLengthLB

MFloat LbSolver::m_domainLength
default = 2^maxLevel() / reductionFactor()

This property overrides the maximum length in cell units. Keywords: LATTICE_BOLTZMANN

initialAlpha

MFloat LbSolver::m_EELiquid.initialAlpha
default = 0.0

Initial value of alpha in the domain.
Keywords: LATTICE_BOLTZMANN, EEMultiphase

alphaInf

MFloat LbSolver::m_EELiquid.alphaInf
default = m_EELiquid.initialAlpha

Infinity value of alpha.
Keywords: LATTICE_BOLTZMANN, EEMultiphase

EELiquidGravity

MBool LbSolver::m_EELiquid.gravity
default = false

Enable the influence of buoyancy on the liquid phase.
Keywords: LATTICE_BOLTZMANN, EEMultiphase

initDensityGradient

MBool LbSolver::m_initDensityGradient
default = false

Initialize the density with a gradient according to m_volumeAccel.
Keywords: LATTICE_BOLTZMANN

EELiquidGravityAccel

MFloat LbSolver::m_EELiquid.gravityAccelM[nDim]
Gravity acceleration used for buoyancy effects.
Gravity has to be specified in non-dimensional form by multiplying by (\delta t ^ 2) / (\delta x) = (\delta x) / (3 * a_inf^2) (see wiki) Keywords: LATTICE_BOLTZMANN, EEMultiphase

volumeAcceleration

MFloat LbSolver::m_volumeAccel
default = [0.0, 0.0, 0.0]

This property defines the amount of acceleration applied in each Cartesian direction The acceleration has to be specified in LB non-dimensional form by multiplying by (\delta t ^ 2) / (\delta x) = (\delta x) / (3 * a_inf^2) (see wiki)
Keywords: LATTICE_BOLTZMANN

Ga

MFloat LbSolver::m_Ga
default = 0.0

Galileo number
Gravity is applied in negative y-direction.
Keywords: LATTICE_BOLTZMANN

externalForcing

MBool LbBndSolver::m_externalForcing
This property defines if external forcing should be activated.

  • 0 (off)
  • 1 (on)


Keywords: LATTICE_BOLTZMANN

velocityControl

MInt LbSolver::m_velocityControl.dir
default = -1

This property defines if velocityControl should be activated and what the main direction of flow is. The velocity control algorithm averages the velocity in the corresponding direction over the whole domain. The volumeAcceleration is subsequently controlled using a PID-controller. The target for the averaged velocity is u_infinity.

  • -1 (off)
  • 0 (on), (positive) x-direction
  • 1 (on), (positive) y-direction
  • 2 (on), (positive) z-direction


Keywords: LATTICE_BOLTZMANN

velocityControlRestart

MBool LbSolver::m_velocityControl.restart
Set this property to true if you restart a run with velocityControl to read values like previousError and integratedError fromm the restart file. Else these values are set to zero.

velocityControlInterval

MInt LbSolver::m_velocityControlInterval
default = 100

This property defines the interval in which the velocity is averaged and the volumeforce is adjusted for velocityControl
Keywords: LATTICE_BOLTZMANN

velocityControlKT

MFloat LbSolver::m_velocityControlKT
default = 1.0

velocityControl works as a PID-controller following the formula: controlSignal = KT * (err + 1/KI * integral(err)dt + KD * (d err / dt))
m_volumeAccel = m_volumeAccelBase - controlSinal * m_volumeAccelBase (in the dimension of m_velocityControl) Keywords: LATTICE_BOLTZMANN

velocityControlKI

MFloat LbSolver::m_velocityControlKI
default = 10000.0

velocityControl works as a PID-controller following the formula: controlSignal = KT * (err + 1/KI * integral(err)dt + KD * (d err / dt))
m_volumeAccel = m_volumeAccelBase - controlSinal * m_volumeAccelBase (in the dimension of m_velocityControl) Keywords: LATTICE_BOLTZMANN

velocityControlKD

MFloat LbSolver::m_velocityControlKD
default = 10.0

velocityControl works as a PID-controller following the formula: controlSignal = KT * (err + 1/KI * integral(err)dt + KD * (d err / dt))
m_volumeAccel = m_volumeAccelBase - controlSinal * m_volumeAccelBase (in the dimension of m_velocityControl) Keywords: LATTICE_BOLTZMANN

solidLayer

MBool LbSolver::m_solidLayerExtension
default = false

enables special treatment if solid cells outside of the domain are not deleted during grid generation Keywords: LATTICE_BOLTZMANN

writeLsData

MBool LbSolver::m_writeLsData
default = false

If enabled, the Level-Set data stored in the LB solver is also written out, this includes the Level-Set, the Body Id and the isActive state Keywords: LATTICE_BOLTZMANN

useOnlyCollectedLS

MBool LbSolver::m_useOnlyCollectedLS
default = false

If enabled, only the 0th level-set is transferred to the LB solver. Keywords: LATTICE_BOLTZMANN

allowBndryAsG0

MBool LbSolver::m_allowBndryAsG0
default = false

If enabled, bndry cells can be G0 candidates / G0 boundary cells. Keywords: LATTICE_BOLTZMANN

correctInterfaceBcCells

MBool LbSolver::m_correctInterfaceBcCells
default = false

Activating this properties toggle interface cells on boundaries including shifting and correction of the interpolation stencil and its coefficients

  • falseli>
  • true


Keywords: LATTICE BOLTZMANN

initRestart

MBool LbSolver::m_initRestart
default = 0

This property defines if the PPDFs should be initialized with the eq. PPDFs of the given PVs loaded from restart file

  • 0 (off)
  • 1 (on)


Keywords: LATTICE BOLTZMANN

initFromCoarse

MBool LbSolver::m_initFromCoarse
default = 0

This property defines if a restart should be initialized from a solution on a coarser mesh.

  • 0 (off)
  • 1 (on)


Keywords: LATTICE BOLTZMANN

isInitRun

MBool LbSolver::m_isInitRun
default = false

This property defines if an initRun is performed. That is, the initialized velocity field is kept constant, while the density is iterated (Analogue to solving Poisson equation). Hereby, a correct density and non-equilibrium field is obtained. Ref.: Mei et al. 2006: https://doi.org/10.1016/j.compfluid.2005.08.008

  • true (off)
  • false (on)


Keywords: LATTICE BOLTZMANN

mbBandwidth

MFloat FvMbSolverXD::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:

  • Any floating point values.

Keywords: MOVING BOUNDARY

Author
Andreas Lintermann
Date
05.04.2013, 03.08.2015

The following is done in this function:

Check if we want to do a reduced communication

  • if no, then run the previous code (run prepareCommunicationNormal)
  • if yes, the run the reduced code ( run prepareCommunicationReduced)

reducedComm

MInt LbSolver::m_reducedComm
default = 0

This property defines if reduced communication should be activated.

  • 0 (off)
  • 1 (on)


Keywords: LATTICE BOLTZMANN

pp_reductionLevel

MString* PostProcessingSolver::m_reductionLevel
default = maxLevel()

This property determines the level to reduce the grid and the solution to.

  • level


Keywords: POSTPROCESSING

children and parents are stored seperately

Author
Georg Eitel-Amor

interfaceCellSize

MFloat LbSolver::m_interfaceCellSize
default = 0.5

Ratio of number of interface cells to overall number of cells.

  • 0.0 - 1.0 (it makes no sense to use more than 1.0)


Keywords: LATTICE_BOLTZMANN, NUMERICAL_SETUP, INITILIZATION

trackMovingBndry

MBool LbSolver::m_trackMovingBndry
default = true
Also read in fvsolver.h and lssolver.cpp
Triggers the displacement of bodies in the moving boundary solver using the G Field.
Possible values are:

  • true: displace bodies
  • false: do not displace bodies

Keywords: MOVING BOUNDARY, BODY DISPLACEMENT

trackMbStart

MInt LbSolver::m_trackMbStart
default = numeric_limits<MInt>::max()
Also read in fvsolver.h and lssolver.cpp
For time steps smaller than m_trackMbStart, the bodies are not displaced and the G Field is not updated
Possible values are:

  • integer > 0 and < numeric_limits<MInt>::max()

Keywords: MOVING BOUNDARY, BODY DISPLACEMENT

trackMbEnd

MInt LbSolver::m_trackMbEnd
default = numeric_limits<MInt>::max()
Also read in fvsolver.h and lssolver.cpp
For time steps larger than m_trackMbEnd, the bodies are not displaced and the G Field is not updated
Possible values are:

  • integer > 0 and < numeric_limits<MInt>::max()

Keywords: MOVING BOUNDARY, BODY DISPLACEMENT

mbBandwidth

MFloat LbSolver::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:

  • Any floating point values.

Keywords: MOVING BOUNDARY

refineDiagonals

MBool LbSolver::m_refineDiagonals
default = true

Determines whether the diagonal cells for the interface sensor should be refined as well!

  • true
  • false

Keywords: SENSOR, ADAPTATION

noDistributions

MInt LbSolver::m_noDistributions
default = 9

Set the number of distributions to use in the Lattice Boltzmann solver in 3D, i.e. the discretization model.

Possible values are:

  • See the possible values of enum "MAIALbModelType"

Keywords: LATTICE_BOLTZMANN, DISTRIBUTIONS, DISCRETIZATION

volumeAcceleration

default = [0.0, 0.0, 0.0]

This property defines the amount of acceleration applied in each Cartesian direction The acceleration has to be specified in LB non-dimensional form by multiplying by (\delta t ^ 2) / (\delta x) = (\delta x) / (3 * a_inf^2) (see wiki)
Keywords: LATTICE_BOLTZMANN

Ga

MFloat LbSolver::m_Ga
default = 0.0

Galileo number for each Cartesian direction
Keywords: LATTICE_BOLTZMANN

engineSetup

MBool LPT::m_engineSetup
default = false
Trigger specific engine features!
Keywords: PARTICLE

particleEllipsoidRandomOrientationSeed

MLong LPT::m_ellipsoidRandomOrientationSeed
default = Default Seed (4865U)

Keywords: PARTICLE

outputFormat

MString PostData::m_outputFormat
default = "NETCDF"
Defines the output file format of the post data solver
Possible values are:

  • NETCDF

Keywords: POST DATA, FILE FORMAT, NETCDF, VTU

solutionOffset

MInt PostSolver::m_solutionOffset
default = 0

which time step to start writing out solution Possible values are:

  • Int

Keywords: output

MFloat lengthFactor
default = 1

Set L_refLB/L_refLPT the conversion between different reference length used in the non-dimensionalisation and the calculation of the solver specific Re-number in the LB and LPT solver.
Keywords: PARTICLE, LATTICE BOLTZMANN

samplingDataFileName

MString PointData::m_inputFileName
This is MString SurfaceData::m_inputFileName
This is necessary for the point data feature to be enabled. This should name a file path which contains the positions at which points the states should be written out.
Possible values are:

  • any string

Keywords: SAMPLING, I/O

samplingDataEnabled

MBool PointData::m_enabled
MBool SurfaceData::m_enabled
If set, can be used to disable this entire feature. Keywords: SAMPLING, I/O

samplingDataSampleInterval

MInt PointData::m_sampleInterval
MInt SurfaceData::m_sampleInterval
default = 1

Specifies at which interval the state at the specified points should be sampled.
Possible values are:

  • any integer

Keywords: SAMPLING, I/O

samplingDataWriteInterval

MInt PointData::m_writeInterval
MInt SurfaceData::m_writeInterval
default = restartInterval if specified
Specifies at which interval the state at the specified points should be saved.
Possible values are:

  • any integer

Keywords: SAMPLING, I/O

samplingDataStartTimeStep

MInt PointData::m_startTimeStep
MInt SurfaceData::m_startTimeStep
default = 0

Specifies the after which time step the recording of conservative variables starts Possible values are:

  • positv integers

Keywords: SAMPLING, I/O

samplingDataEndTimeStep

MInt PointData::m_startTimeStep
MInt SurfaceData::m_startTimeStep
default = Maximun number of time steps

Specifies the after which time step the recording of conservative variables stops Possible values are:

  • positv integers

Keywords: SAMPLING, I/O

samplingDataGeneratePoints_

MBool genPoints
Specifies if points for sampling should be generated.
Possible values are:

  • false
  • true

Keywords: SAMPLING, I/O

samplingDataSampleInterval_

MInt sampleInterval
Specifies at which interval the state at the specified points should be sampled. The sampleInterval_{noFiles} property overrides the value specified in the property sampleInterval
Possible values are:

  • any integer

Keywords: SAMPLING, I/O

Author
Julian Vorspohl j.vor.nosp@m.spoh.nosp@m.l@aia.nosp@m..rwt.nosp@m.h-aac.nosp@m.hen..nosp@m.de
Parameters
[in]returnModeDefine whether location(0), velocity(1) or acceleration(2) is returned
[out]bodyDataBody data for a single body
[in]bodyIdBody id for which is motion is calculated
[in]timeCurrent time

amplitudes

MFloat* LsCartesianSolver::m_static_computeBodyProperties_amplitude
default = none

Amplitude for body motion of embedded bodies.
NOTE: also used in FV-MB solver for some special cases.

Possible values are:

  • list of floating point numbers

Keywords: LEVELSET, MOVING, BODY, BODY_MOTION

rotAngle

MFloat LsPar::rotAngle
default = "0.0"

Used for specific bodyToFunction settings in the Ls-Solver to rotate the primary direction of the body movement.

  • Any positive Float

Keywords: LEVELSET EMBEDED BOUNDARY, MOVEMENT FUNCTIONS

Author
lennart, corrected version of george's version in lb solver

discrete spectrum is computed on unity cube, no spatial scaling required velocity field is computed for u_rms = 1, hence uPhysField subsequently has to be scaled by the magnitude of the fluctuations, e.g. uPhysField *= m_UInfinity

(u,v,w)PhysField: complex velocity in physical space

Parameters
uPhysFieldpointer to a fftw_complex for u
vPhysFieldpointer to a fftw_complex for v
wPhysFieldpointer to a fftw_complex for w
kpRatioratio of peak wave number to minimum wave number, kp/k0
spectrumIdprescribed energy spectrum

referenceCubeSize

MInt MAIAMath::referenceCubeSize
default = 1

Defines the length of the box in which the FFT is used.
On this account, the minimal wavenumber is defined by kmin=2*pi/referenceCubeSize
Possible values are:

  • positive integers

Keywords: FFT, MATH