UList.H File Reference
Include dependency graph for UList.H:
This graph shows which files directly or indirectly include this file:

Go to the source code of this file.

Classes

class  List< T >
 A 1D array of objects of type <T>, where the size of the vector is known and used for subscript bounds checking, etc. More...
 
class  SubList< T >
 A List obtained as a section of another List. More...
 
class  UList< T >
 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. More...
 
class  UList< T >
 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. More...
 
class  UList< T >::less
 Less function class that can be used for sorting. More...
 
class  UList< T >::greater
 Greater function class that can be used for sorting. More...
 

Namespaces

 Foam
 Namespace for OpenFOAM.
 

Macros

#define forAll(list, i)   for (Foam::label i=0; i<(list).size(); i++)
 Loop across all elements in list. More...
 
#define forAllReverse(list, i)   for (Foam::label i=(list).size()-1; i>=0; i--)
 Reverse loop across all elements in list. More...
 
#define forAllIter(Container, container, iter)
 Iterate across all elements in the container object of type. More...
 
#define forAllConstIter(Container, container, iter)
 Iterate across all elements in the container object of type. More...
 

Typedefs

typedef UList< label > labelUList
 

Functions

template<class T >
void writeEntry (Ostream &os, const UList< T > &)
 
template<class T >
Ostream & operator<< (Ostream &, const UList< T > &)
 
template<class T >
Istream & operator>> (Istream &, UList< T > &)
 
template<class T >
void sort (UList< T > &)
 
template<class T , class Cmp >
void sort (UList< T > &, const Cmp &)
 
template<class T >
void stableSort (UList< T > &)
 
template<class T , class Cmp >
void stableSort (UList< T > &, const Cmp &)
 
template<class T >
void shuffle (UList< T > &)
 
template<class T >
void reverse (UList< T > &, const label n)
 
template<class T >
void reverse (UList< T > &)
 
template<class ListType >
void writeListEntry (Ostream &os, const ListType &l)
 
template<class ListType >
void writeListEntries (Ostream &os, const ListType &l)
 
template<class ListType >
void writeListEntries (Ostream &os, const word &keyword, const ListType &l)
 

Detailed Description

Original source file UList.H

Definition in file UList.H.

Macro Definition Documentation

◆ forAll

#define forAll (   list,
 
)    for (Foam::label i=0; i<(list).size(); i++)

Loop across all elements in list.

Usage
forAll(anyList, i)
{
statements;
}
See also
forAllReverse

Definition at line 434 of file UList.H.

Referenced by greyMean::aCont(), wideBand::aCont(), preserveBafflesConstraint::add(), preserveFaceZonesConstraint::add(), preservePatchesConstraint::add(), singleProcessorFaceSetsConstraint::add(), labelRanges::add(), BinSum< IndexType, List, CombineOp >::add(), fvMeshAdder::add(), polyMeshAdder::add(), ISAT::add(), refinementHistory::add(), extendedEdgeMesh::add(), fvMatrix< Type >::addBoundaryDiag(), fvMatrix< Type >::addBoundarySource(), cellTable::addCellZones(), surfaceZonesInfo::addCellZonesToMesh(), MRFZone::addCentrifugalAcceleration(), fvMatrix< Type >::addCmptAvBoundaryDiag(), MRFZoneList::addCoriolis(), MRFZone::addCoriolis(), addPatchCellLayer::addedCells(), mapPatchChange::addedPatches(), surfaceZonesInfo::addFaceZonesToMesh(), radiativeIntensityRay::addIntensity(), lduPrimitiveMesh::addInterfaces(), edgeSurface::addIntersectionEdges(), snappyLayerDriver::addLayers(), fieldAverage::addMeanSqrToPrime2Mean(), polyTopoChange::addMesh(), meshRefinement::addMeshedPatch(), fvMeshTools::addPatch(), repatchMesh::addPatch(), polyMesh::addPatches(), Foam::AddPatchFields(), porosityModelList::addResistance(), cellZoneSet::addSet(), pointZoneSet::addSet(), faceZoneSet::addSet(), fvModels::addsSupToField(), heatSource::addSup(), effectivenessHeatExchangerSource::addSup(), solidificationMeltingSource::addSup(), clouds::addSupFields(), fvMatrix< Type >::addToInternalField(), pointPatchField< vector >::addToInternalField(), polyTopoChanger::addTopologyModifiers(), vtkPVFoam::addToSelection(), regIOobject::addWatch(), fileOperation::addWatches(), masterUncollatedFileOperation::addWatches(), surfMesh::addZones(), MeshedSurface< Foam::face >::addZones(), polyMesh::addZones(), cloud::aDisp(), Foam::adjustPhi(), pairGAMGAgglomeration::agglomerate(), eagerGAMGProcAgglomeration::agglomerate(), manualGAMGProcAgglomeration::agglomerate(), pairPatchAgglomeration::agglomerate(), GAMGInterface::agglomerateCoeffs(), GAMGAgglomeration::agglomerateLduAddressing(), singleCellFvMesh::agglomPatchFieldMapper::agglomPatchFieldMapper(), cellToCellStencil::allCoupledFacesPatch(), cellToFaceStencil::allCoupledFacesPatch(), extendedEdgeMesh::allNearestFeatureEdges(), extendedEdgeMesh::allNearestFeaturePoints(), UPstream::allocateCommunicator(), UPstream::allToAll(), waveAlphaFvPatchScalarField::alphan(), parcelCloudList::ap(), DynamicList< Foam::triFace >::append(), DynamicField< Foam::Vector >::append(), List< Field< scalar > >::append(), blockEdge::appendEndPoints(), meshToMeshMethod::appendNbrCells(), AMIMethod::appendNbrFaces(), directMethod::appendToDirectSeeds(), preserveBafflesConstraint::apply(), preserveFaceZonesConstraint::apply(), preservePatchesConstraint::apply(), singleProcessorFaceSetsConstraint::apply(), refinementHistory::apply(), forces::applyBins(), decompositionMethod::applyConstraints(), rigidBodyModel::applyRestraints(), patchInteractionDataList::applyToPatch(), ParticleErosion< CloudType >::applyToPatch(), faceZoneToFaceZone::applyToSet(), setToPointZone::applyToSet(), setToCellZone::applyToSet(), setToFaceZone::applyToSet(), setAndNormalToFaceZone::applyToSet(), normalToFace::applyToSet(), setsToFaceZone::applyToSet(), face::area(), face::areaInContact(), attachPolyTopoChanger::attach(), FreeStream< CloudType >::autoMap(), Foam::fvc::average(), face::average(), sampledSurface::average(), Foam::average(), InjectionModelList< Foam::MomentumCloud< CloudType > >::averageParcelMass(), AveragingMethod< Foam::Vector >::AveragingMethod(), motionSmootherAlgo::avg(), snappySnapDriver::avgCellCentres(), binaryTree::balance(), meshRefinement::balance(), meshRefinement::balanceAndRefine(), lduAddressing::band(), Foam::bandCompression(), basicCombustionMixture::basicCombustionMixture(), basicSpecieMixture::basicSpecieMixture(), cell::bb(), ListHashTable< T, Key, Hash >::begin(), BinSum< IndexType, List, CombineOp >::BinSum(), blackBodyEmission::blackBodyEmission(), bladeModel::bladeModel(), booleanSurface::booleanSurface(), primitiveMeshTools::boundaryFaceSkewness(), GeometricBoundaryField< vector, pointPatchField, pointMesh >::boundaryInternalField(), fvMatrix< Type >::boundaryManipulate(), GeometricBoundaryField< vector, pointPatchField, pointMesh >::boundaryNeighbourField(), meshSearch::boundaryTree(), searchableBox::boundingSpheres(), searchableSurfaceCollection::boundingSpheres(), triSurfaceMesh::boundingSpheres(), searchableSurfacesQueries::bounds(), MomentumCloud< Foam::DSMCCloud >::buildCellOccupancy(), Reaction< ReactionThermo >::C(), Implicit< CloudType >::cacheFields(), ParticleForceList< MomentumCloud< CloudType > >::cacheFields(), faceAreaIntersect::calc(), ReactingParcel< ParcelType >::calc(), ReactingMultiphaseParcel< ParcelType >::calc(), binaryNode::calcA(), nearWallFields::calcAddressing(), fieldAverage::calcAverages(), PatchTools::calcBounds(), Foam::meshTools::calcBoxPointNormals(), decompositionMethod::calcCellCells(), faceZone::calcCellLayers(), primitiveMesh::calcCells(), targetCoeffTrim::calcCoeffs(), distributionMapBase::calcCompactAddressing(), curvatureSeparation::calcCosAngle(), ParticleForceList< MomentumCloud< CloudType > >::calcCoupled(), ReactingMultiphaseParcel< ParcelType >::calcDevolatilisation(), cellMatcher::calcEdgeAddressing(), enrichedPatch::calcEnrichedFaces(), faceCoupleInfo::calcFaceCentres(), faceCoupleInfo::calcFacePointAverages(), cellToFaceStencil::calcFaceStencil(), coupledPolyPatch::calcFaceTol(), faceZone::calcFaceZonePatch(), CentredFitSnGradData< Polynomial >::calcFit(), FitData< CentredFitSnGradData< Polynomial >, extendedCentredCellToFaceStencil, Polynomial >::calcFit(), forces::calcForcesMoment(), fieldsExpression::calcGeoFieldOp(), symmetryPlanePolyPatch::calcGeometry(), wedgePolyPatch::calcGeometry(), processorPolyPatch::calcGeometry(), faceLimitedGrad< Type >::calcGrad(), faceMDLimitedGrad< Type >::calcGrad(), cellMDLimitedGrad< Type >::calcGrad(), triSurfaceSearch::calcInside(), triSurfaceTools::calcInterpolationWeights(), curvatureSeparation::calcInvR1(), cellMatcher::calcLocalFaces(), zone::calcLookupMap(), mappedPatchBase::calcMapping(), snappySnapDriver::calcNearestSurface(), ParticleForceList< MomentumCloud< CloudType > >::calcNonCoupled(), ReactingParcel< ParcelType >::calcPhaseChange(), cellMatcher::calcPointFaceIndex(), interpolationCellPointWallModified< Type >::calcPointField(), primitiveMesh::calcPointOrder(), createShellMesh::calcPointRegions(), lineFace::calcSamples(), points::calcSamples(), addPatchCellLayer::calcSidePatch(), snappySnapDriver::calcSnapDistance(), fixedCoeff::calcTransformModelData(), DarcyForchheimer::calcTransformModelData(), ConstantRateDevolatilisation< CloudType >::calculate(), P1::calculate(), partialFaceAreaWeightAMI::calculate(), LiquidEvaporation< CloudType >::calculate(), LiquidEvaporationBoil< CloudType >::calculate(), directAMI::calculate(), mapNearestAMI::calculate(), epsilonWallFunctionFvPatchScalarField::calculate(), omegaWallFunctionFvPatchScalarField::calculate(), viewFactor::calculate(), faceAreaWeightAMI::calculate(), fvDOM::calculate(), SingleKineticRateDevolatilisation< CloudType >::calculate(), chemistryModel< ThermoType >::calculate(), rotorDiskSource::calculate(), cellVolumeWeightMethod::calculateAddressing(), mapNearestMethod::calculateAddressing(), directMethod::calculateAddressing(), correlationFunction< Type >::calculateCorrelationFunction(), meshRefinement::calculateEdgeWeights(), singleStepCombustion::calculateMaxProducts(), fieldAverage::calculateMeanFields(), fieldAverage::calculatePrime2MeanFields(), singleStepCombustion::calculateqFuel(), GAMGAgglomeration::calculateRegionMaster(), chemistryModel< ThermoType >::calculateRR(), epsilonWallFunctionFvPatchScalarField::calculateTurbulenceFields(), omegaWallFunctionFvPatchScalarField::calculateTurbulenceFields(), nutkFilmWallFunctionFvPatchScalarField::calcUTau(), nutUSpaldingWallFunctionFvPatchScalarField::calcUTau(), pointMVCWeight::calcWeights(), LiquidEvaporation< CloudType >::calcXc(), LiquidEvaporationBoil< CloudType >::calcXc(), CompositionModel< Foam::ThermoCloud< CloudType > >::carrierId(), ListHashTable< T, Key, Hash >::cbegin(), tetOverlapVolume::cellCellOverlapMinDecomp(), tetOverlapVolume::cellCellOverlapVolumeMinDecomp(), primitiveMesh::cellCells(), primitiveMeshTools::cellClosedness(), primitiveMeshTools::cellDeterminant(), primitiveMesh::cellEdges(), cellFeatures::cellFeatures(), cellMapper::cellMapper(), cellMatcher::cellMatcher(), cellModeller::cellModeller(), fvMotionSolver::cellMotionBoundaryTypes(), primitiveMesh::cellPoints(), heThermo< BasicSolidThermo, MixtureType >::cellSetProperty(), hexRef8::cellShapes(), polyMeshTetDecomposition::cellTetIndices(), valueMultiComponentMixture< ThermoType >::cellThermoMixture(), OppositeFaceCellWave< Type, TrackingData >::cellToFace(), FvFaceCellWave< Type, TrackingData >::cellToFace(), FaceCellWave< Type, TrackingData >::cellToFace(), domainDecomposition::cellToProc(), coefficientWilkeMultiComponentMixture< ThermoType >::cellTransportMixture(), valueMultiComponentMixture< ThermoType >::cellTransportMixture(), ReactingParcel< ParcelType >::cellValueSourceCorrection(), face::centre(), cell::centre(), cellModel::centre(), CentredFitData< Polynomial >::CentredFitData(), MRFZoneList::centrifugalAcceleration(), MPLICface::Cf(), repatchPolyTopoChanger::changeAnchorPoint(), polyTopoChange::changeMesh(), repatchMesh::changePatchType(), polyTopoChanger::changeTopology(), layerAdditionRemoval::changeTopology(), ODESystem::check(), faceZone::checkAddressing(), edgeCollapser::checkBadFaces(), Foam::polyMeshCheck::checkCellDeterminant(), primitiveMesh::checkCellsZipUp(), primitiveMesh::checkCellVolumes(), searchableSurfaces::checkClosed(), primitiveMesh::checkClosedCells(), primitiveMesh::checkCommonOrder(), primitiveMesh::checkConcaveCells(), meshRefinement::checkCoupledFaceZones(), FaceCellWave< Type, TrackingData >::checkCyclic(), FvFaceCellWave< Type, TrackingData >::checkCyclic(), meshRefinement::checkData(), MeshZones< cellZone, polyMesh >::checkDefinition(), zone::checkDefinition(), polyBoundaryMesh::checkDefinition(), primitiveMesh::checkEdgeLength(), triSurface::checkEdges(), Foam::polyMeshCheck::checkFaceAngles(), primitiveMesh::checkFaceAngles(), Foam::polyMeshCheck::checkFaceArea(), primitiveMesh::checkFaceAreas(), Foam::polyMeshCheck::checkFaceDotProduct(), primitiveMesh::checkFaceFaces(), Foam::polyMeshCheck::checkFaceFlatness(), primitiveMesh::checkFaceFlatness(), primitiveMesh::checkFaceOrthogonality(), Foam::polyMeshCheck::checkFacePyramids(), primitiveMesh::checkFacePyramids(), MeshedSurface< Foam::face >::checkFaces(), Foam::polyMeshCheck::checkFaceSkewness(), primitiveMesh::checkFaceSkewness(), Foam::polyMeshCheck::checkFaceTet(), Foam::polyMeshCheck::checkFaceTets(), polyMeshTetDecomposition::checkFaceTets(), Foam::polyMeshCheck::checkFaceTwist(), primitiveMesh::checkFaceVertices(), Foam::polyMeshCheck::checkFaceWeights(), searchableSurfaces::checkIntersection(), hexRef8::checkMesh(), edgeCollapser::checkMeshQuality(), Foam::checkNonManifoldEdge(), searchableSurfaces::checkNormalOrientation(), PatchTools::checkOrientation(), CollisionRecordList< vector, vector >::checkPairRecord(), MeshZones< cellZone, polyMesh >::checkParallelSync(), pointZone::checkParallelSync(), polyBoundaryMesh::checkParallelSync(), faceZone::checkParallelSync(), PrimitivePatch< IndirectList< face >, const pointField & >::checkPointManifold(), primitiveMesh::checkPoints(), searchableSurfaces::checkQuality(), hexRef8::checkRefinementLevels(), GAMGAgglomeration::checkRestriction(), searchableSurfaces::checkSizes(), edgeMeshFormatsCore::checkSupport(), surfaceFormatsCore::checkSupport(), enrichedPatch::checkSupport(), PrimitivePatch< IndirectList< face >, const pointField & >::checkTopology(), triSurface::checkTriangles(), Foam::polyMeshCheck::checkTriangleTwist(), primitiveMesh::checkUpperTriangular(), Foam::polyMeshCheck::checkVolRatio(), CollisionRecordList< vector, vector >::checkWallRecord(), meshRefinement::checkZoneFaces(), MeshedSurface< Foam::face >::checkZones(), surfMesh::checkZones(), chemistryModel< ThermoType >::chemistryModel(), chemPointISAT::chemPointISAT(), SprayParcel< ParcelType >::chi(), ensightPartFaces::classify(), extendedEdgeMesh::classifyFeaturePoint(), probes::classifyFields(), components::clear(), PtrList< transferModel >::clear(), PstreamBuffers::clear(), ListHashTable< T, Key, Hash >::clear(), polyBoundaryMesh::clearAddressing(), MeshZones< cellZone, polyMesh >::clearAddressing(), polyBoundaryMesh::clearGeom(), fvMesh::clearOut(), refinementHistory::clone(), CloudFunctionObjectList< MomentumCloud< CloudType > >::CloudFunctionObjectList(), Foam::cmptAv(), Foam::cmptMag(), Foam::cmptMax(), Foam::cmptMin(), fvPatch::Cn(), cellShape::collapsedFaces(), triSurfaceTools::collapseEdges(), collatedFileOperation::collatedFileOperation(), meshRefinement::collectAndPrint(), extendedCellToFaceStencil::collectData(), extendedFaceToCellStencil::collectData(), meshRefinement::collectFaces(), mappedPatchBase::collectSamples(), ORourkeCollision< CloudType >::collide(), CollisionRecordList< vector, vector >::CollisionRecordList(), Foam::ListListOps::combine(), GAMGInterface::combine(), refinementHistory::combineCells(), Pstream::combineGather(), GAMGAgglomeration::combineLevels(), Foam::ListListOps::combineOffset(), commSchedule::commSchedule(), UPstream::commsStruct::commsStruct(), extendedCentredCellToFaceStencil::compact(), extendedCentredFaceToCellStencil::compact(), extendedCentredCellToCellStencil::compact(), distributionMapBase::compact(), refinementHistory::compact(), GAMGAgglomeration::compactLevels(), CompactListList< T >::CompactListList(), volFieldValue::compareScalars(), Foam::ComplexField(), Foam::component(), fvMeshStitcher::conformalNccBoundaryField(), fvMeshStitcher::conformalOrigBoundaryField(), fvMeshStitcher::connect(), profileModelList::connectBlades(), edgeCollapser::consistentCollapse(), hexRef8::consistentRefinement(), hexRef8::consistentSlowRefinement(), hexRef8::consistentSlowRefinement2(), hexRef8::consistentUnrefinement(), molecule::constantProperties::constantProperties(), ConstantRateDevolatilisation< CloudType >::ConstantRateDevolatilisation(), fvConstraints::constrain(), limitTemperature::constrain(), meanVelocityForce::constrain(), pointConstraints::constrainCorners(), Foam::meshTools::constrainDirection(), meanVelocityForce::constrainedFields(), kinematicSingleLayer::constrainFilmField(), Foam::constrainHbyA(), Foam::constrainPhiHbyA(), Foam::constrainPressure(), fvConstraints::constrainsField(), Foam::meshTools::constrainToMeshCentre(), labelRanges::contains(), boundBox::contains(), boundBox::containsAny(), UPtrList< Foam::diameterModels::sizeGroup >::convert(), ListCompactIO< face, label >::convertFromCompact(), ListCompactIO< face, label >::convertToCompact(), vtkPVFoam::convertVolInternalField(), searchableBox::coordinates(), searchableSurfaceCollection::coordinates(), polyMeshFilter::copyMesh(), dynamicCode::copyOrCreateFiles(), singleRegionCorrectorConvergenceControl::corrCriteriaSatisfied(), pimpleMultiRegionControl::corrCriteriaSatisfied(), forceList::correct(), transferModelList::correct(), ejectionModelList::correct(), patchEjection::correct(), PaSR::correct(), patchPatchDist::correct(), pointPatchDist::correct(), contactAngleForce::correct(), drippingEjection::correct(), BrunDrippingEjection::correct(), curvatureSeparation::correct(), fvModels::correct(), Fickian< unityLewisFourier< laminarThermophysicalTransportModel > >::correct(), radiativeIntensityRay::correct(), Maxwell< BasicMomentumTransportModel >::correct(), EDC::correct(), SSG< BasicMomentumTransportModel >::correct(), LRR< BasicMomentumTransportModel >::correct(), MaxwellStefan< unityLewisFourier< laminarThermophysicalTransportModel > >::correct(), gaussGrad< Type >::correctBoundaryConditions(), motionSmootherAlgo::correctBoundaryConditions(), MRFZoneList::correctBoundaryVelocity(), MRFZone::correctBoundaryVelocity(), Foam::correctContactAngle(), thermoSingleLayer::correctCoverage(), twoDPointCorrector::correctDisplacement(), blockDescriptor::correctFacePoints(), thermoSingleLayer::correctHforMappedT(), linearUpwind< Type >::correction(), cubic< Type >::correction(), linearUpwindV< Type >::correction(), pointLinear< Type >::correction(), outletStabilised< Type >::correction(), basicSpecieMixture::correctMassFractions(), standardPhaseChange::correctModel(), waxSolventEvaporation::correctModel(), solidification::correctModel(), Foam::CorrectPhi(), twoDPointCorrector::correctPoints(), rigidBodySolver::correctQuaternionJoints(), ReactingParcel< ParcelType >::correctSurfaceValues(), Foam::correctUphiBCs(), ReynoldsStress< LESModel< BasicMomentumTransportModel > >::correctWallShearStress(), fvMeshDistribute::countCells(), meshRefinement::countHits(), PointEdgeWave< Type, TrackingData >::countPatchType(), removePoints::countPointUsage(), cyclicPolyPatch::coupledEdges(), globalMeshData::coupledPatch(), globalMeshData::coupledPatchMeshEdgeMap(), cyclicPolyPatch::coupledPoints(), solidMixtureProperties::Cp(), Foam::cp(), liquidMixtureProperties::Cp(), CompositionModel< Foam::ThermoCloud< CloudType > >::Cp(), Foam::cpFiles(), epsilonWallFunctionFvPatchScalarField::createAveragingWeights(), omegaWallFunctionFvPatchScalarField::createAveragingWeights(), meshRefinement::createBaffles(), logFiles::createFiles(), Keyed< T >::createList(), dynamicCode::createMakeFiles(), fvMeshStitcher::createNonConformalStabilisationGeometry(), Foam::createWithValues(), meshRefinement::createZoneBaffles(), singleRegionConvergenceControl::criteriaSatisfied(), pimpleMultiRegionControl::criteriaSatisfied(), STARCD::cullPoints(), Distribution< Type >::cumulativeNormalised(), Distribution< Type >::cumulativeRaw(), multiSolidBodyMotionSolver::curPoints(), interpolatingSolidBodyMotionSolver::curPoints(), displacementComponentLaplacianFvMotionSolver::curPoints(), displacementLaplacianFvMotionSolver::curPoints(), displacementLinearMotionMotionSolver::curPoints(), motionSmootherAlgo::curPoints(), triSurface::curvature(), curvatureSeparation::curvatureSeparation(), hexCellLooper::cut(), geomCellLooper::cut(), Foam::meshTools::cutDirToEdge(), MPLICface::cutFace(), cyclicAMIGAMGInterface::cyclicAMIGAMGInterface(), cyclicGAMGInterface::cyclicGAMGInterface(), cyclicTransform::cyclicTransform(), liquidMixtureProperties::D(), DAC< ThermoType >::DAC(), fvMatrix< Type >::DD(), Reaction< ReactionThermo >::ddNdtByVdcTp(), MRFZoneList::DDt(), powerSeriesReactionRate::ddT(), fluxLimitedLangmuirHinshelwoodReactionRate::ddT(), globalIndexAndTransform::decodeTransformIndex(), structuredDecomp::decompose(), zoltanDecomp::decompose(), decompositionMethod::decompose(), hierarchGeomDecomp::decompose(), domainDecomposition::decompose(), triSurfaceTools::delaunay2D(), mapPatchChange::deletedPatches(), repatchMesh::deletePatch(), cellZoneSet::deleteSet(), pointZoneSet::deleteSet(), faceZoneSet::deleteSet(), cyclicAMIFvPatch::delta(), fvMesh::delta(), blackBodyEmission::deltaLambdaT(), chemistryModel< ThermoType >::derivatives(), snappySnapDriver::detectNearSurfaces(), DiagonalMatrix< scalar >::DiagonalMatrix(), dimensionSets::dimensionSets(), directions::directions(), argList::displayDoc(), fvConstraints::distribute(), parcelCloudList::distribute(), fvModels::distribute(), searchableSurfaceCollection::distribute(), refinementHistory::distribute(), distributionMapBase::distribute(), fvMeshDistribute::distribute(), distributedTriSurfaceMesh::distribute(), meshRefinement::distribute(), distributedTriSurfaceMesh::distributedTriSurfaceMesh(), distributedWeightedFvPatchFieldMapper::distributedWeightedFvPatchFieldMapper(), patchToPatch::distributePatch(), distributionMap::distributionMap(), distributionMapBase::distributionMapBase(), regionSizeDistribution::divide(), MaxwellStefan< unityLewisFourier< laminarThermophysicalTransportModel > >::divj(), Fickian< unityLewisFourier< laminarThermophysicalTransportModel > >::divq(), nonUnityLewisEddyDiffusivity< TurbulenceThermophysicalTransportModel >::divq(), MaxwellStefan< unityLewisFourier< laminarThermophysicalTransportModel > >::divq(), Reaction< ReactionThermo >::dNdtByV(), snappyLayerDriver::doLayers(), meshRefinement::doRemovePoints(), meshRefinement::doRestorePoints(), snappySnapDriver::doSnap(), DRGEP< ThermoType >::DRGEP(), DSMCCloud< ParcelType >::DSMCCloud(), Dual< Type >::Dual(), meshRefinement::dumpIntersections(), meshRefinement::dumpRefinementLevel(), dynamicCodeContext::dynamicCodeContext(), dynamicMeshPointInterpolator::dynamicMeshPointInterpolator(), blackBodyEmission::EbDeltaLambdaT(), extendedEdgeMesh::edgeBaffles(), primitiveMesh::edgeCells(), face::edgeDirection(), edgeIntersections::edgeIntersections(), PatchTools::edgeNormals(), extendedEdgeMesh::edgeNormals(), PatchTools::edgeOwner(), cell::edges(), cellModel::edges(), edgeSurface::edgeSurface(), PatchEdgeFaceWave< PrimitivePatchType, Type, TrackingData >::edgeToFace(), PointEdgeWave< Type, TrackingData >::edgeToPoint(), extendedEdgeMesh::edgeTreesByType(), cloud::EDisp(), EFA< ThermoType >::EFA(), Foam::eigenValues(), ejectionModelList::ejectionModelList(), waveSuperposition::elevation(), globalIndexAndTransform::encodeTransformIndex(), systemCall::end(), functionObjectList::end(), chemistryReductionMethod< ThermoType >::endReduceMechanism(), pairPotential::energyTable(), engine::engine(), parcelCloudList::Ep(), nonConformalCoupledPolyPatch::errorPatchID(), Foam::evaluate(), GeometricBoundaryField< vector, pointPatchField, pointMesh >::evaluate(), Foam::evaluateConstraintTypes(), seriesProfile::evaluateDrag(), seriesProfile::evaluateLift(), WallSpringSliderDashpot< CloudType >::evaluateWall(), WallLocalSpringSliderDashpot< CloudType >::evaluateWall(), parcelCloudList::evolve(), Pstream::exchange(), distributionMapBase::exchangeAddressing(), Pstream::exchangeSizes(), removeEntry::execute(), removeRegisteredObject::execute(), readFields::execute(), fieldCoordinateSystemTransform::execute(), fieldsExpression::execute(), systemCall::execute(), functionObjectList::execute(), masterUncollatedFileOperation::exists(), sampledSurfaces::expire(), extendedCellToCellStencil::extendedCellToCellStencil(), extendedCellToFaceStencil::extendedCellToFaceStencil(), extendedEdgeMesh::extendedEdgeMesh(), extendedFaceToCellStencil::extendedFaceToCellStencil(), extendedFeatureEdgeMesh::extendedFeatureEdgeMesh(), extendedUpwindCellToFaceStencil::extendedUpwindCellToFaceStencil(), triSurfaceMesh::extractCloseness(), regionSizeDistribution::extractData(), triSurfaceMesh::extractPointCloseness(), extrudePatchMesh::extrudePatchMesh(), polyPatch::faceCellCentres(), primitiveMeshTools::faceConcavity(), Foam::faceCorr(), faceCoupleInfo::faceCoupleInfo(), primitiveMesh::faceEdges(), primitiveMeshTools::faceFlatness(), PatchToPatchInterpolation< FromPatch, ToPatch >::faceInterpolate(), hexRef8::faceLevel(), faceMapper::faceMapper(), cellQuality::faceNonOrthogonality(), primitiveMeshTools::faceOrthogonality(), polyMeshTools::faceOrthogonality(), Foam::facePointN(), mappedPatchBase::facePoints(), FacePostProcessing< CloudType >::FacePostProcessing(), primitiveMeshTools::facePyramidVolume(), cellModel::faces(), boundBox::faces(), triSurface::faces(), hexMatcher::faceSizeMatch(), prismMatcher::faceSizeMatch(), pyrMatcher::faceSizeMatch(), tetMatcher::faceSizeMatch(), tetWedgeMatcher::faceSizeMatch(), wedgeMatcher::faceSizeMatch(), polyMeshTools::faceSkewness(), cellQuality::faceSkewness(), primitiveMeshTools::faceSkewness(), OppositeFaceCellWave< Type, TrackingData >::faceToCell(), FvFaceCellWave< Type, TrackingData >::faceToCell(), FaceCellWave< Type, TrackingData >::faceToCell(), PatchEdgeFaceWave< PrimitivePatchType, Type, TrackingData >::faceToEdge(), PrimitivePatchInterpolation< Foam::PrimitivePatch >::faceToPointInterpolate(), polyMeshTools::faceWeights(), extendedEdgeMesh::featurePointNormals(), searchablePlateFeatures::features(), Foam::fftRenumber(), FieldActivatedInjection< CloudType >::FieldActivatedInjection(), FieldField< Foam::fvPatchField, scalar >::FieldField(), fvMeshStitcher::fieldRMapSum(), nearWallFields::fields(), sampledSurfaces::fields(), fieldAverage::fields(), fileName::fileName(), fileOperation::filePath(), masterUncollatedFileOperation::filePathInfo(), cellClassification::fillHangingCells(), cellClassification::fillRegionEdges(), cellClassification::fillRegionPoints(), polyMeshFilter::filter(), surfaceFieldValue::filterField(), patchToPatch::finalise(), ListHashTable< T, Key, Hash >::find(), refinementSurfaces::findAllHigherIntersections(), searchableSurfacesQueries::findAllIntersections(), searchableSurfacesQueries::findAnyIntersection(), polyMeshTetDecomposition::findBasePoint(), refinementParameters::findCells(), Time::findClosestTimeIndex(), functionObjectList::findDict(), localPointRegion::findDuplicateFacePairs(), localPointRegion::findDuplicateFaces(), Foam::meshTools::findEdge(), probes::findElements(), patchProbes::findElements(), refinementSurfaces::findHigherIntersection(), refinementRegions::findHigherLevel(), refinementFeatures::findHigherLevel(), MeshZones< cellZone, polyMesh >::findIndex(), polyBoundaryMesh::findIndex(), pointBoundaryMesh::findIndices(), MeshZones< cellZone, polyMesh >::findIndices(), polyBoundaryMesh::findIndices(), cellVolumeWeightMethod::findInitialSeeds(), refinementSurfaces::findInside(), dynamicIndexedOctree< Foam::dynamicTreeDataPoint >::findInside(), indexedOctree< Foam::treeDataFace >::findInside(), triSurfaceSearch::findLine(), searchableSphere::findLine(), searchablePlate::findLine(), searchablePlane::findLine(), searchableSurfaceWithGaps::findLine(), searchableDisk::findLine(), searchableCylinder::findLine(), searchableBox::findLine(), searchableSurfaceCollection::findLine(), indexedOctree< Foam::treeDataFace >::findLine(), triSurfaceSearch::findLineAll(), searchableSphere::findLineAll(), searchablePlate::findLineAll(), searchablePlane::findLineAll(), searchableSurfaceWithGaps::findLineAll(), searchableDisk::findLineAll(), searchableCylinder::findLineAll(), searchableBox::findLineAll(), searchableSurfaceCollection::findLineAll(), distributedTriSurfaceMesh::findLineAll(), triSurfaceSearch::findLineAny(), searchableSphere::findLineAny(), searchableCylinder::findLineAny(), searchableBox::findLineAny(), mapNearestMethod::findMappedSrcCell(), MeshZones< cellZone, polyMesh >::findMatching(), polyTopoChanger::findModifierID(), triSurfaceRegionSearch::findNearest(), searchableSurfacesQueries::findNearest(), dynamicTreeDataPoint::findNearest(), triSurfaceSearch::findNearest(), searchableExtrudedCircle::findNearest(), searchableSphere::findNearest(), searchablePlate::findNearest(), searchablePlane::findNearest(), searchableDisk::findNearest(), searchableCylinder::findNearest(), searchableBox::findNearest(), refinementSurfaces::findNearest(), distributedTriSurfaceMesh::findNearest(), dynamicIndexedOctree< Foam::dynamicTreeDataPoint >::findNearest(), indexedOctree< Foam::treeDataFace >::findNearest(), refinementFeatures::findNearestEdge(), searchableSurfacesQueries::findNearestIntersection(), refinementSurfaces::findNearestIntersection(), refinementFeatures::findNearestPoint(), refinementSurfaces::findNearestRegion(), refinementFeatures::findNearestRegionEdge(), functionObjectList::findObjectID(), patchToPatch::findOrIntersectFaces(), searchableExtrudedCircle::findParametricNearest(), fvBoundaryMesh::findPatchID(), polyBoundaryMesh::findPatchID(), repatchMesh::findPatchID(), polyBoundaryMesh::findPatchIDs(), meshRefinement::findRegions(), mappedPatchBase::findSamples(), polyMeshTetDecomposition::findSharedBasePoint(), polyMeshTetDecomposition::findTet(), cellPointWeight::findTetrahedron(), fileOperation::findTimes(), cellPointWeight::findTriangle(), fileOperation::findWatch(), masterUncollatedFileOperation::findWatch(), MeshZones< cellZone, polyMesh >::findZoneID(), Foam::first(), FixedList< Type, 3 >::FixedList(), kOmegaSSTLM< BasicMomentumTransportModel >::Flength(), distributionMapBase::flipAndCombine(), extendedEdgeMesh::flipNormals(), fvMatrix< Type >::flux(), fluxLimitedLangmuirHinshelwoodReactionRate::fluxLimitedLangmuirHinshelwoodReactionRate(), for(), damping::forceCoeff(), forceList::forceList(), pairPotential::forceTable(), ListHashTable< T, Key, Hash >::found(), interfaceProperties::fraction(), UPstream::freeCommunicators(), FreeStream< CloudType >::FreeStream(), singleStepCombustion::fresCorrect(), faceCorrectedSnGrad< Type >::fullGradCorrection(), fvBoundaryMeshMapper::fvBoundaryMeshMapper(), ddtScheme< Type >::fvcDdtPhiCoeff(), fvMatrix< Type >::fvMatrix(), gaussConvectionScheme< Type >::fvmDiv(), fvMeshLduAddressing::fvMeshLduAddressing(), gaussLaplacianScheme< Type, GType >::fvmLaplacianUncorrected(), GAMGSolver::GAMGSolver(), Pstream::gather(), decomposedBlockData::gather(), lduPrimitiveMesh::gather(), PatchTools::gatherAndMerge(), Pstream::gatherList(), Foam::gAverage(), meshRefinement::gAverage(), Foam::triIntersect::generateGeometryForLocations(), fvMeshStitcher::geometric(), GeometricBoundaryField< vector, pointPatchField, pointMesh >::GeometricBoundaryField(), get_edge_list(), Foam::polyMeshCheck::getAffectedCells(), surfaceZonesInfo::getAllClosedNamedSurfaces(), FvFaceCellWave< Type, TrackingData >::getChangedPatchFaces(), surfaceZonesInfo::getClosedNamedSurfaces(), triSurfaceTools::getEdge(), Foam::meshTools::getEdgeFaces(), removeCells::getExposedFaces(), searchableSurfaceCollection::getField(), triSurfaceMesh::getField(), distributedTriSurfaceMesh::getField(), surfaceFieldValue::getFieldValues(), cellLooper::getFirstVertEdge(), surfaceSets::getHangingCells(), surfaceZonesInfo::getInsidePointNamedSurfaces(), Foam::fvPatchDistWave::getInternalInfo(), syncTools::getInternalOrCoupledFaces(), syncTools::getInternalOrMasterFaces(), syncTools::getMasterEdges(), meshRefinement::getMasterEdges(), syncTools::getMasterFaces(), syncTools::getMasterPoints(), meshRefinement::getMasterPoints(), combineFaces::getMergeSets(), cellLooper::getMisAlignedEdge(), surfaceZonesInfo::getNamedSurfaces(), repatchMesh::getNearest(), searchableSphere::getNormal(), searchableExtrudedCircle::getNormal(), searchablePlate::getNormal(), searchableCylinder::getNormal(), searchableBox::getNormal(), searchableSurfaceCollection::getNormal(), triSurfaceMesh::getNormal(), distributedTriSurfaceMesh::getNormal(), fvMeshStitcher::getOrigNccMagSfb(), searchableSurfaceCollection::getRegion(), triSurfaceMesh::getRegion(), distributedTriSurfaceMesh::getRegion(), Foam::meshTools::getSharedEdge(), Foam::meshTools::getSharedFace(), hexRef8::getSplitPoints(), surfaceSets::getSurfaceSets(), triSurfaceTools::getTriangle(), surfaceZonesInfo::getUnclosedNamedSurfaces(), surfaceZonesInfo::getUnnamedSurfaces(), removePoints::getUnrefimentSet(), cellLooper::getVertEdgesNonFace(), triSurfaceTools::getVertexTriangles(), triSurfaceTools::getVertexVertices(), cellLooper::getVertFacesNonEdge(), treeDataFace::getVolumeType(), searchableSphere::getVolumeType(), treeDataPrimitivePatch< PatchType >::getVolumeType(), searchableCylinder::getVolumeType(), searchableBox::getVolumeType(), triSurfaceMesh::getVolumeType(), dynamicIndexedOctree< Foam::dynamicTreeDataPoint >::getVolumeType(), indexedOctree< Foam::treeDataFace >::getVolumeType(), snappySnapDriver::getZoneSurfacePoints(), GAMGProcAgglomeration::globalCellCells(), addPatchCellLayer::globalEdgeFaces(), globalIndexAndTransform::globalIndexAndTransform(), triSurfaceTools::greenRefine(), polyBoundaryMesh::groupPatchIDs(), chemPointISAT::grow(), meshRefinement::growFaceCellFace(), cellClassification::growSurface(), CompositionModel< Foam::ThermoCloud< CloudType > >::H(), h0(), fvMatrix< Type >::H1(), FaceCellWave< Type, TrackingData >::handleAMICyclicPatches(), FvFaceCellWave< Type, TrackingData >::handleCyclicAMIPatches(), FaceCellWave< Type, TrackingData >::handleCyclicPatches(), FvFaceCellWave< Type, TrackingData >::handleCyclicPatches(), FaceCellWave< Type, TrackingData >::handleExplicitConnections(), FaceCellWave< Type, TrackingData >::handleProcPatches(), FvFaceCellWave< Type, TrackingData >::handleProcPatches(), noiseFFT::Hanning(), valueMultiComponentMixture< ThermoType >::thermoMixture::harmonicMassWeighted(), pimpleMultiRegionControl::hasCorrResidualControls(), hashedWordList::hashedWordList(), HashSet< Foam::triFace, Foam::Hash< Foam::triFace > >::HashSet(), FaceCellWave< Type, TrackingData >::hasPatch(), FvFaceCellWave< Type, TrackingData >::hasPatch(), pimpleMultiRegionControl::hasResidualControls(), CompositionModel< Foam::ThermoCloud< CloudType > >::Hc(), basicThermo::heBoundaryBaseTypes(), heThermo< BasicSolidThermo, MixtureType >::heBoundaryCorrection(), basicThermo::heBoundaryTypes(), psiuReactionThermo::heuBoundaryCorrection(), psiuReactionThermo::heuBoundaryTypes(), hexRef8Data::hexRef8Data(), particle::hitFace(), liquidMixtureProperties::hl(), hostCollatedFileOperation::hostCollatedFileOperation(), CompositionModel< Foam::ThermoCloud< CloudType > >::Hs(), parcelCloudList::hsCoeff(), parcelCloudList::hsTrans(), ReynoldsAnalogy::htcByRhoCp(), phaseProperties::id(), Foam::identity(), if(), Foam::Im(), Foam::ImComplexField(), Distribution< Type >::index(), indexedOctree< Foam::treeDataFace >::indexedOctree(), sortLabelledTri::indices(), face::inertia(), InflationInjection< CloudType >::InflationInjection(), FreeStream< CloudType >::inflow(), ejectionModelList::info(), transferModelList::info(), InjectionModelList< Foam::MomentumCloud< CloudType > >::info(), LocalInteraction< CloudType >::info(), parcelCloudList::info(), thermalBaffle::info(), MPPICCloud< Foam::DSMCCloud >::info(), AMIMethod::initialise(), fieldAverage::initialise(), patchToPatch::initialise(), LduMatrix< Type, DType, LUType >::initMatrixInterfaces(), lduMatrix::initMatrixInterfaces(), coupledPolyPatch::initOrder(), InjectionModelList< Foam::MomentumCloud< CloudType > >::inject(), SurfaceFilmModel< Foam::MomentumCloud< CloudType > >::inject(), InjectionModelList< Foam::MomentumCloud< CloudType > >::injectSteadyState(), Foam::inplaceRenumber(), Foam::inplaceReorder(), Foam::inplaceSubset(), Foam::inplaceSubsetMatchingStrings(), HashSet< Foam::triFace, Foam::Hash< Foam::triFace > >::insert(), cellToCellStencil::insertFaceCells(), cellToFaceStencil::insertFaceCells(), Polynomial< Type >::integral(), Polynomial< 8 >::integral(), FieldFunction1< Type, Sine< Type > >::integral(), Table< scalar >::integral(), integratedNonUniformTable::integratedNonUniformTable(), linearInterpolationWeights::integrationWeights(), ThermoSurfaceFilm< CloudType >::interactionTypeEnum(), GAMGInterface::interfaceInternalField(), fvBoundaryMesh::interfaces(), GeometricBoundaryField< vector, pointPatchField, pointMesh >::interfaces(), cyclicAMIGAMGInterface::internalFieldTransfer(), cyclicGAMGInterface::internalFieldTransfer(), isoSurface::interpolate(), pointToPointPlanarInterpolation::interpolate(), fvMeshSubset::interpolate(), interpolationCellPointFace< Type >::interpolate(), localMin< Type >::interpolate(), localMax< Type >::interpolate(), interfaceCompressionNew::interpolate(), pointMVCWeight::interpolate(), surfaceInterpolationScheme< GType >::interpolate(), fieldInterpolation< scalar, interpolationCellPoint< scalar > >::interpolate(), singleCellFvMesh::interpolate(), cyclicAMIPolyPatch::interpolate(), meshToMesh0::interpolate(), plane::interpolateField(), isoSurface::interpolateField(), thresholdCellFaces::interpolateField(), patchInternalField::interpolateField(), patch::interpolateField(), triSurfaceMesh::interpolateField(), meshToMesh0::interpolateField(), Foam::interpolatePointToCell(), AMIInterpolation::interpolateToSource(), AMIInterpolation::interpolateToTarget(), volPointInterpolation::interpolateUnconstrained(), interRegionExplicitPorositySource::interRegionExplicitPorositySource(), triangleFuncs::intersectAxesBundle(), meshRefinement::intersectedFaces(), meshRefinement::intersectedPoints(), intersectedSurface::intersectedSurface(), face::intersection(), patchToPatch::intersectPatches(), patchToPatch::intersectPatchQueue(), Foam::triIntersect::intersectTris(), gradingDescriptors::inv(), DiagonalMatrix< scalar >::invert(), Foam::invert(), Foam::invertManyToMany(), Foam::invertOneToMany(), IOobjectList::IOobjectList(), regionModel::isCoupledPatch(), cellFeatures::isFeatureVertex(), ensightPart::isFieldDefined(), meshRefinement::isNormalGap(), isoSurface::isoSurface(), regionModel::isRegionPatch(), MaxwellStefan< unityLewisFourier< laminarThermophysicalTransportModel > >::j(), chemistryModel< ThermoType >::jacobian(), SpalartAllmarasDES< BasicMomentumTransportModel >::k(), heSolidThermo< BasicSolidThermo, MixtureType >::Kappa(), coefficientWilkeMultiComponentMixture< ThermoType >::transportMixture::kappa(), liquidMixtureProperties::kappa(), Distribution< Type >::keys(), Kmesh::Kmesh(), Foam::kShellMean(), CompositionModel< Foam::ThermoCloud< CloudType > >::L(), cell::labels(), LangmuirHinshelwoodReactionRate::LangmuirHinshelwoodReactionRate(), lduPrimitiveMesh::lduPrimitiveMesh(), Foam::levelSetFraction(), Foam::MULES::limit(), PhiScheme< Type, PhiLimiter >::limiter(), Foam::MULES::limiter(), Foam::MULES::limiterCorr(), Foam::MULES::limitSum(), lineDivide::lineDivide(), coordSet::lines(), LiquidEvaporation< CloudType >::LiquidEvaporation(), LiquidEvaporationBoil< CloudType >::LiquidEvaporationBoil(), parcelThermo::liquidId(), liquidMixtureProperties::liquidMixtureProperties(), UCompactListList< Foam::FvWallInfoData >::list(), List< Field< scalar > >::List(), functionObjectList::list(), Pstream::listCombineGather(), FvFaceCellWave< Type, TrackingData >::listListSizes(), Foam::listSwitches(), patchToPatch::localFacesToProcFaces(), LocalInteraction< CloudType >::LocalInteraction(), localPointRegion::localPointRegion(), PrimitiveOldTimePatch< Foam::List, Foam::Field >::localPoints0(), Foam::longestEdge(), interpolationLookUpTable::lookUp(), basicThermo::lookupCstrIter(), dictionary::lookupEntryPtrBackwardsCompatible(), fileOperation::lookupProcessorsPath(), lookupProfile::lookupProfile(), pimpleMultiRegionControl::loop(), cellCuts::loopPoints(), noiseFFT::Lsum(), LUscalarMatrix::LUscalarMatrix(), thirdBodyEfficiencies::M(), cell::mag(), cellModel::mag(), Foam::mag(), Foam::magSqr(), MRFZoneList::makeAbsolute(), MRFZone::makeAbsolute(), primitiveMesh::makeCellCentresAndVols(), meshRefinement::makeDisplacementField(), primitiveMesh::makeFaceCentresAndAreas(), makeFvGradScheme(), polyTopoChange::makeMesh(), meshRefinement::makePatch(), MRFZoneList::makeRelative(), MRFZone::makeRelative(), coupledFvPatch::makeWeights(), cyclicAMIFvPatch::makeWeights(), nonConformalCoupledFvPatch::makeWeights(), epsilonmWallFunctionFvPatchScalarField::manipulateMatrix(), epsilonWallFunctionFvPatchScalarField::manipulateMatrix(), omegaWallFunctionFvPatchScalarField::manipulateMatrix(), ManualInjection< CloudType >::ManualInjection(), Field< PointType >::map(), meshToMesh::mapAndOpTgtToSrc(), Pstream::mapCombineGather(), meshToMesh0::mapField(), Foam::MapGeometricFields(), Foam::MapLagrangianFields(), fvConstraints::mapMesh(), fvModels::mapMesh(), functionObjectList::mapMesh(), mappedPatchFieldBase< Type >::mappedField(), singleLayerRegion::mappedFieldAndInternalPatchTypes(), meshToMesh::mapSrcToTgt(), fvMeshAdder::MapSurfaceFields(), meshToMesh::mapTgtToSrc(), fvMeshAdder::MapVolFields(), repatchMesh::markFaces(), edgeCollapser::markFaceZoneEdges(), edgeCollapser::markMergeEdges(), edgeCollapser::markSmallEdges(), edgeCollapser::markSmallSliverFaces(), PatchTools::markZone(), triSurface::markZone(), meshToMeshMethod::maskCells(), ParticleForceList< MomentumCloud< CloudType > >::massEff(), momentOfInertia::massPropertiesShell(), momentOfInertia::massPropertiesSolid(), valueMultiComponentMixture< ThermoType >::thermoMixture::massWeighted(), PatchTools::matchEdges(), CollisionRecordList< vector, vector >::matchPairRecord(), Foam::matchPoints(), PatchTools::matchPoints(), prismMatcher::matchShape(), pyrMatcher::matchShape(), tetWedgeMatcher::matchShape(), wedgeMatcher::matchShape(), CollisionRecordList< vector, vector >::matchWallRecord(), fvModels::maxDeltaT(), refinementFeatures::maxDistance(), triSurfaceTools::maxEdge(), refinementRegions::maxLevel(), conformalVoronoiMesh::maxSurfaceProtrusion(), Maxwell< BasicMomentumTransportModel >::Maxwell(), MaxwellStefan< unityLewisFourier< laminarThermophysicalTransportModel > >::MaxwellStefan(), distribution::mean(), Distribution< Type >::mean(), noiseFFT::meanPf(), multiNormal::meanValue(), distribution::median(), Distribution< Type >::median(), cellToCellStencil::merge(), cellToFaceStencil::merge(), edgeIntersections::merge(), meshRefinement::mergeBaffles(), edgeMesh::mergeEdges(), snappyLayerDriver::mergePatchFacesUndo(), meshRefinement::mergePatchFacesUndo(), Foam::mergePoints(), edgeMesh::mergePoints(), triSurfaceTools::mergePoints(), globalMeshData::mergePoints(), fileOperation::mergeTimes(), Foam::meshEdge(), cellShape::meshEdges(), PrimitivePatch< IndirectList< face >, const pointField & >::meshEdges(), meshRefinement::meshedPatches(), MeshedSurface< Foam::face >::MeshedSurface(), cellShape::meshFaces(), momentOfInertia::meshInertia(), meshToMesh::meshToMesh(), meshToMesh0::meshToMesh0(), meshTriangulation::meshTriangulation(), MeshZones< cellZone, polyMesh >::MeshZones(), MGridGenGAMGAgglomeration::MGridGenGAMGAgglomeration(), Foam::min(), triSurfaceTools::minEdge(), edgeIntersections::minEdgeLength(), globalIndexAndTransform::minimumTransformIndex(), mixtureFraction::mixtureFraction(), polyTopoChanger::modifyMotionPoints(), attachDetach::modifyMotionPoints(), slidingInterface::modifyMotionPoints(), motionSmootherAlgo::modifyMotionPoints(), molecule::molecule(), moleFractions< ThermoType >::moleFractions(), valueMultiComponentMixture< ThermoType >::transportMixture::moleWeighted(), Moment< Type >::Moment(), MomentumLookupTableInjection< CloudType >::MomentumLookupTableInjection(), Cloud< passiveParticle >::move(), medialAxisMeshMover::move(), molecule::move(), regionModel1D::moveMesh(), pointBoundaryMesh::movePoints(), fvBoundaryMesh::movePoints(), surfaceInterpolation::movePoints(), fvConstraints::movePoints(), MeshZones< cellZone, polyMesh >::movePoints(), polyBoundaryMesh::movePoints(), fvModels::movePoints(), functionObjectList::movePoints(), polyTopoChange::movePoints(), fvMesh::movePoints(), primitiveMesh::movePoints(), coefficientWilkeMultiComponentMixture< ThermoType >::transportMixture::mu(), liquidMixtureProperties::mu(), multiLevelDecomp::multiLevelDecomp(), multiSolidBodyMotionSolver::multiSolidBodyMotionSolver(), NamedEnum< compressibleField, 8 >::names(), polyTopoChanger::names(), MeshZones< cellZone, polyMesh >::names(), polyBoundaryMesh::names(), Foam::NaNGeometricFields(), regionModel::nbrCoupledPatchID(), polyBoundaryMesh::nbrEdges(), interRegionModel::nbrModel(), surfaceFeatures::nearestEdges(), surfaceFeatures::nearestFeatEdge(), extendedEdgeMesh::nearestFeatureEdge(), extendedEdgeMesh::nearestFeatureEdgeByType(), surfaceFeatures::nearestSamples(), surfaceFeatures::nearestSurfEdge(), GeometricField< vector, pointPatchField, pointMesh >::needReference(), sampledSurfaces::needsUpdate(), FieldField< Foam::fvPatchField, scalar >::negate(), basicChemistryModel::New(), functionObjectList::New(), chemistryReductionMethod< ThermoType >::New(), Reaction< ReactionThermo >::New(), FieldField< Foam::fvPatchField, scalar >::NewCalculatedType(), UOprocess::newField(), polygonTriangulate::nIntersections(), cellCuts::nonAnchorPoints(), nonBlockingGaussSeidelSmoother::nonBlockingGaussSeidelSmoother(), lduPrimitiveMesh::nonBlockingSchedule(), fvMeshStitcher::nonConformalBoundaryField(), nonConformalBoundary::nonConformalNonCoupledPatchIDs(), cellQuality::nonOrthogonality(), NonUniformTable< scalar >::NonUniformTable(), surfaceLocation::normal(), basicSpecieMixture::normalise(), distribution::normalised(), distribution::normalisedShifted(), ODESolver::normaliseError(), AMIInterpolation::normaliseWeights(), fileOperation::nProcs(), strainRateFunction::nu(), nutkWallFunctionFvPatchScalarField::nut(), nutUWallFunctionFvPatchScalarField::nut(), nutURoughWallFunctionFvPatchScalarField::nut(), nutkRoughWallFunctionFvPatchScalarField::nut(), nutkAtmRoughWallFunctionFvPatchScalarField::nut(), writeObjectsBase::objectNames(), liquidMixtureProperties::omega(), consumptionSpeed::omega0Sigma(), dlLibraryTable::open(), ConstMatrixBlock< MatrixType >::operator Field< cmptType >(), MatrixBlock< MatrixType >::operator Field< cmptType >(), isNotEqOp< T >::operator()(), minEqOpFace::operator()(), MapInternalField< Type, MeshMapper, surfaceMesh >::operator()(), procLess::operator()(), listPlusEqOp< T >::operator()(), ListPlusEqOp< T, Size >::operator()(), minEqOp< labelPair >::operator()(), faceEqOp< T, CombineOp >::operator()(), ifEqEqOp< value >::operator()(), combineEqOp< Type, TrackingData >::operator()(), findUniqueIntersectOp::operator()(), lessProcPatches::operator()(), treeDataPoint::findNearestOp::operator()(), inversePointDistanceDiffusivity::operator()(), inverseFaceDistanceDiffusivity::operator()(), treeDataCell::findNearestOp::operator()(), cellToCellStencil::unionEqOp::operator()(), cellToFaceStencil::unionEqOp::operator()(), treeDataEdge::findNearestOp::operator()(), treeDataPrimitivePatch< PatchType >::findNearestOp::operator()(), treeDataFace::findNearestOp::operator()(), powerSeriesReactionRate::operator()(), BiIndirectList< T >::operator()(), UIndirectList< Foam::Vector >::operator()(), treeDataCell::findIntersectOp::operator()(), offsetOp< labelledTri >::operator()(), fluxLimitedLangmuirHinshelwoodReactionRate::operator()(), UPstream::listEq::operator()(), RaviPetersen::operator()(), distributionMap::transform::operator()(), offsetOp< triFace >::operator()(), distributionMap::transformPosition::operator()(), ListOp< BinaryOp< Type > >::operator()(), ListEqOp< BinaryEqOp< Type > >::operator()(), ListAppendEqOp< T >::operator()(), offsetOp< face >::operator()(), globalMeshData::ListPlusEqOp< T >::operator()(), listUpdateOp< Type, TrackingData >::operator()(), transformOp< PrimitivePatchType, Type, TrackingData >::operator()(), fvMatrix< Type >::operator*=(), fvMatrix< Type >::operator/=(), Foam::triIntersect::operator<<(), Foam::operator<<(), BiIndirectList< T >::operator=(), SubField< Type >::operator=(), UIndirectList< Foam::Vector >::operator=(), CompactIOField< Type, BaseType >::operator=(), FieldField< Foam::fvPatchField, scalar >::operator=(), Distribution< Type >::operator=(), PtrList< transferModel >::operator=(), PackedBoolList::operator=(), cellTable::operator=(), GeometricBoundaryField< vector, pointPatchField, pointMesh >::operator=(), MatrixBlock< MatrixType >::operator=(), List< Field< scalar > >::operator=(), PackedList< 2 >::operator=(), Foam::operator==(), GeometricBoundaryField< vector, pointPatchField, pointMesh >::operator==(), Foam::operator>>(), MeshZones< cellZone, polyMesh >::operator[](), cell::opposingFace(), cell::opposingFaceLabel(), OppositeFaceCellWave< Type, TrackingData >::opposingFaceLabels(), triSurfaceTools::oppositeEdge(), triSurfaceTools::oppositeVertex(), coupledPolyPatch::order(), Foam::triIntersect::orderLocations(), orientedSurface::orient(), Foam::meshTools::otherEdge(), ListCompactIO< face, label >::overflows(), distributedTriSurfaceMesh::overlappingSurface(), treeDataFace::overlaps(), treeDataPrimitivePatch< PatchType >::overlaps(), dynamicIndexedOctree< Foam::dynamicTreeDataPoint >::overlaps(), indexedOctree< Foam::treeDataFace >::overlaps(), nonConformalBoundary::ownerOrigBoundaryEdgeMeshEdge(), nonConformalBoundary::ownerOrigBoundaryMeshEdges(), nonConformalBoundary::ownerOrigBoundaryPointMeshPoint(), PackedList< 2 >::PackedList(), CollisionRecordList< vector, vector >::pairAccessed(), CollisionRecordList< vector, vector >::pairData(), CollisionRecordList< vector, vector >::pairOrigIdOfOther(), CollisionRecordList< vector, vector >::pairOrigProcOfOther(), InflationInjection< CloudType >::parcelsToInject(), argList::parse(), Foam::parseNASCoord(), SortableListDRGEP< Type >::partialSort(), ParticleCollector< CloudType >::ParticleCollector(), patchToPatch::patchDistributionMap(), patchEjection::patchEjectedMassTotals(), patchEjection::patchEjection(), polyBoundaryMesh::patchFaceID(), valueMultiComponentMixture< ThermoType >::patchFaceThermoMixture(), coefficientWilkeMultiComponentMixture< ThermoType >::patchFaceTransportMixture(), valueMultiComponentMixture< ThermoType >::patchFaceTransportMixture(), heThermo< BasicSolidThermo, MixtureType >::patchFieldProperty(), polyBoundaryMesh::patchID(), patchInteractionDataList::patchInteractionDataList(), fvPatch::patchInternalField(), patchInternalField::patchInternalField(), pairPatchAgglomeration::patchLevel(), AMIInterpolation::patchMagSf(), patchMeanVelocityForce::patchMeanVelocityForce(), jumpCyclicFvPatchField< Type >::patchNeighbourField(), cyclicFvPatchField< Type >::patchNeighbourField(), nonConformalBoundary::patchPointOwnerOrigBoundaryPoints(), PatchPostProcessing< CloudType >::PatchPostProcessing(), polyBoundaryMesh::patchSet(), phasePropertiesList::phasePropertiesList(), specieTransferTemperatureFvPatchScalarField::phiHep(), specieTransferVelocityFvPatchVectorField::phip(), polyBoundaryMesh::physicalTypes(), pimpleMultiRegionControl::pimpleMultiRegionControl(), cyclicAMIPolyPatch::pointAMIAndFace(), sampledSurface::pointAverage(), pointBoundaryMesh::pointBoundaryMesh(), pointBoundaryMeshMapper::pointBoundaryMeshMapper(), primitiveMesh::pointCells(), polyMesh::pointInCell(), primitiveMesh::pointInCell(), PatchToPatchInterpolation< FromPatch, ToPatch >::pointInterpolate(), pointMapper::pointMapper(), pointMVCWeight::pointMVCWeight(), PatchTools::pointNormals(), primitiveMesh::pointPoints(), cell::points(), cellShape::points(), face::points(), treeBoundBox::points(), searchableSurfaceCollection::points(), PointEdgeWave< Type, TrackingData >::pointToEdge(), PrimitivePatchInterpolation< Foam::PrimitivePatch >::pointToFaceInterpolate(), fvMesh::polyBFacePatches(), polyBoundaryMesh::polyBoundaryMesh(), fvMesh::polyFacesBf(), polyMesh::polyMesh(), Foam::polyMeshUnMergeCyclics(), Foam::polyMeshZipUpCells(), Polynomial< Type >::Polynomial(), projectCurveEdge::position(), projectEdge::position(), blockEdge::position(), CloudFunctionObjectList< MomentumCloud< CloudType > >::postEvolve(), regionModelFunctionObjectList::postEvolveRegion(), CloudFunctionObjectList< MomentumCloud< CloudType > >::postFace(), FacePostProcessing< CloudType >::postFace(), CloudFunctionObjectList< MomentumCloud< CloudType > >::postMove(), ParticleCollector< CloudType >::postMove(), CloudFunctionObjectList< MomentumCloud< CloudType > >::postPatch(), Foam::pow(), powerLawLopesdaCostaZone::powerLawLopesdaCostaZone(), liquidMixtureProperties::Ppc(), CloudFunctionObjectList< MomentumCloud< CloudType > >::preEvolve(), regionModelFunctionObjectList::preEvolveRegion(), probes::prepare(), Foam::preservePatchTypes(), snappySnapDriver::preSmoothPatch(), fvModels::preUpdateMesh(), Foam::primitivePatchGetHalves(), dynamicIndexedOctree< Foam::dynamicTreeDataPoint >::print(), indexedOctree< Foam::treeDataFace >::print(), singleRegionCorrectorConvergenceControl::printCorrResidualControls(), fvMeshDistribute::printCoupleInfo(), fvMeshDistribute::printFieldInfo(), vtkUnstructuredReader::printFieldStats(), ListHashTable< T, Key, Hash >::printInfo(), distributionMapBase::printLayout(), distributionMap::printLayout(), fvMeshDistribute::printMeshInfo(), meshRefinement::printMeshInfo(), singleRegionConvergenceControl::printResidualControls(), GAMGProcAgglomeration::printStats(), Foam::printTable(), argList::printUsage(), GAMGAgglomeration::procAgglomerateRestrictAddressing(), processorGAMGInterface::processorGAMGInterface(), processorRunTimes::processorRunTimes(), collatedFileOperation::processorsDir(), processorTopology::processorTopology(), domainDecomposition::procFaceAddressingBf(), patchToPatch::procFacesToLocalFaces(), procLduMatrix::procLduMatrix(), profileModelList::profileModelList(), projectFace::project(), sampledSurface::project(), projectCurveEdge::projectCurveEdge(), projectEdge::projectEdge(), PrimitivePatch< IndirectList< face >, const pointField & >::projectFaceCentres(), PrimitivePatch< IndirectList< face >, const pointField & >::projectPoints(), projectVertex::projectVertex(), pairPatchAgglomeration::prolongField(), GAMGAgglomeration::prolongField(), valueMultiComponentMixture< ThermoType >::thermoMixture::psi(), noiseFFT::pt(), PtrList< transferModel >::PtrList(), liquidMixtureProperties::pv(), Fickian< unityLewisFourier< laminarThermophysicalTransportModel > >::q(), nonUnityLewisEddyDiffusivity< TurbulenceThermophysicalTransportModel >::q(), MaxwellStefan< unityLewisFourier< laminarThermophysicalTransportModel > >::q(), chemistryModel< ThermoType >::Qdot(), polygonTriangulate::quality(), radiativeIntensityRay::radiativeIntensityRay(), polygonTriangulate::randomPolygon(), distribution::raw(), patchToPatch::rDistributeTgt(), Foam::Re(), ReactingCloud< Foam::DSMCCloud >::ReactingCloud(), ReactingLookupTableInjection< CloudType >::ReactingLookupTableInjection(), ReactingMultiphaseLookupTableInjection< CloudType >::ReactingMultiphaseLookupTableInjection(), ReactionList< Foam::sutherlandTransport >::ReactionList(), fixedTrim::read(), PtrList< transferModel >::read(), NASedgeFormat::read(), thermalBaffleModel::read(), GTSsurfaceFormat< Face >::read(), NASsurfaceFormat< Face >::read(), porosityModelList::read(), OFFsurfaceFormat< Face >::read(), AC3DsurfaceFormat< Face >::read(), OBJedgeFormat::read(), VTKedgeFormat::read(), VTKsurfaceFormat< Face >::read(), writeDictionary::read(), TRIsurfaceFormat< Face >::read(), pimpleMultiRegionControl::read(), Fickian< unityLewisFourier< laminarThermophysicalTransportModel > >::read(), STARCDsurfaceFormat< Face >::read(), cloudSolution::read(), STARCDedgeFormat::read(), timeActivatedFileUpdate::read(), cloudInfo::read(), STLsurfaceFormat< Face >::read(), viewFactor::read(), fvConstraints::read(), wallHeatFlux::read(), writeObjectsBase::read(), sampledSets::read(), wallShearStress::read(), MaxwellStefan< unityLewisFourier< laminarThermophysicalTransportModel > >::read(), wallHeatTransferCoeff::read(), MRFZoneList::read(), kOmegaSSTSato< BasicMomentumTransportModel >::read(), nearWallFields::read(), repatchMesh::read(), uncollatedFileOperation::read(), sampledSurfaces::read(), fvModels::read(), regIOobject::read(), forces::read(), masterUncollatedFileOperation::read(), masterUncollatedFileOperation::readAndSend(), fieldAverage::readAveragingProperties(), STARCD::readBoundary(), damping::readCoeffs(), singleRegionCorrectorConvergenceControl::readCorrResidualControls(), externalCoupledMixedFvPatchField< scalar >::readData(), GeometricBoundaryField< vector, pointPatchField, pointMesh >::readField(), ReactingParcel< ParcelType >::readFields(), ReactingMultiphaseParcel< ParcelType >::readFields(), meshRefinement::readFlags(), functionObjectList::readFunctionObject(), masterUncollatedFileOperation::readHeader(), Maxwell< BasicMomentumTransportModel >::readModeCoefficients(), singleRegionConvergenceControl::readResidualControls(), repatchMesh::readTriSurface(), Foam::readUniformFields(), domainDecomposition::readUpdate(), surfMesh::readUpdate(), polyMesh::readUpdate(), ensightParts::recalculate(), InteractionLists< typename CloudType::parcelType >::receiveReferredData(), Foam::ReComplexField(), ensightPart::reconstruct(), Foam::fvc::reconstructMag(), triSurfaceTools::redGreenRefine(), EFA< ThermoType >::reduceMechanism(), DRG< ThermoType >::reduceMechanism(), PFA< ThermoType >::reduceMechanism(), DAC< ThermoType >::reduceMechanism(), DRGEP< ThermoType >::reduceMechanism(), meshRefinement::refineCandidates(), refinementFeatures::refinementFeatures(), refinementHistory::refinementHistory(), refinementRegions::refinementRegions(), refinementSurfaces::refinementSurfaces(), refiner::refiner(), refinementFeatures::regionEdgeTrees(), regionModelFunctionObjectList::regionModelFunctionObjectList(), regionModel::regionPatchID(), searchableSurfaceCollection::regions(), edgeMesh::regions(), triSurfaceMesh::regions(), regionSizeDistribution::regionSum(), Foam::ReImSum(), MRFZoneList::relative(), fvMatrix< Type >::relax(), cloudSolution::relaxCoeff(), ReactingCloud< Foam::DSMCCloud >::relaxSources(), UnsortedMeshedSurface< Face >::remapFaces(), cuttingPlane::remapFaces(), MeshedSurface< Foam::face >::remapFaces(), labelRanges::remove(), edgeIntersections::removeDegenerates(), dynamicIndexedOctree< Foam::dynamicTreeDataPoint >::removeIndex(), undoableMeshCutter::removeSplitFaces(), fileMonitorWatcher::removeWatch(), polyBoundaryMesh::renamePatches(), Foam::renumber(), randomRenumber::renumber(), manualRenumber::renumber(), ensightParts::renumber(), SloanRenumber::renumber(), zoltanRenumber::renumber(), springRenumber::renumber(), structuredRenumber::renumber(), renumberMethod::renumber(), ensightPart::renumber(), Foam::reorder(), UPtrList< Foam::diameterModels::sizeGroup >::reorder(), PtrList< transferModel >::reorder(), fvMeshTools::reorderPatches(), polyBoundaryMesh::reorderPatches(), Foam::ReorderPatchFields(), snappySnapDriver::repatchToSurface(), Foam::repeat(), FieldField< Foam::fvPatchField, scalar >::replace(), pointBoundaryMesh::reset(), GeometricBoundaryField< vector, pointPatchField, pointMesh >::reset(), ISAT::reset(), fvMesh::reset(), polyMesh::reset(), pimpleMultiRegionControl::resetCorrSolveIndex(), fieldAverage::resetFields(), polyMesh::resetPrimitives(), ReactingCloud< Foam::DSMCCloud >::resetSourceTerms(), LduMatrix< Type, DType, LUType >::residual(), lduMatrix::residual(), convergenceControl::residualControlIndex(), fvMeshStitcher::resizeBoundaryFieldPatchFields(), dynamicCode::resolveTemplates(), faceAreaWeightAMI::restartUncoveredSourceFace(), GAMGAgglomeration::restrictFaceField(), pairPatchAgglomeration::restrictField(), GAMGAgglomeration::restrictField(), kOmegaSSTLM< BasicMomentumTransportModel >::ReThetac(), kOmegaSSTLM< BasicMomentumTransportModel >::ReThetat0(), Foam::reusable(), Foam::reverseList(), SortableList< T >::reverseSort(), solidMixtureProperties::rho(), liquidMixtureProperties::rho(), rigidBodyMeshMotion::rigidBodyMeshMotion(), Field< PointType >::rmap(), noiseFFT::RMSmeanPf(), Roots< N >::Roots(), Foam::rotateList(), pimpleMultiRegionControl::run(), face::sameVertices(), patchProbes::sample(), probes::sample(), nearWallFields::sampleBoundaryField(), patch::sampleField(), triSurfaceMesh::sampleField(), patchInternalField::sampleField(), nearWallFields::sampleFields(), sampledSets::sampleLocalType(), sampledSurfaces::sampleLocalType(), sampledSurfaces::sampleType(), sampledSets::sampleType(), GeometricBoundaryField< vector, pointPatchField, pointMesh >::scalarInterfaces(), waveSuperposition::scale(), motionSmootherAlgo::scaleMesh(), ReactingCloud< Foam::DSMCCloud >::scaleSources(), Pstream::scatterList(), distributionMapBase::schedule(), Foam::search(), searchableSurfaceCollection::searchableSurfaceCollection(), searchableSurfaces::searchableSurfaces(), Foam::second(), timeSelector::select(), Foam::selectBox(), processorRunTimes::selectComplete(), Foam::selectCutEdges(), scalarRanges::selected(), timeSelector::selected(), Foam::selectManifoldEdges(), Foam::selectRegionNames(), meshRefinement::selectSeparatedCoupledFaces(), cloudSolution::semiImplicit(), distributionMapBase::send(), InteractionLists< typename CloudType::parcelType >::sendReferredData(), Foam::setBlockFaceCorrespondence(), kEpsilonLopesdaCosta< BasicMomentumTransportModel >::setCdSigma(), MPLIC::setCellAlphaf(), fvMeshSubset::setCellSubset(), decompositionMethod::setConstraints(), motionSmootherAlgo::setDisplacement(), motionSmootherAlgo::setDisplacementPatchFields(), PatchEdgeFaceWave< PrimitivePatchType, Type, TrackingData >::setEdgeInfo(), FvFaceCellWave< Type, TrackingData >::setFaceInfo(), FaceCellWave< Type, TrackingData >::setFaceInfo(), repatchMesh::setFeatureEdges(), searchableSurfaceCollection::setField(), surfaceFeatures::setFromStatus(), polyBoundaryMesh::setGroup(), PackedBoolList::setIndices(), hexRef8::setInstance(), pointPatchField< vector >::setInternalField(), fvMeshSubset::setLargeCellSubset(), pairPotential::setLookupTables(), epsilonWallFunctionFvPatchScalarField::setMaster(), omegaWallFunctionFvPatchScalarField::setMaster(), refinementSurfaces::setMinLevelFields(), cellVolumeWeightMethod::setNextCells(), faceAreaWeightAMI::setNextFaces(), mapNearestMethod::setNextNearestCells(), pointConstraints::setPatchFields(), PointEdgeWave< Type, TrackingData >::setPointInfo(), kEpsilonLopesdaCosta< BasicMomentumTransportModel >::setPorosityCoefficient(), kEpsilonLopesdaCosta< BasicMomentumTransportModel >::setPorosityCoefficients(), patchInjectionBase::setPositionAndCell(), duplicatePoints::setRefinement(), removeCells::setRefinement(), refinementIterator::setRefinement(), perfectInterface::setRefinement(), faceCollapser::setRefinement(), removePoints::setRefinement(), boundaryCutter::setRefinement(), tetDecomposer::setRefinement(), createShellMesh::setRefinement(), combineFaces::setRefinement(), meshCutAndRemove::setRefinement(), meshCutter::setRefinement(), edgeCollapser::setRefinement(), addPatchCellLayer::setRefinement(), hexRef8::setRefinement(), CompactListList< T >::setSize(), bufferedAccumulator< scalar >::setSizes(), Foam::setSnGrad(), processorRunTimes::setTime(), removePoints::setUnrefinement(), combineFaces::setUnrefinement(), hexRef8::setUnrefinement(), fvMatrix< Type >::setValue(), Foam::setValues(), fvMatrix< Type >::setValues(), UnsortedMeshedSurface< Face >::setZones(), parcelCloudList::Sh(), thermoSingleLayer::Sh(), treeDataCell::shapePoints(), treeDataEdge::shapePoints(), treeDataFace::shapePoints(), treeDataPrimitivePatch< PatchType >::shapePoints(), globalMeshData::sharedPointGlobalLabels(), globalMeshData::sharedPoints(), UPtrList< Foam::diameterModels::sizeGroup >::shuffle(), PtrList< transferModel >::shuffle(), eddyViscosity< LESModel< BasicMomentumTransportModel > >::sigma(), temperatureDependent::sigma(), liquidMixtureProperties::sigma(), cloud::sigmaEff(), parcelCloudList::sigmap(), searchableSurfacesQueries::signedDistance(), singleCellFvMesh::singleCellFvMesh(), SingleKineticRateDevolatilisation< CloudType >::SingleKineticRateDevolatilisation(), singleLayerRegion::singleLayerRegion(), singleProcessorFaceSetsConstraint::singleProcessorFaceSetsConstraint(), singleStepCombustion::singleStepCombustion(), UCompactListList< Foam::FvWallInfoData >::sizes(), FvFaceCellWave< Type, TrackingData >::sizesListList(), cellQuality::skewness(), Foam::fvc::smooth(), GaussSeidelSmoother::smooth(), symGaussSeidelSmoother::smooth(), TGaussSeidelSmoother< Type, DType, LUType >::smooth(), nonBlockingGaussSeidelSmoother::smooth(), motionSmootherAlgo::smooth(), snappyRefineDriver::snappyRefineDriver(), snGradScheme< Type >::snGrad(), solidBodyMotionSolver::solidBodyMotionSolver(), parcelThermo::solidId(), solidMixtureProperties::solidMixtureProperties(), Trapezoid::solve(), Euler::solve(), EulerSI::solve(), Rosenbrock12::solve(), rodas23::solve(), Rosenbrock23::solve(), RKCK45::solve(), rodas34::solve(), RKDP45::solve(), RKF45::solve(), Rosenbrock34::solve(), seulex::solve(), rigidBodyMeshMotionSolver::solve(), rigidBodyMeshMotion::solve(), GAMGSolver::solve(), chemistryModel< ThermoType >::solve(), thermalBaffle::solveEnergy(), Foam::triIntersect::solveProjection(), SortableListDRGEP< Type >::sort(), SortableListEFA< Type >::sort(), SortableList< T >::sort(), ParSortableList< Type >::sort(), SortableListEFA< Type >::SortableListEFA(), PatchTools::sortedEdgeFaces(), Foam::sortedOrder(), PatchTools::sortedPointEdges(), UnsortedMeshedSurface< Face >::sortedZones(), MeshedSurface< Foam::face >::sortFacesAndStore(), sortLabelledTri::sortLabelledTri(), extendedEdgeMesh::sortPointsAndEdges(), fileOperation::sortTimes(), fvModels::source(), ThermoSurfaceFilm< CloudType >::splashInteraction(), SlicedGeometricField< Type, PatchField, SlicedPatchField, GeoMesh >::splice(), meshRefinement::splitFaces(), meshRefinement::splitMesh(), meshRefinement::splitMeshRegions(), Foam::fvc::spread(), Foam::sqr(), patchToPatch::srcBox(), intersection::srcBoxStatic(), Foam::triIntersect::srcInTgt(), patchToPatch::srcPatchSendFaces(), AMIInterpolation::srcPointFace(), Foam::triIntersect::srcTriTgtPointIntersection(), nearest::srcWeights(), intersection::srcWeights(), parcelCloudList::Srho(), ReactingCloud< Foam::DSMCCloud >::Srho(), kinematicSingleLayer::Srho(), Foam::stabilise(), SortableListEFA< Type >::stableSort(), SortableListDRGEP< Type >::stableSort(), functionObjectList::start(), fvMeshStitcher::stitches(), MeshedSurface< Foam::face >::stitchFaces(), hexRef8::storeData(), parcelCloudList::storeGlobalPositions(), refinementHistory::storeSplit(), parcelCloudList::SU(), kinematicSingleLayer::SU(), subCycleFields< GeometricField >::subCycleFields(), cellZoneSet::subset(), pointZoneSet::subset(), Foam::subset(), faceZoneSet::subset(), refinementHistory::subset(), hexRef8::subset(), PackedBoolList::subsetIndices(), PatchTools::subsetMap(), Foam::subsetMatchingStrings(), UnsortedMeshedSurface< Face >::subsetMesh(), MeshedSurface< Foam::face >::subsetMesh(), triSurface::subsetMesh(), triSurface::subsetMeshMap(), Foam::ListListOps::subSizes(), fvMatrix< Type >::subtractFromInternalField(), globalIndexAndTransform::subtractTransformIndex(), layerAverage::sum(), Foam::sum(), LduMatrix< Type, DType, LUType >::sumA(), lduMatrix::sumA(), Foam::sumMag(), AMIInterpolation::sumWeights(), MPLIC::surfaceAlpha(), surfaceFeatures::surfaceFeatures(), surfaceFilm::surfaceFilm(), Foam::fvc::surfaceIntegrate(), surfaceIntersection::surfaceIntersection(), triSurfaceTools::surfaceNormal(), surfacePatchIOList::surfacePatchIOList(), triSurfaceTools::surfaceSide(), Foam::fvc::surfaceSum(), PrimitivePatch< IndirectList< face >, const pointField & >::surfaceType(), surfZoneIOList::surfZoneIOList(), SVD::SVD(), syncTools::swapBoundaryCellList(), syncTools::swapBoundaryCellPositions(), Foam::fvc::sweep(), parcelCloudList::SYi(), thermoSingleLayer::SYi(), faceSet::sync(), pointSet::sync(), faceZoneSet::sync(), syncTools::syncBoundaryFaceList(), globalMeshData::syncData(), syncTools::syncEdgeList(), syncTools::syncEdgeMap(), syncTools::syncFaceList(), fvMeshStitcher::synchronisedBoundaryField(), globalMeshData::syncPointData(), syncTools::syncPointList(), syncTools::syncPointMap(), pointConstraints::syncUntransformedData(), Foam::T(), TAB< CloudType >::TAB(), ParticleStressModel::tau(), liquidMixtureProperties::Tc(), chemistryModel< ThermoType >::tc(), meshRefinement::testSyncBoundaryFaceList(), meshRefinement::testSyncPointList(), tetOverlapVolume::tetOverlapVolume(), patchToPatch::tgtBox(), Foam::triIntersect::tgtInSrc(), patchToPatch::tgtPatchSendFaces(), AMIInterpolation::tgtPointFace(), nearest::tgtWeights(), intersection::tgtWeights(), ThermoLookupTableInjection< CloudType >::ThermoLookupTableInjection(), thermoSingleLayer::thermoSingleLayer(), temperatureDependentContactAngleForce::theta(), distributionContactAngleForce::theta(), perturbedTemperatureDependentContactAngleForce::theta(), parcelCloudList::theta(), targetCoeffTrim::thetag(), thirdBodyEfficiencies::thirdBodyEfficiencies(), Foam::triIntersect::thisIsOther(), subCycleFields< GeometricField >::time(), Time::Time(), InjectionModelList< Foam::MomentumCloud< CloudType > >::timeEnd(), pointToPointPlanarInterpolation::timeNames(), InjectionModelList< Foam::MomentumCloud< CloudType > >::timeStart(), meshToMeshAdjustTimeStepFunctionObject::timeToNextWrite(), functionObjectList::timeToNextWrite(), ListHashTable< T, Key, Hash >::toc(), InjectionModelList< Foam::MomentumCloud< CloudType > >::topoChange(), solidBodyMotionSolver::topoChange(), pointBoundaryMesh::topoChange(), duplicatePoints::topoChange(), patchInjectionBase::topoChange(), processorPolyPatch::topoChange(), componentDisplacementMotionSolver::topoChange(), ManualInjection< CloudType >::topoChange(), CellZoneInjection< CloudType >::topoChange(), ThermoLookupTableInjection< CloudType >::topoChange(), ReactingLookupTableInjection< CloudType >::topoChange(), fvConstraints::topoChange(), ReactingMultiphaseLookupTableInjection< CloudType >::topoChange(), removePoints::topoChange(), cellZoneSet::topoChange(), displacementLayeredMotionMotionSolver::topoChange(), boundaryCutter::topoChange(), pointZoneSet::topoChange(), FieldActivatedInjection< CloudType >::topoChange(), MomentumLookupTableInjection< CloudType >::topoChange(), faceZoneSet::topoChange(), externalDisplacementMeshMover::topoChange(), rigidBodyMeshMotion::topoChange(), tetDecomposer::topoChange(), combineFaces::topoChange(), polyBoundaryMesh::topoChange(), probes::topoChange(), fvModels::topoChange(), functionObjectList::topoChange(), faceZone::topoChange(), refinementHistory::topoChange(), addPatchCellLayer::topoChange(), motionSmootherAlgo::topoChange(), hexRef8::topoChange(), fvMesh::topoChange(), polyMesh::topoChange(), meshRefinement::topoChange(), polyTopoChanger::topoChangeRequest(), CV2D::toPoint2D(), regionModel::toPrimary(), regionModel::toRegion(), Distribution< Type >::totalWeight(), liquidMixtureProperties::Tpc(), liquidMixtureProperties::Tpt(), particle::trackToMovingTri(), MeshedSurface< Foam::face >::transcribe(), MeshedSurface< Foam::face >::transfer(), externalCoupledTemperatureMixedFvPatchScalarField::transferData(), externalCoupledMixedFvPatchField< scalar >::transferData(), patchToPatch::transferListList(), transferModelList::transferModelList(), thermoSingleLayer::transferPrimaryRegionSourceFields(), kinematicSingleLayer::transferPrimaryRegionSourceFields(), thermoSingleLayer::transferPrimaryRegionThermoFields(), Foam::transform(), fft::transform(), coupledPolyPatch::ownToNbrOrderData::transform(), sixDoFRigidBodyMotion::transform(), globalIndexAndTransform::transformPatches(), Foam::transformPoints(), EulerCoordinateRotation::transformVector(), STARCDCoordinateRotation::transformVector(), axesRotation::transformVector(), cylindrical::transformVector(), coefficientWilkeMultiComponentMixture< ThermoType >::transportMixture::transportMixture(), triSurfaceRegionSearch::treeByRegion(), MeshedSurface< Foam::face >::triangulate(), triSurfaceTools::triangulate(), triSurfaceTools::triangulateFaceCentre(), cellClassification::trimCutCells(), surfaceFeatures::trimFeatures(), intersection::triPointValues(), triSurface::triSurfInstance(), turbulentTemperatureCoupledBaffleMixedFvPatchScalarField::turbulentTemperatureCoupledBaffleMixedFvPatchScalarField(), turbulentTemperatureRadCoupledMixedFvPatchScalarField::turbulentTemperatureRadCoupledMixedFvPatchScalarField(), polyTopoChanger::types(), MeshZones< cellZone, polyMesh >::types(), GeometricBoundaryField< vector, pointPatchField, pointMesh >::types(), polyBoundaryMesh::types(), turbGen::U(), SRFModel::Uabs(), parcelCloudList::UCoeff(), waveVelocityFvPatchVectorField::Un(), fvMesh::unconform(), setWriter::unpackTypeValueSets(), PackedBoolList::unsetIndices(), UOprocess::UOprocess(), layeredEngine::update(), raw::update(), fvMeshMover::velocityMotionCorrection::update(), fvMeshTopoChanger::velocityMotionCorrection::update(), fvMeshDistributor::velocityMotionCorrection::update(), loadBalancer::update(), meshToMesh::update(), polyTopoChanger::update(), MRFZoneList::update(), CollisionRecordList< vector, vector >::update(), patch::update(), sampledSurfaces::update(), refiner::update(), AMIInterpolation::update(), cellMotionFvPatchField< Type >::updateCoeffs(), movingWallVelocityFvPatchVectorField::updateCoeffs(), fWallFunctionFvPatchScalarField::updateCoeffs(), v2WallFunctionFvPatchScalarField::updateCoeffs(), GeometricBoundaryField< vector, pointPatchField, pointMesh >::updateCoeffs(), kLowReWallFunctionFvPatchScalarField::updateCoeffs(), mappedVelocityFluxFixedValueFvPatchField::updateCoeffs(), freestreamVelocityFvPatchVectorField::updateCoeffs(), mappedFixedInternalValueFvPatchField< Type >::updateCoeffs(), variableHeightFlowRateFvPatchScalarField::updateCoeffs(), wideBandDiffusiveRadiationMixedFvPatchScalarField::updateCoeffs(), freestreamPressureFvPatchScalarField::updateCoeffs(), surfaceDisplacementPointPatchVectorField::updateCoeffs(), convectiveHeatTransferFvPatchScalarField::updateCoeffs(), greyDiffusiveRadiationMixedFvPatchScalarField::updateCoeffs(), alphatJayatillekeWallFunctionFvPatchScalarField::updateCoeffs(), alphatFilmWallFunctionFvPatchScalarField::updateCoeffs(), epsilonWallFunctionFvPatchScalarField::updateCoeffs(), thermalBaffle1DFvPatchScalarField< solidType >::updateCoeffs(), omegaWallFunctionFvPatchScalarField::updateCoeffs(), supersonicFreestreamFvPatchVectorField::updateCoeffs(), turbulentInletFvPatchField< Type >::updateCoeffs(), externalWallHeatFluxTemperatureFvPatchScalarField::updateCoeffs(), singleRegionCorrectorConvergenceControl::updateCorrSolveIndex(), pimpleMultiRegionControl::updateCorrSolveIndex(), patchEdgeFaceRegions::updateEdge(), fvDOM::updateG(), cyclicAMIGAMGInterfaceField::updateInterfaceMatrix(), cyclicGAMGInterfaceField::updateInterfaceMatrix(), jumpCyclicFvPatchField< Type >::updateInterfaceMatrix(), processorGAMGInterfaceField::updateInterfaceMatrix(), jumpCyclicAMIFvPatchField< Type >::updateInterfaceMatrix(), cyclicFvPatchField< Type >::updateInterfaceMatrix(), cyclicAMIFvPatchField< Type >::updateInterfaceMatrix(), processorFvPatchField< Type >::updateInterfaceMatrix(), edgeVertex::updateLabels(), meshRefinement::updateList(), ReactingParcel< ParcelType >::updateMassFraction(), LduMatrix< Type, DType, LUType >::updateMatrixInterfaces(), lduMatrix::updateMatrixInterfaces(), cylindrical::updatePoints(), cellZoneSet::updateSet(), pointZoneSet::updateSet(), faceZoneSet::updateSet(), fileMonitor::updateStates(), solution::upgradeSolverDict(), UpwindFitData< Polynomial >::UpwindFitData(), PackedBoolList::used(), USERD_get_gold_part_build_info(), USERD_get_gold_variable_info(), USERD_get_nsided_conn(), USERD_get_part_element_ids_by_type(), USERD_get_part_elements_by_type(), USERD_set_filenames(), parcelCloudList::UTrans(), cellToCellStencil::validBoundaryFaces(), cellToFaceStencil::validBoundaryFaces(), Distribution< Type >::validLimits(), Polynomial< Type >::value(), FieldFunction2< Type, ZeroConstant< Type > >::value(), FieldFunction1< Type, Sine< Type > >::value(), Table< scalar >::value(), PackedList< 2 >::values(), waveSuperposition::velocity(), Foam::vertices(), coordSet::vertices(), Foam::meshTools::visNormal(), polyMeshTools::volRatio(), heThermo< BasicSolidThermo, MixtureType >::volScalarFieldProperty(), InjectionModelList< Foam::MomentumCloud< CloudType > >::volumeToInject(), ThermoLookupTableInjection< CloudType >::volumeToInject(), ReactingLookupTableInjection< CloudType >::volumeToInject(), ReactingMultiphaseLookupTableInjection< CloudType >::volumeToInject(), MomentumLookupTableInjection< CloudType >::volumeToInject(), vtkUnstructuredReader::vtkUnstructuredReader(), W(), liquidMixtureProperties::W(), CollisionRecordList< vector, vector >::wallAccessed(), CollisionRecordList< vector, vector >::wallData(), wallLayerCells::wallLayerCells(), WallLocalSpringSliderDashpot< CloudType >::WallLocalSpringSliderDashpot(), CollisionRecordList< vector, vector >::wallPRel(), meshReader::warnDuplicates(), waveSuperposition::waveSuperposition(), extendedUpwindCellToFaceStencil::weightedSum(), extendedFaceToCellStencil::weightedSum(), extendedCellToFaceStencil::weightedSum(), meshRefinement::weightedSum(), midPoint< Type >::weights(), reverseLinear< Type >::weights(), outletStabilised< Type >::weights(), clippedLinear< Type >::weights(), limitedSurfaceInterpolationScheme< scalar >::weights(), face::which(), PrimitivePatch< IndirectList< face >, const pointField & >::whichEdge(), polyBoundaryMesh::whichPatch(), repatchMesh::whichPatch(), noiseFFT::window(), graph::wordify(), PhaseChangeModel< Foam::ReactingCloud< Foam::DSMCCloud > >::wordToEnthalpyTransfer(), ensightSetWriter::write(), ensightSurfaceWriter::write(), gnuplotSetWriter::write(), foamSurfaceWriter::write(), distribution::write(), X3DsurfaceFormat< Face >::write(), WRLsurfaceFormat< Face >::write(), PatchPostProcessing< CloudType >::write(), SMESHsurfaceFormat< Face >::write(), ReactionList< Foam::sutherlandTransport >::write(), GTSsurfaceFormat< Face >::write(), OBJsurfaceFormat< Face >::write(), thirdBodyEfficiencies::write(), AC3DsurfaceFormat< Face >::write(), OFFsurfaceFormat< Face >::write(), VTKsurfaceFormat< Face >::write(), OBJedgeFormat::write(), ensightBinaryStream::write(), TRIsurfaceFormat< Face >::write(), dsmcFields::write(), ensightAsciiStream::write(), components::write(), FacePostProcessing< CloudType >::write(), STARCDsurfaceFormat< Face >::write(), OFSsurfaceFormat< Face >::write(), writeDictionary::write(), moleFractions< ThermoType >::write(), residuals::write(), rigidBodyState::write(), cloudInfo::write(), OBJstream::write(), blockFace::write(), Distribution< Type >::write(), yPlus::write(), AveragingMethod< Foam::Vector >::write(), writeObjectsBase::write(), sampledSets::write(), fieldCoordinateSystemTransform::write(), histogram::write(), systemCall::write(), cellMatcher::write(), layerAverage::write(), nearWallFields::write(), ParticleCollector< CloudType >::write(), forceCoeffs::write(), sampledSurfaces::write(), waveSuperposition::write(), dimensionSet::write(), regionSizeDistribution::write(), streamlines::write(), sixDoFRigidBodyMotion::write(), rigidBodyModel::write(), PackedList< 2 >::write(), refiner::write(), volFieldValue::write(), surfaceFieldValue::write(), dynamicIndexedOctree< Foam::dynamicTreeDataPoint >::write(), meshRefinement::write(), STLsurfaceFormat< Face >::writeAscii(), correlationFunction< Type >::writeAveraged(), fieldAverage::writeAveragingProperties(), STLsurfaceFormat< Face >::writeBinary(), forces::writeBins(), STARCDsurfaceFormatCore::writeCase(), codedBase::writeCode(), domainDecomposition::writeComplete(), ensightPartFaces::writeConnectivity(), meshToMeshMethod::writeConnectivity(), edgeVertex::writeCuts(), porosityModelList::writeData(), ensightParts::writeData(), MRFZoneList::writeData(), polyBoundaryMesh::writeData(), externalCoupledMixedFvPatchField< scalar >::writeData(), ensightPart::writeData(), VTKedgeFormat::writeEdges(), pairPotential::writeEnergyAndForceTables(), Foam::writeEntry(), GeometricBoundaryField< vector, pointPatchField, pointMesh >::writeEntry(), AMIInterpolation::writeFaceConnectivity(), ensightParts::writeField(), ensightPart::writeField(), ensightPart::writeFieldList(), fieldAverage::writeFields(), ReactingParcel< ParcelType >::writeFields(), ReactingMultiphaseParcel< ParcelType >::writeFields(), residuals::writeFileHeader(), interfaceHeight::writeFileHeader(), fieldValueDelta::writeFileHeader(), forceCoeffs::writeFileHeader(), forces::writeFileHeader(), volFieldValue::writeFileHeader(), surfaceFieldValue::writeFileHeader(), ensightParts::writeGeometry(), ensightPart::writeGeometry(), externalCoupledMixedFvPatchField< scalar >::writeGeometry(), WRLsurfaceFormatCore::writeHeader(), VTKedgeFormat::writeHeader(), VTKsurfaceFormatCore::writeHeader(), OFSsurfaceFormatCore::writeHeader(), AC3DsurfaceFormatCore::writeHeader(), AMIMethod::writeIntersectionOBJ(), Foam::writeListEntries(), Foam::meshTools::writeOBJ(), coupledPolyPatch::writeOBJ(), triSurfaceTools::writeOBJ(), enrichedPatch::writeOBJ(), treeBoundBox::writeOBJ(), surfaceFeatures::writeObj(), extendedEdgeMesh::writeObj(), cellCuts::writeOBJ(), fvMesh::writeObject(), STARCDCore::writePoints(), domainDecomposition::writeProcs(), ensightParts::writeScalarField(), ensightPart::writeScalarField(), searchableSurfaces::writeStats(), MeshedSurface< Foam::face >::writeStats(), triSurface::writeStats(), extendedCellToFaceStencil::writeStencilStats(), ensightParts::writeSummary(), graph::writeTable(), setWriter::writeTable(), setWriter::writeTableHeader(), VTKsurfaceFormatCore::writeTail(), dynamicIndexedOctree< Foam::dynamicTreeDataPoint >::writeTreeInfo(), ensightParts::writeVectorField(), ensightPart::writeVectorField(), setWriter::writeWord(), graph::writer::writeXY(), moleculeCloud::writeXYZ(), liquidMixtureProperties::X(), CompositionModel< Foam::ThermoCloud< CloudType > >::X(), Table< scalar >::x(), liquidMixtureProperties::Xs(), liquidMixtureProperties::Y(), Table< scalar >::y(), nutUWallFunctionFvPatchScalarField::yPlus(), nutURoughWallFunctionFvPatchScalarField::yPlus(), MRFZone::zero(), MRFZoneList::zeroFilter(), meshRefinement::zonify(), ensightPartCells::~ensightPartCells(), ensightPartFaces::~ensightPartFaces(), externalCoupledMixedFvPatchField< scalar >::~externalCoupledMixedFvPatchField(), fileMonitorWatcher::~fileMonitorWatcher(), FSD::~FSD(), Gulders::~Gulders(), GuldersEGR::~GuldersEGR(), leastSquaresVectors::~leastSquaresVectors(), LeastSquaresVectors< Stencil >::~LeastSquaresVectors(), medialAxisMeshMover::~medialAxisMeshMover(), PstreamBuffers::~PstreamBuffers(), PtrList< transferModel >::~PtrList(), RaviPetersen::~RaviPetersen(), skewCorrectionVectors::~skewCorrectionVectors(), subCycleFields< GeometricField >::~subCycleFields(), and TRIsurfaceFormatCore::~TRIsurfaceFormatCore().

◆ forAllReverse

◆ forAllIter

#define forAllIter (   Container,
  container,
  iter 
)
Value:
for \
( \
Container::iterator iter = (container).begin(); \
iter != (container).end(); \
++iter \
)

Iterate across all elements in the container object of type.

Container.

Usage
forAll(ContainerType, container, iter)
{
statements;
}
See also
forAllConstIter

Definition at line 459 of file UList.H.

Referenced by meshObject::addPatch(), moleculeCloud::applyConstraintsAndThermostats(), genericPointPatchField< Type >::autoMap(), genericFvPatchField< Type >::autoMap(), Cloud< passiveParticle >::autoMap(), MomentumCloud< Foam::DSMCCloud >::buildCellOccupancy(), Stochastic< CloudType >::calculate(), moleculeCloud::calculateForce(), objectRegistry::checkCacheTemporaryObjects(), meshObject::clear(), meshObject::clearUpto(), SuppressionCollision< CloudType >::collide(), ORourkeCollision< CloudType >::collide(), kOmegaSSTSato< BasicMomentumTransportModel >::correctNut(), Cloud< passiveParticle >::deleteLostParticles(), dictionary::dictionary(), list::distribute(), motionSolverList::distribute(), meshObject::distribute(), distributionMapBase::exchangeAddressing(), if(), transformer::invTransformList(), objectRegistry::lookupClass(), Foam::MapConsistentVolFields(), Foam::MapLagrangianFields(), list::mapMesh(), motionSolverList::mapMesh(), meshObject::mapMesh(), Foam::MapVolFields(), Foam::min(), Cloud< passiveParticle >::move(), motionSolverList::movePoints(), meshObject::movePoints(), distributionMap::transformPosition::operator()(), probes::prepare(), fvMeshDistribute::printFieldInfo(), STARCD::readBoundary(), MomentumParcel< ParcelType >::readFields(), solidParticle::readFields(), DSMCParcel< ParcelType >::readFields(), MPPICParcel< ParcelType >::readFields(), streamlinesParticle::readFields(), ReactingParcel< ParcelType >::readFields(), CollidingParcel< ParcelType >::readFields(), molecule::readFields(), ReactingMultiphaseParcel< ParcelType >::readFields(), SprayParcel< ParcelType >::readFields(), ThermoParcel< ParcelType >::readFields(), particle::readFields(), InteractionLists< typename CloudType::parcelType >::receiveReferredData(), meshObject::reorderPatches(), genericPointPatchField< Type >::reset(), genericFvPatchField< Type >::reset(), genericPointPatchField< Type >::rmap(), genericFvPatchField< Type >::rmap(), motionSolverList::solve(), UnsortedMeshedSurface< Face >::sortedZones(), singleRegionSolutionControl::storePrevIterTypeFields(), list::topoChange(), motionSolverList::topoChange(), meshObject::topoChange(), transformer::transformList(), list::update(), loadBalancer::update(), solution::upgradeSolverDict(), while(), regionSizeDistribution::write(), CallbackRegistry< CallbackType >::~CallbackRegistry(), and undoableMeshCutter::~undoableMeshCutter().

◆ forAllConstIter

#define forAllConstIter (   Container,
  container,
  iter 
)
Value:
for \
( \
Container::const_iterator iter = (container).begin(); \
iter != (container).end(); \
++iter \
)

Iterate across all elements in the container object of type.

Container with const access.

Usage
forAllConstIter(ContainerType, container, iter)
{
statements;
}
See also
forAllIter

Definition at line 477 of file UList.H.

Referenced by greyMean::aCont(), wideBand::aCont(), singleProcessorFaceSetsConstraint::add(), sixDoFRigidBodyMotion::addConstraints(), sixDoFRigidBodyMotion::addRestraints(), fileOperation::addWatches(), masterUncollatedFileOperation::addWatches(), MomentumCloud< Foam::DSMCCloud >::alpha(), alphaContactAngleFvPatchScalarField::alphaContactAngleFvPatchScalarField(), boundaryRegion::append(), cellTable::append(), setToPointZone::applyToSet(), setToCellZone::applyToSet(), setToFaceZone::applyToSet(), setAndNormalToFaceZone::applyToSet(), normalToFace::applyToSet(), setsToFaceZone::applyToSet(), distribution::approxTotalEntries(), boundaryRegion::boundaryTypes(), nearWallFields::calcAddressing(), cellToFaceStencil::calcFaceStencil(), forces::calcForcesMoment(), cellMatcher::calcLocalFaces(), GAMGAgglomeration::calculateRegionMaster(), primitiveMesh::cellEdges(), primitiveMesh::cellPoints(), argList::check(), objectRegistry::checkCacheTemporaryObjects(), primitiveMesh::checkCommonOrder(), primitiveMesh::checkDuplicateFaces(), edgeCollapser::checkMeshQuality(), cellTable::combine(), hexRef8::consistentSlowRefinement(), patchPatchDist::correct(), pointPatchDist::correct(), advectionDiffusion::correct(), nearWallFields::createFields(), meshRefinement::createZoneBaffles(), dynamicMeshPointInterpolator::curPointField(), motionSolverList::curPoints(), DAC< ThermoType >::DAC(), structuredDecomp::decompose(), decompositionMethod::decompositionMethod(), dictionary::digest(), MomentumCloud< Foam::DSMCCloud >::Dij(), fvMeshDistribute::distribute(), MomentumCloud< Foam::DSMCCloud >::Dmax(), DRG< ThermoType >::DRG(), DRGEP< ThermoType >::DRGEP(), DSMCCloud< ParcelType >::dumpParticlePositions(), dynamicCodeContext::dynamicCodeContext(), edgeSurface::edgeSurface(), ejectionModelList::ejectionModelList(), turbulenceFields::execute(), cellClassification::fillRegionPoints(), functionObjectList::findDict(), Foam::blockMeshTools::findEntry(), boundaryRegion::findIndex(), cellTable::findIndex(), coupleGroupIdentifier::findOtherPatchID(), forceList::forceList(), fvConstraints::fvConstraints(), fvModels::fvModels(), genericFvPatchField< Type >::genericFvPatchField(), genericPointPatchField< Type >::genericPointPatchField(), get_edge_list(), undoableMeshCutter::getAddedCells(), surfaceSets::getHangingCells(), combineFaces::getMergeSets(), undoableMeshCutter::getSplitFaces(), greyMean::greyMean(), meshRefinement::growFaceCellFace(), kappaEff::htcByRhoCp(), if(), InjectionModelList< Foam::MomentumCloud< CloudType > >::InjectionModelList(), sweptFaceAreaWeightAMI::interArea(), DSMCCloud< ParcelType >::internalEnergyOfSystem(), dictionary::keys(), layerParameters::layerParameters(), lduPrimitiveMesh::lduPrimitiveMesh(), DSMCCloud< ParcelType >::linearKineticEnergyOfSystem(), MomentumCloud< Foam::DSMCCloud >::linearKineticEnergyOfSystem(), DSMCCloud< ParcelType >::linearMomentumOfSystem(), MomentumCloud< Foam::DSMCCloud >::linearMomentumOfSystem(), list::list(), Foam::listSwitches(), IOobjectList::lookup(), objectRegistry::lookupClass(), IOobjectList::lookupClass(), meshToMesh::mapAndOpTgtToSrc(), Foam::MapDimensionedFields(), DSMCCloud< ParcelType >::massInSystem(), MomentumCloud< Foam::DSMCCloud >::massInSystem(), cellTable::materialTypes(), cellToCellStencil::merge(), cellToFaceStencil::merge(), dictionary::merge(), edgeMesh::mergeEdges(), meshRefinement::mergePatchFacesUndo(), edgeMesh::mergePoints(), MGridGenGAMGAgglomeration::MGridGenGAMGAgglomeration(), objectRegistry::modified(), motionSolverList::motionSolverList(), MRFZone::MRFZone(), multiLevelDecomp::multiLevelDecomp(), multiSolidBodyMotionSolver::multiSolidBodyMotionSolver(), objectRegistry::names(), NamedEnum< compressibleField, 8 >::names(), boundaryRegion::names(), IOobjectList::names(), cellTable::names(), surfaceFeatures::nearestEdges(), surfaceFeatures::nearestSamples(), fvMeshStitcher::New(), cellCuts::nonAnchorPoints(), minEqOpFace::operator()(), ListPlusEqOp< T, Size >::operator()(), inversePointDistanceDiffusivity::operator()(), inverseFaceDistanceDiffusivity::operator()(), distributionMap::transformPosition::operator()(), dictionary::operator+=(), dictionary::operator<<=(), dictionary::operator=(), Foam::operator>>(), dictionary::operator|=(), Foam::parseNASCoord(), ParticleForceList< MomentumCloud< CloudType > >::ParticleForceList(), patchEjection::patchEjection(), patchDistMethod::patchTypes(), SprayCloud< Foam::DSMCCloud >::penetration(), PFA< ThermoType >::PFA(), phaseProperties::phaseProperties(), probes::prepare(), fvMeshDistribute::printFieldInfo(), argList::printNotes(), argList::printUsage(), domainDecomposition::procFaceAddressingBf(), ReactionList< Foam::sutherlandTransport >::ReactionList(), NASsurfaceFormat< Face >::read(), multiMotion::read(), wallHeatFlux::read(), wallShearStress::read(), wallHeatTransferCoeff::read(), functionObjectList::read(), turbulenceFields::read(), forces::read(), singleRegionCorrectorConvergenceControl::readCorrResidualControls(), coordinateSystems::readData(), GeometricBoundaryField< vector, pointPatchField, pointMesh >::readField(), Foam::readFields(), singleRegionConvergenceControl::readResidualControls(), Foam::readUniformFields(), refinementSurfaces::refinementSurfaces(), boundaryRegion::rename(), zoltanRenumber::renumber(), structuredRenumber::renumber(), MRFZoneList::reset(), porosityModelList::reset(), dynamicCode::reset(), faceAreaWeightAMI::restartUncoveredSourceFace(), MomentumCloud< Foam::DSMCCloud >::rhoEff(), rigidBodyMeshMotion::rigidBodyMeshMotion(), rigidBodyMeshMotionSolver::rigidBodyMeshMotionSolver(), rigidBodyModel::rigidBodyModel(), CollidingCloud< Foam::DSMCCloud >::rotationalKineticEnergyOfSystem(), nearWallFields::sampleBoundaryField(), motionSmootherAlgo::scaleMesh(), searchableSurfaceCollection::searchableSurfaceCollection(), searchableSurfaces::searchableSurfaces(), Foam::selectRegionNames(), cellTable::selectType(), hexRef8::setInstance(), fvMeshSubset::setLargeCellSubset(), duplicatePoints::setRefinement(), refinementIterator::setRefinement(), perfectInterface::setRefinement(), faceCollapser::setRefinement(), removePoints::setRefinement(), boundaryCutter::setRefinement(), undoableMeshCutter::setRefinement(), meshCutAndRemove::setRefinement(), meshCutter::setRefinement(), edgeCollapser::setRefinement(), displacementLayeredMotionMotionSolver::solve(), rigidBodyMeshMotionSolver::solve(), Cloud< passiveParticle >::storeGlobalPositions(), dictionary::substituteKeyword(), dictionary::substituteScopedKeyword(), surfaceIntersection::surfaceIntersection(), pointSet::sync(), faceSet::sync(), syncTools::syncEdgeMap(), syncTools::syncPointMap(), MomentumCloud< Foam::DSMCCloud >::theta(), ThermoCloud< Foam::DSMCCloud >::Tmax(), ThermoCloud< Foam::DSMCCloud >::Tmin(), dictionary::toc(), boundaryCutter::topoChange(), localPointRegion::topoChange(), meshCutAndRemove::topoChange(), meshCutter::topoChange(), hexRef8::topoChange(), distribution::totalEntries(), transferModelList::transferModelList(), globalIndexAndTransform::transformIndicesForPatches(), triSurfaceTools::triangulate(), triSurfaceTools::triangulateFaceCentre(), Foam::unitSet(), Foam::UnMapped(), loadBalancer::update(), refiner::update(), MPPICParcel< ParcelType >::trackingData::updateAverages(), edgeVertex::updateLabels(), USERD_get_part_coords(), USERD_get_part_node_ids(), MomentumCloud< Foam::DSMCCloud >::vDotSweep(), meshReader::warnDuplicates(), wideBand::wideBand(), wideBandCombustion::wideBandCombustion(), Foam::blockMeshTools::write(), RelativeVelocity< CloudType >::write(), jplotGraph::write(), gnuplotGraph::write(), xmgrGraph::write(), genericPointPatchField< Type >::write(), genericPolyPatch::write(), genericFvPatchField< Type >::write(), wallHeatFlux::write(), wallShearStress::write(), wallHeatTransferCoeff::write(), alphaContactAngleFvPatchScalarField::write(), thermalBaffleFvPatchScalarField::write(), turbulenceFields::write(), regionSizeDistribution::write(), dictionary::write(), domainDecomposition::writeComplete(), IOPosition< CloudType >::writeData(), MomentumParcel< ParcelType >::writeFields(), solidParticle::writeFields(), DSMCParcel< ParcelType >::writeFields(), MPPICParcel< ParcelType >::writeFields(), streamlinesParticle::writeFields(), CollidingParcel< ParcelType >::writeFields(), ReactingParcel< ParcelType >::writeFields(), molecule::writeFields(), ReactingMultiphaseParcel< ParcelType >::writeFields(), ThermoParcel< ParcelType >::writeFields(), SprayParcel< ParcelType >::writeFields(), particle::writeFields(), objectRegistry::writeObject(), Cloud< passiveParticle >::writePositions(), domainDecomposition::writeProcs(), graph::writeTable(), and moleculeCloud::writeXYZ().