 @1207 | |
 @1229 | |
 @3874 | |
 @4109 | |
 @4185 | |
 @4249 | |
 @4278 | |
 @4377 | |
 Foam | Namespace for OpenFOAM |
  meshReaders | A namespace for holding various types of mesh readers |
   STARCD | Read pro-STAR vrt/cel/bnd files. The protected data in meshReader are filled |
  meshWriters | A namespace for holding various types of mesh writers |
   STARCD | Writes polyMesh in pro-STAR (v4) bnd/cel/vrt format |
  solidBodyMotionFunctions | Namespace for solid-body motions |
   SDA | Ship design analysis (SDA) 3DoF motion function |
   SKA | Sea Keeping Analysis (SKA) 6DoF motion function |
  resError | Namespace for residual error estimate operators |
  SRF | Namespace for single rotating frame (SRF) models |
   rpm | Basic SRF model whereby angular velocity is specified in terms of a (global) axis and revolutions-per-minute [rpm] |
   SRFModel | Top level model for single rotating frame |
  fv | Namespace for finite-volume |
   convectionScheme | Abstract base class for convection schemes |
   gaussConvectionScheme | Basic second-order convection using face-gradients and Gauss' theorem |
   multivariateGaussConvectionScheme | Basic second-order convection using face-gradients and Gauss' theorem |
   d2dt2Scheme | Abstract base class for d2dt2 schemes |
   EulerD2dt2Scheme | First-order Euler implicit d2dt2 using the current and two previous time-step values |
   steadyStateD2dt2Scheme | SteadyState d2dt2 which returns 0 |
   backwardDdtScheme | Second-order backward-differencing ddt using the current and two previous time-step values |
   boundedBackwardDdtScheme | Second-order bounded-backward-differencing ddt using the current and two previous time-step values |
   CoEulerDdtScheme | Courant number limited first-order Euler implicit/explicit ddt |
   CrankNicholsonDdtScheme | Second-oder CrankNicholson implicit ddt using the current and previous time-step fields as well as the previous time-step ddt |
   ddtScheme | Abstract base class for ddt schemes |
   EulerDdtScheme | Basic first-order Euler implicit/explicit ddt using only the current and previous time-step values |
   localEulerDdtScheme | Local time-step first-order Euler implicit/explicit ddt. The reciprocal of the local time-step field is looked-up from the database with the name provided |
   SLTSDdtScheme | Stabilised local time-step first-order Euler implicit/explicit ddt. The time-step is adjusted locally so that an advective equations remains diagonally dominant |
   steadyStateDdtScheme | SteadyState implicit/explicit ddt which returns 0 |
   divScheme | Abstract base class for div schemes |
   gaussDivScheme | Basic second-order div using face-gradients and Gauss' theorem |
   extendedLeastSquaresGrad | Second-order gradient scheme using least-squares |
   fourthGrad | Second-order gradient scheme using least-squares |
   gaussGrad | Basic second-order gradient scheme using face-interpolation and Gauss' theorem |
   gradScheme | Abstract base class for gradient schemes |
   leastSquaresGrad | Second-order gradient scheme using least-squares |
   cellLimitedGrad | CellLimitedGrad gradient scheme applied to a runTime selected base gradient scheme |
   cellMDLimitedGrad | CellMDLimitedGrad gradient scheme applied to a runTime selected base gradient scheme |
   faceLimitedGrad | FaceLimitedGrad gradient scheme applied to a runTime selected base gradient scheme |
   faceMDLimitedGrad | FaceMDLimitedGrad gradient scheme applied to a runTime selected base gradient scheme |
   gaussLaplacianScheme | Basic second-order laplacian using face-gradients and Gauss' theorem |
   laplacianScheme | Abstract base class for laplacian schemes |
   correctedSnGrad | Simple central-difference snGrad scheme with non-orthogonal correction |
   limitedSnGrad | Central-difference snGrad scheme with limited non-orthogonal correction |
   quadraticFitSnGrad | |
   snGradScheme | Abstract base class for snGrad schemes |
   uncorrectedSnGrad | Simple central-difference snGrad scheme without non-orthogonal correction |
  fvc | Namespace of functions to calculate explicit derivatives |
  fvm | Namespace of functions to calculate implicit derivatives returning a matrix |
  MULES | Multidimensional universal limiter with explicit solution |
  limitFuncs | Namespace for limiting functions |
   null | |
   magSqr | |
   rhoMagSqr | |
   LimitFuncs | Class to create NVD/TVD limited weighting-factors |
  radiation | Namespace for radiation modelling |
   cloudAbsorptionEmission | Retrieves absorption/emission data from a cloud object |
   cloudScatter | Cloud radiation scatter model |
   greyDiffusiveRadiationMixedFvPatchScalarField | |
   wideBandDiffusiveRadiationMixedFvPatchScalarField | |
   absorptionCoeffs | |
   blackBodyEmission | Class black body emission |
   fvDOM | Finite Volume Discrete Ordinates Method. Solves the RTE equation for n directions in a participating media, not including scatter |
   radiativeIntensityRay | Radiation intensity for a ray in a given direction |
   noRadiation | No radiation - does nothing to energy equation source terms (returns zeros) |
   P1 | Works well for combustion applications where optical thickness, tau is large, i.e. tau = a*L > 3 (L = distance between objects) |
   radiationModel | Top level model for radiation modelling |
   absorptionEmissionModel | Model to supply absorption and emission coefficients for radiation modelling |
   binaryAbsorptionEmission | Radiation coefficient based on two absorption models |
   constantAbsorptionEmission | Constant radiation absorption and emission coefficients for continuous phase |
   greyMeanAbsorptionEmission | GreyMeanAbsorptionEmission radiation absorption and emission coefficients for continuous phase |
   noAbsorptionEmission | Dummy absorption-emission model for 'none' |
   wideBandAbsorptionEmission | WideBandAbsorptionEmission radiation absorption and emission coefficients for continuous phase |
   constantScatter | Constant radiation scatter coefficient |
   scatterModel | Base class for radiation scattering |
  energyScalingFunctions | |
   doubleSigmoid | |
   noScaling | |
   shifted | |
   shiftedForce | |
   sigmoid | |
  pairPotentials | |
   azizChen | Foam::pairPotentials::azizChen |
   coulomb | |
   dampedCoulomb | |
   exponentialRepulsion | |
   lennardJones | |
   maitlandSmith | Foam::pairPotentials::maitlandSmith |
   noInteraction | |
   electrostaticPotential | |
  tetherPotentials | |
   harmonicSpring | |
   pitchForkRing | |
   restrainedHarmonicSpring | |
  meshTools | Collection of static functions to do various simple mesh related things |
  ListListOps | Various utility functions to work on Lists of Lists (usually resulting from 'gather'ing and combining information from individual processors) |
  functionEntries | Namespace for containing a functionEntry |
   includeEntry | Specify an include file when reading dictionaries, expects a single string to follow |
   includeIfPresentEntry | Specify a file to include if it exists. Expects a single string to follow |
   inputModeEntry | Specify the input mode when reading dictionaries, expects a single word to follow |
   removeEntry | Remove a dictionary entry |
  helper_ | |
   PstreamBase | Helper class |
  debug | Namespace for handling debugging switches |
  mathematicalConstant | Mathematical constants such as pi, e |
  POSIX | OS-specific functions implemented in POSIX |
  calcTypes | Namespace for post-processing calculation functions |
   addSubtract | Adds/subtracts a field or value to/from a base field |
   components | Writes scalar fields corresponding to each component of the supplied field (name) for each time |
   div | Writes scalar fields corresponding to the divergence of the supplied field (name) for each time |
   interpolate | Interpolates volume fields to surface fields for each time |
   mag | Calculates and writes the magnitude of a field for each time |
   magGrad | Writes scalar fields corresponding to the magnitude ot the gradient of the supplied field (name) for each time |
   magSqr | Calculates and writes the magnitude-sqaured of a field for each time |
   randomise | Adds a random component to a field, with a given perturbation magnitude |
  fieldValues | |
   cellSource | Cell source variant of field value function object. Values of user- specified fields reported for collections of cells |
   faceSource | Face source variant of field value function object. Values of user- specified fields reported for collections of faces |
  sixDoFRigidBodyMotionConstraints | Namespace for six DoF motion constraints |
   fixedAxis | SixDoFRigidBodyMotionConstraint. Body may only rotate around an axis fixed in global space |
   fixedLine | SixDoFRigidBodyMotionConstraint. Reference point may only move along a line |
   fixedOrientation | SixDoFRigidBodyMotionConstraint. Orientation of body fixed global space. Only valid where the predicted deviation from alignment is < 90 degrees |
   fixedPlane | SixDoFRigidBodyMotionConstraint. Reference point may only move along a plane |
   fixedPoint | SixDoFRigidBodyMotionConstraint. Point fixed in space |
  sixDoFRigidBodyMotionRestraints | Namespace for six DoF motion restraints |
   linearAxialAngularSpring | SixDoFRigidBodyMotionRestraints model. Linear axial angular spring |
   linearSpring | SixDoFRigidBodyMotionRestraints model. Linear spring |
   sphericalAngularSpring | SixDoFRigidBodyMotionRestraints model. Spherical angular spring |
   tabulatedAxialAngularSpring | SixDoFRigidBodyMotionRestraints model. Axial angular spring with moment values drawn from an interpolation table. Linear damping |
  PstreamGlobals | Global functions and variables for working with parallel streams, but principally for gamma/mpi |
  fileFormats | |
   AC3DsurfaceFormat | Provide a means of reading/writing AC3D format |
   AC3DsurfaceFormatCore | Internal class used by the AC3DsurfaceFormat |
   FTRsurfaceFormat | Reading of the (now deprecated and infrequently used) Foam Trisurface Format |
   GTSsurfaceFormat | Provide a means of reading/writing GTS format. The output is never sorted by zone and is only written if it consists entirely of triangles |
   NASsurfaceFormat | Nastran surface reader |
   NASsurfaceFormatCore | Internal class used by the NASsurfaceFormat |
   OBJsurfaceFormat | Provide a means of reading/writing Alias/Wavefront OBJ format |
   OFFsurfaceFormat | Provide a means of reading/writing Geomview OFF polyList format |
   OFSsurfaceFormat | Provide a means of reading/writing the single-file OpenFOAM surface format |
   OFSsurfaceFormatCore | Internal class used by the OFSsurfaceFormat |
   SMESHsurfaceFormat | Provide a means of writing tetgen SMESH format |
   STARCDsurfaceFormat | Read/write the surface shells from pro-STAR vrt/cel files |
   STARCDsurfaceFormatCore | Internal class used by the STARCDsurfaceFormat |
   STLsurfaceFormat | Provide a means of reading/writing STL files (ASCII and binary) |
   STLsurfaceFormatCore | Internal class used by the STLsurfaceFormat |
   surfaceFormatsCore | A collection of helper functions for reading/writing surface formats |
   TRIsurfaceFormat | Provide a means of reading/writing .tri format |
   TRIsurfaceFormatCore | Internal class used by the TRIsurfaceFormat |
   VTKsurfaceFormat | Provide a means of writing VTK legacy format. The output is never sorted by zone |
   VTKsurfaceFormatCore | Internal class used by the VTKsurfaceFormat |
   WRLsurfaceFormat | Provide a means of writing VRML97 (wrl) format |
   WRLsurfaceFormatCore | Internal class used by the WRLsurfaceFormat |
   X3DsurfaceFormat | Provide a means of writing x3d format |
   X3DsurfaceFormatCore | Internal class used by the X3DsurfaceFormat |
  compressibilityModels | Namespace for compressibility models |
   Chung | Chung compressibility model |
   linear | Linear compressibility model |
   Wallis | Wallis compressibility model |
  laminarFlameSpeedModels | Namespace for laminar flame speed models |
   constant | Constant laminar flame speed model |
   Gulders | Laminar flame speed obtained from Gulder's correlation |
   GuldersEGR | Laminar flame speed obtained from Gulder's correlation with EGR modelling |
   SCOPE | Laminar flame speed obtained from the SCOPE correlation |
  pdfs | |
   exponential | |
   fixedValue | |
   general | |
   multiNormal | |
   normal | |
   pdf | |
   RosinRammler | |
   uniform | |
  viscosityModels | A namespace for various incompressible viscosityModel implementations |
   BirdCarreau | An incompressible Bird-Carreau non-Newtonian viscosity model |
   CrossPowerLaw | An incompressible Cross-Power law non-Newtonian viscosity model |
   HerschelBulkley | Herschel-Bulkley non-Newtonian viscosity model |
   Newtonian | An incompressible Newtonian viscosity model |
   powerLaw | Standard power-law non-Newtonian viscosity model |
  compressible | |
   LESModels | Namespace for compressible LES models |
    DeardorffDiffStress | Differential SGS Stress Equation Model for compressible flows |
    alphaSgsJayatillekeWallFunctionFvPatchScalarField | |
    alphaSgsWallFunctionFvPatchScalarField | |
    muSgsWallFunctionFvPatchScalarField | Spalart Allmaas wall function boundary condition for compressible flows |
    dynOneEqEddy | One Equation Eddy Viscosity Model for compressible flows |
    GenEddyVisc | General base class for all compressible models that can be implemented as an eddy viscosity, i.e. algebraic and one-equation models |
    GenSGSStress | General base class for all compressible models that directly solve for the SGS stress tensor B |
    lowReOneEqEddy | One Equation Eddy Viscosity Model for compressible flow |
    oneEqEddy | One Equation Eddy Viscosity Model for incompressible flows |
    Smagorinsky | The choric Smagorinsky Model for compressible flows |
    SpalartAllmaras | SpalartAllmaras for compressible flows |
    vanDriestDelta | Simple cube-root of cell volume delta used in compressible LES models |
   RASModels | Namespace for compressible RAS turbulence models |
    alphatWallFunctionFvPatchScalarField | Boundary condition for turbulent thermal diffusivity when using wall functions |
    epsilonWallFunctionFvPatchScalarField | Boundary condition for epsilon when using wall functions |
    kqRWallFunctionFvPatchField | Boundary condition for turbulence k, Q, and R when using wall functions. Simply acts as a zero gradient condition |
    mutkWallFunctionFvPatchScalarField | Boundary condition for turbulent (kinematic) viscosity when using wall functions, based on turbulence kinetic energy |
    mutLowReWallFunctionFvPatchScalarField | Boundary condition for turbulent (kinematic) viscosity when for use with low Reynolds number models |
    mutRoughWallFunctionFvPatchScalarField | Boundary condition for turbulent (kinematic) viscosity when using wall functions for rough walls |
    mutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField | Wall function boundary condition for rough walls |
    mutSpalartAllmarasStandardWallFunctionFvPatchScalarField | Wall function boundary condition for walls |
    mutSpalartAllmarasWallFunctionFvPatchScalarField | Wall function boundary condition for walls |
    mutWallFunctionFvPatchScalarField | Boundary condition for turbulent (kinematic) viscosity when using wall functions |
    omegaWallFunctionFvPatchScalarField | Provides a wall function boundary condition/constraint on omega |
    kEpsilon | Standard k-epsilon turbulence model for compressible flows |
    kOmegaSST | Implementation of the k-omega-SST turbulence model for compressible flows |
    laminar | Dummy turbulence model for laminar compressible flow |
    LaunderGibsonRSTM | Launder-Gibson Reynolds stress turbulence model for compressible flows |
    LaunderSharmaKE | Launder and Sharma low-Reynolds k-epsilon turbulence model for compressible and combusting flows |
    LRR | Launder, Reece and Rodi Reynolds-stress turbulence model for compressible flows |
    realizableKE | Realizable k-epsilon turbulence model for compressible flows |
    RNGkEpsilon | Renormalisation group k-epsilon turbulence model for compressible flows |
    SpalartAllmaras | Spalart-Allmaras one-eqn mixing-length model for compressible external flows |
    PDRkEpsilon | Standard k-epsilon turbulence model with additional source terms corresponding to PDR basic drag model (basic.H) |
   turbulenceModels | Namespace for compressible turbulence turbulence models |
   LESModel | Base class for all compressible flow LES SGS models |
   turbulentHeatFluxTemperatureFvPatchScalarField | |
   turbulentMixingLengthDissipationRateInletFvPatchScalarField | Calculate epsilon via the mixing length [m] |
   turbulentMixingLengthFrequencyInletFvPatchScalarField | Calculate omega via the mixing length |
   turbulentTemperatureCoupledBaffleMixedFvPatchScalarField | Mixed boundary condition for temperature, to be used for heat-transfer on back-to-back baffles |
   RASModel | Abstract base class for turbulence models for compressible and combusting flows |
   laminar | Turbulence model for laminar compressible flow |
   turbulenceModel | Abstract base class for compressible turbulence models (RAS, LES and laminar) |
  incompressible | |
   LESModels | Namespace for incompressible LES models |
    DeardorffDiffStress | Differential SGS Stress Equation Model for incompressible flows |
    nuSgsWallFunctionFvPatchScalarField | Spalart Allmaras wall function boundary condition for incompressible flows |
    dynOneEqEddy | One Equation Eddy Viscosity Model for incompressible flows |
    GenEddyVisc | General base class for all incompressible models that can be implemented as an eddy viscosity, i.e. algebraic and one-equation models |
    GenSGSStress | General base class for all incompressible models that directly solve for the SGS stress tensor B |
    homogeneousDynSmagorinsky | The Isochoric homogeneous dynamic Smagorinsky Model for incompressible flows |
    kOmegaSSTSAS | |
    laminar | LES model for laminar incompressible flow. It simply returns laminar properties |
    locDynOneEqEddy | Localised Dynamic One Equation Eddy Viscosity Model for incompressible flows |
    LRRDiffStress | Differential SGS Stress Equation Model for incompressible flows |
    mixedSmagorinsky | The mixed Isochoric Smagorinsky Model for incompressible flows |
    oneEqEddy | One Equation Eddy Viscosity Model for incompressible flows |
    scaleSimilarity | General base class for all scale similarity models for incompressible flows |
    Smagorinsky | The Isochoric Smagorinsky Model for incompressible flows |
    Smagorinsky2 | The Isochoric Smagorinsky Model for incompressible flows |
    SpalartAllmaras | |
    SpalartAllmarasDDES | |
    SpalartAllmarasIDDES | |
    spectEddyVisc | The Isochoric spectral Eddy Viscosity Model for incompressible flows |
    vanDriestDelta | Simple cube-root of cell volume delta used in incompressible LES models |
   RASModels | Namespace for incompressible RAS turbulence models |
    epsilonWallFunctionFvPatchScalarField | Boundary condition for epsilon when using wall functions |
    kappatJayatillekeWallFunctionFvPatchScalarField | Boundary condition for (kinematic) turbulent thermal conductivity when using wall functions, using Jayatilleke P function |
    kqRWallFunctionFvPatchField | Boundary condition for turbulence k, Q, and R when using wall functions. Simply acts as a zero gradient condition |
    nutkWallFunctionFvPatchScalarField | Boundary condition for turbulent (kinematic) viscosity when using wall functions, based on turbulence kinetic energy |
    nutLowReWallFunctionFvPatchScalarField | Boundary condition for turbulent (kinematic) viscosity when for use with low Reynolds number models |
    nutRoughWallFunctionFvPatchScalarField | Boundary condition for turbulent (kinematic) viscosity when using wall functions for rough walls |
    nutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField | Wall function boundary condition for rough walls |
    nutSpalartAllmarasStandardWallFunctionFvPatchScalarField | Wall function boundary condition for walls |
    nutSpalartAllmarasWallFunctionFvPatchScalarField | Wall function boundary condition for walls |
    nutWallFunctionFvPatchScalarField | Boundary condition for turbulent (kinematic) viscosity when using wall functions |
    omegaWallFunctionFvPatchScalarField | Provides a wall function boundary condition/constraint on omega |
    kEpsilon | Standard k-epsilon turbulence model for incompressible flows |
    kOmega | Standard high Reynolds-number k-omega turbulence model for incompressible flows |
    kOmegaSST | Implementation of the k-omega-SST turbulence model for incompressible flows |
    LamBremhorstKE | Lam and Bremhorst low-Reynolds number k-epsilon turbulence model for incompressible flows |
    laminar | Dummy turbulence model for laminar incompressible flow |
    LaunderGibsonRSTM | Launder-Gibson Reynolds stress turbulence model for incompressible flows |
    LaunderSharmaKE | Launder and Sharma low-Reynolds k-epsilon turbulence model for incompressible flows |
    LienCubicKE | Lien cubic non-linear k-epsilon turbulence model for incompressible flows |
    LienCubicKELowRe | Lien cubic non-linear low-Reynolds k-epsilon turbulence models for incompressible flows |
    LienLeschzinerLowRe | Lien and Leschziner low-Reynolds k-epsilon turbulence model for incompressible flows |
    LRR | Launder, Reece and Rodi Reynolds-stress turbulence model for incompressible flows |
    NonlinearKEShih | Shih's quadratic non-linear k-epsilon turbulence model for incompressible flows |
    qZeta | Gibson and Dafa'Alla's q-zeta two-equation low-Re turbulence model for incompressible flows |
    realizableKE | Realizable k-epsilon turbulence model for incompressible flows |
    RNGkEpsilon | Renormalisation group k-epsilon turbulence model for incompressible flows |
    SpalartAllmaras | Spalart-Allmaras 1-eqn mixing-length model for incompressible external flows |
   turbulenceModels | Namespace for incompressible turbulence turbulence models |
  extrudeModels | |
   linearNormal | Extrudes by transforming points normal to the surface by a given distance |
   linearRadial | |
   sigmaRadial | |
   wedge | Extrudes by rotating a surface around an axis |
  combustionModels | |
   infinitelyFastChemistry | Simple infinitely fast chemistry combustion model based on the principle mixed is burnt. Additional parameter C is used to distribute the heat release rate.in time |
   noCombustion | |
  PDRDragModels | |
   basic | Basic sub-grid obstacle drag model. Details supplied by J Puttock 2/7/06 |
  XiEqModels | |
   basicSubGrid | Basic sub-grid obstacle flame-wrinking enhancement factor model. Details supplied by J Puttock 2/7/06 |
   Gulder | Simple Gulder model for XiEq based on Gulders correlation with a linear correction function to give a plausible profile for XiEq |
   instability | This is the equilibrium level of the flame wrinkling generated by instability. It is a constant (default 2.5). It is used in XiModel.H |
   SCOPEBlend | Simple SCOPEBlendXiEq model for XiEq based on SCOPEXiEqs correlation with a linear correction function to give a plausible profile for XiEq. See SCOPELaminarFlameSpeed.H for details on the SCOPE laminar flame speed model |
   SCOPEXiEq | |
  XiGModels | |
   basicSubGrid | |
   instabilityG | Flame-surface instabilityG flame-wrinking generation rate coefficient model used in XiModel.H |
   KTS | Simple Kolmogorov time-scale (KTS) model for the flame-wrinling generation rate |
  XiModels | |
   algebraic | Simple algebraic model for Xi based on Gulders correlation with a linear correction function to give a plausible profile for Xi. See report TR/HGW/10 for details on the Weller two equations model. See XiModel.H for more details on flame wrinkling modelling |
   fixed | Fixed value model for Xi. See XiModel.H for more details on flame wrinkling modelling |
   transport | Simple transport model for Xi based on Gulders correlation with a linear correction function to give a plausible profile for Xi. See report TR/HGW/10 for details on the Weller two equations model. See XiModel.H for more details on flame wrinkling modelling |
  phaseChangeTwoPhaseMixtures | |
   Kunz | Kunz cavitation model slightly modified so that the condensation term is switched off when the pressure is less than the saturation vapour pressure. This change allows the condensation term to be formulated as a coefficient multiplying (p - p_sat) so that it can be included as an implicit term in the pressure equation |
   Merkle | Merkle cavitation model |
   SchnerrSauer | SchnerrSauer cavitation model |
  kineticTheoryModels | |
   GidaspowViscosity | |
   HrenyaSinclairViscosity | |
   noneViscosity | |
   SyamlalViscosity | |
   viscosityModel | |
  LESmodels | |
   kOmegaSSTSAS | KOmegaSSTSAS LES turbulence model for incompressible flows |
   SpalartAllmaras | SpalartAllmaras DES (SA + LES) turbulence model for incompressible flows |
   SpalartAllmarasDDES | SpalartAllmaras DDES LES turbulence model for incompressible flows |
   SpalartAllmarasIDDES | SpalartAllmarasIDDES LES turbulence model for incompressible flows |
  autoHexMeshDriver | Main meshing driver |
  autoLayerDriver | All to do with adding layers |
  autoRefineDriver | |
  autoSnapDriver | All to do with snapping to surface |
  layerParameters | Simple container to keep together layer specific information |
  pointData | Holds information regarding nearest wall point. Used in pointEdgeWave. (so not standard meshWave) |
  refinementParameters | Simple container to keep together refinement specific information |
  snapParameters | Simple container to keep together snap specific information |
  meshRefinement | Helper class which maintains intersections of (changing) mesh with (static) surfaces |
  refinementSurfaces | Container for data on surfaces used for surface-driven refinement. Contains all the data about the level of refinement needed per surface |
  shellSurfaces | Encapsulates queries for volume refinement ('refine all cells within shell') |
  ExactParticle | Special version of Particle to do tracking on non-convex cells |
   iNew | Factory class to read-construct particles used for parallel transfer |
  trackedParticle | Particle class that marks cells it passes through. Used to mark cells visited by feature edges. Uses ExactParticle tracking class so will work on concave cells |
   trackData | Class used to pass tracking data to the trackToFace function |
  ensightFile | Ensight output with specialized write() for strings, integers and floats. Correctly handles binary write as well |
  ensightGeoFile | Specialized Ensight output with extra geometry file header |
  ensightPart | Base class for ensightPartCells and ensightPartFaces |
   localPoints | Track the points used by the part and map global to local indices |
  ensightPartCells | An implementation of ensightPart to hold volume mesh cells |
  ensightPartFaces | An implementation of ensightPart to hold volume mesh faces |
  ensightParts | A collection of several ensightPart elements |
  meshReader | This class supports creating polyMeshes with baffles |
   cellFaceIdentifier | Identify cell faces in terms of cell Id and face Id |
  boundaryRegion | The boundaryRegion persistent data saved as a Map<dictionary> |
  cellTable | The cellTable persistent data saved as a Map<dictionary> |
  meshWriter | Write OpenFOAM meshes and/or results to another CFD format |
  polyDualMesh | Creates dual of polyMesh |
  decompositionMethod | Abstract base class for decomposition |
  geomDecomp | Geometrical domain decomposition |
  hierarchGeomDecomp | Does hierarchical decomposition of points. Works by first sorting the points in x direction into equal sized bins, then in y direction and finally in z direction |
  manualDecomp | Decomposition given a cell-to-processor association in a file |
  simpleGeomDecomp | |
  scotchDecomp | Scotch domain decomposition |
  dynamicFvMesh | Abstract base class for geometry and/or topology changing fvMesh |
  dynamicInkJetFvMesh | Mesh motion specifically for the "pumping" system of an ink-jet injector |
  dynamicMotionSolverFvMesh | The dynamicMotionSolverFvMesh |
  dynamicRefineFvMesh | A fvMesh with built-in refinement |
  solidBodyMotionFunction | Base class for defining solid-body motions |
  solidBodyMotionFvMesh | Solid-body motion of the mesh specified by a run-time selectable motion function |
  staticFvMesh | Foam::staticFvMesh |
  attachDetach | Attach/detach boundary mesh modifier. This modifier takes a set of internal faces and converts them into boundary faces and vice versa based on the given activation switch |
  boundaryMesh | Addressing for all faces on surface of mesh. Can either be read from polyMesh or from triSurface. Used for repatching existing meshes |
  octreeDataFaceList | Holds data for octree to work on list of faces on a bMesh (= PrimitivePatch which holds faces, not references them) Same as octreeDataFace except for that |
  boundaryPatch | Like polyPatch but without reference to mesh. patchIdentifier::index is not used. Used in boundaryMesh to hold data on patches |
  fvMeshAdder | Adds two fvMeshes without using any polyMesh morphing. Uses fvMeshAdder |
  CompactListList_dev | A packed storage unstructured matrix of objects of type <T> using an offset table for access |
  fvMeshDistribute | Sends/receives parts of mesh+fvfields to neighbouring processors. Used in load balancing |
  layerAdditionRemoval | Cell layer addition mesh modifier |
  cellCuts | Description of cuts across cells |
  cellLooper | Abstract base class. Concrete implementations know how to cut a cell (i.e. determine a loop around the circumference) |
  geomCellLooper | Implementation of cellLooper. Does pure geometric cut through cell |
  hexCellLooper | Implementation of cellLooper |
  topoCellLooper | Implementation of cellLooper. This one recognizes splitHexes and tries to make a cut such that if the neighbour was split (in a previous iteration) this one also gets split in the same direction so that the result will be a mesh without splitHexes |
  directionInfo | Holds direction in which to split cell (in fact a local coordinate axes). Information is a label and a direction |
  directions | Set of directions for each cell in the mesh. Either uniform and size=1 or one set of directions per cell |
  edgeVertex | Combines edge or vertex in single label. Used to specify cuts across cell circumference |
  boundaryCutter | Does modifications to boundary faces |
  meshCutAndRemove | Like meshCutter but also removes non-anchor side of cell |
  meshCutter | Cuts (splits) cells |
  multiDirRefinement | Does multiple pass refinement to refine cells in multiple directions |
  refinementIterator | Utility class to do iterating meshCutter until all requests satisfied |
  undoableMeshCutter | The main refinement handler. Gets cellCuts which is structure that describes which cells are to be cut and in what way. Maintains an undo list (if told so during construction). Apart from undo list is just wrapper around meshCutter |
  refineCell | Container with cells to refine. Refinement given as single direction |
  splitCell | Description of cell after splitting. Contains cellLabel and pointers to cells it it split in. See directedRefinement |
  wallLayerCells | After construction is a list of <refineCell> of cells within a certain distance to the wall and with the wall normal direction |
  wallNormalInfo | Holds information regarding nearest wall point. Used in wall refinement |
  motionSmoother | Given a displacement moves the mesh by scaling the displacement back until there are no more mesh errors |
  polyMeshGeometry | Updateable mesh geometry and checking routines |
  motionSolver | Virtual base class for mesh motion solver |
  perfectInterface | Hack of attachDetach to couple patches when they perfectly align. Does not decouple. Used by stitchMesh app. Does geometric matching |
  faceCoupleInfo | Container for information needed to couple to meshes. When constructed from two meshes and a geometric tolerance finds the corresponding boundary faces |
  polyMeshAdder | Adds two meshes without using any polyMesh morphing |
  attachPolyTopoChanger | This class is derived from polyMesh and serves as a tool for statically connecting pieces of a mesh by executing the mesh modifiers and cleaning the mesh |
  polyMeshModifier | Virtual base class for mesh modifiers |
  polyAddCell | Class containing data for cell addition |
  polyAddFace | A face addition data class. A face can be inflated either from a point or from another face and can either be in internal or a boundary face |
  polyAddPoint | Class containing data for point addition |
  addPatchCellLayer | Adds layers of cells to outside of polyPatch |
  combineFaces | Combines boundary faces into single face. The faces get the patch of the first face ('the master') |
  duplicatePoints | Duplicate points |
  edgeCollapser | Does polyTopoChanges to remove edges. Can remove faces due to edge collapse but can not remove cells due to face removal! Also removes unused points |
  faceCollapser | Collapses faces into edges. Used to remove sliver faces (faces with small area but non-zero span) |
  ifEqEqOp | Reduction class. If x and y are not equal assign value |
  hexRef8 | Refinement of (split) hexes using polyTopoChange |
  minEqOpFace | |
  localPointRegion | Takes mesh with 'baffles' (= boundary faces sharing points). Determines for selected points on boundary faces the 'point region' it is connected to. Each region can be visited by a cell-face-cell walk. Used in duplicating points after splitting baffles |
  polyModifyCell | Class describing modification of a cell |
  polyModifyFace | Class describing modification of a face |
  polyModifyPoint | Class describing modification of a point |
  polyTopoChange | Direct mesh changes based on v1.3 polyTopoChange syntax |
  refinementData | Transfers refinement levels such that slow transition between levels is maintained. Used in meshWave |
  refinementDistanceData | Transfers refinement levels such that slow transition between levels is maintained. Used in FaceCellWave |
  refinementHistory | All refinement history. Used in unrefinement |
   splitCell8 | |
  removeCells | Given list of cells to remove insert all the topology changes |
  removeFaces | Given list of faces to remove insert all the topology changes. Contains helper function to get consistent set of faces to remove |
  polyRemoveCell | Class containing data for cell removal |
  polyRemoveFace | Class containing data for face removal |
  polyRemovePoint | Class containing data for point removal |
  removePoints | Removes selected points from mesh and updates faces using these points |
  topoAction | A virtual base class for topological actions |
  polyTopoChanger | List of mesh modifiers defining the mesh dynamics |
  repatchPolyTopoChanger | A mesh which allows changes in the patch distribution of the boundary faces. The change in patching is set using changePatchID. For a boundary face, a new patch ID is given |
  setUpdater | Keeps cell/face/vertex sets uptodate. Both the ones loaded and the ones on disk |
  enrichedPatch | The enriched patch contains a double set of faces from the two sides of the sliding interface before the cutting |
  slidingInterface | Sliding interface mesh modifier. Given two face zones, couple the master and slave side using a cutting procedure |
  edgeMesh | Points connected by edges |
  featureEdgeMesh | Features (lines), readable from file |
  engineMesh | Foam::engineMesh |
  fvMotionSolverEngineMesh | Foam::fvMotionSolverEngineMesh |
  layeredEngineMesh | Foam::layeredEngineMesh |
  staticEngineMesh | Foam::staticEngineMesh |
  enginePiston | Foam::enginePiston |
  engineTime | Manage time in terms of engine RPM and crank-angle |
  engineValve | Foam::engineValve |
  valveBank | A list of valves |
  ignition | Foam::ignition |
  ignitionSite | Foam::ignitionSite |
   iNew | Class used for the read-construction of |
  errorDrivenRefinement | Refines and coarsens based on error estimate |
  errorEstimate | Residual error estimation |
  evaluateError | Foam::evaluateError |
  actuationDiskSource | Actuation disk zone definition. Constant values for momentum source for actuation disk |
  basicSource | Basic source abtract class |
   iNew | Return pointer to new basicSource object created |
  basicSourceList | List of explict sources |
  IObasicSourceList | IObasicSourceList |
  explicitSource | Explicit source |
  pressureGradientExplicitSource | Creates a cell set pressure gradient source |
  TimeActivatedExplicitSource | Time activated explicit source |
   iNew | Return pointer to new TimeActivatedExplicitSource object created |
  TimeActivatedExplicitSourceList | List of time activeted explict sources |
  MRFZone | MRF zone definition based on cell zone and parameters obtained from a control dictionary constructed from the given stream |
   iNew | Return a pointer to a new MRFZone created on freestore |
  MRFZones | Container class for a set of MRFZones with the MRFZone member functions implemented to loop over the functions for each MRFZone |
  porousZone | Porous zone definition based on cell zones |
   iNew | Return pointer to new porousZone created on freestore from Istream |
  porousZones | A centralized porousZone collection |
  SRFFreestreamVelocityFvPatchVectorField | Freestream velocity patch to be used with SRF model to apply the appropriate rotation transformation in time and space |
  SRFVelocityFvPatchVectorField | Velocity patch to be used with SRF model |
  basicSymmetryFvPatchField | A symmetry patch |
  calculatedFvPatchField | Foam::calculatedFvPatchField |
  coupledFvPatchField | Foam::coupledFvPatchField |
  directionMixedFvPatchField | Foam::directionMixedFvPatchField |
  fixedGradientFvPatchField | Foam::fixedGradientFvPatchField |
  fixedValueFvPatchField | Foam::fixedValueFvPatchField |
  mixedFvPatchField | Foam::mixedFvPatchField |
  slicedFvPatchField | Specialization of fvPatchField which creates the underlying fvPatchField as a slice of the given complete field |
  transformFvPatchField | Foam::transformFvPatchField |
  zeroGradientFvPatchField | Foam::zeroGradientFvPatchField |
  cyclicFvPatchField | Foam::cyclicFvPatchField |
  emptyFvPatchField | Foam::emptyFvPatchField |
  jumpCyclicFvPatchField | Foam::jumpCyclicFvPatchField |
  processorFvPatchField | Foam::processorFvPatchField |
  symmetryFvPatchField | Foam::symmetryFvPatchField |
  wedgeFvPatchField | Foam::wedgeFvPatchField |
  activeBaffleVelocityFvPatchVectorField | Boundary condition that modifies mesh areas based on velocity |
  advectiveFvPatchField | Advective outflow boundary condition based on solving DDt(psi, U) = 0 at the boundary |
  buoyantPressureFvPatchScalarField | Set the pressure gradient boundary condition appropriately for buoyant flow |
  cylindricalInletVelocityFvPatchVectorField | Describes an inlet vector boundary condition in cylindrical coordinates given a central axis, central point, rpm, axial and radial velocity |
  directMappedFixedValueFvPatchField | Recycles the value at a set of cells or patch faces back to *this. Can not sample internal faces (since volField not defined on faces) |
  directMappedVelocityFluxFixedValueFvPatchField | Recycles the velocity and flux at a patch to this patch |
  fanFvPatchField | Foam::fanFvPatchField |
  fixedFluxPressureFvPatchScalarField | Foam::fixedFluxPressureFvPatchScalarField |
  fixedInternalValueFvPatchField | Boundary condition providing mechanism to set boundary (cell) values directly into a matrix, i.e. to set a constraint condition. Default behaviour is to act as a zero gradient condition |
  fixedNormalSlipFvPatchField | Foam::fixedNormalSlipFvPatchField |
  fixedPressureCompressibleDensityFvPatchScalarField | Calculate compressible density as a function of pressure and fluid properties |
  flowRateInletVelocityFvPatchVectorField | Describes a volumetric/mass flow normal vector boundary condition by its magnitude as an integral over its area |
  fluxCorrectedVelocityFvPatchVectorField | Velocity outlet boundary condition for patches where the pressure is specified. The outflow velocity is obtained by "zeroGradient" and then corrected from the flux. If reverse flow is possible or expected use the "pressureInletOutletVelocityFvPatchVectorField" BC instead |
  freestreamFvPatchField | Foam::freestreamFvPatchField |
  freestreamPressureFvPatchScalarField | Foam::freestreamPressureFvPatchScalarField |
  inletOutletFvPatchField | Foam::inletOutletFvPatchField |
  inletOutletTotalTemperatureFvPatchScalarField | Foam::inletOutletTotalTemperatureFvPatchScalarField |
  movingWallVelocityFvPatchVectorField | Foam::movingWallVelocityFvPatchVectorField |
  oscillatingFixedValueFvPatchField | Foam::oscillatingFixedValueFvPatchField |
  outletInletFvPatchField | Foam::outletInletFvPatchField |
  outletMappedUniformInletFvPatchField | Averages the field over the "outlet" patch specified by name "outletPatchName" and applies this as the uniform value of the field over this patch |
  partialSlipFvPatchField | Foam::partialSlipFvPatchField |
  pressureDirectedInletOutletVelocityFvPatchVectorField | Velocity inlet/outlet boundary condition for pressure boundary where the pressure is specified. zero-gradient is applied for outflow (as defined by the flux) and for inflow the velocity is obtained from the flux with the specified `inletDirection' |
  pressureDirectedInletVelocityFvPatchVectorField | Velocity inlet boundary condition for patches where the pressure is specified. The inflow velocity is obtained from the flux with the specified "inletDirection" direction. If reverse flow is possible or expected use the "pressureDirectedInletOutletVelocityFvPatchVectorField" BC instead |
  pressureInletOutletVelocityFvPatchVectorField | Velocity inlet/outlet boundary condition patches for where the pressure is specified. zero-gradient is applied for outflow (as defined by the flux) and for inflow the velocity is obtained from the patch-face normal component of the internal-cell value |
  pressureInletUniformVelocityFvPatchVectorField | Velocity inlet boundary condition for patches where the pressure is specified. The uniform inflow velocity is obtained by averaging the flux over the patch and apply it in the direction normal to the patch faces |
  pressureInletVelocityFvPatchVectorField | Velocity inlet boundary condition for patches where the pressure is specified. The inflow velocity is obtained from the flux with a direction normal to the patch faces. If reverse flow is possible or expected use the "pressureInletOutletVelocityFvPatchVectorField" BC instead |
  pressureNormalInletOutletVelocityFvPatchVectorField | Velocity inlet/outlet boundary condition for patches where the pressure is specified. zero-gradient is applied for outflow (as defined by the flux) and for inflow the velocity is obtained from the flux with a direction normal to the patch faces |
  rotatingPressureInletOutletVelocityFvPatchVectorField | Velocity inlet/outlet boundary condition in a rotating frame for patches where the pressure is specified. zero-gradient is applied for outflow (as defined by the flux) and for inflow the velocity is obtained from the flux with a direction normal to the patch faces |
  rotatingTotalPressureFvPatchScalarField | Foam::rotatingTotalPressureFvPatchScalarField |
  rotatingWallVelocityFvPatchVectorField | Foam::rotatingWallVelocityFvPatchVectorField |
  slipFvPatchField | Foam::slipFvPatchField |
  supersonicFreestreamFvPatchVectorField | Supersonic free stream condition |
  surfaceNormalFixedValueFvPatchVectorField | Describes a surface normal vector boundary condition by its magnitude. Note: The value is positive for outward-pointing vectors |
  swirlFlowRateInletVelocityFvPatchVectorField | Describes a volumetric/mass flow normal vector boundary condition by its magnitude as an integral over its area with a swirl component determined by the RPM |
  syringePressureFvPatchScalarField | Pressure boundary condition obtained from a 0-D model of the cylinder of a syringe |
  timeVaryingFlowRateInletVelocityFvPatchVectorField | A time-varying form of a flow normal vector boundary condition |
  AverageIOField | A primitive field + average with IO |
  timeVaryingMappedFixedValueFvPatchField | Foam::timeVaryingMappedFixedValueFvPatchField |
  timeVaryingMappedPressureDirectedInletVelocityFvPatchVectorField | Velocity inlet boundary condition for patches where the pressure is specified. The inflow velocity is obtained from the flux with the "inletDirection" direction mapped from a time/space-varying table |
  timeVaryingMappedTotalPressureFvPatchScalarField | Foam::timeVaryingMappedTotalPressureFvPatchScalarField |
  timeVaryingUniformFixedValueFvPatchField | A time-varying form of a uniform fixed value boundary condition |
  timeVaryingUniformInletOutletFvPatchField | A time-varying form of a uniform fixed value boundary condition |
  timeVaryingUniformTotalPressureFvPatchScalarField | A time-varying form of a uniform total pressure boundary condition |
  totalPressureFvPatchScalarField | Foam::totalPressureFvPatchScalarField |
  totalTemperatureFvPatchScalarField | Foam::totalTemperatureFvPatchScalarField |
  translatingWallVelocityFvPatchVectorField | Foam::translatingWallVelocityFvPatchVectorField |
  turbulentInletFvPatchField | Generate a fluctuating inlet condition by adding a random component to a reference (mean) field. Input: referenceField Mean field. fluctuationScale RMS fluctuation, provided as the fraction of the mean field. alpha temporal correlation factor; the fraction of the new random component added to the previous time-step (defaults to 0.1) |
  turbulentIntensityKineticEnergyInletFvPatchScalarField | Calculate turbulent kinetic energy from the intensity provided as a fraction of the mean velocity |
  uniformDensityHydrostaticPressureFvPatchScalarField | Hydrostatic pressure boundary condition calculated as |
  uniformFixedValueFvPatchField | Foam::uniformFixedValueFvPatchField |
  waveTransmissiveFvPatchField | Foam::waveTransmissiveFvPatchField |
  fvPatchField | Abstract base class with a fat-interface to all derived classes covering all possible ways in which they might be used |
  fvPatchFieldMapper | Foam::fvPatchFieldMapper |
  calculatedFvsPatchField | Foam::calculatedFvsPatchField |
  coupledFvsPatchField | Foam::coupledFvsPatchField |
  fixedValueFvsPatchField | Foam::fixedValueFvsPatchField |
  slicedFvsPatchField | Specialization of fvsPatchField which creates the underlying fvsPatchField as a slice of the given complete field |
  cyclicFvsPatchField | Foam::cyclicFvsPatchField |
  emptyFvsPatchField | Foam::emptyFvsPatchField |
  processorFvsPatchField | Foam::processorFvsPatchField |
  symmetryFvsPatchField | Foam::symmetryFvsPatchField |
  wedgeFvsPatchField | Foam::wedgeFvsPatchField |
  fvsPatchField | An abstract base class with a fat-interface to all derived classes covering all possible ways in which they might be used |
  fvSchemes | Selector class for finite volume differencing schemes. fvMesh is derived from fvShemes so that all fields have access to the fvSchemes from the mesh reference they hold |
  fvSolution | Selector class for finite volume solution solution. fvMesh is derived from fvSolution so that all fields have access to the fvSolution from the mesh reference they hold |
  extendedLeastSquaresVectors | Extended molecule least-squares gradient scheme vectors |
  leastSquaresVectors | Least-squares gradient scheme vectors |
  quadraticFitSnGradData | |
  fvMatrix | A special matrix type and solver, designed for finite volume solutions of scalar equations. Face addressing is used to make all matrix assembly and solution loops vectorise |
   fvSolver | Solver class returned by the solver function |
  faceAreaPairGAMGAgglomeration | Agglomerate using the pair algorithm |
  CECCellToCellStencil | |
  cellToCellStencil | Baseclass for extended cell centred addressing. Contains per cell a list of neighbouring cells and/or boundaryfaces in global addressing |
   unionEqOp | Combine operator for labelLists |
  CFCCellToCellStencil | |
  CPCCellToCellStencil | |
  extendedCellToFaceStencil | Calculates/constains the extended cell-to-face stencil |
  extendedCentredCellToFaceStencil | |
  extendedUpwindCellToFaceStencil | Creates upwind stencil by shifting a centred stencil to upwind and downwind faces and optionally removing all non-(up/down)wind faces ('pureUpwind') |
  CECCellToFaceStencil | Combined corresponding cellToCellStencil of owner and neighbour |
  cellToFaceStencil | Baseclass for extended cell-to-facel stencils (face values from neighbouring cells) |
   unionEqOp | Combine operator for labelLists |
  CFCCellToFaceStencil | Combined corresponding cellToCellStencil of owner and neighbour |
  CPCCellToFaceStencil | Combined corresponding cellToCellStencil of owner and neighbour |
  FECCellToFaceStencil | All cells connected via edge to face |
  centredCECCellToFaceStencilObject | |
  centredCFCCellToFaceStencilObject | |
  centredCPCCellToFaceStencilObject | |
  centredFECCellToFaceStencilObject | |
  pureUpwindCFCCellToFaceStencilObject | |
  upwindCECCellToFaceStencilObject | |
  upwindCFCCellToFaceStencilObject | |
  upwindCPCCellToFaceStencilObject | |
  upwindFECCellToFaceStencilObject | |
  extendedCentredFaceToCellStencil | |
  extendedFaceToCellStencil | Note: transformations on coupled patches not supported. Problem is the positions of cells reachable through these patches |
  CFCFaceToCellStencil | |
  faceToCellStencil | Baseclass for extended cell centred addressing. Contains per cell a list of neighbouring faces in global addressing |
  centredCFCFaceToCellStencilObject | |
  fvBoundaryMesh | Foam::fvBoundaryMesh |
  fvMesh | Mesh data needed to do the Finite Volume discretisation |
  fvMeshLduAddressing | Foam::fvMeshLduAddressing |
  fvBoundaryMeshMapper | Foam::fvBoundaryMeshMapper |
  fvMeshMapper | Class holds all the necessary information for mapping fields associated with fvMesh |
  fvPatchMapper | Mapping class for a fvPatchField |
  fvSurfaceMapper | FV surface mapper |
  fvMeshSubset | Post-processing mesh subset tool. Given the original mesh and the list of selected cells, it creates the mesh consisting only of the desired cells, with the mapping list for points, faces, and cells |
   patchFieldSubset | Patch-field subset interpolation class |
   pointPatchFieldSubset | Patch-field subset interpolation class |
  coupledFvPatch | An abstract base class for patches that couple regions of the computational domain e.g. cyclic and processor-processor links |
  genericFvPatch | FV variant of the genericPolyPatch |
  cyclicFvPatch | Cyclic-plane patch |
  emptyFvPatch | A patch which will not exist in the fvMesh. Typical example is a front and back plane of a 2-D geometry |
  processorFvPatch | Processor patch |
  symmetryFvPatch | Symmetry-plane patch |
  wedgeFvPatch | Wedge front and back plane patch |
  directMappedFvPatch | Foam::directMappedFvPatch |
  directMappedWallFvPatch | Foam::directMappedWallFvPatch |
  wallFvPatch | Foam::wallFvPatch |
  fvPatch | Foam::fvPatch |
  nearWallDist | Distance calculation for cells with face on a wall. Searches pointNeighbours to find closest |
  nearWallDistNoSearch | Distance calculation for cells with face on a wall. Does not search anything, just takes normal component of distance |
  reflectionVectors | Container for reflection vectors (= unit normal of nearest wall) |
  wallDist | Calculation of distance to nearest wall for all cells and boundary. Uses meshWave to do actual calculation |
  wallDistData | Wall distance calculation. Like wallDist but also transports extra data (template argument) |
  wallDistReflection | Wall distance and reflection vector calculation. See wallDist.H |
  wallPointYPlus | Holds information (coordinate and yStar) regarding nearest wall point |
  interpolation | Abstract base class for interpolation |
  interpolationCell | Foam::interpolationCell |
  interpolationCellPatchConstrained | Uses the cell value for any point in the cell apart from a boundary face where it uses the boundary value directly. Note: will not work on an empty patch |
  cellPointWeight | Foam::cellPointWeight |
  interpolationCellPoint | Foam::interpolationCellPoint |
  interpolationCellPointFace | Foam::interpolationCellPointFace |
  cellPointWeightWallModified | Foam::cellPointWeightWallModified |
  interpolationCellPointWallModified | Same as interpolationCellPoint, but if interpolating a wall face, uses cell centre value instead |
  MapInternalField< Type, MeshMapper, surfaceMesh > | |
  MapInternalField< Type, MeshMapper, volMesh > | |
  blended | Linear/upwind blended differencing scheme |
  filteredLinearLimiter | Class to generate weighting factors for the filteredLinear differencing scheme |
  filteredLinear2Limiter | Class to generate weighting factors for the filteredLinear2 differencing scheme |
  filteredLinear2VLimiter | Class to generate weighting factors for the filteredLinear2V differencing scheme |
  filteredLinear3Limiter | Class to generate weighting factors for the filteredLinear differencing scheme |
  filteredLinear3VLimiter | Class to generate weighting factors for the filteredLinear3V differencing scheme |
  GammaLimiter | Class with limiter function which returns the limiter for the Gamma differencing scheme based on phict obtained from the LimiterFunc class |
  LimitedLimiter | Foam::LimitedLimiter |
  Limited01Limiter | A LimitedLimiter with the range 0-1 |
  limitedCubicLimiter | Class with limiter function which returns the limiter for the TVD limited centred-cubic differencing scheme based on r obtained from the LimiterFunc class |
  limitedCubicVLimiter | Class with limiter function which returns the limiter for the limitedCubicV differencing scheme based on r obtained from the LimiterFunc class |
  limitedLinearLimiter | Class with limiter function which returns the limiter for the TVD limited linear differencing scheme based on r obtained from the LimiterFunc class |
  LimitedScheme | Class to create NVD/TVD limited weighting-factors |
  NVDTVD | Foam::NVDTVD |
  NVDVTVDV | Foam::NVDVTVDV |
  limitedSurfaceInterpolationScheme | Abstract base class for limited surface interpolation schemes |
  limitWith | LimitWith differencing scheme limits the specified scheme with the specified limiter |
  linearUpwind | LinearUpwind interpolation scheme class derived from upwind and returns upwind weighting factors but also applies an explicit correction |
  linearUpwindV | LinearUpwindV interpolation scheme class derived from upwind and returns upwind weighting factors but also applies an explicit correction |
  MinmodLimiter | Class with limiter function which returns the limiter for the Minmod differencing scheme |
  MUSCLLimiter | Class with limiter function which returns the limiter for the van Leer's MUSCL differencing scheme |
  OSPRELimiter | Class with limiter function which returns the limiter for the OSPRE differencing scheme based on r obtained from the LimiterFunc class |
  PhiLimiter | Class with limiter function which returns the limiter for the Phi differencing scheme |
  PhiScheme | Class to create the weighting-factors based on the face-flux |
  QUICKLimiter | Class with limiter function which returns the limiter for the quadratic-upwind differencing scheme |
  QUICKVLimiter | Class with limiter function which returns the limiter for the quadratic-upwind differencing scheme |
  SFCDLimiter | Class with limiter function which returns the limiter for the SFCD differencing scheme based on phict obtained from the LimiterFunc class |
  SuperBeeLimiter | Class with limiter function which returns the limiter for the SuperBee differencing scheme based on r obtained from the LimiterFunc class |
  UMISTLimiter | Class with limiter function which returns the limiter for the UMIST differencing scheme |
  upwind | Upwind differencing scheme class |
  vanAlbadaLimiter | Class with limiter function which returns the limiter for the vanAlbada differencing scheme based on r obtained from the LimiterFunc class |
  vanLeerLimiter | Class with limiter function which returns the limiter for the vanLeer differencing scheme based on r obtained from the LimiterFunc class |
  multivariateScheme | Generic multi-variate discretisation scheme class which may be instantiated for any of the NVD, CNVD or NVDV schemes |
   fieldScheme | SurfaceInterpolationScheme sub-class returned by operator(field) |
  multivariateSelectionScheme | Generic multi-variate discretisation scheme class for which any of the NVD, CNVD or NVDV schemes may be selected for each variable |
   fieldScheme | SurfaceInterpolationScheme sub-class returned by operator(field) |
  multivariateSurfaceInterpolationScheme | Abstract base class for multi-variate surface interpolation schemes |
   fieldScheme | SurfaceInterpolationScheme sub-class returned by operator(field) |
   fieldTable | FieldTable |
  multivariateUpwind | Upwind-difference form of the multivariate surfaceInterpolationScheme |
   fieldScheme | SurfaceInterpolationScheme sub-class returned by operator(field) |
  biLinearFitPolynomial | BiLinear polynomial for interpolation fitting |
  CentredFitData | Data for the quadratic fit correction interpolation scheme |
  CentredFitScheme | Centred fit surface interpolation scheme which applies an explicit correction to linear |
  clippedLinear | Central-differencing interpolation scheme using clipped-weights to improve stability on meshes with very rapid variations in cell size |
  cubic | Cubic interpolation scheme class derived from linear and returns linear weighting factors but also applies an explicit correction |
  cubicUpwindFitPolynomial | Cubic polynomial for upwind biased interpolation fitting |
  downwind | Downwind differencing scheme class |
  FitData | Data for the upwinded and centred polynomial fit interpolation schemes. The linearCorrection_ determines whether the fit is for a corrected linear scheme (first two coefficients are corrections for owner and neighbour) or a pure upwind scheme (first coefficient is correction for owner ; weight on face taken as 1) |
  fixedBlended | Two-scheme fixed-blending differencing scheme |
  harmonic | Harmonic-mean differencing scheme class |
  linear | Central-differencing interpolation scheme class |
  linearFitPolynomial | Linear polynomial for interpolation fitting |
  localBlended | Two-scheme localBlended differencing scheme |
  localMax | LocalMax-mean differencing scheme class |
  localMin | LocalMin-mean differencing scheme class |
  midPoint | Mid-point interpolation (weighting factors = 0.5) scheme class |
  outletStabilised | Outlet-stabilised interpolation scheme which applies upwind differencing to the faces of the cells adjacent to outlets |
  pointLinear | |
  PureUpwindFitScheme | Upwind biased fit surface interpolation scheme that applies an explicit correction to upwind |
  quadraticFitPolynomial | Quadratic polynomial for centred interpolation fitting |
  quadraticLinearFitPolynomial | Quadratic/linear polynomial for interpolation fitting: quadratic normal to the face, linear in the plane of the face for consistency with 2nd-order Gauss |
  quadraticLinearUpwindFitPolynomial | Quadratic polynomial for upwind biased interpolation fitting |
  quadraticUpwindFitPolynomial | Quadratic polynomial for upwind biased interpolation fitting |
  reverseLinear | Inversed weight central-differencing interpolation scheme class |
  skewCorrected | Skewness-corrected interpolation scheme that applies an explicit correction to given scheme |
  skewCorrectionVectors | Skew-correction vectors for the skewness-corrected interpolation scheme |
  UpwindFitData | Data for the quadratic fit correction interpolation scheme to be used with upwind biased stencil |
  UpwindFitScheme | Upwind biased fit surface interpolation scheme that applies an explicit correction to linear |
  weighted | Interpolation scheme class using weights looked-up from the objectRegistry |
  surfaceInterpolation | Cell to surface interpolation scheme. Included in fvMesh |
  surfaceInterpolationScheme | Abstract base class for surface interpolation schemes |
  pointPatchInterpolation | Foam::pointPatchInterpolation |
  volPointInterpolation | Foam::volPointInterpolation |
  surfaceMesh | Mesh data needed to do the Finite Volume discretisation |
  volMesh | Mesh data needed to do the Finite Volume discretisation |
  displacementComponentLaplacianFvMotionSolver | Mesh motion solver for an fvMesh. Based on solving the cell-centre Laplacian for the given component of the motion displacement |
  displacementFvMotionSolver | Base class for fvMotionSolvers which calculate displacement |
  displacementInterpolationFvMotionSolver | Mesh motion solver for an fvMesh |
  displacementLaplacianFvMotionSolver | Mesh motion solver for an fvMesh. Based on solving the cell-centre Laplacian for the motion displacement |
  displacementSBRStressFvMotionSolver | Mesh motion solver for an fvMesh. Based on solving the cell-centre solid-body rotation stress equations for the motion displacement |
  fvMotionSolver | Virtual base class for finite volume mesh motion solvers |
  velocityComponentLaplacianFvMotionSolver | Mesh motion solver for an fvMesh. Based on solving the cell-centre Laplacian for the given component of the motion velocity |
  velocityLaplacianFvMotionSolver | Mesh motion solver for an fvMesh. Based on solving the cell-centre Laplacian for the motion velocity |
  cellMotionFvPatchField | Foam::cellMotionFvPatchField |
  surfaceSlipDisplacementFvPatchField | FvPatchField corresponding to surfaceSlipDisplacementPointPatchField. Is just a slip type since all hard work (projection) is done in the pointPatch field |
  directionalDiffusivity | Directional finite volume mesh motion diffusivity |
  fileDiffusivity | Motion diffusivity read from given file name |
  inverseDistanceDiffusivity | Inverse distance to the given patches motion diffusivity |
  inverseFaceDistanceDiffusivity | Inverse distance to the given patches motion diffusivity |
  inversePointDistanceDiffusivity | Inverse distance to the given patches motion diffusivity |
  inverseVolumeDiffusivity | Inverse cell-volume motion diffusivity |
  exponentialDiffusivity | Mesh motion diffusivity maipulator which returns the exp(-alpha/D) of the given diffusivity D |
  quadraticDiffusivity | Mesh motion diffusivity maipulator which returns the sqr of the given diffusivity |
  motionDiffusivity | Abstract base class for cell-centre mesh motion diffusivity |
  motionDirectionalDiffusivity | MotionDirectional finite volume mesh motion diffusivity |
  uniformDiffusivity | Uniform uniform finite volume mesh motion diffusivity |
  angularOscillatingDisplacementPointPatchVectorField | Foam::angularOscillatingDisplacementPointPatchVectorField |
  angularOscillatingVelocityPointPatchVectorField | Foam::angularOscillatingVelocityPointPatchVectorField |
  oscillatingDisplacementPointPatchVectorField | Foam::oscillatingDisplacementPointPatchVectorField |
  oscillatingVelocityPointPatchVectorField | Foam::oscillatingVelocityPointPatchVectorField |
  surfaceDisplacementPointPatchVectorField | |
  surfaceSlipDisplacementPointPatchVectorField | Displacement follows a triSurface. Use in a displacement fvMotionSolver as a bc on the pointDisplacement field. Following is done by calculating the projection onto the surface according to the projectMode |
  genericFvPatchField | Foam::genericFvPatchField |
  genericPointPatchField | Foam::genericPointPatchField |
  combineNsTransPs | |
  Cloud | |
  indexedParticle | |
  indexedParticleCloud | A Cloud of particles carrying an additional index |
  IOPosition | Helper IO class to read and write particle positions |
  Particle | |
   iNew | Factory class to read-construct particles used for |
   trackData | Class used to pass tracking data to the trackToFace function |
  passiveParticle | |
  passiveParticleCloud | A Cloud of passive particles |
  CoalParcel | |
  COxidationDiffusionLimitedRate | |
  COxidationKineticDiffusionLimitedRate | |
  COxidationMurphyShaddix | |
  commonRailInjector | Common-rail injector |
  definedInjector | User specified MFR vs time and velocity vs time |
  injector | Spray injector |
   iNew | Return a pointer to a new injector created on freestore |
  injectorType | Base class for injectors |
  multiHoleInjector | The unit injector |
  swirlInjector | The swirl injector |
  unitInjector | The unit injector |
  parcel | A parcel of particles |
  spray | A spray is a cloud of parcels |
  atomizationModel | Base class for selecting the atomization model |
  blobsSheetAtomization | Primary Breakup Model for pressure swirl atomizers |
  LISA | Primary Breakup Model for pressure swirl atomizers |
  noAtomization | Secondary atomization model for the spray |
  breakupModel | Base class for selecting a breakup model |
  ETAB | The Enhanced TAB model |
  noBreakup | Spray breakup "off" |
  reitzDiwakar | Secondary breakup model for the spray |
  reitzKHRT | Secondary breakup model which uses the Kelvin-Helmholtz instability theory to predict the 'stripped' droplets... and the Raleigh-Taylor instability as well |
  SHF | Secondary Breakup Model to take account of the different breakup regimes, bag, molutimode, shear... |
  TAB | The TAB Method for Numerical Calculation of Spray Droplet Breakup |
  collisionModel | Base case for selecting a collision model |
  noCollision | No collisions between parcels All parcels move independently of eachother |
  ORourkeCollisionModel | Collision model by P.J. O'Rourke |
  trajectoryCollisionModel | Collision model by P.J. O'Rourke. Implemented as described in the KIVA manual |
  dispersionLESModel | Foam::dispersionLESModel |
  dispersionModel | Foam::dispersionModel |
  dispersionRASModel | Dispersion RAS model |
  gradientDispersionRAS | The velocity is perturbed in the direction of -grad(k), with a Gaussian random number distribution with variance sigma. where sigma is defined below |
  noDispersion | No turbulent dispersion of the parcels |
  stochasticDispersionRAS | The velocity is perturbed in random direction, with a Gaussian random number distribution with variance sigma. where sigma is defined below |
  dragModel | Foam::dragModel |
  noDragModel | Standard drag law model with a lower limit on the Cd-value |
  standardDragModel | Standard drag law model with a lower limit on the Cd-value |
  evaporationModel | Base class for selecting an evaporation model |
  noEvaporation | Set the relaxation-times to something negative. this will disable evaporation |
  RutlandFlashBoil | Evaporation model with flash boiling |
  saturateEvaporationModel | Saturate evaporation model. Characteristic time is calculated to immediately saturate the cell It should be mentioned that this is coupled with the (implicit) way evaporation is done in parcel, since the evaporation time depends on the integration step |
  standardEvaporationModel | Standard evaporation model based on the logarithmic expression of the ration of pressure differences |
  heatTransferModel | Foam::heatTransferModel |
  noHeatTransfer | No heat transfer. return a negative value to prevent the liquid being heated up |
  RanzMarshall | The Ranz-Marshal correlation for heat transfer |
  blobsSwirlInjector | Model for parcels injection in pressure Swirl Atomizers |
  ChomiakInjector | Injector model based on an idea of Jerzy Chomiak |
  constInjector | Injector model with specified Constant values for the droplet diameter and spray cone angle |
  definedHollowConeInjector | An injector model for hollow/solid cone injection |
  definedPressureSwirlInjector | Pressure swirl injector model with user-defined cone-angle/interval vs. time |
  hollowConeInjector | A hollow cone injector with randomly distributed parcels between the inner and outer cone angle |
  injectorModel | The injectormodel is used to set initial droplet size and the velocity direction |
  pressureSwirlInjector | Randomly distribute the parcels between the inner and outer cone angle |
  reflectParcel | The parcels are reflected back from the wall in an inelastic collision |
  removeParcel | Remove parcel, regardless of boundary type |
  wallModel | A wall interaction model |
  DsmcBaseCloud | Virtual abstract base class for templated DsmcCloud |
  DsmcCloud | Templated base class for dsmc cloud |
  dsmcParcel | |
  DsmcParcel | DSMC parcel class |
   constantProperties | Class to hold DSMC particle constant properties |
   trackData | Class used to pass kinematic tracking data to the trackToFace function |
  BinaryCollisionModel | Templated DSMC particle collision class |
  LarsenBorgnakkeVariableHardSphere | Variable Hard Sphere BinaryCollision Model with Larsen Borgnakke internal energy redistribution. Based on the INELRS subroutine in Bird's DSMC0R.FOR |
  VariableHardSphere | Variable Hard Sphere BinaryCollision Model |
  FreeStream | Inserting new particles across the faces of a all patched of type "patch" for a free stream. Uniform values number density, temperature and velocity sourced face-by-face from the boundaryT and boundaryU fields of the cloud |
  InflowBoundaryModel | Templated inflow boundary model class |
  NoInflow | Not inserting any particles |
  MaxwellianThermal | Wall interaction setting microscopic velocity to a random one drawn from a Maxwellian distribution corresponding to a specified temperature |
  MixedDiffuseSpecular | Wall interaction setting microscopic velocity to a random one drawn from a Maxwellian distribution corresponding to a specified temperature |
  SpecularReflection | Reversing the wall-normal component of the particle velocity |
  WallInteractionModel | Templated wall interaction model class |
  kinematicCloud | Virtual abstract base class for templated KinematicCloud |
  reactingCloud | Virtual abstract base class for templated ReactingCloud |
  reactingMultiphaseCloud | Virtual abstract base class for templated reactingMultiphaseCloud |
  thermoCloud | Virtual abstract base class for templated ThermoCloud |
  KinematicCloud | Templated base class for kinematic cloud |
  ReactingCloud | Templated base class for reacting cloud |
  ReactingMultiphaseCloud | Templated base class for multiphase reacting cloud |
  ThermoCloud | Templated base class for thermodynamic cloud |
  Analytical | Analytical integration |
  Euler | Euler-implicit integration |
  IntegrationScheme | Top level model for Integration schemes |
   integrationResult | Helper class to supply results of integration |
  reactingParcel | Base class for reacting parcel - simply used to set the contiguous flag |
  basicKinematicParcel | |
  BasicReactingMultiphaseParcel | |
  BasicReactingParcel | |
  basicThermoParcel | |
  KinematicParcel | Kinematic parcel class with one/two-way coupling with the continuous phase |
   constantProperties | Class to hold kinematic particle constant properties |
   trackData | Class used to pass kinematic tracking data to the trackToFace function |
  ReactingMultiphaseParcel | Multiphase variant of the reacting parcel class with one/two-way coupling with the continuous phase |
   constantProperties | Class to hold reacting multiphase particle constant properties |
   trackData | Class used to pass reacting tracking data to the trackToFace function |
  ReactingParcel | Reacting parcel class with one/two-way coupling with the continuous phase |
   constantProperties | Class to hold reacting particle constant properties |
   trackData | Class used to pass reacting tracking data to the trackToFace function |
  ThermoParcel | Thermodynamic parcel class with one/two-way coupling with the continuous phase. Includes Kinematic parcel sub-models, plus: |
   constantProperties | Class to hold thermo particle constant properties |
   trackData | Class used to pass thermo tracking data to the trackToFace function |
  particleForces | Provides a mechanism to calculate particle forces Note: forces are force per unit mass (accelerations) |
  phaseProperties | Helper class to manage multi-component phase properties |
  phasePropertiesList | Simple container for a list of phase properties |
  Constant | Templated basic entry that holds a constant value |
  DataEntry | Top level data entry class for use in dictionaries. Provides a mechanism to specify a variable as a certain type, e.g. constant or table, and provide functions to return the (interpolated) value, and integral between limits |
  polynomial | Polynomial container data entry for scalars. Items are stored in a list of Tuple2's. Data is input in the form, e.g. for an entry <entryName> that describes y = x^2 + 2x^3 |
  Table | Templated table container data entry. Items are stored in a list of Tuple2's. First column is always stored as scalar entries. Data is read in the form, e.g. for an entry <entryName> that is (scalar, vector): |
  DispersionModel | |
  DispersionRASModel | |
  GradientDispersionRAS | The velocity is perturbed in the direction of -grad(k), with a Gaussian random number distribution with variance sigma. where sigma is defined below |
  NoDispersion | Place holder for 'none' option |
  StochasticDispersionRAS | The velocity is perturbed in random direction, with a Gaussian random number distribution with variance sigma. where sigma is defined below |
  DragModel | Templated drag model class |
  NoDrag | Dummy drag model for 'none' |
  SphereDrag | Drag model based on assumption of solid spheres |
  ConeInjection | Cone injection |
  ConeInjectionMP | Cone injection multi-point |
  FieldActivatedInjection | Injection at specified positions, with the conditions: |
  InjectionModel | Templated injection model class |
  KinematicLookupTableInjection | Particle injection sources read from look-up table. Each row corresponds to an injection site |
  kinematicParcelInjectionData | Container class to provide injection data for kinematic parcels |
  ManualInjection | Manual injection |
  NoInjection | Place holder for 'none' option |
  PatchInjection | Patch injection |
  LocalInteraction | Patch interaction specified on a patch-by-patch basis |
  patchInteractionData | Helper class for the LocalInteraction patch interaction model |
  PatchInteractionModel | Templated patch interaction model class |
  Rebound | Simple rebound patch interaction model |
  StandardWallInteraction | Wall interaction model. Three choices: |
  NoPostProcessing | Place holder for 'none' option |
  PatchPostProcessing | Standard post-processing |
  PostProcessingModel | Templated post-processing model class |
  CompositionModel | Templated reacting parcel composition model class Consists of carrier species (via thermo package), and additional liquids and solids |
  SingleMixtureFraction | Templated parcel multi-phase, multi-component class |
  SinglePhaseMixture | Templated parcel single phase, multi-component class |
  ReactingLookupTableInjection | Particle injection sources read from look-up table. Each row corresponds to an injection site |
  reactingParcelInjectionData | Container class to provide injection data for reacting parcels |
  LiquidEvaporation | Liquid evaporation model |
  NoPhaseChange | Dummy phase change model for 'none' |
  PhaseChangeModel | Templated phase change model class |
  ConstantRateDevolatilisation | Constant rate devolatisation model |
  DevolatilisationModel | Templated devolatilisation model class |
  NoDevolatilisation | Dummy devolatilisation model for 'none' |
  SingleKineticRateDevolatilisation | Single kinetic rate devolatisation model |
  ReactingMultiphaseLookupTableInjection | Particle injection sources read from look-up table. Each row corresponds to an injection site |
  reactingMultiphaseParcelInjectionData | Container class to provide injection data for reacting multiphase parcels |
  NoSurfaceReaction | Dummy surface reaction model for 'none' |
  SurfaceReactionModel | Templated surface reaction model class |
  HeatTransferModel | Templated heat transfer model class |
  NoHeatTransfer | Dummy heat transfer model for 'none' |
  ThermoLookupTableInjection | Particle injection sources read from look-up table. Each row corresponds to an injection site |
  thermoParcelInjectionData | Container class to provide injection data for thermodynamic parcels |
  bufferedAccumulator | |
  correlationFunction | |
  distribution | |
  directInteractionList | |
  interactionLists | |
  receivingReferralList | |
  sendingReferralList | |
  referredCell | |
  referredCellList | |
  referredMolecule | |
  molecule | Foam::molecule |
   constantProperties | Class to hold molecule constant properties |
   trackData | Class used to pass tracking data to the trackToFace function |
  moleculeCloud | |
  reducedUnits | |
  electrostaticPotential | |
  energyScalingFunction | |
  pairPotential | |
  pairPotentialList | |
  potential | |
  tetherPotential | |
  tetherPotentialList | |
  solidParticle | Simple solid spherical particle class with one-way coupling with the continuous phase |
   trackData | Class used to pass tracking data to the trackToFace function |
  solidParticleCloud | A Cloud of solid particles |
  cellClassification | 'Cuts' a mesh with a surface |
  cellInfo | Holds information regarding type of cell. Used in inside/outside determination in cellClassification |
  cellDistFuncs | Collection of functions used in wall distance calculation |
  patchDataWave | Takes a set of patches to start MeshWave from |
  patchWave | Takes a set of patches to start MeshWave from. After construction holds distance at cells and distance at patches. Is e.g. used by wallDist to construct volScalarField with correct distance to wall |
  wallPoint | Holds information regarding nearest wall point. Used in wall distance calculation |
  wallPointData | Holds information (coordinate and normal) regarding nearest wall point |
  cellFeatures | Cell analysis class |
  cellQuality | Class calculates cell quality measures |
  coordinateRotation | A coordinate rotation specified per local axes and the base class for other rotation specifications |
  EulerCoordinateRotation | A coordinateRotation defined in the z-x-y Euler convention |
  STARCDCoordinateRotation | A coordinateRotation defined by the STAR-CD convention |
  coordinateSystem | A cartesian coordinate system and the base class for other coordinate system specifications |
  coordinateSystems | Provides a centralized coordinateSystem collection |
  cylindricalCS | Cylindrical coordinate system |
  parabolicCylindricalCS | Parabolic cylindrical coordinate system |
  sphericalCS | Spherical coordinate system |
  toroidalCS | Toroidal coordinate system, always in degrees |
  directMappedPointPatch | DirectMapped patch |
  directMappedWallPointPatch | DirectMapped patch |
  directMappedPatchBase | Determines a mapping between patch face centres and mesh cell or face centres and processors they're on |
   nearestEqOp | |
  directMappedPolyPatch | Determines a mapping between patch face centres and mesh cell or face centres and processors they're on |
  directMappedWallPolyPatch | Determines a mapping between patch face centres and mesh cell or face centres and processors they're on |
  edgeFaceCirculator | Walks from starting face around edge |
  indexedOctree | Non-pointer based hierarchical recursive searching |
   node | |
  labelBits | A 29bits label and 3bits direction packed into single label |
  treeDataCell | Encapsulation of data needed to search in/for cells. Used to find the cell containing a point (e.g. cell-cell mapping) |
  treeDataEdge | Holds data for octree to work on an edges subset |
  treeDataFace | Encapsulation of data needed to search for faces |
  treeDataPoint | Holds (reference to) pointField. Encapsulation of data needed for octree searches. Used for searching for nearest point. No bounding boxes around points. Only overlaps and calcNearest are implemented, rest makes little sense |
  treeDataTriSurface | Encapsulates data for (indexedOc)tree searches on triSurface |
  meshSearch | Various (local, not parallel) searches on polyMesh; uses (demand driven) octree to search |
  octree | Octree, templated on type of shapes it refers to |
   const_iterator | An STL const_iterator for octree |
   iterator | An STL iterator for octree |
  octreeDataCell | Encapsulation of data needed to search in/for cells |
  octreeDataEdges | Holds data for octree to work on an edges subset |
  octreeDataFace | Holds data for octree to work on mesh faces |
  octreeDataPoint | Encapsulation of data needed for octree searches |
  octreeLine | Iterates over intersections of line with octree leaf elements |
  pointHitSort | Container for sorting intersections |
  PointIndexHit | This class describes the interaction of (usually) a face and a point. It carries the info of a successful hit and (if successful), returns the interaction point |
  treeBoundBox | Standard boundBox + extra functionality for use in octree |
  treeElem | Common functionality of treeNode and treeLeaf |
  treeLeaf | An octree treeLeaf |
  treeNode | Class to implement octree |
  pointEdgePoint | Holds information regarding nearest wall point. Used in pointEdgeWave. (so not standard meshWave) To be used in wall distance calculation |
  PointEdgeWave | Wave propagation of information through grid. Every iteration information goes through one layer of edges. Templated on information that is transferred |
  listUpdateOp | List update operation |
  primitiveMeshGeometry | Updateable mesh geometry + checking routines |
  regionSplit | This class separates the mesh into distinct unconnected regions, each of which is then given a label |
  distributedTriSurfaceMesh | IOoject and searching on distributed triSurface. All processor hold (possibly overlapping) part of the overall surface. All queries are distributed to the processor that can answer it and the result sent back |
  searchableBox | Searching on bounding box |
  searchableCylinder | Searching on cylinder |
  searchablePlane | Searching on (infinite) plane. See plane.H |
  searchablePlate | Searching on finite plate. Plate has to be aligned with coordinate axes. Plate defined as origin and span. One of the components of span has to be 0 which defines the normal direction. E.g |
  searchableSphere | Searching on sphere |
  searchableSurface | Base class of (analytical or triangulated) surface. Encapsulates all the search routines. WIP |
   iNew | Class used for the read-construction of |
  searchableSurfaceCollection | Set of transformed searchableSurfaces. Does not do boolean operations. So when meshing might find parts 'inside' |
  searchableSurfaces | Container for searchableSurfaces |
  searchableSurfacesQueries | A collection of tools for searchableSurfaces |
  searchableSurfaceWithGaps | SearchableSurface using multiple slightly shifted underlying surfaces to make sure pierces don't go through gaps: |
  triSurfaceMesh | IOoject and searching on triSurface |
  boxToCell | A topoSetSource to select cells based on cell centres inside box |
  cellToCell | A topoSetSource to select the cells from another cellSet |
  cylinderAnnulusToCell | A topoSetSource to select cells based on cell centres inside a cylinder annulus |
  cylinderToCell | A topoSetSource to select cells based on cell centres inside a cylinder |
  faceToCell | A topoSetSource to select cells based on usage in faces |
  faceZoneToCell | A topoSetSource to select cells based on side of faceZone |
  fieldToCell | A topoSetSource to select cells based on field values |
  labelToCell | A topoSetSource to select cells based on explicitly given labels |
  nbrToCell | A topoSetSource to select cells based on number of neighbouring cells (i.e. number of internal or coupled faces) |
  nearestToCell | A topoSetSource to select cells nearest to points |
  pointToCell | A topoSetSource to select cells based on usage of points |
  regionToCell | TopoSetSource. Select cells belonging to topological connected region (that contains given point) |
  rotatedBoxToCell | A topoSetSource to select cells based on cell centres inside rotated/skewed box (parallelopiped?) |
  shapeToCell | A topoSetSource to select cells based on cell shape |
  sphereToCell | A topoSetSource to select cells based on cell centres inside sphere |
  surfaceToCell | A topoSetSource to select cells based on relation to surface |
  zoneToCell | A topoSetSource to select faces based on cellZone |
  setToCellZone | A topoSetSource to select cells based on usage in a cellSet |
  boundaryToFace | A topoSetSource to select all external (boundary) faces |
  boxToFace | A topoSetSource to select faces based on face centres inside box |
  cellToFace | A topoSetSource to select a faceSet from cells |
  faceToFace | A topoSetSource to select faces based on usage in another faceSet |
  labelToFace | A topoSetSource to select faces given explicitly provided face labels |
  normalToFace | A topoSetSource to select faces based on normal |
  patchToFace | A topoSetSource to select faces based on usage in patches |
  pointToFace | A topoSetSource to select faces based on use of points |
  zoneToFace | A topoSetSource to select faces based on faceZone |
  faceZoneToFaceZone | A topoSetSource to select faces based on usage in another faceSet |
  setsToFaceZone | A topoSetSource to select faces based on usage in a faceSet and cellSet |
  setToFaceZone | A topoSetSource to select faces based on usage in a faceSet. Sets flipMap to true |
  boxToPoint | A topoSetSource to select points based on whether they are inside box |
  cellToPoint | A topoSetSource to select points based on usage in cells |
  faceToPoint | A topoSetSource to select points based on usage in faces |
  labelToPoint | A topoSetSource to select points given explicitly provided labels |
  nearestToPoint | A topoSetSource to select points nearest to points |
  pointToPoint | A topoSetSource to select points based on usage in pointSet |
  surfaceToPoint | A topoSetSource to selects points based on relation to surface |
  zoneToPoint | A topoSetSource to select points based on pointZone |
  setToPointZone | A topoSetSource to select points based on usage in a pointSet |
  cellSet | A collection of cell labels |
  cellZoneSet | Like cellSet but updates cellZone when writing |
  faceSet | A list of face labels |
  faceZoneSet | Like faceSet but updates faceZone when writing |
  pointSet | A set of point labels |
  pointZoneSet | Like pointSet but updates pointZone when writing |
  topoSet | General set of labels of mesh quantity (points, cells, faces) |
  topoSetSource | Base class of a source for a topoSet |
   addToUsageTable | Class with constructor to add usage string to table |
   iNew | Class used for the read-construction of |
  surfaceSets | Various utilities to handle sets relating mesh to surface. Note: work in progress. Used in meshing tools |
  booleanSurface | Surface-surface intersection. Given two surfaces construct combined surface |
  edgeSurface | Description of surface in form of 'cloud of edges' |
  intersectedSurface | Given triSurface and intersection creates the intersected (properly triangulated) surface. (note: intersection is the list of points and edges 'shared' by two surfaces) |
  edgeIntersections | Holder of intersections of edges of a surface with another surface. Optionally shuffles around points on surface to resolve any 'conflicts' (edge hitting triangle edge, edge hitting point etc.) |
  surfaceIntersection | Basic surface-surface intersection description. Constructed from two surfaces it creates a description of the intersection |
  octreeDataTriSurface | Encapsulates data for octree searches on triSurface |
  orientedSurface | Given point flip all faces such that normals point in same direction |
  surfaceFeatures | Holds feature edges/points of surface |
  surfaceLocation | Contains information about location on a triSurface: |
  triangleFuncs | Various triangle functions |
  triSurfaceSearch | Helper class to search on triSurface |
  triSurfaceTools | A collection of tools for triSurfaceMesh |
  twoDPointCorrector | Class applies a two-dimensional correction to mesh motion point field |
  ODE | Abstract base class for the ODE solvers |
  KRR4 | Foam::KRR4 |
  ODESolver | Selection for ODE solver |
  RK | Foam::RK |
  SIBS | Foam::SIBS |
  FaceCellWave | Wave propagation of information through grid. Every iteration information goes through one layer of cells. Templated on information that is transferred |
  MeshWave | FaceCellWave plus data |
  subCycle | Perform a subCycleTime on a field |
  Dictionary | Gerneral purpose template dictionary class which manages the storage associated with it |
  DictionaryBase | Base dictionary class templated on both the form of doubly-linked list it uses as well as the type it holds |
  PtrDictionary | Template dictionary class which does not manages the storage associated with it |
  UDictionary | Template dictionary class which does not manages the storage associated with it |
  UPtrDictionary | Template dictionary class which does not manages the storage associated with it |
  HashPtrTable | A HashTable specialization for hashing pointers |
  HashSet | A HashTable with keys but without contents |
  HashTable | An STL-conforming hash table |
   const_iterator | An STL-conforming const_iterator |
   iterator | An STL-conforming iterator |
  Map | A HashTable to objects of type <T> with a label key |
  PtrMap | A HashTable of pointers to objects of type <T> with a label key |
  StaticHashTable | STL conforming hash table |
   Iterator | An STL iterator |
  Keyed | A container with an integer key attached to any item |
  ILList | Template class for intrusive linked lists |
  LList | Template class for non-intrusive linked lists |
   const_iterator | An STL-conforming const_iterator |
   iterator | An STL-conforming iterator |
   link | Link structure |
  LPtrList | Template class for non-intrusive linked PtrLists |
   const_iterator | An STL-conforming const_iterator |
   iterator | An STL-conforming iterator |
  UILList | Template class for intrusive linked lists |
   const_iterator | An STL-conforming const_iterator |
   iterator | An STL-conforming iterator |
  DLListBase | Base doubly-linked list |
   const_iterator | An STL-conforming const_iterator |
   iterator | An STL-conforming iterator |
   link | Link structure |
  SLListBase | Base singly-linked list |
   const_iterator | An STL-conforming const_iterator |
   iterator | An STL-conforming iterator |
   link | Link structure |
  DLList | Non-intrusive doubly-linked list |
  DLPtrList | Non-intrusive doubly-linked pointer list |
  FIFOStack | A FIFO stack based on a singly-linked list. Operations are push(), pop(), top(), bottom() and empty() |
  IDLList | Intrusive doubly-linked list |
  ISLList | Intrusive singly-linked list |
  LIFOStack | A LIFO stack based on a singly-linked list. Operations are push(), pop(), top(), bottom() and empty() |
  SLList | Non-intrusive singly-linked list |
  SLPtrList | Non-intrusive singly-linked pointer list |
  UIDLList | Intrusive doubly-linked list |
  BiIndirectList | Indexes into negList (negative index) or posList (zero or positive index) |
  CompactListList | A packed storage unstructured matrix of objects of type <T> using an offset table for access |
  DynamicList | A 1D vector of objects of type <T> that resizes itself as necessary to accept the new objects |
  FixedList | A 1D vector of objects of type <T> with a fixed size <Size> |
   Hash | Hashing function class |
  Histogram | Calculates the counts per bin of a list |
  IndirectList | A List with indirect addressing |
  List | A 1D array of objects of type <T>, where the size of the vector is known and used for subscript bounds checking, etc |
  accessOp | |
  offsetOp | |
  PackedList | A dynamically allocatable list of packed unsigned integers |
   const_iterator | The const_iterator for PackedList |
   iterator | Used for PackedList |
   iteratorBase | The iterator base for PackedList |
  PtrList | A templated 1D list of pointers to objects of type <T>, where the size of the array is known and used for subscript bounds checking, etc |
   iterator | An STL-conforming iterator |
  ParSortableList | Implementation of PSRS parallel sorting routine |
  SortableList | A list that is sorted upon construction or when explicitly requested with the sort() method |
  SubList | A List obtained as a section of another List |
  UIndirectList | A List with indirect addressing. Like IndirectList but does not store addressing |
  UList | A 1D vector of objects of type <T>, where the size of the vector is known and can be used for subscript bounds checking, etc |
   less | Less function class that can be used for sorting |
  UPtrList | A 1D array of pointers to objects of type <T>, where the size of the array is known and used for subscript bounds checking, etc |
   iterator | An STL iterator |
  NamedEnum | Initialise the NamedEnum HashTable from the static list of names |
  Callback | Abstract class to handle automatic call-back registration with the CallbackRegistry. Derive from this class and extend by adding the appropriate callback functions |
  CallbackRegistry | Base class with which callbacks are registered |
  dictionaryName | |
  dictionary | A list of keyword definitions, which are a keyword followed by any number of values (e.g. words and numbers). The keywords can represent patterns which are matched using Posix regular expressions. The general order for searching is as follows: |
  dictionaryEntry | A keyword and a list of tokens is a 'dictionaryEntry' |
  entry | A keyword and a list of tokens is an 'entry' |
  functionEntry | A functionEntry causes entries to be added/manipulated on the specified dictionary given an input stream |
  primitiveEntry | A keyword and a list of tokens is a 'primitiveEntry'. An primitiveEntry can be read, written and printed, and the types and values of its tokens analysed |
  dlLibraryTable | A table of dynamically loaded libraries |
   readDlLibrary | Class whose construction causes the reading of dynamic libraries |
  error | Class to handle errors and exceptions in a simple, consistent stream-based manner |
  IOerror | Report an I/O error |
  errorManip | Error stream manipulators for exit and abort which may terminate the program or throw an exception depending if the exception handling has been switched on (off by default) |
  errorManipArg | ErrorManipArg |
  messageStream | Class to handle messaging in a simple, consistent stream-based manner |
  StaticAssertionFailed< true > | Specialization for successful assertions |
  StaticAssertionTest | Helper class for handling static assertions |
  functionObject | Abstract base-class for Time/database function objects |
   iNew | Return a pointer to a new functionObject created on freestore |
  functionObjectList | List of function objects with start(), execute() and end() functions that is called for each object |
  IOOutputFilter | IOdictionary wrapper around OutputFilter to allow them to read from their associated dictionaries |
  OutputFilterFunctionObject | A functionObject wrapper around OutputFilter to allow them to be created via the functions list within controlDict |
  outputFilterOutputControl | |
  IOobject | IOobject defines the attributes of an object for which implicit objectRegistry management is supported, and provides the infrastructure for performing stream I/O |
  IOobjectList | List of IOobjects with searching and retrieving facilities |
  IOdictionary | IOdictionary is derived from dictionary and IOobject to give the dictionary automatic IO functionality via the objectRegistry. To facilitate IO, IOdictioanry is provided with a constructor from IOobject and writeData and write functions |
  IOField | A primitive field of type <T> with automated input and output |
  IOList | A List of objects of type <T> with automated input and output |
  IOMap | A Map of objects of type <T> with automated input and output |
  IOPtrList | A PtrList of objects of type <T> with automated input and output |
  IFstreamAllocator | A std::istream with ability to handle compressed files |
  IFstream | Input from file stream |
  OFstreamAllocator | A std::ostream with ability to handle compressed files |
  OFstream | Output to file stream |
  sha1streambuf | A streambuf class for calculating SHA1 digests |
  osha1stream | A basic output stream for calculating SHA1 digests |
  OSHA1stream | The output stream for calculating SHA1 digests |
  INew | A helper class when constructing from an Istream |
  InfoProxy | A helper class for outputting values to Ostream |
  Smanip | |
  Imanip | |
  Omanip | |
  IOstream | An IOstream is an abstract base class for all input/output systems; be they streams, files, token lists etc |
   versionNumber | Version number type |
  Istream | An Istream is an abstract base class for all input systems (streams, files, token lists etc). The basic operations are construct, close, read token, read primitive and read binary block |
  Ostream | An Ostream is an abstract base class for all output systems (streams, files, token lists, etc) |
  IPstream | Input inter-processor communications stream |
  IPstreamImpl | Abstract base class for IPstream operations that depend on the parallel library used. Foam::IPstreamImpl::New will lookup the entry "PstreamImplementation" in the global controlDict file (i.e. the one found by Foam::dotFoam) and tries to first load a library named lib<PstreamImplementation>Pstream.so, and then instantiate the class <PstreamImplementation>IPstreamImpl |
  OPstream | Output inter-processor communications stream |
  OPstreamImpl | Abstract base class for OPstream operations that depend on the parallel library used. Foam::OPstreamImpl::New will lookup the entry "PstreamImplementation" in the global controlDict file (i.e. the one found by Foam::dotFoam) and tries to first load a library named lib<PstreamImplementation>Pstream.so, and then instantiate the class <PstreamImplementation>OPstreamImpl |
  Pstream | Inter-processor communications stream |
   commsStruct | Structure for communicating between processors |
  PstreamImpl | Abstract base class for Pstream operations that depend on the parallel library used. Foam::PstreamImpl::New will lookup the entry "PstreamImplementation" in the global controlDict file (i.e. the one found by Foam::dotFoam) and tries to first load a library named lib<PstreamImplementation>Pstream.so, and then instantiate the class <PstreamImplementation>PstreamImpl |
  ISstream | Generic input stream |
  OSstream | Generic output stream |
  prefixOSstream | Version of OSstream which prints a prefix on each line |
  IStringStream | Input from memory buffer stream |
  OStringStream | Output to memory buffer stream |
  CompoundToken | An abstract base class for managing compound tokens |
  token | A token holds items read from Istream |
   Compound | A templated class for holding compound tokens |
   compound | Abstract base class for complex tokens |
  ITstream | Input token stream |
  objectRegistry | Registry of regIOobjects |
  regIOobject | RegIOobject is an abstract class derived from IOobject to handle automatic object registration with the objectRegistry |
  scalarRange | A scalar range specifier |
  scalarRanges | A List of scalarRange |
  instant | An instant of time. Contains the time value and name |
   less | Less function class used in sorting instants |
  subCycleTime | A class for managing sub-cycling times |
  Time | Class to control time during OpenFOAM simulations that is also the top-level objectRegistry |
  TimePaths | A class for addressing time paths without using the Time class |
  timeSelector | A List of scalarRange for selecting times |
  TimeState | The time value with time-stepping information, user-defined remapping, etc |
  dimensioned | Generic dimensioned Type class |
  dimensionSet | Dimension set for the base types. This type may be used to implement rigorous dimension checking for algebraic manipulation |
  cloud | A cloud is a collection of lagrangian particles |
  DimensionedField | Field with dimensions and associated with geometry type GeoMesh which is used to size the field and a reference to it is maintained |
  reuseTmpDimensionedField | |
  reuseTmpDimensionedField< TypeR, TypeR, GeoMesh > | |
  reuseTmpTmpDimensionedField | |
  reuseTmpTmpDimensionedField< TypeR, Type1, Type12, TypeR, GeoMesh > | |
  reuseTmpTmpDimensionedField< TypeR, TypeR, TypeR, Type2, GeoMesh > | |
  reuseTmpTmpDimensionedField< TypeR, TypeR, TypeR, TypeR, GeoMesh > | |
  SubDimensionedField | SubDimensionedField is a DimensionedField obtained as a section of another DimensionedField |
  FieldField | Generic field type |
  reuseTmpFieldField | |
  reuseTmpFieldField< Field, TypeR, TypeR > | |
  reuseTmpTmpFieldField | |
  reuseTmpTmpFieldField< Field, TypeR, Type1, Type12, TypeR > | |
  reuseTmpTmpFieldField< Field, TypeR, TypeR, TypeR, Type2 > | |
  reuseTmpTmpFieldField< Field, TypeR, TypeR, TypeR, TypeR > | |
  oneFieldField | A class representing the concept of a field of oneFields used to avoid unnecessary manipulations for objects which are known to be one at compile-time |
  DynamicField | Dynamically sized Field |
  Field | Generic templated field type |
  FieldMapper | Abstract base class to hold the Field mapping addressing and weights |
  reuseTmp | |
  reuseTmp< TypeR, TypeR > | |
  reuseTmpTmp | |
  reuseTmpTmp< TypeR, Type1, Type12, TypeR > | |
  reuseTmpTmp< TypeR, TypeR, TypeR, Type2 > | |
  reuseTmpTmp< TypeR, TypeR, TypeR, TypeR > | |
  SubField | SubField is a Field obtained as a section of another Field |
  oneField | A class representing the concept of a field of 1 used to avoid unnecessary manipulations for objects which are known to be one at compile-time |
  zeroField | A class representing the concept of a field of 0 used to avoid unnecessary manipulations for objects which are known to be zero at compile-time |
  GeometricField | Generic GeometricField class |
   GeometricBoundaryField | |
  reuseTmpGeometricField | |
  reuseTmpGeometricField< TypeR, TypeR, PatchField, GeoMesh > | |
  reuseTmpTmpGeometricField | |
  reuseTmpTmpGeometricField< TypeR, Type1, Type12, TypeR, PatchField, GeoMesh > | |
  reuseTmpTmpGeometricField< TypeR, TypeR, TypeR, Type2, PatchField, GeoMesh > | |
  reuseTmpTmpGeometricField< TypeR, TypeR, TypeR, TypeR, PatchField, GeoMesh > | |
  MapInternalField | Generic internal field mapper. For "real" mapping, add template specialisations for mapping of internal fields depending on mesh type |
  geometricOneField | A class representing the concept of a GeometricField of 1 used to avoid unnecessary manipulations for objects which are known to be one at compile-time |
  SlicedGeometricField | Specialization of GeometricField which holds slices of given complete fields in a form that they act as a GeometricField |
   DimensionedInternalField | The internalField of a SlicedGeometricField |
  basicSymmetryPointPatchField | A Symmetry boundary condition for pointField |
  calculatedPointPatchField | A calculated boundary condition for pointField |
  coupledPointPatchField | A Coupled boundary condition for pointField |
  fixedValuePointPatchField | A FixedValue boundary condition for pointField |
  mixedPointPatchField | A mixed FixedValue / ZeroGradient boundary condition for pointField |
  valuePointPatchField | Foam::valuePointPatchField |
  zeroGradientPointPatchField | Foam::zeroGradientPointPatchField |
  cyclicPointPatchField | Cyclic front and back plane patch field |
  emptyPointPatchField | An empty boundary condition for pointField |
  processorPointPatchField | Foam::processorPointPatchField |
  symmetryPointPatchField | A Symmetry boundary condition for pointField |
  wedgePointPatchField | Wedge front and back plane patch field |
  fixedNormalSlipPointPatchField | Slip with user-specified normal |
  globalPointPatchField | Foam::globalPointPatchField |
  slipPointPatchField | Foam::slipPointPatchField |
  timeVaryingUniformFixedValuePointPatchField | A time-varying form of a uniform fixed value boundary condition |
  uniformFixedValuePointPatchField | Foam::uniformFixedValuePointPatchField |
  pointConstraint | Accumulates point constraints through successive applications of the applyConstraint function |
  pointPatchField | Abstract base class for point-mesh patch fields |
  pointPatchFieldMapper | Foam::pointPatchFieldMapper |
  pointPatchFieldMapperPatchRef | Foam::pointPatchFieldMapperPatchRef |
  UniformDimensionedField | Dimensioned<Type> registered with the database as a registered IOobject which has the functionality of a uniform field and allows values from the top-level code to be passed to boundary conditions etc |
  argList | Extract command arguments and options from the supplied argc and argv parameters |
  ParRunControl | Helper class for initializing parallel jobs from the command arguments |
  clock | Read access to the system clock with formatting |
  JobInfo | Helper class for recording information about run/finished jobs |
  curve | A single curve in a graph |
   curveStyle | The style (line, symbol, etc) of a curve |
  graph | Class to create, store and output qgraph files |
   writer | Abstract base class for a graph writer |
  gnuplotGraph | Output in gnuplot (http://www.gnuplot.info) format |
  jplotGraph | Jplot graph output |
  rawGraph | A raw xy graph output |
  xmgrGraph | Output and agr file for xmgrace (http://plasma-gate.weizmann.ac.il/Grace/) |
  interpolationTable | A list of times and values. The time values must be positive and monotonically increasing |
  csvTableReader | |
  openFoamTableReader | Reads an interpolation table from a file - OpenFOAM-format |
  tableReader | Base class to read table data for the interpolationTable |
  PatchToPatchInterpolation | Interpolation class dealing with transfer of data between two primitivePatches |
  PrimitivePatchInterpolation | Interpolation class within a primitive patch. Allows interpolation from points to faces and vice versa |
  DiagonalMatrix | DiagonalMatrix<Type> is a 2D diagonal matrix of objects of type Type, size nxn |
  lduAddressing | The class contains the addressing required by the lduMatrix: upper, lower and losort |
  cyclicLduInterface | An abstract base class for cyclic coupled interfaces |
  lduInterface | An abstract base class for implicitly-coupled interfaces e.g. processor and cyclic patches |
  processorLduInterface | An abstract base class for processor coupled interfaces |
  cyclicLduInterfaceField | Abstract base class for cyclic coupled interfaces |
  lduInterfaceField | An abstract base class for implicitly-coupled interface fields e.g. processor and cyclic patch fields |
  processorLduInterfaceField | Abstract base class for processor coupled interfaces |
  lduScheduleEntry | Struct to hold the patch index and the initialisation flag for the patch schedule |
  lduMatrix | LduMatrix is a general matrix class in which the coefficients are stored as three arrays, one for the upper triangle, one for the lower triangle and a third for the diagonal |
   preconditioner | Abstract base-class for lduMatrix preconditioners |
   smoother | Abstract base-class for lduMatrix smoothers |
   solver | Abstract base-class for lduMatrix solvers |
   solverPerformance | Class returned by the solver, containing performance statistics |
  diagonalPreconditioner | Diagonal preconditioner for both symmetric and asymmetric matrices |
  DICPreconditioner | Simplified diagonal-based incomplete Cholesky preconditioner for symmetric matrices (symmetric equivalent of DILU). The reciprocal of the preconditioned diagonal is calculated and stored |
  DILUPreconditioner | Simplified diagonal-based incomplete LU preconditioner for asymmetric matrices. The reciprocal of the preconditioned diagonal is calculated and stored |
  FDICPreconditioner | Faster version of the DICPreconditioner diagonal-based incomplete Cholesky preconditioner for symmetric matrices (symmetric equivalent of DILU) in which the the reciprocal of the preconditioned diagonal and the upper coefficients divided by the diagonal are calculated and stored |
  GAMGPreconditioner | Geometric agglomerated algebraic multigrid preconditioner |
  noPreconditioner | Null preconditioner for both symmetric and asymmetric matrices |
  DICSmoother | Simplified diagonal-based incomplete Cholesky smoother for symmetric matrices |
  DICGaussSeidelSmoother | Combined DIC/GaussSeidel smoother for symmetric matrices in which DIC smoothing is followed by GaussSeidel to ensure that any "spikes" created by the DIC sweeps are smoothed-out |
  DILUSmoother | Simplified diagonal-based incomplete LU smoother for asymmetric matrices |
  DILUGaussSeidelSmoother | Combined DILU/GaussSeidel smoother for asymmetric matrices in which DILU smoothing is followed by GaussSeidel to ensure that any "spikes" created by the DILU sweeps are smoothed-out |
  GaussSeidelSmoother | A lduMatrix::smoother for Gauss-Seidel |
  BICCG | Diagonal incomplete LU preconditioned BiCG solver derived from the general preconditioned BiCG solver PBiCG but with the choice of preconditioner pre-selected |
  diagonalSolver | Foam::diagonalSolver |
  algebraicPairGAMGAgglomeration | Agglomerate using the pair algorithm |
  GAMGAgglomeration | Geometric agglomerated algebraic multigrid agglomeration class |
  pairGAMGAgglomeration | Agglomerate using the pair algorithm |
  GAMGSolver | Geometric agglomerated algebraic multigrid solver |
  cyclicGAMGInterfaceField | GAMG agglomerated cyclic interface field |
  GAMGInterfaceField | Abstract base class for GAMG agglomerated interface fields |
  processorGAMGInterfaceField | GAMG agglomerated processor interface field |
  cyclicGAMGInterface | GAMG agglomerated cyclic interface |
  GAMGInterface | Abstract base class for GAMG agglomerated interfaces |
  processorGAMGInterface | GAMG agglomerated processor interface |
  ICCG | Incomplete Cholesky preconditioned CG solver derived from the general preconditioned CG solver PCG but with the choice of preconditioner pre-selected |
  PBiCG | Preconditioned bi-conjugate gradient solver for asymmetric lduMatrices using a run-time selectable preconditiioner |
  PCG | Preconditioned conjugate gradient solver for symmetric lduMatrices using a run-time selectable preconditioner |
  smoothSolver | Iterative solver for symmetric and assymetric matrices which uses a run-time selected smoother e.g. GaussSeidel to converge the solution to the required tolerance |
  LUscalarMatrix | Foam::LUscalarMatrix |
  procLduInterface | Foam::procLduInterface |
  procLduMatrix | Foam::procLduMatrix |
  Matrix | A templated 2D matrix of objects of <T>, where the n x m matrix dimensions are known and used for subscript bounds checking, etc |
  RectangularMatrix | A templated 2D rectangular matrix of objects of <T>, where the n x n matrix dimension is known and used for subscript bounds checking, etc |
  SVD | Singular value decomposition of a rectangular matrix |
  simpleMatrix | A simple square matrix solver with scalar coefficients |
  solution | Selector class for relaxation factors, solver type and solution |
  SquareMatrix | A templated 2D square matrix of objects of <T>, where the n x n matrix dimension is known and used for subscript bounds checking, etc |
  tolerances | Selector class for solution tolerances |
  autoPtr | An auto-pointer similar to the STL auto_ptr but with automatic casting to a reference to the type and with pointer allocation checking on access |
  refCount | Reference counter for tmp<field> |
  tmp | A class for managing temporary objects |
  Xfer | A simple container for copying or transferring objects of type <T> |
  boundBox | A bounding box defined in terms of the points at its extremities |
  GeoMesh | Generic mesh wrapper used by volMesh, surfaceMesh, pointMesh etc |
  lduMesh | Abstract base class for meshes which provide LDU addressing for the construction of lduMatrix and LDU-solvers |
  lduPrimitiveMesh | Simplest contrete lduMesh which stores the addressing needed bu lduMatrix |
  MeshObject | Templated abstract base-class for dynamic mesh objects used to automate their allocation to the mesh database and the mesh-modifier event-loop |
  cell | A cell is defined as a list of faces with extra functionality |
  cellMatcher | Base class for cellshape matchers (hexMatch, prismMatch, etc.). These are classes which given a mesh and cell number find out the orientation of the cellShape and construct cell-vertex to mesh-vertex mapping and cell-face to mesh-face mapping |
  degenerateMatcher | Collection of all hex degenerate matchers (hex, wedge, prism etc.) Has static member function to match a shape |
  hexMatcher | A cellMatcher for hex cells |
  prismMatcher | A cellMatcher for prism cells |
  pyrMatcher | A cellMatcher for pyr cells |
  tetMatcher | A cellMatcher for tet cells |
  tetWedgeMatcher | A cellMatcher for tetWedge cells |
  wedgeMatcher | A cellMatcher for wedge cells |
  cellModel | Maps a geometry to a set of cell primitives, which enables geometric cell data to be calculated without access to the primitive geometric level. This means mapping a 3D geometry to a set of pyramids which are each described by a cell face and the cell centre point |
  cellModeller | A static collection of cell models, and a means of looking them up |
  cellShape | An analytical geometric cellShape |
  edge | An edge is a list of two point labels. The functionality it provides supports the discretisation on a 2-D flat mesh |
  EdgeMap | Map from edge (expressed as its endpoints) to value |
  face | A face is a list of labels corresponding to mesh vertices |
  oppositeFace | Class containing opposite face for a prismatic cell with addresing and a possibility of failure |
  tetCell | A tetrahedral cell primitive |
  triFace | A triangle face primitive using a FixedList |
  patchIdentifier | Identifies patch by name, patch index and physical type |
  pointBoundaryMesh | Foam::pointBoundaryMesh |
  pointMesh | Mesh representing a set of points created from polyMesh |
  MapInternalField< Type, MeshMapper, pointMesh > | |
  pointBoundaryMeshMapper | Foam::pointBoundaryMeshMapper |
  pointMapper | This object provides mapping and fill-in information for point data between the two meshes after the topological change. It is constructed from mapPolyMesh |
  pointMeshMapper | Class holds all the necessary information for mapping fields associated with pointMesh |
  pointPatchMapper | Mapping class for a pointPatchField |
  coupledPointPatch | Coupled patch for post-processing. Used as the base class for processor and cyclic pointPatches |
  genericPointPatch | DirectMapped patch |
  cyclicPointPatch | Cyclic patch for post-processing |
  emptyPointPatch | Empty plane patch |
  processorPointPatch | Processor patch boundary needs to be such that the ordering of points in the patch is the same on both sides |
  symmetryPointPatch | Symmetry-plane patch |
  wedgePointPatch | Wedge front and back plane patch |
  coupledFacePointPatch | Coupled patch for post-processing. Used as the base class for processor and cyclic pointPatches |
  globalPointPatch | Foam::globalPointPatch |
  wallPointPatch | Foam::wallPointPatch |
  facePointPatch | A pointPatch based on a polyPatch |
  pointPatch | Basic pointPatch represents a set of points from the mesh |
  globalIndex | Calculates a unique integer (label so might not have enough room - 2G max) for processor + local index. E.g |
  globalMeshData | Various mesh related information for a parallel run. Upon construction constructs all info by using parallel communication |
  globalPoints | Calculates points shared by more than two processor patches or cyclic patches |
  cellMapper | This object provides mapping and fill-in information for cell data between the two meshes after the topological change. It is constructed from mapPolyMesh |
  faceMapper | This object provides mapping and fill-in information for face data between the two meshes after the topological change. It is constructed from mapPolyMesh |
  mapAddedPolyMesh | Class containing mesh-to-mesh mapping information after a mesh addition where we add a mesh ('added mesh') to an old mesh, creating a new mesh |
  mapDistribute | Class containing processor-to-processor mapping information |
  mapDistributeLagrangian | Class containing mesh-to-mesh mapping information for particles |
  mapDistributePolyMesh | Class containing mesh-to-mesh mapping information after a mesh distribution where we send parts of meshes (using subsetting) to other processors and receive and reconstruct mesh |
  mapPatchChange | Class containing mesh-to-mesh mapping information after a patch change operation |
  mapPolyMesh | Class containing mesh-to-mesh mapping information after a change in polyMesh topology |
  mapSubsetMesh | Class containing mesh-to-mesh mapping information after a subset operation |
  morphFieldMapper | Abstract base class to hold the Field mapping for mesh morphs |
  objectMap | An objectMap is a pair of labels defining the mapping of an object from another object, e.g. a cell mapped from a point |
  polyBoundaryMesh | Foam::polyBoundaryMesh |
  polyBoundaryMeshEntries | Foam::polyBoundaryMeshEntries |
  polyMesh | Mesh consisting of general polyhedral cells |
  coupledPolyPatch | The coupledPolyPatch is an abstract base class for patches that couple regions of the computational domain e.g. cyclic and processor-processor links |
  genericPolyPatch | Determines a mapping between patch face centres and mesh cell centres and processors they're on |
  cyclicPolyPatch | Cyclic plane patch |
  emptyPolyPatch | Empty front and back plane patch. Used for 2-D geometries |
  processorPolyPatch | Neighbour processor patch |
  symmetryPolyPatch | Symmetry-plane patch |
  wedgePolyPatch | Wedge front and back plane patch |
  wallPolyPatch | Foam::wallPolyPatch |
  polyPatch | A patch is a list of labels that address the faces in the global face list |
  syncTools | Various tools to aid synchronizing lists across coupled patches |
  cellZone | A subset of mesh cells |
  faceZone | A subset of mesh faces organised as a primitive patch |
  pointZone | A subset of mesh points. The labels of points in the zone can be obtained from the addressing() list |
  polyPatchID | A class holds the data needed to identify a patch in a dynamic mesh |
  ZoneID | A class that holds the data needed to identify a zone in a dynamic mesh |
  ZoneMesh | List of mesh zones |
  PatchTools | A collection of tools for searching, sorting PrimitivePatch information |
  primitiveMesh | Cell-face mesh analysis engine |
  patchZones | Calculates zone number for every face of patch |
  walkPatch | Collection of static functions to do various simple patch related things |
  PrimitivePatch | A list of faces which address into the list of points |
  line | A line primitive |
  objectHit | This class describes a combination of target object index and success flag |
  PointHit | This class describes the interaction of a face and a point. It carries the info of a successful hit and (if successful), returns the interaction point |
  plane | Geometric class that creates a 2D plane and can return the intersection point between a line and the plane |
   ray | A direction and a reference point |
  pyramid | A geometric pyramid primitive with a base of 'n' sides: i.e. a parametric pyramid. A pyramid is constructed from a base polygon and an apex point |
  tetrahedron | A tetrahedron primitive |
  intersection | Foam::intersection |
  triangle | A triangle primitive used to calculate face normals and swept volumes |
  commSchedule | Determines the order in which a set of processors should communicate with one another |
  ProcessorTopology | Determines processor-processor connection. After instantiation contains on all processors the processor-processor connection table |
  pTraits< bool > | |
  Switch | A simple wrapper around bool so that it can be read as a word: true/false, on/off, yes/no or y/n or none |
  complex | Extension to the c++ complex library type |
  DiagTensor | Templated 3D DiagTensor derived from VectorSpace |
  Polynomial | Polynomial templated on size (order): |
  Hash | Hash function class for primitives. All non-primitives used to hash entries on hash tables likely need a specialized version of this class |
  Hash< void * > | Hash specialization for hashing pointer addresses |
  Hash< Foam::label > | Hash specialization for hashing labels |
  SHA1 | Functions to compute SHA1 message digest according to the NIST specification FIPS-180-1 |
  SHA1Digest | The SHA1 message digest |
  pTraits< label > | Template specialization for pTraits<label> |
  pTraits< uLabel > | Template specialization for pTraits<uLabel> |
  wordReListMatcher | A wrapper for matching a List of wordRe |
  nil | A zero-sized class without any storage. Used, for example, in HashSet |
  one | A class representing the concept of 1 (scalar(1.0)) used to avoid unnecessary manipulations for objects which are known to be one at compile-time |
  eqOp2 | |
  eqOp | |
  plusEqOp2 | |
  plusEqOp | |
  minusEqOp2 | |
  minusEqOp | |
  multiplyEqOp2 | |
  multiplyEqOp | |
  divideEqOp2 | |
  divideEqOp | |
  eqMagOp2 | |
  eqMagOp | |
  plusEqMagSqrOp2 | |
  plusEqMagSqrOp | |
  maxEqOp2 | |
  maxEqOp | |
  minEqOp2 | |
  minEqOp | |
  andEqOp2 | |
  andEqOp | |
  orEqOp2 | |
  orEqOp | |
  eqMinusOp2 | |
  eqMinusOp | |
  sumOp3 | |
  sumOp2 | |
  sumOp | |
  plusOp3 | |
  plusOp2 | |
  plusOp | |
  minusOp3 | |
  minusOp2 | |
  minusOp | |
  multiplyOp3 | |
  multiplyOp2 | |
  multiplyOp | |
  divideOp3 | |
  divideOp2 | |
  divideOp | |
  cmptMultiplyOp3 | |
  cmptMultiplyOp2 | |
  cmptMultiplyOp | |
  cmptDivideOp3 | |
  cmptDivideOp2 | |
  cmptDivideOp | |
  stabiliseOp3 | |
  stabiliseOp2 | |
  stabiliseOp | |
  maxOp3 | |
  maxOp2 | |
  maxOp | |
  minOp3 | |
  minOp2 | |
  minOp | |
  minModOp3 | |
  minModOp2 | |
  minModOp | |
  andOp3 | |
  andOp2 | |
  andOp | |
  orOp3 | |
  orOp2 | |
  orOp | |
  eqEqOp3 | |
  eqEqOp2 | |
  eqEqOp | |
  Pair | An ordered pair of two objects of type <T> with first() and second() elements |
  pTraits | Traits class for primitives |
  quaternion | Quaternion class used to perform rotations in 3D space |
  Random | Simple random number generator |
  typeOfRank< Cmpt, 0 > | |
  symmTypeOfRank< Cmpt, 0 > | |
  septernion | Septernion class used to perform translations and rotations in 3D space |
  SphericalTensor | Templated 3D SphericalTensor derived from VectorSpace adding construction from 1 component, element access using th ii() member function and the inner-product (dot-product) and outer-product operators |
  outerProduct< SphericalTensor< Cmpt >, Cmpt > | |
  outerProduct< Cmpt, SphericalTensor< Cmpt > > | |
  innerProduct< SphericalTensor< Cmpt >, SphericalTensor< Cmpt > > | |
  innerProduct< SphericalTensor< Cmpt >, Vector< Cmpt > > | |
  innerProduct< Vector< Cmpt >, SphericalTensor< Cmpt > > | |
  SphericalTensor2D | Templated 2D sphericalTensor derived from VectorSpace adding construction from 1 component, element access using ii() member function and the inner-product (dot-product) and outer-product operators |
  outerProduct< SphericalTensor2D< Cmpt >, Cmpt > | |
  outerProduct< Cmpt, SphericalTensor2D< Cmpt > > | |
  innerProduct< SphericalTensor2D< Cmpt >, SphericalTensor2D< Cmpt > > | |
  innerProduct< SphericalTensor2D< Cmpt >, Vector2D< Cmpt > > | |
  innerProduct< Vector2D< Cmpt >, SphericalTensor2D< Cmpt > > | |
  fileName | A class for handling file names |
  keyType | A class for handling keywords in dictionaries |
  string | A class for handling character strings derived from std::string |
   hash | Hashing function class, shared by all the derived classes |
  word | A class for handling words, derived from string |
  wordRe | A wordRe is a word, but can also have a regular expression for matching words |
  SymmTensor | Templated 3D symmetric tensor derived from VectorSpace adding construction from 6 components, element access using xx(), xy() etc. member functions and the inner-product (dot-product) and outer-product of two Vectors (tensor-product) operators |
  symmTypeOfRank< Cmpt, 2 > | |
  outerProduct< SymmTensor< Cmpt >, Cmpt > | |
  outerProduct< Cmpt, SymmTensor< Cmpt > > | |
  innerProduct< SymmTensor< Cmpt >, SymmTensor< Cmpt > > | |
  innerProduct< SymmTensor< Cmpt >, Vector< Cmpt > > | |
  innerProduct< Vector< Cmpt >, SymmTensor< Cmpt > > | |
  typeOfSum< SphericalTensor< Cmpt >, SymmTensor< Cmpt > > | |
  typeOfSum< SymmTensor< Cmpt >, SphericalTensor< Cmpt > > | |
  innerProduct< SphericalTensor< Cmpt >, SymmTensor< Cmpt > > | |
  innerProduct< SymmTensor< Cmpt >, SphericalTensor< Cmpt > > | |
  Tensor | Templated 3D tensor derived from VectorSpace adding construction from 9 components, element access using xx(), xy() etc. member functions and the inner-product (dot-product) and outer-product of two Vectors (tensor-product) operators |
  typeOfRank< Cmpt, 2 > | |
  typeOfSum< SphericalTensor< Cmpt >, Tensor< Cmpt > > | |
  typeOfSum< Tensor< Cmpt >, SphericalTensor< Cmpt > > | |
  innerProduct< SphericalTensor< Cmpt >, Tensor< Cmpt > > | |
  innerProduct< Tensor< Cmpt >, SphericalTensor< Cmpt > > | |
  typeOfSum< SymmTensor< Cmpt >, Tensor< Cmpt > > | |
  typeOfSum< Tensor< Cmpt >, SymmTensor< Cmpt > > | |
  innerProduct< SymmTensor< Cmpt >, Tensor< Cmpt > > | |
  innerProduct< Tensor< Cmpt >, SymmTensor< Cmpt > > | |
  Tensor2D | Templated 2D tensor derived from VectorSpace adding construction from 4 components, element access using xx(), xy(), yx() and yy() member functions and the iner-product (dot-product) and outer-product of two Vector2Ds (tensor-product) operators |
  typeOfSum< SphericalTensor2D< Cmpt >, Tensor2D< Cmpt > > | |
  typeOfSum< Tensor2D< Cmpt >, SphericalTensor2D< Cmpt > > | |
  innerProduct< Tensor2D< Cmpt >, Tensor2D< Cmpt > > | |
  innerProduct< SphericalTensor2D< Cmpt >, Tensor2D< Cmpt > > | |
  innerProduct< Tensor2D< Cmpt >, SphericalTensor2D< Cmpt > > | |
  innerProduct< Tensor2D< Cmpt >, Vector2D< Cmpt > > | |
  innerProduct< Vector2D< Cmpt >, Tensor2D< Cmpt > > | |
  Tuple2 | A 2-tuple |
  flux | |
  flux< scalar > | |
  Vector | Templated 3D Vector derived from VectorSpace adding construction from 3 components, element access using x(), y() and z() member functions and the inner-product (dot-product) and cross product operators |
  typeOfRank< Cmpt, 1 > | |
  symmTypeOfRank< Cmpt, 1 > | |
  Vector2D | Templated 2D Vector derived from VectorSpace adding construction from 2 components, element access using x() and y() member functions and the inner-product (dot-product) |
  typeOfRank | |
  symmTypeOfRank | |
  typeOfSum | |
  outerProduct | |
  crossProduct | |
  innerProduct | |
  scalarProduct | |
  powProduct | |
  VectorSpace | Templated vector space |
  zero | A class representing the concept of 0 used to avoid unnecessary manipulations for objects that are known to be zero at compile-time |
  clockTime | Starts timing (using rtc) and returns elapsed time from start. Better resolution (2uSec instead of ~20mSec) than cpuTime |
  cpuTime | Starts timing CPU usage and return elapsed time from start |
  sigFpe | Set up trapping for floating point exceptions (signal FPE) |
  sigInt | Signal handler for INT interupt |
  sigQuit | Signal handler for QUIT interupt |
  sigSegv | Signal handler for SEGV interupt |
  clockTimeImpl | Starts timing (using rtc) and returns elapsed time from start. Better resolution (2uSec instead of ~20mSec) than cpuTime |
  cpuTimeImpl | Starts timing CPU usage and return elapsed time from start |
  fileStat | Wrapper for stat() system call |
  regExp | Wrapper around POSIX extended regular expressions |
  sigFpeImpl | Set up trapping for floating point exceptions (signal FPE) |
  sigIntImpl | Signal handler for INT interupt |
  sigQuitImpl | Signal handler for QUIT interupt |
  sigSegvImpl | Signal handler for SEGV interupt |
  timer | Implements a timeout mechanism via sigalarm |
  calcType | Base class for post-processing calculation functions |
  fieldAverage | Calculates the field averages given list of fieldAverageItems, e.g |
  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: |
  fieldMinMax | Calculates scalar minimim and maximum field values |
  fieldValue | Base class for field value -based function objects |
  readFields | Reads fields from the time folders and adds them to the mesh database for further post-processing |
  surfaceInterpolateFields | Reads fields from the time folders and adds them to the mesh database for further post-processing |
  forceCoeffs | Derived from the forces function object, creates a specialisation to calculate lift and drag forces |
  forces | Calculates the forces and moments by integrating the pressure and skin-friction forces over a given list of patches |
   sumOp | Sum operation class to accumulate the pressure, viscous forces and moments |
  sixDoFRigidBodyDisplacementPointPatchVectorField | Foam::sixDoFRigidBodyDisplacementPointPatchVectorField |
  sixDoFRigidBodyMotion | Six degree of freedom motion for a rigid body. Angular momentum stored in body fixed reference frame. Reference orientation of the body (where Q = I) must align with the cartesian axes such that the Inertia tensor is in principle component form |
  sixDoFRigidBodyMotionConstraint | Base class for defining constraints for sixDoF motions |
  sixDoFRigidBodyMotionRestraint | Base class for defining restraints for sixDoF motions |
  sixDoFRigidBodyMotionState | Holds the motion state of sixDoF object. Wrapped up together to allow rapid scatter to other processors. The processors must all maintain exactly the same state data to avoid any drift or inconsistency |
  uncoupledSixDoFRigidBodyDisplacementPointPatchVectorField | Foam::uncoupledSixDoFRigidBodyDisplacementPointPatchVectorField |
  partialWrite | Allows some fields/registered objects to be written more often than others |
  writeRegisteredObject | Takes over the writing of registered IO objects |
  systemCall | Executes system calls, entered in the form of a string list |
  dsmcFields | Calculate intensive fields: |
  staticPressure | Converts kinematic pressure to static pressure, from the name of the pressure field, and density, i.e |
  dummyIPstreamImpl | Dummy implementation of the IPstreamImpl abstract base class |
  dummyOPstreamImpl | Dummy implementation of the OPstreamImpl abstract base class |
  dummyPstreamImpl | Dummy implementation of the PstreamImpl abstract base class |
  mpiIPstreamImpl | MPI implementation of the IPstreamImpl abstract base class |
  mpiOPstreamImpl | MPI implementation of the OPstreamImpl abstract base class |
  mpiPstreamImpl | MPI implementation of the PstreamImpl abstract base class |
  fft | Fast fourier transform derived from the Numerical Recipes in C routine |
  Kmesh | Calculate the wavenumber vector field corresponding to the space vector field of a finite volume mesh; |
  noiseFFT | FFT of the pressure field |
  UOprocess | Random UO process |
  turbGen | Generate a turbulent velocity field conforming to a given energy spectrum and being divergence free |
  cuttingPlane | Constructs plane through mesh |
  meshToMesh | Mesh to mesh interpolation class |
   patchFieldInterpolator | Patch-field interpolation class |
  patchProbes | Set of locations to sample.at patches |
  probes | Set of locations to sample |
   fieldGroup | Class used for grouping field types |
  isNotEqOp | Comparison operator for probes class |
  cloudSet | |
  coordSet | Holds list of sampling positions |
  curveSet | |
  faceOnlySet | |
  midPointSet | |
  midPointAndFaceSet | |
  patchCloudSet | Like cloudSet but samples nearest patch face |
  sampledSet | Holds list of sampling points which is filled at construction time. Various implementations of this base class to e.g. get sampling points at uniform distance along a line (uniformSet) or directly specified (cloudSet) |
   iNew | Class used for the read-construction of |
  sampledSets | Set of sets to sample. Call sampledSets.write() to sample&write files |
  uniformSet | |
  csvSetWriter | |
  gnuplotSetWriter | |
  jplotSetWriter | |
  rawSetWriter | |
  writer | Base class for graphics format writing. Entry points are |
  xmgraceSetWriter | |
  distanceSurface | A sampledSurface defined by a distance to a surface |
  isoSurface | A surface formed by the iso value. After "Regularised Marching Tetrahedra: improved iso-surface extraction", G.M. Treece, R.W. Prager and A.H. Gee |
  isoSurfaceCell | A surface formed by the iso value. After "Polygonising A Scalar Field Using Tetrahedrons", Paul Bourke and "Regularised Marching Tetrahedra: improved iso-surface extraction", G.M. Treece, R.W. Prager and A.H. Gee |
  sampledIsoSurface | A sampledSurface defined by a surface of iso value. Always triangulated. To be used in sampleSurfaces / functionObjects. Recalculates iso surface only if time changes |
  sampledIsoSurfaceCell | A sampledSurface defined by a surface of iso value. Always triangulated. To be used in sampleSurfaces / functionObjects. Recalculates iso surface only if time changes |
  sampledCuttingPlane | A sampledSurface defined by a plane |
  sampledPatch | A sampledSurface on a patch. Non-triangulated by default |
  sampledPlane | A sampledSurface defined by a cuttingPlane. Always triangulated |
  sampledSurface | An abstract class for surfaces with sampling |
   iNew | Class used for the PtrLists read-construction |
  offsetOp< face > | Used to offset faces in Pstream::combineOffset |
  sampledSurfaces | Set of surfaces to sample |
  nearestEqOp | |
  sampledTriSurfaceMesh | A sampledSurface from a triSurfaceMesh. It samples on the points/triangles of the triSurface |
  sampledThresholdCellFaces | A sampledSurface defined by the cell faces corresponding to a threshold value |
  thresholdCellFaces | Selects the mesh cell faces specified by a threshold value. Non-triangulated by default |
  dxSurfaceWriter | |
  foamFileSurfaceWriter | A surfaceWriter for foamFiles |
  nullSurfaceWriter | |
  proxySurfaceWriter | |
  rawSurfaceWriter | |
  surfaceWriter | |
  vtkSurfaceWriter | |
  MeshedSurface | A surface geometry mesh with zone information, not to be confused with the similarly named surfaceMesh, which actually refers to the cell faces of a volume mesh |
  MeshedSurfaceIOAllocator | A helper class for storing points, faces and zones |
  MeshedSurfaceProxy | A proxy for writing MeshedSurface, UnsortedMeshedSurface and surfMesh to various file formats |
  STLpoint | A vertex point representation for STL files |
  STLtriangle | A triangle representation for STL files |
  surfaceRegistry | Wraps the normal objectRegistry with a local instance for surfaces |
  surfGeoMesh | The surfMesh GeoMesh (for holding fields) |
  surfPointGeoMesh | The surfMesh GeoMesh (for holding fields) |
  surfMesh | A surface mesh consisting of general polygon faces |
  surfZone | A surface zone on a MeshedSurface |
  surfZoneIOList | IOobject for a surfZoneList |
  surfZoneIdentifier | An identifier for a surface zone on a meshed surface |
  UnsortedMeshedSurface | A surface geometry mesh, in which the surface zone information is conveyed by the 'zoneId' associated with each face |
  barotropicCompressibilityModel | Abstract class for barotropic compressibility models |
  basicThermo | Basic thermodynamic properties |
  fixedEnthalpyFvPatchScalarField | A fixed boundary condition for enthalpy |
  fixedInternalEnergyFvPatchScalarField | A fixed boundary condition for internal energy |
  gradientEnthalpyFvPatchScalarField | Gradient boundary condition for enthalpy |
  gradientInternalEnergyFvPatchScalarField | Gradient boundary condition for internal energy |
  mixedEnthalpyFvPatchScalarField | Mixed boundary conditions for enthalpy |
  mixedInternalEnergyFvPatchScalarField | Mixed boundary conditions for internal energy |
  wallHeatTransferFvPatchScalarField | Enthalpy boundary conditions for wall heat transfer |
  basicMixture | Foam::basicMixture |
  pureMixture | Foam::pureMixture |
  basicPsiThermo | Basic thermodynamic properties based on compressibility |
  ePsiThermo | Internal energy for a mixture based on compressibility |
  hPsiThermo | Enthalpy for a mixture based on compressibility |
  hsPsiThermo | Sensible enthalpy for a mixture based on compressibility |
  basicRhoThermo | Basic thermodynamic properties based on density |
  hRhoThermo | Enthalpy for a mixture based on density |
  hsRhoThermo | Sensible enthalpy for a mixture based on density |
  basicChemistryModel | Base class for chemistry models |
  ODEChemistryModel | Extends base chemistry model by adding a thermo package, and ODE functions. Introduces chemistry equation system and evaluation of chemical source terms |
  psiChemistryModel | Chemistry model for compressibility-based thermodynamics |
  rhoChemistryModel | Chemistry model for density-based thermodynamics |
  chemistrySolver | An abstract base class for solving chemistry |
  EulerImplicit | An Euler implicit solver for chemistry |
  ode | An ODE solver for chemistry |
  sequential | Foam::sequential |
  laminarFlameSpeed | Abstract class for laminar flame speed |
  liquidMixture | A mixture of liquids |
  aC10H7CH3 | AlphaMethylNaphthalene |
  Ar | Liquid Ar |
  bC10H7CH3 | BetaMethylNaphthalene |
  C10H22 | NDecane |
  C12H26 | NDodecane |
  C13H28 | NTriDecane |
  C14H30 | NTetraDecane |
  C16H34 | NHexaDecane |
  C2H5OH | Ethanol |
  C2H6 | Ethane |
  C2H6O | DiMethylEther |
  C3H6O | Acetone |
  C3H8 | Propane |
  C4H10O | DiEthylEther |
  C6H14 | NHexane |
  C6H6 | Benzene |
  C7H16 | NHeptane |
  C7H8 | Toluene |
  C8H10 | EthylBenzene |
  C8H18 | NOctane |
  C9H20 | NNonane |
  CH3OH | Methanol |
  CH4N2O | Urea, note that some of the properties are unavailable in the literature and have been copied from water |
  H2O | Water |
  iC3H8O | Iso-propanol |
  IC8H18 | Iso-Octane |
  IDEA | The IDEA fuel is constructed by adding 30% alphaMethylNaphthalene with 70% n-decane |
  liquid | The thermophysical properties of a liquid |
  MB | Liquid nC3H7COOCH3 or (MB) methyl butyrate (used for biodiesel surrogate) |
  N2 | Liquid N2 |
  nC3H8O | Propanol |
  MarshakRadiationFvPatchScalarField | Marshak boundary for radiation G field |
  MarshakRadiationFixedTMixedFvPatchScalarField | Marshak boundary for radiation G field |
  interpolationLookUpTable | A list of lists. Interpolates based on the first dimension. The values must be positive and monotonically increasing in each dimension |
  chemistryReader | Abstract class for reading chemistry |
  chemkinReader | Foam::chemkinReader |
   specieElement | Species element |
  foamChemistryReader | Chemistry reader for OpenFOAM format |
  hCombustionThermo | Foam::hCombustionThermo |
  hhuCombustionThermo | Foam::hhuCombustionThermo |
  hsCombustionThermo | Sensible enthalpy variant of combustionThermo |
  hhuMixtureThermo | Foam::hhuMixtureThermo |
  hPsiMixtureThermo | Foam::hPsiMixtureThermo |
  hsPsiMixtureThermo | Foam::hsPsiMixtureThermo |
  fixedUnburntEnthalpyFvPatchScalarField | Fixed boundary condition for unburnt |
  gradientUnburntEnthalpyFvPatchScalarField | Gradient boundary condition for unburnt |
  mixedUnburntEnthalpyFvPatchScalarField | Mixed boundary condition for unburnt |
  basicMultiComponentMixture | Combustion mixture |
  dieselMixture | Foam::dieselMixture |
  egrMixture | Foam::egrMixture |
  homogeneousMixture | Foam::homogeneousMixture |
  inhomogeneousMixture | Foam::inhomogeneousMixture |
  multiComponentMixture | Foam::multiComponentMixture |
  reactingMixture | Foam::reactingMixture |
  veryInhomogeneousMixture | Foam::veryInhomogeneousMixture |
  hReactionThermo | Foam::hReactionThermo |
  hsReactionThermo | Sensible enthalpy variant for reactionThermo |
  hRhoMixtureThermo | Foam::hRhoMixtureThermo |
  hsRhoMixtureThermo | Foam::hsRhoMixtureThermo |
  solidMixture | Foam::solidMixture |
  ash | Coal ash |
  C | Graphite |
  CaCO3 | Calcium carbonate (limestone) |
  solid | The thermophysical properties of a solid |
  atomicWeightTable | A table of atomic weights for all the elements |
   atomicWeight | Structure to hold the element name and atomic weight pair |
  icoPolynomial | Incompressible, polynomial form of equation of state, using a polynomial function for density |
  incompressible | Incompressible gas/liquid equation of state |
   atmBoundaryLayerInletEpsilonFvPatchScalarField | |
   atmBoundaryLayerInletVelocityFvPatchVectorField | |
   fixedShearStressFvPatchVectorField | |
   laminar | Turbulence model for laminar incompressible flow |
   LESModel | Base class for all incompressible flow LES SGS models |
   RASModel | Abstract base class for incompressible turbulence models |
   turbulenceModel | Abstract base class for incompressible turbulence models (RAS, LES and laminar) |
   turbulentHeatFluxTemperatureFvPatchScalarField | |
   turbulentMixingLengthDissipationRateInletFvPatchScalarField | Calculate epsilon via the mixing length [m] |
   turbulentMixingLengthFrequencyInletFvPatchScalarField | Calculate omega via the mixing length |
  perfectGas | Perfect gas equation of state |
  ArrheniusReactionRate | Arrhenius reaction rate |
  ChemicallyActivatedReactionRate | General class for handling chemically-activated bimolecular reactions |
  LindemannFallOffFunction | Lindemann fall-off function |
  SRIFallOffFunction | The SRI fall-off function |
  TroeFallOffFunction | The Troe fall-off function |
  FallOffReactionRate | General class for handling unimolecular/recombination fall-off reactions |
  JanevReactionRate | Janev, Langer, Evans and Post reaction rate |
  LandauTellerReactionRate | Landau-Teller reaction rate |
  LangmuirHinshelwoodReactionRate | Power series reaction rate |
  powerSeriesReactionRate | Power series reaction rate |
  thirdBodyArrheniusReactionRate | Arrhenius reaction rate enhanced by third-body interation |
  thirdBodyEfficiencies | Third body efficiencies |
  IrreversibleReaction | Simple extension of Reaction to handle reversible reactions using equilibrium thermodynamics |
  NonEquilibriumReversibleReaction | Simple extension of Reaction to handle reversible reactions using equilibrium thermodynamics |
  Reaction | Simple extension of ReactionThermo to handle reaction kinetics in addition to the equilibrium thermodynamics already handled |
   iNew | Class used for the read-construction of PtrLists of reaction |
   specieCoeffs | Class to hold the specie index and its coefficients in the |
  ReversibleReaction | Simple extension of Reaction to handle reversible reactions using equilibrium thermodynamics |
  specie | Base class of the thermophysical property types |
  speciesTable | A table of species |
  eConstThermo | Constant properties thermodynamics package templated on an equation of state |
  hConstThermo | Constant properties thermodynamics package templated into the equationOfState |
  hPolynomialThermo | Thermodynamics package templated on the equation of state, using polynomial functions for cp, h and s |
  janafThermo | JANAF tables based thermodynamics package templated into the equationOfState |
  specieThermo | Basic thermodynamics type based on the use of fitting functions for cp, h, s obtained from the template argument type thermo. All other properties are derived from these primitive functions |
  constTransport | Constant properties Transport package. Templated into a given thermodynamics package (needed for thermal conductivity) |
  polynomialTransport | Transport package using polynomial functions for mu and kappa |
  speciesTransport | Basic species transport type based on the use of a fitting function for nu |
  sutherlandTransport | Transport package using Sutherland's formula |
  APIdiffCoefFunc | API function for vapour mass diffusivity |
  NSRDSfunc0 | NSRDS function number 100 |
  NSRDSfunc1 | NSRDS function number 101 |
  NSRDSfunc14 | NSRDS function number 114 |
  NSRDSfunc2 | NSRDS function number 102 |
  NSRDSfunc3 | NSRDS function number 103 |
  NSRDSfunc4 | NSRDS function number 104 |
  NSRDSfunc5 | NSRDS function number 105 |
  NSRDSfunc6 | NSRDS function number 106 |
  NSRDSfunc7 | NSRDS-AICHE function number 107 |
  thermophysicalFunction | Abstract base class for thermo-physical functions |
  linearValveFvMesh | A sliding linear valve |
  linearValveLayersFvMesh | A sliding linear valve with layers |
  mixerFvMesh | A rotating slider mesh |
  movingConeTopoFvMesh | Sample topoChangerFvMesh that moves an object in x direction and introduces/removes layers |
  rawTopoChangerFvMesh | TopoChangerFvMesh without any added functionality |
  topoChangerFvMesh | Abstract base class for a topology changing fvMesh |
  twoPhaseMixture | A two-phase incompressible transportModel |
  singlePhaseTransportModel | A simple single-phase transport model based on viscosityModel |
  transportModel | Base-class for all transport models used by the incompressible turbulence models |
  viscosityModel | An abstract base class for incompressible viscosityModels |
  interfaceCompressionLimiter | Interface compression scheme currently based on the generic limited scheme although it does not use the NVD/TVD functions |
  interfaceProperties | Contains the interface properties |
  alphaContactAngleFvPatchScalarField | Abstract base class for alphaContactAngle boundary conditions |
   interfaceThetaProps | |
  constantAlphaContactAngleFvPatchScalarField | A constant alphaContactAngle scalar boundary condition (alphaContactAngleFvPatchScalarField) |
  dynamicAlphaContactAngleFvPatchScalarField | A dynamic alphaContactAngle scalar boundary condition (alphaContactAngleFvPatchScalarField) |
  timeVaryingAlphaContactAngleFvPatchScalarField | A time-varying alphaContactAngle scalar boundary condition (alphaContactAngleFvPatchScalarField) |
  alphaFixedPressureFvPatchScalarField | A fixed-pressure alphaContactAngle boundary |
  faceTriangulation | Triangulation of faces. Handles concave polygons as well (inefficiently) |
  meshTriangulation | Triangulation of mesh faces. Generates (multiply connected) trisurface |
  hashSignedLabel | Hash for signed integers (Hash<label> only works for unsigned ints) |
  labelledTri | Triangle with additional region number |
  surfAndLabel | Hold surface and label |
  sortLabelledTri | Helper class which when constructed with a triSurface sorts the faces according to region number (or rather constructs a mapping) |
  geometricSurfacePatch | The geometricSurfacePatch is like patchIdentifier but for surfaces. Holds type, name and index |
  surfacePatch | 'Patch' on surface as subset of triSurface |
  surfacePatchIOList | IOobject for a surfacePatchList |
  triSurface | Triangulated surface description with patch information |
  triSurfaceGeoMesh | The triSurface GeoMesh (for holding fields) |
  regionProperties | |
  turbulentTemperatureCoupledBaffleFvPatchScalarField | |
  IDDESDelta | IDDESDelta used by the IDDES (improved low Re Spalart-Allmaras DES model) The min and max delta are calculated using the double distance of the min or max from the face centre to the cell centre |
  cubeRootVolDelta | Simple cube-root of cell volume delta used in LES models |
  LESdelta | Abstract base class for LES deltas |
  maxDeltaxyz | MaxDeltaxyz takes the maximum of the three dimensions per cell: max(hx, hy, hz). Valid for structures hexahedral cells only |
  maxhxhyhzDelta | MaxhxhyhzDelta takes the maximum of the three dimensions per cell: max(hx, hy, hz). Valid for structures hexahedral cells only |
  PrandtlDelta | Simple cube-root of cell volume delta used in LES models |
  smoothDelta | Smoothed delta which takes a given simple geometric delta and applies smoothing to it such that the ratio of deltas between two cells is no larger than a specified amount, typically 1.15 |
  anisotropicFilter | Anisotropic filter |
  laplaceFilter | Laplace filter for LES |
  LESfilter | Abstract class for LES filters |
  simpleFilter | Simple top-hat filter used in dynamic LES models |
  cellSplitter | Does pyramidal decomposition of selected cells. So all faces will become base of pyramid with as top a user-supplied point (usually the cell centre) |
  Tuple | A 2 Tuple. Differs from Tuple in that the two elements can be different type |
  edgeStats | Helper class to calculate minimum edge length on mesh |
  block | Creates a single block of cells from point coordinates, numbers of cells in each direction and expansion ratio |
  hexBlock | Hex block definition used in the cfx converter |
  fluentFvMesh | |
  meshDualiser | |
  coupledFacePair | Data associated with a pair of coupled faces |
  blockDescriptor | Block descriptor. Takes the description of the block and the list of curved edges and creates a list of points on edges together with the weighting factors |
  blockMesh | |
  arcEdge | Defines the arcEdge of a circle in terms of 3 points on its circumference |
  BSpline | An implementation of B-splines |
  CatmullRomSpline | An implementation of Catmull-Rom splines (sometimes known as Overhauser splines) |
  curvedEdge | Define a curved edge that is parameterized for 0<lambda<1 between the start and end point |
  lineDivide | Divides a line into segments |
  lineEdge | A straight edge between the start point and the end point |
  polyLine | A series of straight line segments, which can also be interpreted as a series of control points for splines, etc |
  polyLineEdge | A curvedEdge defined in terms of a series of straight line segments |
  splineEdge | A curvedEdge interface for Catmull-Rom splines |
  extrude2DMesh | Given 2D mesh insert all the topology changes to extrude. Does not work in parallel |
  extrudedMesh | |
  extrudeModel | Top level extrusion model class |
  faceMesh | Storage for surface mesh i.e. points and faces |
  mergePolyMesh | Add a given mesh to the original mesh to create a single new mesh |
  mirrorFvMesh | |
  writeFuns | Various functions for collecting and writing binary data |
  regionSide | Determines the 'side' for every face and connected to a singly-connected (through edges) region of faces. Gets set of faces and a list of mesh edges ('fenceEdges') which should not be crossed. Used in splitting a mesh region |
  fieldDictionary | Read field as dictionary (without mesh) |
  fvFieldDecomposer | Finite Volume volume and surface field decomposer |
   patchFieldDecomposer | Patch field decomposer class |
   processorSurfacePatchFieldDecomposer | Processor patch field decomposer class. Surface field is assumed |
   processorVolPatchFieldDecomposer | Processor patch field decomposer class. Maps either owner or |
  lagrangianFieldDecomposer | Lagrangian field decomposer |
  pointFieldDecomposer | Point field decomposer |
   patchFieldDecomposer | Point patch field decomposer class |
  fvFieldReconstructor | FV volume and surface field reconstructor |
   fvPatchFieldReconstructor | |
  pointFieldReconstructor | Point field reconstructor |
   pointPatchFieldReconstructor | |
  processorMeshes | Container for processor mesh addressing |
  cellSets | |
  ensightMesh | |
   nFacePrimitives | |
  faceSets | |
  fieldviewTopology | |
  internalWriter | Write fields (internal) |
  lagrangianWriter | Write fields (internal) |
  patchWriter | Write patch fields |
  vtkMesh | Encapsulation of VTK mesh data. Holds mesh or meshsubset and polyhedral-cell decomposition on it |
  vtkTopo | Polyhedral cell decomposition for VTK |
  readerDatabase | Singleton caching Foam database and mesh and various. Used in Fv reader to keep track of data inbetween callbacks |
  channelIndex | Does averaging of fields over layers of cells. Assumes layered mesh |
  treeDataPrimitivePatch | Encapsulation of data needed to search on PrimitivePatches |
  mixture | |
  substance | |
  combustionModel | Base class for all non-premixed combustion models |
   noCombustion | No combustion |
  PDRDragModel | Base-class for sub-grid obstacle drag models. The available drag model is at basic.H |
  XiEqModel | Base-class for all XiEq models used by the b-XiEq combustion model. The available models are : basicXiSubXiEq.H Gulder.H instabilityXiEq.H SCOPEBlendXiEq.H SCOPEXiEq.H |
   SCOPEXiEq | Simple SCOPEXiEq model for XiEq based on SCOPEXiEqs correlation with a linear correction function to give a plausible profile for XiEq. See SCOPELaminarFlameSpeed.H for details on the SCOPE laminar flame speed model |
  XiGModel | Base-class for all Xi generation models used by the b-Xi combustion model. See Technical Report SH/RE/01R for details on the PDR modelling. For details on the use of XiGModel see XiModel.H. The model available is instabilityG.H |
   basicSubGrid | Basic sub-grid obstacle flame-wrinking generation rate coefficient model. Details supplied by J Puttock 2/7/06 |
  XiModel | Base-class for all Xi models used by the b-Xi combustion model. See Technical Report SH/RE/01R for details on the PDR modelling |
  mixedFixedValueSlipFvPatchField | A mixed boundary type that blends between fixedValue and slip, as opposed to the standard mixed condition that blends between fixedValue and fixedGradient; required to implement maxwellSlipU condition |
  fixedRhoFvPatchScalarField | Foam::fixedRhoFvPatchScalarField |
  smoluchowskiJumpTFvPatchScalarField | Smoluchowski temperature jump boundary condition |
  maxwellSlipUFvPatchVectorField | Maxwell slip boundary condition including thermal creep and surface curvature terms that can be optionally switched off |
  solidWallHeatFluxTemperatureFvPatchScalarField | |
  solidWallMixedTemperatureCoupledFvPatchScalarField | |
  threePhaseMixture | |
  threePhaseInterfaceProperties | |
  phaseChangeTwoPhaseMixture | |
  multiphaseMixture | Incompressible multi-phase mixture with built in solution for the phase fractions with interface compression for interface-capturing |
   interfacePair | |
    hash | |
  phase | Single incompressible phase derived from the phase-fraction. Used as part of the multiPhaseMixture for interface-capturing multi-phase simulations |
   iNew | Return a pointer to a new phase created on freestore |
  Ergun | H, Enwald, E. Peirano, A-E Almstedt 'Eulerian Two-Phase Flow Theory Applied to Fluidization' Int. J. Multiphase Flow, Vol. 22, Suppl, pp. 21-66 (1996) Eq. 104, p. 42 |
  Gibilaro | H, Enwald, E. Peirano, A-E Almstedt 'Eulerian Two-Phase Flow Theory Applied to Fluidization' Int. J. Multiphase Flow, Vol. 22, Suppl, pp. 21-66 (1996) Eq. 106, p. 43 |
  GidaspowErgunWenYu | D. Gidaspow, Multiphase flow and fluidization, Academic Press, New York, 1994 |
  GidaspowSchillerNaumann | H, Enwald, E. Peirano, A-E Almstedt 'Eulerian Two-Phase Flow Theory Applied to Fluidization' Int. J. Multiphase Flow, Vol. 22, Suppl, pp. 21-66 (1996) Eq. 86-87, p. 40 |
  SchillerNaumann | |
  SyamlalOBrien | Syamlal, M., Rogers, W. and O'Brien, T. J. (1993) MFIX documentation, Theory Guide. Technical Note DOE/METC-94/1004. Morgantown, West Virginia, USA |
  WenYu | H, Enwald, E. Peirano, A-E Almstedt 'Eulerian Two-Phase Flow Theory Applied to Fluidization' Int. J. Multiphase Flow, Vol. 22, Suppl, pp. 21-66 (1996) Eq. 86-87, p. 40 |
  conductivityModel | |
  GidaspowConductivity | |
  HrenyaSinclairConductivity | |
  SyamlalConductivity | |
  frictionalStressModel | |
  JohnsonJacksonFrictionalStress | |
  SchaefferFrictionalStress | |
  granularPressureModel | |
  LunPressure | |
  SyamlalRogersOBrienPressure | |
  kineticTheoryModel | |
  CarnahanStarlingRadial | |
  GidaspowRadial | |
  LunSavageRadial | |
  radialModel | |
  SinclairJacksonRadial | |
  phaseModel | |
  tractionDisplacementFvPatchVectorField | Fixed traction boundary condition for the standard linear elastic, fixed coefficient displacement equation |
  tractionDisplacementCorrectionFvPatchVectorField | |
  MapFvSurfaceField | Map Surface internal field on topology change. This is a partial template specialisation, see MapGeometricFields |
  MapFvVolField | Map volume internal field on topology change. This is a partial template specialisation, see MapGeometricFields |
  basicKinematicCloud | Cloud class to introduce kinematic parcels |
  basicThermoCloud | Cloud class to introduce thermodynamic parcels |
  octreeDataPointTreeLeaf | Template specialisation for octreeDataPoint |
  octreeDataTriSurfaceTreeLeaf | Template specialisation for octreeDataTriSurfaceTreeLeaf |
  StaticAssertionFailed | Macros and classes to provide static (compile-time) assertions |
  memberFunctionSelectionTables | Macros to enable the easy declaration of member function selection tables |
  runTimeSelectionTables | Macros to enable the easy declaration of run-time selection tables |
  cvsTableReader | Reads an interpolation table from a file - CSV-format |
  MapPointField | Map point field on topology change. This is a partial template specialisation for GeoMesh=pointMesh |
  surfFields | Fields for surfMesh |
  surfPointFields | Point fields for surfMesh |
  exponential | Exponential pdf |
  fixedValue | Returns a fixed value |
  general | General pdf |
  multiNormal | A multiNormal pdf |
  normal | A normal pdf |
  pdf | A library of runtime-selectable PDF's |
  RosinRammler | Rosin-Rammler pdf |
  uniform | Uniform pdf |
  greyDiffusiveRadiationMixedFvPatchScalarField | Radiation temperature specified |
  wideBandDiffusiveRadiationMixedFvPatchScalarField | Radiation temperature specified |
  absorptionCoeffs | Absorption coefficients class used in greyMeanAbsorptionEmission and wideBandAbsorptionEmission |
  compressible | Auto creation of fields to provide backwards compatibility with runtime selectable wall functions |
  turbulentHeatFluxTemperatureFvPatchScalarField | Fixed heat flux boundary condition for temperature |
  fixedShearStressFvPatchVectorField | Set a constant shear stress as tau0 = -nuEff dU/dn |
  sammMesh | A messy mesh class which supports the possibility of creating a shapeMesh for regular Samm meshes (no arbitrary interfaces or collapsed SAMM cells). If any of these special feateres exist, the mesh is created as polyMesh |
  starMesh | A messy mesh class which supports the possibility of creating a shapeMesh for regular Star meshes (no arbitrary interfaces or collapsed SAMM cells). If any of these special feateres exist, the mesh is created as polyMesh |
  domainDecomposition | Automatic domain decomposition class for FOAM meshes |
  GidaspowViscosity | |
  HrenyaSinclairViscosity | |
  noneViscosity | |
  SyamlalViscosity | |
 std | |
 alphaSgsJayatillekeWallFunctionFvPatchScalarField | Thermal wall function for turbulent thermal diffusivity based on the Jayatilleke thermal wall function |
 alphaSgsWallFunctionFvPatchScalarField | Boundary condition for thermal diffusivity when using wall functions |
 atmBoundaryLayerInletEpsilonFvPatchScalarField | Boundary condition specifies a epsilon inlet for the atmospheric boundary layer (ABL). This boundaty is to be used in conjunction with ABLInletVelocity |
 atmBoundaryLayerInletVelocityFvPatchVectorField | Boundary condition specifies a atmospheric boundary layer (ABL) velocity inlet profile given the friction velocity value, flow direction n and direction of the parabolic coordinate z |
 CoalParcel | |
 COxidationDiffusionLimitedRate | Diffusion limited rate surface reaction model for coal parcels. Limited to: |
 COxidationKineticDiffusionLimitedRate | Kinetic/diffusion limited rate surface reaction model for coal parcels. Limited to: |
 COxidationMurphyShaddix | Limited to C(s) + O2 -> CO2 |
 domainDecomposition | |
 HashTableName | |
 indexedOctreeName | |
 link | |
 listEq | CombineReduce operator for lists. Used for counting |
 meshDualiser | Creates dual of polyMesh. Every point becomes a cell (or multiple cells for feature points), a walk around every edge creates faces between them |
 pointLinear | Face-point interpolation scheme class derived from linear and returns linear weighting factors but also applies an explicit correction |
 PrimitivePatchName | |
 pTraits< Scalar > | |
 quadraticFitSnGrad | Simple central-difference snGrad scheme with quadratic fit correction from a larger stencil |
 quadraticFitSnGradData | Data for the quadratic fit correction snGrad scheme |
 regionProperties | Simple class to hold region information for coupled region simulations |
 sammMesh | |
 scalarMatrices | Scalar matrices |
 solidWallHeatFluxTemperatureFvPatchScalarField | Heat flux boundary condition for temperature on solid region |
 solidWallMixedTemperatureCoupledFvPatchScalarField | Mixed boundary condition for temperature, to be used by the conjugate heat transfer solver. Both sides use a mix of zeroGradient and neighbourvalue |
 starMesh | |
 surfaceDisplacementPointPatchVectorField | Displacement fixed by projection onto triSurface. Use in a displacement fvMotionSolver as a bc on the pointDisplacement field |
 ThermoType | |
 threePhaseInterfaceProperties | Properties to aid interFoam : |
 threePhaseMixture | |
 turbulentTemperatureCoupledBaffleFvPatchScalarField | Harmonic fixed value boundary condition for temperature, to be used for heat-transfer on back-to-back baffles |
 VectorSpaceOps | |
 VectorSpaceOps< 0, 0 > | |