Loading [MathJax]/extensions/tex2jax.js
MAIA bb96820c
Multiphysics at AIA
All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Pages
Finite Volumen Moving Boundary (FVMB)

localTimeSteppingMb

MInt FvMbCartesianSolverXD::localTS
default = none

Switch to use local time stepping in Runge Kutta Scheme Possible values are:

  • true/false

Keywords: FINITE VOLUME, MOVING BOUNDARY, LOCAL TIME STEPPING

motionEquation

MInt FvMbCartesianSolverXD::m_motionEquation
default = 0
How do bodys move in moving boundary computations?
Possible values are:

  • 0: forced motion
  • 1: free motion under gravity
  • 2: Ahn & Kallinderis scheme
  • 3: Borazjani scheme
  • 4: Lennart's scheme

Keywords: MOVING BOUNDARY

euler

MBool FvCartesianSolver::m_euler
default = 0

Sets the system of equations to solve to the Euler Equations in the moving boundary solver. Keywords: FINITE_VOLUME, MOVING_BOUNDARY

generateOuterBndryCells

MBool FvMbCartesianSolverXD::m_generateOuterBndryCells
default = 1

Controls whether or not outer (not-moving) boundary cells should be created.
Keywords: FINITE_VOLUME, MOVING_BOUNDARY, BOUNDARY

centralizeSurfaceVariables

MInt FvMbCartesianSolverXD::m_centralizeSurfaceVariables
default = 0
How to compute surface values in moving boundary Ausm?
Possible values are:

  • 0: standard method from computeSurfaceValues
  • 1: Thornber version (Thornber et al. JCP 2008)
  • 2: Thornber, changed upwind factor min(1,max(A,B)) -> min(1,A*B), more central, less dissipative, but less damping
  • 3: central, not recommended
  • 4: refinement depending upwind factor pow(min(1,A*B),fac), fac=f(a_level)
  • 5: upwind factor computation based on property: centralizeSurfaceVariablesFactor

Keywords: MOVING BOUNDARY, AUSM, NUMERICS

m_levelSetAdaptationScheme

MInt FvMbCartesianSolverXD::m_levelSetAdaptationScheme
default = 0

Can be used to switch between the function updateLevelSetOutsideBandPar (0) and updateLevelSetOutsideBand (1) and no Update of the OutsideBand (2)
The first two compute an approximate level set value for cells outside the level-set computing band, which is necessary for the according adaptation!
Possible values are:

0, 1

Keywords: FINITE_VOLUME, LEVEL_SET

haloCellOutput

MInt FvMbCartesianSolverXD::m_haloCellOutput
default = 0 (false)
Write haloCells output (???). Keywords: MOVING BOUNDARY, FINITE_VOLUME

bodySamplingInterval

MInt FvMbCartesianSolverXD::m_bodySamplingInterval
default = 0

Defines the sampling interval of the body
Possible values are:

positive integers

Keywords: FINITE_VOLUME, PARTICLE, I/O

particleSamplingInterval

MInt FvMbCartesianSolverXD::m_particleSamplingInterval
default = 0

Defines the interval in which the properties of the particles are saved by saveParticleSamples()
Possible values are:

positive integers

Keywords: FINITE_VOLUME, PARTICLE, I/O

conservationCheck

MBool FvMbCartesianSolverXD::m_conservationCheck
default = false
Checks conservation of the conservative variables in FvMbCartesianSolverXD::applyBoundaryCondition(). Since FSFvMbCartesianSolverXD::applyBoundaryConditionMb() is used, the property seems deprecated.
Possible values are:

  • true
  • false

Keywords: FINITE VOLUME, MOVING BOUNDARY, CONSERVATION, BOUNDARY CONDITION, UNUSED

writeCenterLineData

MBool FvMbCartesianSolverXD::m_writeCenterLineData
default = false
Writes out the Data at the center line of the domain.

  • true
  • false

Keywords: FINITE VOLUME, MOVING BOUNDARY, OUTPUT

trackMovingBndry

MBool FvMbSolver2/3D::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, FINITE VOLUME, BODY DISPLACEMENT

trackMbStart

MInt FvMbSolver2/3D::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, FINITE VOLUME, BODY DISPLACEMENT

FSIStart

MInt FvMbSolver2/3D::m_FSIStart
default = numeric_limits<MInt>::max()
Start interation of the fluid structure interaction, from
which the body is then displaced
Possible values are:

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

Keywords: MOVING BOUNDARY, FINITE VOLUME, BODY DISPLACEMENT

trackMbEnd

MInt FvMbSolver2/3D::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, FINITE VOLUME, BODY DISPLACEMENT

bodyTypeMb

MInt FvMbSolver2/3D::m_bodyTypeMb
default = 1

Select the moving boundary body type to simulate.

Possible values are:

  • 0: generic body (STL)
  • 1: sphere
  • 2: piston
  • 3: ellipsoid
  • 4: NACA00XX
  • 5: split sphere
  • 6: cube
  • 7: tetrahedron

Keywords: FINITE_VOLUME, MOVING_BOUNDARY, BODY_TYPE

logBoundaryData

MBool FvBndryCnd::m_logBoundaryData>
default = "FALSE"

Triggers the logs of several boundary values to the given output file.

  • 0 (deactivated)
  • 1 (activated)

Keywords: FINITE_VOLUME, BOUNDARY CONDITION, OUTPUT

complexBoundary

MBool FvMbSolverXD::m_complexBoundary
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:

  • 0 or 1 (false or true)

Keywords: MOVING BOUNDARY, MULTIPLE LEVEL SET FUNCTIONS

maxNoSurfacePointSamples

MInt FvMbCartesianSolverXD::m_maxNoSurfacePointSamples
default = property maxNoBndryCells
STL files can be read and data at the triangle centroids can be sampled. maxNoSurfacePointSamples is the upper limit for the number of sampling points. However the function for determining the sampling points (readStlFile) is not called in the trunk.
Possible values are:

  • integers > O(maxNoBndryCells)

Keywords: MOVING BOUNDARY, FINITE VOLUME, PROBING, UNUSED

timeStepAdaptationStart

MInt fvmbcartesiansolverxd::m_timeStepAdaptationStart
default = -1

which time step to adaptTimeStep Possible values are:

  • Int

Keywords: time step

timeStepAdaptationEnd

MInt FvMbCartesianSolverXD::m_timeStepAdaptationEnd
default = -1
The time step at which a desired cfl number cflTarget is reached.
Possible values are:

  • -1: no time step adaptation

Keywords: FINITE VOLUME, MOVING BOUNDARY, TIME STEP, CFL

cflInitial

MInt FvMbCartesianSolverXD::m_cflInitial
default = -1
The initial CFL number for the time step adaptation.
Possible values are:

  • Floating point number for CFL

Keywords: FINITE VOLUME, MOVING BOUNDARY, TIME STEP, CFL

Fr

MFloat FvMbCartesianSolverXD::m_Fr
default = 1.0

Defines the Froude-Number
Possible values are:

positive floating-point values

Keywords: FINITE_VOLUME, FROUDE

gravitationalAcceleration

MFloat FvMbCartesianSolverXD::m_g
default = 0

Defines the gravitational acceleration
Possible values are:



Keywords: MOVING BOUNDARY, FINITE_VOLUME

gravity

MInt FvMbCartesianSolverXD::m_gravity
default = None
Gravitational acceleration in each of the directions.

Valid values: Any floating point values with length being spaceDimension. Keywords: MOVING BOUNDARY, FINITE_VOLUME

noPointParticles

MInt FvMbCartesianSolverXD::m_noPointParticles
default = 0
Number of point particles in the moving boundary solver.
Possible values are:

  • integers >= 0 and < O(maxNoCells)

Keywords: CAPITALS

pointParticleType

MInt FvMbCartesianSolverXD::m_pointParticleType
default = 1
defines the shape of point particles in the moving boundary solver.
Possible values are:

  • 1: sphere
  • 2: generic (shape factor)
  • 3: spheroid

Keywords: MOVING BOUNDARY, PARTICLES, FINITE_VOLUME

pointParticleTwoWayCoupling

MInt FvMbCartesianSolverXD::m_pointParticleTwoWayCoupling
default = 0
Activates or Deactivates two way coupling of point particles with the flow grid.
Possible values are:

  • 0: Inactive
  • 1: Active

Keywords: MOVING BOUNDARY, PARTICLES, FINITE_VOLUME

particleTerminalVelocity

MInt FvMbCartesianSolverXD::m_particleTerminalVelocity
default = None
Sets the terminal velocity for all particles.
Possible values are:

  • Any floating point values with length spaceDimension.

Keywords: MOVING BOUNDARY, PARTICLES, FINITE_VOLUME

m_gapInitMethod

MInt FvMbCartesianSolverXD::m_gapInitMethod
default = 2
Possible values are:

  • 0: all gap Cells are reseted and initialized (older version from Claudia)
  • 1: only new arising gap Cells are reseted!
  • 2: only new arising gap Cells are reseted and mew epsilons are used

Keywords: MOVING BOUNDARY, GAP, FINITE_VOLUME

LsRotate

MString FvMbSolver::m_LsRotate
default = flase

This property needs to be true for rotating levelset

surfaceValueReconstruction

MInt FvCartesianSolver::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:

  • 0: only use distance weights
  • 1: only use distance weights and set weight = 0 for diagonal neighbors
  • 2: use distance and cellFraction weights for all neighbors

Keywords: FINITE_VOLUME, SVD, reconstructionConstants

engineSetup

MBool LsCartesianSolver::m_engineSetup
Triggers specific stuff for TINA or other engine applications default = false

Keywords: LEVELSET, ADAPTATION, ENGINE

linerLvlJump

MBool LsCartesianSolver::m_linerLvlJump
Triggers a level Jump in the levelset of the engine liner, so that only the liner inside is refined! default = false

Keywords: LEVELSET, ADAPTATION, ENGINE

forceNoGaps

MInt LsCartesianSolver::m_forceNoGaps
default = 0
triggers the surpression of gap cells

  • 0: do not surpress gap cells (1)
  • 1: surpress gap cells for multi-valve engine (2)
  • 2: surpress gap cells for single-valve engine

Keywords: MOVING BOUNDARY, GAP, LS

splitSphereSlitHeight

MFloat FvMbCartesianSolverXD::getDistanceSplitSphere::h
default = property bodyRadius (default 0.5)
The extend of the gap of a splitted sphere
Possible values are:

  • values > 0 and < O(lengthLevel0)

Keywords: FINITTE VOLUME, MOVING BOUNDARY, SPLIT SPHERE

NACA00XX

MFloat xx
default = 0

Percentage of thickness to chord of a symmetrical (no camber) NACA00xx airfoil used by the NACA00XX body type to set the wing shape. Keywords: FINITE_VOLUME, MOVING_BOUNDARY, BODY_TYPE

adaptiveGravity

MBool FvMbCartesianSolverXD::constructGFieldPredictor::adaptiveGravity
default = m_static_constructGFieldPredictor_adaptiveGravity(false)
Sets the gravity in z-direction to -F/m at the first call of constructGFieldPredictor.
Possible values are:

  • true: do that
  • false: don't do that

Keywords: FINITE VOLUME, MOVING BOUNDARY, GRAVITY

pointParticleDiameter

MFloat FvMbCartesianSolverXD::initPointParticleProperties::diameter
default = F1
Diameter of a point particle.
Possible values are:

  • Floating point number > 0.0

Keywords: FINITE VOLUME, MOVING BOUNDARY, PARTICLE

pointParticleAspectRatio

MFloat FvMbCartesianSolverXD::initPointParticleProperties::beta
default = F1
Aspect ratio of a point particle.
Possible values are:

  • Floating point number > 0.0

Keywords: FINITE VOLUME, MOVING BOUNDARY, PARTICLE

randomDeviceSeed

int64_t FvMbCartesianSolverXD::seed0
default = -1
Float number used as a seed for a random number generator.
If seed is not set, uses std::random_device() to generate a seed.
Keywords: FINITE VOLUME, MOVING BOUNDARY, PARTICLE, RANDOM NUMBER GENERATOR

bodyTemperatureRatio

MInt FvMbCartesianSolverXD
default = 1

Sets the body temperature of the embedded body based on m_TInfinity. Possible values are:

  • Any positive float value.

Keywords: MOVING BOUNDARY, TEMPERATURE

fixedBodyComponents

MInt fvmbcartesiansolverxd::*m_fixedBodyComponents
default = 0.0

decide in which direction the body motion is fixed(restricted) Possible values are:

  • 1 or 0

Keywords: moving

fixedBodyComponentsRotation

MInt fvmbcartesiansolverxd::*m_fixedBodyComponentsRotation
default = 0.0

decide in which direction the body rotation is fixed(restricted) Possible values are:

  • 1 or 0

Keywords: moving

reducedMass

MFloat reducedMass
Ratio between the mass of the solid $$m_s$$ and the mass of the fluid $$m_{f,0}$ that would otherwise occupy the solid volume in stagnation conditions: $$m_{red} = m_s / m_{f, 0}$$. default = 0

Keywords: FINITE_VOLUME, MOVING_BOUNDARY, BODY_MOTION

bodyRadius

MFloat FvMbCartesianSolverXD::m_bodyRadius
default = None

Sets the radius of all moving bodies to the same value
Possible values are:

  • Single positive floating-point numbers greater than zero

Keywords: MOVING BOUNDARY, BODY PARAMETERS

bodyDiameters

MFloat FvMbCartesianSolverXD::m_bodyDiameter
default = None

Sets the diameter of each moving body
Possible values are:

  • Positive floating-point numbers greater than zero - one number per body

Keywords: MOVING BOUNDARY, BODY PARAMETERS

bodyRadii

MFloat FvMbPar::m_bodyRadii
default = ""

Defines the three radii for an elliptical body implemented in the analytical levelset. Only necessary if elliptical bodies are used in that sense.

  • any positive float

Keywords: LEVELSET, ANALYTICAL, G0,

densityRatio

MFloat FvMbSolver::m_desitiyRatio
default = 1.0
Sets the density of a moving body based on m_rhoInfinity. Possible values are:

  • Any positive float value

Keywords: FINITE_VOLUME, MOVING BOUNDARY, DENSITY

capacityConstantVolumeRatio

MFloat FvMbSolver::m_capacityConstantVolumeRatio
default = no default
Heat capacity at constant volume Cv_particle/Cv_fluid Keywords: FINITE_VOLUME, HEAT_CAPACITY

initialBodyVelocity

MFloat Lssolver::m_bodyVelocity
default = 0.0

This property defines the components of the intial velocity vector of a moving object. Possible values are:

  • Any float values

Keywords: FINITE-VOLUME, MOVING BOUNDARY

xBodyCenter

MFloat m_bodyCenter
default = 0

Initial value of the x-component of the center of mass of each body. That is, for N bodies this is an N-element array. Keywords: FINITE_VOLUME, MOVING_BOUNDARY, INITIAL_CONDITION

yBodyCenter

MFloat m_bodyCenter
default = 0

Initial value of the y-component of the center of mass of each body. That is, for N bodies this is an N-element array. Keywords: FINITE_VOLUME, MOVING_BOUNDARY, INITIAL_CONDITION

zBodyCenter

MFloat m_bodyCenter
default = 0

Initial value of the z-component of the center of mass of each body. That is, for N bodies this is an N-element array. Keywords: FINITE_VOLUME, MOVING_BOUNDARY, INITIAL_CONDITION

xBodyVelocity

MFloat m_bodyVelocity
default = 0

Initial value of the x-component of the velocity of each body. That is, for N bodies this is an N-element array. Keywords: FINITE_VOLUME, MOVING_BOUNDARY, INITIAL_CONDITION

yBodyVelocity

MFloat m_bodyVelocity
default = 0

Initial value of the y-component of the velocity of each body. That is, for N bodies this is an N-element array. Keywords: FINITE_VOLUME, MOVING_BOUNDARY, INITIAL_CONDITION

zBodyVelocity

MFloat m_bodyVelocity
default = 0

Initial value of the z-component of the velocity of each body. That is, for N bodies this is an N-element array. Keywords: FINITE_VOLUME, MOVING_BOUNDARY, INITIAL_CONDITION

xBodyNeutralCenter

MFloat m_bodyNeutralCenter
default = 0

x-Coordinate of the neutral position for elastically mounted bodies Keywords: FINITE_VOLUME, MOVING_BOUNDARY, INITIAL_CONDITION

yBodyNeutralCenter

MFloat m_bodyNeutralCenter
default = 0

y-Coordinate of the neutral position for elastically mounted bodies Keywords: FINITE_VOLUME, MOVING_BOUNDARY, INITIAL_CONDITION

zBodyNeutralCenter

MFloat m_bodyNeutralCenter
default = 0

z-Coordinate of the neutral position for elastically mounted bodies Keywords: FINITE_VOLUME, MOVING_BOUNDARY, INITIAL_CONDITION

initialBodyCenter

MFloat Lssolver::initialBodyCenter
default = no default value

The property is intial position of moving object, reads in during initialization or restart. possible values are:

  • Any float value

Keywords: moving boundaries

initialBodyQuaternion

MFloat[4] FvMbCartesianSolverXD::m_bodyQuaternion
default = [0.,0.,0.,0.]

Initializes the quaternion storing the position and rotation of each body
Possible values are:

  • Four floating-point numbers per body

Keywords: MOVING BOUNDARY, BODY INITIALIZATION

initialBodyRotation

MFloat* FvMbSolver2/3D::m_bodyRotation
default = 0.0 or set by initialBodyQuaternion

Initial rotation of all embedded bodies. If three values are given these are used for all bodies, alternatively provide nDim values per body.

Possible values are:

  • list of floating point values

Keywords: FINITE_VOLUME, MOVING_BOUNDARY, BODY_MOTION, INITIAL_CONDITION

restart

bodyTerminalVelocity

MFloat FvMbPar::m_bodyTerminalVelocity
default = ""

Specifies the terminal velocity of all embedded analytical moving levelset functions in each dimension.

  • any positive float

One velocity value per Dimension Keywords: LEVELSET, ANALYTICAL, G0,

amplitudeFactor

MFloat FvMbCartesianSolverXD::updateBodyProperties()::amplitudeFactor
default = 0.1

Set the amplitude factor (in terms of body diameters) for prescribing body motion.

Possible values are:

  • any positive floating point number

Keywords: FINITE_VOLUME, MOVING_BOUNDARY, BODY, BODY_MOTION

freqFactor

MFloat FvMbCartesianSolverXD::updateBodyProperties()::freqFactor
default = depending on body equation for current body

Set the frequency factor for prescribing body motion.

Possible values are:

  • any positive floating point number

Keywords: FINITE_VOLUME, MOVING_BOUNDARY, BODY, BODY_MOTION

KeuleganCarpenter

MFloat FvMbCartesianSolverXD::updateBodyProperties::KC
default = 0
Keulegan Carpenter number (period number) of a sinusoidally oscillating sphere in stratified fluid in case 452.
Describes relative importance of drag forces over inertia forces in oscillatory flow. Possible values are:

  • non-negative values !!

Keywords: FINITE VOLUME, MOVING BOUNDARY, OSCILLATING SPHERE, KEULEGAN CARPENTER

nonDimensionalFreq

MFloat FvMbCartesianSolverXD::updateBodyProperties::Sf
default = 0
Strouhal number of a sinusoidally oscillating sphere in stratified fluid in case 452.
Possible values are:

  • values > 0 and < O(referenceLength/(timeStep*UInfinity))

Keywords: FINITE VOLUME, MOVING BOUNDARY, OSCILLATING SPHERE, STROUHAL NUMBER

StokesNumber

MFloat fvmbcartesiansolverxd::StokesNumber
default = F4

The Stokes number is a dimensionless number characterising the behavior of particles suspended in a fluid flow. The Stokes number is defined as the ratio of the characteristic time of a particle (or droplet) to a characteristic time of the flow or of an obstacle StokesNumber in fvmbcartesiansolverxd.h updateBodyProperties for oscillating sphere, quiescent flow

  1. used to compute Strouhal number
  2. used to compute one constant velocity possible values are:
    • Any non-negative float value
    Keywords: oscillating sphere, quiescent flow

case 1: submerging old-Bndry-Cell

case 2: emerging cell

case 3: cut cell became an internal cell

particleTemperatureRatio

MFloat particleTemperatureRatio
default = 1.0

Set ratio of particle temperature relativ to fluid temperature.

Possible values are:

  • any positive floating point number

Keywords: FINITE_VOLUME, MOVING_BOUNDARY, PARTICLES, TEMPERATURE

initPPVelocitiesFactor

MFloat initPPVelocitiesFactor
default = 1.0

Sets a factor for the initial m_particleVelocityFluid

Possible values are:

  • any positive floating point number

Keywords: FINITE_VOLUME, MOVING_BOUNDARY, PARTICLES, VELOCITY

Author

initBodyRotation

MInt FvMbCartesianSolverXD::initBodyVelocities::initBodyRotation
default = 0

Initializes the body rotation.

  • 0: initial body rotation set to 0
  • 1: initial body rotation set to the mean rotation of former fluid cells inside the particles
  • 2: initial body rotation set to the rotation of a random former fluid cell inside the particle

Keywords: FINITE_VOLUME, MOVING_BOUNDARY, ROTATION

rungeKuttaStepMethod

MInt FvMbSolverXD::rungeKuttaStepMethod
default = false

Switch to use new modified Runge Kutta Scheme optimized for moving boundaries Possible values are:

  • true/false

Keywords: FINITE VOLUME, MOVING BOUNDARY

mbSpongeLayer

MBool FvMbSolver::m_static_updateSpongeLayer_mbSpongeLayer
default = false

Enable the use of the moving boundary solver sponge layer instead of the default finite volume solver sponge layer.

Possible values are:

  • 0 (off)
  • 1 (on)

Keywords: FINITE_VOLUME, MOVING_BOUNDARY, SPONGE, LAYER

writePointData

MFloat FvMbSolver2D::writeVtkXmlOutput::writePointData
default = 0
Triggers wether point (vertex-centered) or cell (cell-centered) data is written to the output file.
Possible values are:

  • 0: deactivated
  • 1: activated

Keywords: FINITE VOLUME, MOVING BOUNDARY, VTK