Foam::functionObjects Namespace Reference

Namespace for functionObjects. More...

Namespaces

 fieldValues
 

Classes

class  adjustTimeStepToCombustion
 Adjusts the time step to match bulk reaction time scales. This allows the solver to temporally resolve chemical changes, in order to better couple the chemistry and transport, or to improve the time-accuracy of post-processing. More...
 
class  Qdot
 Calculates and outputs the heat release rate for the current combustion model. More...
 
class  fvMeshFunctionObject
 Specialisation of Foam::functionObject for an Foam::fvMesh, providing a reference to the Foam::fvMesh. More...
 
class  fvModel
 functionObject to instantiate and execute an fvModel More...
 
class  add
 Add a list of fields. More...
 
class  age
 Calculates and writes out the time taken for a particle to travel from an inlet to the location. Solves the following equation when incompressible: More...
 
class  blendingFactor
 Calculates and outputs the blendingFactor as used by the bended convection schemes. The output is a volume field (cells) whose value is calculated via the maximum blending factor for any cell face. More...
 
class  comfort
 Calculates the thermal comfort quantities predicted mean vote (PMV), predicted percentage of dissatisfaction (PPD) and the draught rate (DR) based on DIN ISO EN 7730:2005. More...
 
class  components
 Calculates the components of a field. More...
 
class  CourantNo
 Calculates and outputs the Courant number as a volScalarField. The field is stored on the mesh database so that it can be retrieved and used for other applications. More...
 
class  cylindrical
 Transforms the specified velocity field into a cylindrical polar coordinate system or back to Cartesian. More...
 
class  ddt
 Calculates the Eulerian time derivative of a field. More...
 
class  div
 Calculates the divergence of a field. The operation is limited to surfaceScalarFields and volVectorFields, and the output is a volScalarField. More...
 
class  divide
 Divide a list of fields. More...
 
class  enstrophy
 Calculates the enstrophy of the velocity. More...
 
class  fieldAverage
 Calculates average quantities for a user-specified selection of volumetric and surface fields. More...
 
class  fieldAverageItem
 Helper class to describe what form of averaging to apply. A set will be applied to each base field in Foam::fieldAverage, of the form: More...
 
class  fieldCoordinateSystemTransform
 Transforms a user-specified selection of fields from global Cartesian co-ordinates to a local co-ordinate system. The fields are run-time modifiable. More...
 
class  fieldExpression
 
class  fieldsExpression
 
class  fieldValue
 Base class for field value -based function objects. More...
 
class  flowType
 Calculates and writes the flowType of a velocity field. More...
 
class  grad
 Calculates the gradient of a field. More...
 
class  histogram
 Write the volume-weighted histogram of a volScalarField. More...
 
class  interfaceHeight
 This function object reports the height of the interface above a set of locations. For each location, it writes the vertical distance of the interface above both the location and the lowest boundary. It also writes the point on the interface from which these heights are computed. It uses an integral approach, so if there are multiple interfaces above or below a location then this method will generate average values. More...
 
class  Lambda2
 Calculates and outputs the second largest eigenvalue of the sum of the square of the symmetric and anti-symmetric parts of the velocity gradient tensor. More...
 
class  layerAverage
 
class  log
 Calculates the natural logarithm of the specified scalar field. More...
 
class  MachNo
 Calculates and writes the Mach number as a volScalarField. More...
 
class  mag
 Calculates the magnitude of a field. More...
 
class  magSqr
 Calculates the magnitude of the sqr of a field. More...
 
class  multiply
 Multiply a list of fields. More...
 
class  nearWallFields
 Samples near-patch volume fields. More...
 
class  patchCutLayerAverage
 This function object writes graphs of patch face values, area-averaged in planes perpendicular to a given direction. It adaptively grades the distribution of graph points to match the resolution of the mesh. More...
 
class  PecletNo
 Calculates and outputs the Peclet number as a surfaceScalarField. More...
 
class  pressure
 Includes tools to manipulate the pressure into different forms. More...
 
class  processorField
 Writes a scalar field whose value is the local processor ID. The output field name is 'processorID'. More...
 
class  Q
 Calculates and outputs the second invariant of the velocity gradient tensor [1/s^2]. More...
 
class  randomise
 Adds a random component to a field, with a specified perturbation magnitude. More...
 
class  readFields
 Reads fields from the time directories and adds them to the mesh database for further post-processing. More...
 
class  reconstruct
 Calculates the reconstruction of a field; e.g., to construct a cell-centred velocity, U, from the face-centred flux, phi. The operation is limited to scalar and vector surface fields, and the output is a volume vector or tensor field. More...
 
class  regionSizeDistribution
 Creates a size distribution via interrogating a continuous phase fraction field. More...
 
class  scale
 Multiplies a field by a scaling factor. More...
 
class  shearStress
 Calculates and writes the shear-stress as the volSymmTensorField field 'shearStress'. More...
 
class  streamFunction
 This function object calculates and outputs the stream-function as a pointScalarField. More...
 
class  streamlines
 Generates streamline data by sampling a set of user-specified fields along a particle track, transported by a user-specified velocity field. More...
 
class  subtract
 From the first field subtract the remaining fields in the list. More...
 
class  surfaceInterpolate
 Calculates the surface interpolation of a field. More...
 
class  totalEnthalpy
 Calculates and writes the total enthalpy (ha + K) as the volScalarField 'Ha'. More...
 
class  turbulenceFields
 Stores turbulence fields on the mesh database for further manipulation. More...
 
class  turbulenceIntensity
 Evaluates and writes the turbulence intensity field 'I'. More...
 
class  uniform
 Generate a uniform field. More...
 
class  vorticity
 Calculates the vorticity, the curl of the velocity. More...
 
class  wallHeatFlux
 Calculates and write the heat-flux at wall patches as the volScalarField field 'wallHeatFlux'. More...
 
class  wallHeatTransferCoeff
 Calculates and writes the estimated heat transfer coefficient at wall patches as the volScalarField field. More...
 
class  wallShearStress
 Calculates and write the shear-stress at wall patches as the volVectorField field 'wallShearStress' or 'wallShearStress.<phase>'. More...
 
class  writeCellCentres
 Writes the cell-centres volVectorField and the three component fields as volScalarFields. More...
 
class  writeCellVolumes
 Writes the cell-volumes volScalarField. More...
 
class  XiReactionRate
 Writes the turbulent flame-speed and reaction-rate volScalarFields for the Xi-based combustion models. More...
 
class  yPlus
 Evaluates and outputs turbulence y+ for models. Values written to time directories as field 'yPlus' or 'yPlus.<phase>'. More...
 
class  forceCoeffs
 Extends the forces functionObject by providing lift, drag and moment coefficients. The data can optionally be output into bins, defined in a given direction. More...
 
class  forces
 Calculates the forces and moments by integrating the pressure and skin-friction forces over a given list of patches. More...
 
class  phaseScalarTransport
 Evolves a passive scalar transport equation within one phase of a multiphase simulation. The scalar is considered to be a phase-intensive property; i.e., its value represents an amount per-unit of the phase. In addition to the scalar, the function also writes out the product of the volume fraction and the scalar, as this provides a phase-extensive field which is often more convenient to post-process. More...
 
class  scalarTransport
 Evolves a passive scalar transport equation. More...
 
class  checkMesh
 Executes primitiveMesh::checkMesh(true) every execute time for which the mesh changed, i.e. moved or changed topology. More...
 
class  removeRegisteredObject
 Removes registered objects if present in the database. More...
 
class  residuals
 Writes out the initial residual for specified fields. More...
 
class  setTimeStepFunctionObject
 Updates the time step as a Function1 of time. More...
 
class  setWriteIntervalFunctionObject
 Updates the writeInterval as a Function1 of time. More...
 
class  stopAt
 Abstract base class for stop conditions. More...
 
class  stopAtClockTime
 Stops the run when the specified clock time in seconds has been reached and optionally write results before stopping. More...
 
class  stopAtFile
 Stops the run when the specified file is created in the case directory and optionally write results before stopping. More...
 
class  stopAtTimeStep
 Stops the run if the time-step drops below the specified value in seconds and optionally write results before stopping. More...
 
class  systemCall
 Executes system calls, entered in the form of a string lists. More...
 
class  time
 Writes run time, CPU time and clock time and optionally the CPU and clock times per time step. More...
 
class  timeActivatedFileUpdate
 Performs a file copy/replacement once a specified time has been reached. More...
 
class  timeStep
 Writes the time step. More...
 
class  writeDictionary
 Writes dictionaries on start-up and on change. More...
 
class  writeObjects
 Allows specification of different writing frequency of objects registered to the database. More...
 
class  meshToMeshAdjustTimeStepFunctionObject
 Adjusts time-step for meshToMesh mapping. More...
 
class  cloudInfo
 Outputs Lagrangian cloud information to a file. More...
 
class  dsmcFields
 Calculate intensive fields: More...
 
class  particles
 This functionObject tracks a particle cloud in the specified velocity field of an incompressible flow (laminar, RANS or LES). More...
 
class  stopAtEmptyClouds
 Stops the run when all parcel clouds are empty. More...
 
class  logFiles
 functionObject base class for creating, maintaining and writing log files e.g. integrated of averaged field data vs time. More...
 
class  regionFunctionObject
 Specialisation of Foam::functionObject for a region and providing a reference to the region Foam::objectRegistry. More...
 
class  timeControl
 General time control for functionObjects. More...
 
class  writeFile
 functionObject base class for writing single files More...
 
class  writeLocalObjects
 FunctionObject base class for managing a list of objects on behalf of the inheriting function object, on when those should be written to disk. More...
 
class  writeObjectsBase
 FunctionObject base class for writing a list of objects registered to the database, on behalf of the inheriting function object, on when those should be written to disk. More...
 
class  rigidBodyPoints
 Writes the position, linear and angular velocities and accelerations of a list of points on a body specified in the body local coordinate system. More...
 
class  rigidBodyState
 Writes the rigid body motion state. More...
 
class  sampledSets
 
class  sampledSurfaces
 Set of surfaces to sample. More...
 
class  sixDoFRigidBodyControl
 Convergence control based on the 6-DoF motion state. More...
 
class  sixDoFRigidBodyState
 Writes the 6-DoF motion state. More...
 
class  adjustTimeStepToChemistry
 Adjusts the time step to match a chemistry model's stored chemical time step. This allows the solver to temporally resolve chemical changes, in order to better couple the chemistry and transport, or in order to accurately post-process the chemical changes. More...
 
class  specieReactionRates
 Writes the domain averaged reaction rates for each specie for each reaction into the file <timeDir>/specieReactionRates.dat. More...
 
class  massFractions
 This function object calculates mass-fraction fields from mole-fraction or moles fields present on disk. This is intended to be used for initialisation where mole-fractions are known. If any mass fraction fields are found (other than Ydefault) then an error will be generated and the fields will not be overwritten. The names of the mole-fraction fields are obtained from the corresponding mass-fraction fields prepended by "X_", and the moles fields are prepended by "n_". Either mole-fraction fields or moles fields should be present, not both. More...
 
class  moleFractions
 This function object calculates mole-fraction fields from the mass-fraction fields of the multicomponent thermo. The names of the mole-fraction fields are obtained from the corresponding mass-fraction fields prepended by "X_". More...
 
class  writeVTK
 This functionObject writes objects registered to the database in VTK format using the foamToVTK library. More...
 
class  phaseForces
 This functionObject calculates and outputs the blended interfacial forces acting on a given phase, i.e. drag, virtual mass, lift, wall-lubrication and turbulent dispersion. Note that it works only in run-time processing mode and in combination with the multiphaseEulerFoam solver. More...
 
class  phaseMap
 This functionObject writes the phase-fraction map field alpha.map with incremental value ranges for each phase e.g., with values 0 for water, 1 for air, 2 for oil etc. More...
 
class  populationBalanceMoments
 Calculates and writes out integral (integer moments) or mean properties (mean, variance, standard deviation) of a size distribution determined by a population balance model. Requires solver post-processing. More...
 
class  populationBalanceSizeDistribution
 Writes out the size distribution determined by a population balance model, either for the entire domain or a cell zone. Requires solver post- processing. More...
 
class  wallBoilingProperties
 This function looks up wall boiling wall functions and collects and writes out out the following data: More...
 

Functions

 defineTypeNameAndDebug (adjustTimeStepToCombustion, 0)
 
 addToRunTimeSelectionTable (functionObject, adjustTimeStepToCombustion, dictionary)
 
 defineTypeNameAndDebug (Qdot, 0)
 
 addToRunTimeSelectionTable (functionObject, Qdot, dictionary)
 
 defineTypeNameAndDebug (fvMeshFunctionObject, 0)
 
 defineTypeNameAndDebug (fvModel, 0)
 
 addToRunTimeSelectionTable (functionObject, fvModel, dictionary)
 
 defineTypeNameAndDebug (add, 0)
 
 addToRunTimeSelectionTable (functionObject, add, dictionary)
 
 defineTypeNameAndDebug (age, 0)
 
 addToRunTimeSelectionTable (functionObject, age, dictionary)
 
 defineTypeNameAndDebug (blendingFactor, 0)
 
 addToRunTimeSelectionTable (functionObject, blendingFactor, dictionary)
 
 defineTypeNameAndDebug (comfort, 0)
 
 addToRunTimeSelectionTable (functionObject, comfort, dictionary)
 
 defineTypeNameAndDebug (components, 0)
 
 addToRunTimeSelectionTable (functionObject, components, dictionary)
 
 defineTypeNameAndDebug (CourantNo, 0)
 
 addToRunTimeSelectionTable (functionObject, CourantNo, dictionary)
 
 defineTypeNameAndDebug (cylindrical, 0)
 
 addToRunTimeSelectionTable (functionObject, cylindrical, dictionary)
 
 defineTypeNameAndDebug (ddt, 0)
 
 addToRunTimeSelectionTable (functionObject, ddt, dictionary)
 
 defineTypeNameAndDebug (div, 0)
 
 addToRunTimeSelectionTable (functionObject, div, dictionary)
 
 defineTypeNameAndDebug (divide, 0)
 
 addToRunTimeSelectionTable (functionObject, divide, dictionary)
 
 defineTypeNameAndDebug (enstrophy, 0)
 
 addToRunTimeSelectionTable (functionObject, enstrophy, dictionary)
 
 defineTypeNameAndDebug (fieldAverage, 0)
 
 addToRunTimeSelectionTable (functionObject, fieldAverage, dictionary)
 
 defineTypeNameAndDebug (fieldCoordinateSystemTransform, 0)
 
 addToRunTimeSelectionTable (functionObject, fieldCoordinateSystemTransform, dictionary)
 
 defineTypeNameAndDebug (fieldExpression, 0)
 
 defineTypeNameAndDebug (fieldsExpression, 0)
 
 defineTypeNameAndDebug (fieldValue, 0)
 
 defineRunTimeSelectionTable (fieldValue, dictionary)
 
 defineTypeNameAndDebug (flowType, 0)
 
 addToRunTimeSelectionTable (functionObject, flowType, dictionary)
 
 defineTypeNameAndDebug (grad, 0)
 
 addToRunTimeSelectionTable (functionObject, grad, dictionary)
 
 defineTypeNameAndDebug (histogram, 0)
 
 addToRunTimeSelectionTable (functionObject, histogram, dictionary)
 
 defineTypeNameAndDebug (interfaceHeight, 0)
 
 addToRunTimeSelectionTable (functionObject, interfaceHeight, dictionary)
 
 defineTypeNameAndDebug (Lambda2, 0)
 
 addToRunTimeSelectionTable (functionObject, Lambda2, dictionary)
 
 defineTypeNameAndDebug (layerAverage, 0)
 
 addToRunTimeSelectionTable (functionObject, layerAverage, dictionary)
 
 defineTypeNameAndDebug (log, 0)
 
 addToRunTimeSelectionTable (functionObject, log, dictionary)
 
 defineTypeNameAndDebug (MachNo, 0)
 
 addToRunTimeSelectionTable (functionObject, MachNo, dictionary)
 
 defineTypeNameAndDebug (mag, 0)
 
 addToRunTimeSelectionTable (functionObject, mag, dictionary)
 
 defineTypeNameAndDebug (magSqr, 0)
 
 addToRunTimeSelectionTable (functionObject, magSqr, dictionary)
 
 defineTypeNameAndDebug (multiply, 0)
 
 addToRunTimeSelectionTable (functionObject, multiply, dictionary)
 
 defineTypeNameAndDebug (nearWallFields, 0)
 
 addToRunTimeSelectionTable (functionObject, nearWallFields, dictionary)
 
 defineTypeNameAndDebug (patchCutLayerAverage, 0)
 
 addToRunTimeSelectionTable (functionObject, patchCutLayerAverage, dictionary)
 
 defineTypeNameAndDebug (PecletNo, 0)
 
 addToRunTimeSelectionTable (functionObject, PecletNo, dictionary)
 
 defineTypeNameAndDebug (pressure, 0)
 
 addToRunTimeSelectionTable (functionObject, pressure, dictionary)
 
 defineTypeNameAndDebug (processorField, 0)
 
 addToRunTimeSelectionTable (functionObject, processorField, dictionary)
 
 defineTypeNameAndDebug (Q, 0)
 
 addToRunTimeSelectionTable (functionObject, Q, dictionary)
 
 defineTypeNameAndDebug (randomise, 0)
 
 addToRunTimeSelectionTable (functionObject, randomise, dictionary)
 
 defineTypeNameAndDebug (readFields, 0)
 
 addToRunTimeSelectionTable (functionObject, readFields, dictionary)
 
 defineTypeNameAndDebug (reconstruct, 0)
 
 addToRunTimeSelectionTable (functionObject, reconstruct, dictionary)
 
 defineTypeNameAndDebug (regionSizeDistribution, 0)
 
 addToRunTimeSelectionTable (functionObject, regionSizeDistribution, dictionary)
 
 defineTypeNameAndDebug (scale, 0)
 
 addToRunTimeSelectionTable (functionObject, scale, dictionary)
 
 defineTypeNameAndDebug (shearStress, 0)
 
 addToRunTimeSelectionTable (functionObject, shearStress, dictionary)
 
 defineTypeNameAndDebug (streamFunction, 0)
 
 addToRunTimeSelectionTable (functionObject, streamFunction, dictionary)
 
 defineTypeNameAndDebug (streamlines, 0)
 
 addToRunTimeSelectionTable (functionObject, streamlines, dictionary)
 
 defineTypeNameAndDebug (subtract, 0)
 
 addToRunTimeSelectionTable (functionObject, subtract, dictionary)
 
 defineTypeNameAndDebug (surfaceInterpolate, 0)
 
 addToRunTimeSelectionTable (functionObject, surfaceInterpolate, dictionary)
 
 defineTypeNameAndDebug (totalEnthalpy, 0)
 
 addToRunTimeSelectionTable (functionObject, totalEnthalpy, dictionary)
 
 defineTypeNameAndDebug (turbulenceFields, 0)
 
 addToRunTimeSelectionTable (functionObject, turbulenceFields, dictionary)
 
 defineTypeNameAndDebug (turbulenceIntensity, 0)
 
 addToRunTimeSelectionTable (functionObject, turbulenceIntensity, dictionary)
 
 defineTypeNameAndDebug (uniform, 0)
 
 addToRunTimeSelectionTable (functionObject, uniform, dictionary)
 
 defineTypeNameAndDebug (vorticity, 0)
 
 addToRunTimeSelectionTable (functionObject, vorticity, dictionary)
 
 defineTypeNameAndDebug (wallHeatFlux, 0)
 
 addToRunTimeSelectionTable (functionObject, wallHeatFlux, dictionary)
 
 defineTypeNameAndDebug (wallHeatTransferCoeff, 0)
 
 addToRunTimeSelectionTable (functionObject, wallHeatTransferCoeff, dictionary)
 
 defineTypeNameAndDebug (wallShearStress, 0)
 
 addToRunTimeSelectionTable (functionObject, wallShearStress, dictionary)
 
 defineTypeNameAndDebug (writeCellCentres, 0)
 
 addToRunTimeSelectionTable (functionObject, writeCellCentres, dictionary)
 
 defineTypeNameAndDebug (writeCellVolumes, 0)
 
 addToRunTimeSelectionTable (functionObject, writeCellVolumes, dictionary)
 
 defineTypeNameAndDebug (XiReactionRate, 0)
 
 addToRunTimeSelectionTable (functionObject, XiReactionRate, dictionary)
 
 defineTypeNameAndDebug (yPlus, 0)
 
 addToRunTimeSelectionTable (functionObject, yPlus, dictionary)
 
 defineTypeNameAndDebug (forceCoeffs, 0)
 
 addToRunTimeSelectionTable (functionObject, forceCoeffs, dictionary)
 
 defineTypeNameAndDebug (forces, 0)
 
 addToRunTimeSelectionTable (functionObject, forces, dictionary)
 
 defineTypeNameAndDebug (phaseScalarTransport, 0)
 
 addToRunTimeSelectionTable (functionObject, phaseScalarTransport, dictionary)
 
 defineTypeNameAndDebug (scalarTransport, 0)
 
 addToRunTimeSelectionTable (functionObject, scalarTransport, dictionary)
 
 defineTypeNameAndDebug (checkMesh, 0)
 
 addToRunTimeSelectionTable (functionObject, checkMesh, dictionary)
 
 defineTypeNameAndDebug (removeRegisteredObject, 0)
 
 addToRunTimeSelectionTable (functionObject, removeRegisteredObject, dictionary)
 
 defineTypeNameAndDebug (residuals, 0)
 
 addToRunTimeSelectionTable (functionObject, residuals, dictionary)
 
 defineTypeNameAndDebug (setTimeStepFunctionObject, 0)
 
 addToRunTimeSelectionTable (functionObject, setTimeStepFunctionObject, dictionary)
 
 defineTypeNameAndDebug (setWriteIntervalFunctionObject, 0)
 
 addToRunTimeSelectionTable (functionObject, setWriteIntervalFunctionObject, dictionary)
 
 defineTypeNameAndDebug (stopAt, 0)
 
 defineTypeNameAndDebug (stopAtClockTime, 0)
 
 addToRunTimeSelectionTable (functionObject, stopAtClockTime, dictionary)
 
 defineTypeNameAndDebug (stopAtFile, 0)
 
 addToRunTimeSelectionTable (functionObject, stopAtFile, dictionary)
 
 defineTypeNameAndDebug (stopAtTimeStep, 0)
 
 addToRunTimeSelectionTable (functionObject, stopAtTimeStep, dictionary)
 
 defineTypeNameAndDebug (systemCall, 0)
 
 addToRunTimeSelectionTable (functionObject, systemCall, dictionary)
 
 defineTypeNameAndDebug (time, 0)
 
 addToRunTimeSelectionTable (functionObject, time, dictionary)
 
 defineTypeNameAndDebug (timeActivatedFileUpdate, 0)
 
 addToRunTimeSelectionTable (functionObject, timeActivatedFileUpdate, dictionary)
 
 defineTypeNameAndDebug (timeStep, 0)
 
 addToRunTimeSelectionTable (functionObject, timeStep, dictionary)
 
 defineTypeNameAndDebug (writeDictionary, 0)
 
 addToRunTimeSelectionTable (functionObject, writeDictionary, dictionary)
 
 defineTypeNameAndDebug (writeObjects, 0)
 
 addToRunTimeSelectionTable (functionObject, writeObjects, dictionary)
 
 defineTypeNameAndDebug (meshToMeshAdjustTimeStepFunctionObject, 0)
 
 addToRunTimeSelectionTable (functionObject, meshToMeshAdjustTimeStepFunctionObject, dictionary)
 
 defineTypeNameAndDebug (cloudInfo, 0)
 
 addToRunTimeSelectionTable (functionObject, cloudInfo, dictionary)
 
 defineTypeNameAndDebug (dsmcFields, 0)
 
 addToRunTimeSelectionTable (functionObject, dsmcFields, dictionary)
 
 defineTypeNameAndDebug (particles, 0)
 
 addToRunTimeSelectionTable (functionObject, particles, dictionary)
 
 defineTypeNameAndDebug (stopAtEmptyClouds, 0)
 
 addToRunTimeSelectionTable (functionObject, stopAtEmptyClouds, dictionary)
 
 defineTypeNameAndDebug (regionFunctionObject, 0)
 
 defineTypeNameAndDebug (timeControl, 0)
 
 defineTypeNameAndDebug (rigidBodyPoints, 0)
 
 addToRunTimeSelectionTable (functionObject, rigidBodyPoints, dictionary)
 
 defineTypeNameAndDebug (rigidBodyState, 0)
 
 addToRunTimeSelectionTable (functionObject, rigidBodyState, dictionary)
 
 defineTypeNameAndDebug (sampledSets, 0)
 
 addToRunTimeSelectionTable (functionObject, sampledSets, dictionary)
 
 defineTypeNameAndDebug (sampledSurfaces, 0)
 
 addToRunTimeSelectionTable (functionObject, sampledSurfaces, dictionary)
 
 defineTypeNameAndDebug (sixDoFRigidBodyControl, 0)
 
 addToRunTimeSelectionTable (functionObject, sixDoFRigidBodyControl, dictionary)
 
 defineTypeNameAndDebug (sixDoFRigidBodyState, 0)
 
 addToRunTimeSelectionTable (functionObject, sixDoFRigidBodyState, dictionary)
 
 defineTypeNameAndDebug (adjustTimeStepToChemistry, 0)
 
 addToRunTimeSelectionTable (functionObject, adjustTimeStepToChemistry, dictionary)
 
 defineTypeNameAndDebug (specieReactionRates, 0)
 
 addToRunTimeSelectionTable (functionObject, specieReactionRates, dictionary)
 
 defineTypeNameAndDebug (massFractions, 0)
 
 addToRunTimeSelectionTable (functionObject, massFractions, dictionary)
 
 defineTypeNameAndDebug (moleFractions, 0)
 
 addToRunTimeSelectionTable (functionObject, moleFractions, dictionary)
 
 defineTypeNameAndDebug (phaseForces, 0)
 
 addToRunTimeSelectionTable (functionObject, phaseForces, dictionary)
 
 defineTypeNameAndDebug (phaseMap, 0)
 
 addToRunTimeSelectionTable (functionObject, phaseMap, dictionary)
 
 defineTypeNameAndDebug (populationBalanceMoments, 0)
 
 addToRunTimeSelectionTable (functionObject, populationBalanceMoments, dictionary)
 
 defineTypeNameAndDebug (populationBalanceSizeDistribution, 0)
 
 addToRunTimeSelectionTable (functionObject, populationBalanceSizeDistribution, dictionary)
 
 defineTypeNameAndDebug (wallBoilingProperties, 0)
 
 addToRunTimeSelectionTable (functionObject, wallBoilingProperties, dictionary)
 

Detailed Description

Namespace for functionObjects.

OpenFOAM includes a collection of functionObjects selected by the user at run-time to manipulate the simulation and provide mechanisms to extract field and derived quantities. Alternatively, the same actions can be executed after the simulation using the -postProcess command-line option.

Using functionObjects

FunctionObjects are selected by additional entries in the $FOAM_CASE/system/controlDict dictionary. Each object is listed in the functions sub-dictionary, e.g. to select the functionObjectType functionObject the following entry would be specified:

functions
{
    <functionObjectName>
    {
        type                functionObjectType;
        libs                ("libMyFunctionObjectlib.so");
        region              defaultRegion;
        enabled             yes;
        startTime           0;
        endTime             10;
        writeControl        writeTime;
        writeInterval       1;
        ...
    }
}

Where:

Property Description Required Default value
type Type of functionObject yes
libs Libraries containing implementation yes
region Name of region for multi-region cases no
enabled On/off switch no yes
log Log information to standard output no no
startTime Start time no
endTime End time no
executeAtStart Execute at start time switch no yes
executeControl See time controls below no timeStep
executeInterval Steps between each execution no
executeTimes List of execution times no
writeControl See time controls below no timeStep
writeInterval Steps between each write no
writeTimes List of write times no

Time controls:

Option Description
timeStep Execute/write every 'Interval' time-steps
writeTime Execute/write every 'Interval' write times
adjustableRunTime Execute/write every 'Interval' run time period
runTime Execute/write every 'Interval' run time period
runTimes Execute/write at specified list of run times
clockTime Execute/write every 'Interval' clock time period
cpuTime Execute/write every 'Interval' CPU time period
none No execution

The sub-dictionary name <functionObjectName> is chosen by the user, and is typically used as the name of the output directory for any data written by the functionObject. The type entry defines the type of function object properties that follow. FunctionObjects are packaged into separate libraries and the libs entry is used to specify which library should be loaded.

Each functionObject has two separate run phases:

  • The execute phase is meant to be used for updating calculations or for management tasks.
  • The write phase is meant for writing the calculated data to disk.

For each phase the respective time controls are provided, as listed above.

Function Documentation

◆ defineTypeNameAndDebug() [1/100]

Foam::functionObjects::defineTypeNameAndDebug ( adjustTimeStepToCombustion  ,
 
)

◆ addToRunTimeSelectionTable() [1/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
adjustTimeStepToCombustion  ,
dictionary   
)

◆ defineTypeNameAndDebug() [2/100]

Foam::functionObjects::defineTypeNameAndDebug ( Qdot  ,
 
)

◆ addToRunTimeSelectionTable() [2/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
Qdot  ,
dictionary   
)

◆ defineTypeNameAndDebug() [3/100]

Foam::functionObjects::defineTypeNameAndDebug ( fvMeshFunctionObject  ,
 
)

◆ defineTypeNameAndDebug() [4/100]

Foam::functionObjects::defineTypeNameAndDebug ( fvModel  ,
 
)

◆ addToRunTimeSelectionTable() [3/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
fvModel  ,
dictionary   
)

◆ defineTypeNameAndDebug() [5/100]

Foam::functionObjects::defineTypeNameAndDebug ( add  ,
 
)

◆ addToRunTimeSelectionTable() [4/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
add  ,
dictionary   
)

◆ defineTypeNameAndDebug() [6/100]

Foam::functionObjects::defineTypeNameAndDebug ( age  ,
 
)

◆ addToRunTimeSelectionTable() [5/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
age  ,
dictionary   
)

◆ defineTypeNameAndDebug() [7/100]

Foam::functionObjects::defineTypeNameAndDebug ( blendingFactor  ,
 
)

◆ addToRunTimeSelectionTable() [6/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
blendingFactor  ,
dictionary   
)

◆ defineTypeNameAndDebug() [8/100]

Foam::functionObjects::defineTypeNameAndDebug ( comfort  ,
 
)

◆ addToRunTimeSelectionTable() [7/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
comfort  ,
dictionary   
)

◆ defineTypeNameAndDebug() [9/100]

Foam::functionObjects::defineTypeNameAndDebug ( components  ,
 
)

◆ addToRunTimeSelectionTable() [8/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
components  ,
dictionary   
)

◆ defineTypeNameAndDebug() [10/100]

Foam::functionObjects::defineTypeNameAndDebug ( CourantNo  ,
 
)

◆ addToRunTimeSelectionTable() [9/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
CourantNo  ,
dictionary   
)

◆ defineTypeNameAndDebug() [11/100]

Foam::functionObjects::defineTypeNameAndDebug ( cylindrical  ,
 
)

◆ addToRunTimeSelectionTable() [10/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
cylindrical  ,
dictionary   
)

◆ defineTypeNameAndDebug() [12/100]

Foam::functionObjects::defineTypeNameAndDebug ( ddt  ,
 
)

◆ addToRunTimeSelectionTable() [11/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
ddt  ,
dictionary   
)

◆ defineTypeNameAndDebug() [13/100]

Foam::functionObjects::defineTypeNameAndDebug ( div  ,
 
)

◆ addToRunTimeSelectionTable() [12/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
div  ,
dictionary   
)

◆ defineTypeNameAndDebug() [14/100]

Foam::functionObjects::defineTypeNameAndDebug ( divide  ,
 
)

◆ addToRunTimeSelectionTable() [13/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
divide  ,
dictionary   
)

◆ defineTypeNameAndDebug() [15/100]

Foam::functionObjects::defineTypeNameAndDebug ( enstrophy  ,
 
)

◆ addToRunTimeSelectionTable() [14/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
enstrophy  ,
dictionary   
)

◆ defineTypeNameAndDebug() [16/100]

Foam::functionObjects::defineTypeNameAndDebug ( fieldAverage  ,
 
)

◆ addToRunTimeSelectionTable() [15/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
fieldAverage  ,
dictionary   
)

◆ defineTypeNameAndDebug() [17/100]

Foam::functionObjects::defineTypeNameAndDebug ( fieldCoordinateSystemTransform  ,
 
)

◆ addToRunTimeSelectionTable() [16/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
fieldCoordinateSystemTransform  ,
dictionary   
)

◆ defineTypeNameAndDebug() [18/100]

Foam::functionObjects::defineTypeNameAndDebug ( fieldExpression  ,
 
)

◆ defineTypeNameAndDebug() [19/100]

Foam::functionObjects::defineTypeNameAndDebug ( fieldsExpression  ,
 
)

◆ defineTypeNameAndDebug() [20/100]

Foam::functionObjects::defineTypeNameAndDebug ( fieldValue  ,
 
)

◆ defineRunTimeSelectionTable()

Foam::functionObjects::defineRunTimeSelectionTable ( fieldValue  ,
dictionary   
)

◆ defineTypeNameAndDebug() [21/100]

Foam::functionObjects::defineTypeNameAndDebug ( flowType  ,
 
)

◆ addToRunTimeSelectionTable() [17/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
flowType  ,
dictionary   
)

◆ defineTypeNameAndDebug() [22/100]

Foam::functionObjects::defineTypeNameAndDebug ( grad  ,
 
)

◆ addToRunTimeSelectionTable() [18/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
grad  ,
dictionary   
)

◆ defineTypeNameAndDebug() [23/100]

Foam::functionObjects::defineTypeNameAndDebug ( histogram  ,
 
)

◆ addToRunTimeSelectionTable() [19/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
histogram  ,
dictionary   
)

◆ defineTypeNameAndDebug() [24/100]

Foam::functionObjects::defineTypeNameAndDebug ( interfaceHeight  ,
 
)

◆ addToRunTimeSelectionTable() [20/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
interfaceHeight  ,
dictionary   
)

◆ defineTypeNameAndDebug() [25/100]

Foam::functionObjects::defineTypeNameAndDebug ( Lambda2  ,
 
)

◆ addToRunTimeSelectionTable() [21/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
Lambda2  ,
dictionary   
)

◆ defineTypeNameAndDebug() [26/100]

Foam::functionObjects::defineTypeNameAndDebug ( layerAverage  ,
 
)

◆ addToRunTimeSelectionTable() [22/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
layerAverage  ,
dictionary   
)

◆ defineTypeNameAndDebug() [27/100]

Foam::functionObjects::defineTypeNameAndDebug ( log  ,
 
)

◆ addToRunTimeSelectionTable() [23/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
log  ,
dictionary   
)

◆ defineTypeNameAndDebug() [28/100]

Foam::functionObjects::defineTypeNameAndDebug ( MachNo  ,
 
)

◆ addToRunTimeSelectionTable() [24/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
MachNo  ,
dictionary   
)

◆ defineTypeNameAndDebug() [29/100]

Foam::functionObjects::defineTypeNameAndDebug ( mag  ,
 
)

◆ addToRunTimeSelectionTable() [25/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
mag  ,
dictionary   
)

◆ defineTypeNameAndDebug() [30/100]

Foam::functionObjects::defineTypeNameAndDebug ( magSqr  ,
 
)

◆ addToRunTimeSelectionTable() [26/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
magSqr  ,
dictionary   
)

◆ defineTypeNameAndDebug() [31/100]

Foam::functionObjects::defineTypeNameAndDebug ( multiply  ,
 
)

◆ addToRunTimeSelectionTable() [27/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
multiply  ,
dictionary   
)

◆ defineTypeNameAndDebug() [32/100]

Foam::functionObjects::defineTypeNameAndDebug ( nearWallFields  ,
 
)

◆ addToRunTimeSelectionTable() [28/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
nearWallFields  ,
dictionary   
)

◆ defineTypeNameAndDebug() [33/100]

Foam::functionObjects::defineTypeNameAndDebug ( patchCutLayerAverage  ,
 
)

◆ addToRunTimeSelectionTable() [29/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
patchCutLayerAverage  ,
dictionary   
)

◆ defineTypeNameAndDebug() [34/100]

Foam::functionObjects::defineTypeNameAndDebug ( PecletNo  ,
 
)

◆ addToRunTimeSelectionTable() [30/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
PecletNo  ,
dictionary   
)

◆ defineTypeNameAndDebug() [35/100]

Foam::functionObjects::defineTypeNameAndDebug ( pressure  ,
 
)

◆ addToRunTimeSelectionTable() [31/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
pressure  ,
dictionary   
)

◆ defineTypeNameAndDebug() [36/100]

Foam::functionObjects::defineTypeNameAndDebug ( processorField  ,
 
)

◆ addToRunTimeSelectionTable() [32/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
processorField  ,
dictionary   
)

◆ defineTypeNameAndDebug() [37/100]

Foam::functionObjects::defineTypeNameAndDebug ( Q  ,
 
)

◆ addToRunTimeSelectionTable() [33/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
Q  ,
dictionary   
)

◆ defineTypeNameAndDebug() [38/100]

Foam::functionObjects::defineTypeNameAndDebug ( randomise  ,
 
)

◆ addToRunTimeSelectionTable() [34/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
randomise  ,
dictionary   
)

◆ defineTypeNameAndDebug() [39/100]

Foam::functionObjects::defineTypeNameAndDebug ( readFields  ,
 
)

◆ addToRunTimeSelectionTable() [35/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
readFields  ,
dictionary   
)

◆ defineTypeNameAndDebug() [40/100]

Foam::functionObjects::defineTypeNameAndDebug ( reconstruct  ,
 
)

◆ addToRunTimeSelectionTable() [36/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
reconstruct  ,
dictionary   
)

◆ defineTypeNameAndDebug() [41/100]

Foam::functionObjects::defineTypeNameAndDebug ( regionSizeDistribution  ,
 
)

◆ addToRunTimeSelectionTable() [37/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
regionSizeDistribution  ,
dictionary   
)

◆ defineTypeNameAndDebug() [42/100]

Foam::functionObjects::defineTypeNameAndDebug ( scale  ,
 
)

◆ addToRunTimeSelectionTable() [38/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
scale  ,
dictionary   
)

◆ defineTypeNameAndDebug() [43/100]

Foam::functionObjects::defineTypeNameAndDebug ( shearStress  ,
 
)

◆ addToRunTimeSelectionTable() [39/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
shearStress  ,
dictionary   
)

◆ defineTypeNameAndDebug() [44/100]

Foam::functionObjects::defineTypeNameAndDebug ( streamFunction  ,
 
)

◆ addToRunTimeSelectionTable() [40/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
streamFunction  ,
dictionary   
)

◆ defineTypeNameAndDebug() [45/100]

Foam::functionObjects::defineTypeNameAndDebug ( streamlines  ,
 
)

◆ addToRunTimeSelectionTable() [41/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
streamlines  ,
dictionary   
)

◆ defineTypeNameAndDebug() [46/100]

Foam::functionObjects::defineTypeNameAndDebug ( subtract  ,
 
)

◆ addToRunTimeSelectionTable() [42/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
subtract  ,
dictionary   
)

◆ defineTypeNameAndDebug() [47/100]

Foam::functionObjects::defineTypeNameAndDebug ( surfaceInterpolate  ,
 
)

◆ addToRunTimeSelectionTable() [43/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
surfaceInterpolate  ,
dictionary   
)

◆ defineTypeNameAndDebug() [48/100]

Foam::functionObjects::defineTypeNameAndDebug ( totalEnthalpy  ,
 
)

◆ addToRunTimeSelectionTable() [44/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
totalEnthalpy  ,
dictionary   
)

◆ defineTypeNameAndDebug() [49/100]

Foam::functionObjects::defineTypeNameAndDebug ( turbulenceFields  ,
 
)

◆ addToRunTimeSelectionTable() [45/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
turbulenceFields  ,
dictionary   
)

◆ defineTypeNameAndDebug() [50/100]

Foam::functionObjects::defineTypeNameAndDebug ( turbulenceIntensity  ,
 
)

◆ addToRunTimeSelectionTable() [46/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
turbulenceIntensity  ,
dictionary   
)

◆ defineTypeNameAndDebug() [51/100]

Foam::functionObjects::defineTypeNameAndDebug ( uniform  ,
 
)

◆ addToRunTimeSelectionTable() [47/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
uniform  ,
dictionary   
)

◆ defineTypeNameAndDebug() [52/100]

Foam::functionObjects::defineTypeNameAndDebug ( vorticity  ,
 
)

◆ addToRunTimeSelectionTable() [48/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
vorticity  ,
dictionary   
)

◆ defineTypeNameAndDebug() [53/100]

Foam::functionObjects::defineTypeNameAndDebug ( wallHeatFlux  ,
 
)

◆ addToRunTimeSelectionTable() [49/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
wallHeatFlux  ,
dictionary   
)

◆ defineTypeNameAndDebug() [54/100]

Foam::functionObjects::defineTypeNameAndDebug ( wallHeatTransferCoeff  ,
 
)

◆ addToRunTimeSelectionTable() [50/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
wallHeatTransferCoeff  ,
dictionary   
)

◆ defineTypeNameAndDebug() [55/100]

Foam::functionObjects::defineTypeNameAndDebug ( wallShearStress  ,
 
)

◆ addToRunTimeSelectionTable() [51/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
wallShearStress  ,
dictionary   
)

◆ defineTypeNameAndDebug() [56/100]

Foam::functionObjects::defineTypeNameAndDebug ( writeCellCentres  ,
 
)

◆ addToRunTimeSelectionTable() [52/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
writeCellCentres  ,
dictionary   
)

◆ defineTypeNameAndDebug() [57/100]

Foam::functionObjects::defineTypeNameAndDebug ( writeCellVolumes  ,
 
)

◆ addToRunTimeSelectionTable() [53/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
writeCellVolumes  ,
dictionary   
)

◆ defineTypeNameAndDebug() [58/100]

Foam::functionObjects::defineTypeNameAndDebug ( XiReactionRate  ,
 
)

◆ addToRunTimeSelectionTable() [54/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
XiReactionRate  ,
dictionary   
)

◆ defineTypeNameAndDebug() [59/100]

Foam::functionObjects::defineTypeNameAndDebug ( yPlus  ,
 
)

◆ addToRunTimeSelectionTable() [55/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
yPlus  ,
dictionary   
)

◆ defineTypeNameAndDebug() [60/100]

Foam::functionObjects::defineTypeNameAndDebug ( forceCoeffs  ,
 
)

◆ addToRunTimeSelectionTable() [56/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
forceCoeffs  ,
dictionary   
)

◆ defineTypeNameAndDebug() [61/100]

Foam::functionObjects::defineTypeNameAndDebug ( forces  ,
 
)

◆ addToRunTimeSelectionTable() [57/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
forces  ,
dictionary   
)

◆ defineTypeNameAndDebug() [62/100]

Foam::functionObjects::defineTypeNameAndDebug ( phaseScalarTransport  ,
 
)

◆ addToRunTimeSelectionTable() [58/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
phaseScalarTransport  ,
dictionary   
)

◆ defineTypeNameAndDebug() [63/100]

Foam::functionObjects::defineTypeNameAndDebug ( scalarTransport  ,
 
)

◆ addToRunTimeSelectionTable() [59/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
scalarTransport  ,
dictionary   
)

◆ defineTypeNameAndDebug() [64/100]

Foam::functionObjects::defineTypeNameAndDebug ( checkMesh  ,
 
)

◆ addToRunTimeSelectionTable() [60/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
checkMesh  ,
dictionary   
)

◆ defineTypeNameAndDebug() [65/100]

Foam::functionObjects::defineTypeNameAndDebug ( removeRegisteredObject  ,
 
)

◆ addToRunTimeSelectionTable() [61/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
removeRegisteredObject  ,
dictionary   
)

◆ defineTypeNameAndDebug() [66/100]

Foam::functionObjects::defineTypeNameAndDebug ( residuals  ,
 
)

◆ addToRunTimeSelectionTable() [62/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
residuals  ,
dictionary   
)

◆ defineTypeNameAndDebug() [67/100]

Foam::functionObjects::defineTypeNameAndDebug ( setTimeStepFunctionObject  ,
 
)

◆ addToRunTimeSelectionTable() [63/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
setTimeStepFunctionObject  ,
dictionary   
)

◆ defineTypeNameAndDebug() [68/100]

Foam::functionObjects::defineTypeNameAndDebug ( setWriteIntervalFunctionObject  ,
 
)

◆ addToRunTimeSelectionTable() [64/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
setWriteIntervalFunctionObject  ,
dictionary   
)

◆ defineTypeNameAndDebug() [69/100]

Foam::functionObjects::defineTypeNameAndDebug ( stopAt  ,
 
)

◆ defineTypeNameAndDebug() [70/100]

Foam::functionObjects::defineTypeNameAndDebug ( stopAtClockTime  ,
 
)

◆ addToRunTimeSelectionTable() [65/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
stopAtClockTime  ,
dictionary   
)

◆ defineTypeNameAndDebug() [71/100]

Foam::functionObjects::defineTypeNameAndDebug ( stopAtFile  ,
 
)

◆ addToRunTimeSelectionTable() [66/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
stopAtFile  ,
dictionary   
)

◆ defineTypeNameAndDebug() [72/100]

Foam::functionObjects::defineTypeNameAndDebug ( stopAtTimeStep  ,
 
)

◆ addToRunTimeSelectionTable() [67/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
stopAtTimeStep  ,
dictionary   
)

◆ defineTypeNameAndDebug() [73/100]

Foam::functionObjects::defineTypeNameAndDebug ( systemCall  ,
 
)

◆ addToRunTimeSelectionTable() [68/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
systemCall  ,
dictionary   
)

◆ defineTypeNameAndDebug() [74/100]

Foam::functionObjects::defineTypeNameAndDebug ( time  ,
 
)

◆ addToRunTimeSelectionTable() [69/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
time  ,
dictionary   
)

◆ defineTypeNameAndDebug() [75/100]

Foam::functionObjects::defineTypeNameAndDebug ( timeActivatedFileUpdate  ,
 
)

◆ addToRunTimeSelectionTable() [70/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
timeActivatedFileUpdate  ,
dictionary   
)

◆ defineTypeNameAndDebug() [76/100]

Foam::functionObjects::defineTypeNameAndDebug ( timeStep  ,
 
)

◆ addToRunTimeSelectionTable() [71/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
timeStep  ,
dictionary   
)

◆ defineTypeNameAndDebug() [77/100]

Foam::functionObjects::defineTypeNameAndDebug ( writeDictionary  ,
 
)

◆ addToRunTimeSelectionTable() [72/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
writeDictionary  ,
dictionary   
)

◆ defineTypeNameAndDebug() [78/100]

Foam::functionObjects::defineTypeNameAndDebug ( writeObjects  ,
 
)

◆ addToRunTimeSelectionTable() [73/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
writeObjects  ,
dictionary   
)

◆ defineTypeNameAndDebug() [79/100]

Foam::functionObjects::defineTypeNameAndDebug ( meshToMeshAdjustTimeStepFunctionObject  ,
 
)

◆ addToRunTimeSelectionTable() [74/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
meshToMeshAdjustTimeStepFunctionObject  ,
dictionary   
)

◆ defineTypeNameAndDebug() [80/100]

Foam::functionObjects::defineTypeNameAndDebug ( cloudInfo  ,
 
)

◆ addToRunTimeSelectionTable() [75/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
cloudInfo  ,
dictionary   
)

◆ defineTypeNameAndDebug() [81/100]

Foam::functionObjects::defineTypeNameAndDebug ( dsmcFields  ,
 
)

◆ addToRunTimeSelectionTable() [76/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
dsmcFields  ,
dictionary   
)

◆ defineTypeNameAndDebug() [82/100]

Foam::functionObjects::defineTypeNameAndDebug ( particles  ,
 
)

◆ addToRunTimeSelectionTable() [77/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
particles  ,
dictionary   
)

◆ defineTypeNameAndDebug() [83/100]

Foam::functionObjects::defineTypeNameAndDebug ( stopAtEmptyClouds  ,
 
)

◆ addToRunTimeSelectionTable() [78/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
stopAtEmptyClouds  ,
dictionary   
)

◆ defineTypeNameAndDebug() [84/100]

Foam::functionObjects::defineTypeNameAndDebug ( regionFunctionObject  ,
 
)

◆ defineTypeNameAndDebug() [85/100]

Foam::functionObjects::defineTypeNameAndDebug ( timeControl  ,
 
)

◆ defineTypeNameAndDebug() [86/100]

Foam::functionObjects::defineTypeNameAndDebug ( rigidBodyPoints  ,
 
)

◆ addToRunTimeSelectionTable() [79/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
rigidBodyPoints  ,
dictionary   
)

◆ defineTypeNameAndDebug() [87/100]

Foam::functionObjects::defineTypeNameAndDebug ( rigidBodyState  ,
 
)

◆ addToRunTimeSelectionTable() [80/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
rigidBodyState  ,
dictionary   
)

◆ defineTypeNameAndDebug() [88/100]

Foam::functionObjects::defineTypeNameAndDebug ( sampledSets  ,
 
)

◆ addToRunTimeSelectionTable() [81/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
sampledSets  ,
dictionary   
)

◆ defineTypeNameAndDebug() [89/100]

Foam::functionObjects::defineTypeNameAndDebug ( sampledSurfaces  ,
 
)

◆ addToRunTimeSelectionTable() [82/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
sampledSurfaces  ,
dictionary   
)

◆ defineTypeNameAndDebug() [90/100]

Foam::functionObjects::defineTypeNameAndDebug ( sixDoFRigidBodyControl  ,
 
)

◆ addToRunTimeSelectionTable() [83/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
sixDoFRigidBodyControl  ,
dictionary   
)

◆ defineTypeNameAndDebug() [91/100]

Foam::functionObjects::defineTypeNameAndDebug ( sixDoFRigidBodyState  ,
 
)

◆ addToRunTimeSelectionTable() [84/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
sixDoFRigidBodyState  ,
dictionary   
)

◆ defineTypeNameAndDebug() [92/100]

Foam::functionObjects::defineTypeNameAndDebug ( adjustTimeStepToChemistry  ,
 
)

◆ addToRunTimeSelectionTable() [85/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
adjustTimeStepToChemistry  ,
dictionary   
)

◆ defineTypeNameAndDebug() [93/100]

Foam::functionObjects::defineTypeNameAndDebug ( specieReactionRates  ,
 
)

◆ addToRunTimeSelectionTable() [86/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
specieReactionRates  ,
dictionary   
)

◆ defineTypeNameAndDebug() [94/100]

Foam::functionObjects::defineTypeNameAndDebug ( massFractions  ,
 
)

◆ addToRunTimeSelectionTable() [87/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
massFractions  ,
dictionary   
)

◆ defineTypeNameAndDebug() [95/100]

Foam::functionObjects::defineTypeNameAndDebug ( moleFractions  ,
 
)

◆ addToRunTimeSelectionTable() [88/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
moleFractions  ,
dictionary   
)

◆ defineTypeNameAndDebug() [96/100]

Foam::functionObjects::defineTypeNameAndDebug ( phaseForces  ,
 
)

◆ addToRunTimeSelectionTable() [89/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
phaseForces  ,
dictionary   
)

◆ defineTypeNameAndDebug() [97/100]

Foam::functionObjects::defineTypeNameAndDebug ( phaseMap  ,
 
)

◆ addToRunTimeSelectionTable() [90/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
phaseMap  ,
dictionary   
)

◆ defineTypeNameAndDebug() [98/100]

Foam::functionObjects::defineTypeNameAndDebug ( populationBalanceMoments  ,
 
)

◆ addToRunTimeSelectionTable() [91/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
populationBalanceMoments  ,
dictionary   
)

◆ defineTypeNameAndDebug() [99/100]

Foam::functionObjects::defineTypeNameAndDebug ( populationBalanceSizeDistribution  ,
 
)

◆ addToRunTimeSelectionTable() [92/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
populationBalanceSizeDistribution  ,
dictionary   
)

◆ defineTypeNameAndDebug() [100/100]

Foam::functionObjects::defineTypeNameAndDebug ( wallBoilingProperties  ,
 
)

◆ addToRunTimeSelectionTable() [93/93]

Foam::functionObjects::addToRunTimeSelectionTable ( functionObject  ,
wallBoilingProperties  ,
dictionary   
)