Public Types | Public Member Functions | Static Public Member Functions | Protected Member Functions | Friends
List Class Reference

A 1D array of objects of type <T>, where the size of the vector is known and used for subscript bounds checking, etc. More...

Inherited by BinSum< IndexType, List, CombineOp >, cell, cellClassification, cellListPMG, cellShape, cellToCellStencil, cellToFaceStencil, face, faceListPMG, faceToCellStencil, faceTriangulation, ITstream, patchZones, polynomialFunction [private], ProcessorTopology< Container, ProcPatch >, regionSplit, surfacePatchIOList, surfZoneIOList, thirdBodyEfficiencies, and zone.

Public Types

typedef SubList< TsubList
 Declare type of subList. More...
 

Public Member Functions

 List ()
 Null constructor. More...
 
 List (const label)
 Construct with given size. More...
 
 List (const label, const T &)
 Construct with given size and value for all elements. More...
 
 List (const List< T > &)
 Copy constructor. More...
 
 List (const Xfer< List< T > > &)
 Construct by transferring the parameter contents. More...
 
 List (List< T > &, bool reUse)
 Construct as copy or re-use as specified. More...
 
 List (const UList< T > &, const labelUList &mapAddressing)
 Construct as subset. More...
 
template<class InputIterator >
 List (InputIterator first, InputIterator last)
 Construct given start and end iterators. More...
 
template<unsigned Size>
 List (const FixedList< T, Size > &)
 Construct as copy of FixedList<T, Size> More...
 
 List (const PtrList< T > &)
 Construct as copy of PtrList<T> More...
 
 List (const SLList< T > &)
 Construct as copy of SLList<T> More...
 
 List (const UIndirectList< T > &)
 Construct as copy of UIndirectList<T> More...
 
 List (const BiIndirectList< T > &)
 Construct as copy of BiIndirectList<T> More...
 
 List (Istream &)
 Construct from Istream. More...
 
autoPtr< List< T > > clone () const
 Clone. More...
 
 ~List ()
 Destructor. More...
 
label size () const
 Return the number of elements in the UList. More...
 
void resize (const label)
 Alias for setSize(const label) More...
 
void resize (const label, const T &)
 Alias for setSize(const label, const T&) More...
 
void setSize (const label)
 Reset size of List. More...
 
void setSize (const label, const T &)
 Reset size of List and value for new elements. More...
 
void clear ()
 Clear the list, i.e. set size to zero. More...
 
void append (const T &)
 Append an element at the end of the list. More...
 
void append (const UList< T > &)
 Append a List at the end of this list. More...
 
void append (const UIndirectList< T > &)
 Append a UIndirectList at the end of this list. More...
 
void transfer (List< T > &)
 Transfer the contents of the argument List into this list. More...
 
template<unsigned SizeInc, unsigned SizeMult, unsigned SizeDiv>
void transfer (DynamicList< T, SizeInc, SizeMult, SizeDiv > &)
 Transfer the contents of the argument List into this list. More...
 
void transfer (SortableList< T > &)
 Transfer the contents of the argument List into this list. More...
 
Xfer< List< T > > xfer ()
 Transfer contents to the Xfer container. More...
 
TnewElmt (const label)
 Return subscript-checked element of UList. More...
 
void operator= (const UList< T > &)
 Assignment from UList operator. Takes linear time. More...
 
void operator= (const List< T > &)
 Assignment operator. Takes linear time. More...
 
void operator= (const SLList< T > &)
 Assignment from SLList operator. Takes linear time. More...
 
void operator= (const UIndirectList< T > &)
 Assignment from UIndirectList operator. Takes linear time. More...
 
void operator= (const BiIndirectList< T > &)
 Assignment from BiIndirectList operator. Takes linear time. More...
 
void operator= (const T &)
 Assignment of all entries to the given value. More...
 
template<class T >
 List (const label s)
 
template<class T >
 List (const label s, const T &a)
 
template<class T >
 List (const List< T > &a)
 
template<class T >
 List (const Xfer< List< T > > &lst)
 
template<class T >
 List (List< T > &a, bool reUse)
 
template<class T >
 List (const UList< T > &a, const labelUList &map)
 
template<class T >
 List (const PtrList< T > &lst)
 
template<class T >
 List (const SLList< T > &lst)
 
template<class T >
 List (const UIndirectList< T > &lst)
 
template<class T >
 List (const BiIndirectList< T > &lst)
 
template<class T >
void transfer (List< T > &a)
 
template<class T >
void transfer (SortableList< T > &a)
 
template<class T >
 List ()
 
template<class T >
 List (Istream &is)
 

Static Public Member Functions

static const List< T > & null ()
 Return a null List. More...
 

Protected Member Functions

void size (const label)
 Override size to be inconsistent with allocated storage. More...
 

Friends

Istreamoperator>> (Istream &, List< T > &)
 Read List from Istream, discarding contents of existing List. More...
 

Detailed Description

A 1D array of objects of type <T>, where the size of the vector is known and used for subscript bounds checking, etc.

Storage is allocated on free-store during construction.

Source files

Definition at line 59 of file HashTable.H.

Member Typedef Documentation

◆ subList

typedef SubList<T> subList

Declare type of subList.

Definition at line 153 of file List.H.

Constructor & Destructor Documentation

◆ List() [1/26]

List ( )
inline

Null constructor.

◆ List() [2/26]

List ( const  label)
explicit

Construct with given size.

◆ List() [3/26]

List ( const  label,
const T  
)

Construct with given size and value for all elements.

◆ List() [4/26]

List ( const List< T > &  )

Copy constructor.

◆ List() [5/26]

List ( const Xfer< List< T > > &  )

Construct by transferring the parameter contents.

◆ List() [6/26]

List ( List< T > &  ,
bool  reUse 
)

Construct as copy or re-use as specified.

◆ List() [7/26]

List ( const UList< T > &  ,
const labelUList mapAddressing 
)

Construct as subset.

◆ List() [8/26]

List ( InputIterator  first,
InputIterator  last 
)

Construct given start and end iterators.

Definition at line 179 of file List.C.

◆ List() [9/26]

List ( const FixedList< T, Size > &  lst)
explicit

Construct as copy of FixedList<T, Size>

Definition at line 211 of file List.C.

◆ List() [10/26]

List ( const PtrList< T > &  )
explicit

Construct as copy of PtrList<T>

◆ List() [11/26]

List ( const SLList< T > &  )
explicit

Construct as copy of SLList<T>

◆ List() [12/26]

List ( const UIndirectList< T > &  )
explicit

Construct as copy of UIndirectList<T>

◆ List() [13/26]

List ( const BiIndirectList< T > &  )
explicit

Construct as copy of BiIndirectList<T>

◆ List() [14/26]

List ( Istream )

Construct from Istream.

◆ ~List()

~List ( )

Destructor.

◆ List() [15/26]

List ( const label  s)

Definition at line 43 of file List.C.

◆ List() [16/26]

List ( const label  s,
const T a 
)

Definition at line 63 of file List.C.

◆ List() [17/26]

List ( const List< T > &  a)

Definition at line 88 of file List.C.

◆ List() [18/26]

List ( const Xfer< List< T > > &  lst)

Definition at line 116 of file List.C.

◆ List() [19/26]

List ( List< T > &  a,
bool  reUse 
)

Definition at line 124 of file List.C.

◆ List() [20/26]

List ( const UList< T > &  a,
const labelUList map 
)

Definition at line 158 of file List.C.

◆ List() [21/26]

List ( const PtrList< T > &  lst)

Definition at line 229 of file List.C.

◆ List() [22/26]

List ( const SLList< T > &  lst)

Definition at line 247 of file List.C.

◆ List() [23/26]

List ( const UIndirectList< T > &  lst)

Definition at line 271 of file List.C.

◆ List() [24/26]

List ( const BiIndirectList< T > &  lst)

Definition at line 289 of file List.C.

◆ List() [25/26]

List ( )
inline

Definition at line 29 of file ListI.H.

◆ List() [26/26]

List ( Istream is)

Definition at line 36 of file ListIO.C.

Member Function Documentation

◆ size() [1/2]

void size ( const  label)
inlineprotected

Override size to be inconsistent with allocated storage.

Use with care.

Referenced by preserveBafflesConstraint::add(), polyMeshAdder::add(), extendedEdgeMesh::add(), polyMeshGenModifierAddCellByCell::addCell(), polyMeshGenModifier::addCell(), layerAdditionRemoval::addCellLayer(), multiDirRefinement::addCells(), polyMeshGenModifier::addCells(), cellTable::addCellZones(), surfaceZonesInfo::addCellZonesToMesh(), addPatchCellLayer::addedCells(), meshCutter::addEdgeCutsToFace(), mapPatchChange::addedPatches(), surfaceZonesInfo::addFaceZonesToMesh(), immersedBoundaryFvPatch::addIbCornerCells(), edgeSurface::addIntersectionEdges(), autoLayerDriver::addLayers(), polyTopoChange::addMesh(), chemkinReader::addPressureDependentReaction(), globalPoints::addSendTransform(), faceZoneSet::addSet(), addPatchCellLayer::addSideFace(), polyTopoChanger::addTopologyModifiers(), boundaryLayers::addWrapperLayer(), polyMesh::addZones(), primitiveMeshGeometry::affectedCells(), polyMeshGeometry::affectedCells(), manualGAMGProcAgglomeration::agglomerate(), singleCellFvMesh::agglomerate(), AMIInterpolation< SourcePatch, TargetPatch >::agglomerate(), singleCellFvMesh::agglomerateMesh(), pairPatchAgglomeration::agglomeratePatch(), extendedEdgeMesh::allNearestFeaturePoints(), UPstream::allocateCommunicator(), AMIInterpolation< SourcePatch, TargetPatch >::AMIInterpolation(), refineBoundaryLayers::analyseLayers(), ptscotchDecomp::append(), domainDecomposition::append(), AMIInterpolation< SourcePatch, TargetPatch >::append(), singleProcessorFaceSetsConstraint::apply(), mapDistribute::applyInverseTransforms(), searchableSurfaceToFaceZone::applyToSet(), setToCellZone::applyToSet(), faceZoneToFaceZone::applyToSet(), setToPointZone::applyToSet(), setToFaceZone::applyToSet(), setAndNormalToFaceZone::applyToSet(), setsToFaceZone::applyToSet(), face::areaInContact(), simpleGeomDecomp::assignToProcessorGroup(), attachDetach::attachInterface(), Field< Foam::Vector2D >::autoMap(), fvPatchField< Type >::autoMap(), extendedEdgeMesh::autoMap(), Foam::average(), autoSnapDriver::avgCellCentres(), meshRefinement::balance(), meshRefinement::balanceAndRefine(), Foam::bandCompression(), autoRefineDriver::bigGapOnlyRefine(), blockDescriptor::blockDescriptor(), booleanSurface::booleanSurface(), searchableSurfacesQueries::bounds(), moleculeCloud::buildConstProps(), InteractionLists< typename CloudType::parcelType >::buildInteractionLists(), InteractionLists< typename CloudType::parcelType >::buildMap(), tetherPotentialList::buildPotentials(), pairPotentialList::buildPotentials(), refinementFeatures::buildTrees(), cachedRandom::cachedRandom(), ReactingParcel::calc(), fvSurfaceMapper::calcAddressing(), cellMapper::calcAddressing(), fvPatchMapper::calcAddressing(), faceMapper::calcAddressing(), pointMapper::calcAddressing(), pointPatchMapper::calcAddressing(), meshToMesh0::calcAddressing(), PrimitivePatch< labelledTri, List, pointField, point >::calcAddressing(), isoSurfaceCell::calcAddressing(), meshSurfaceEngine::calcAddressingForProcEdges(), cellCuts::calcAnchors(), meshRefinement::calcCellCellRays(), primitiveMesh::calcCellCells(), primitiveMesh::calcCellEdges(), faceZone::calcCellLayers(), cellCuts::calcCellLoops(), primitiveMesh::calcCells(), CFCCellToCellStencil::calcCellStencil(), calcCurvature(), cuttingPlane::calcCutCells(), enrichedPatch::calcCutFaces(), isoSurfaceCell::calcCutType(), polyDualMesh::calcDual(), FECCellToFaceStencil::calcEdgeBoundaryData(), CECCellToCellStencil::calcEdgeBoundaryData(), polyMeshGenAddressing::calcEdgeFaces(), PrimitivePatch< labelledTri, List, pointField, point >::calcEdgeLoops(), triSurface::calcEdgeOwner(), faceTriangulation::calcEdges(), primitiveMesh::calcEdges(), motionSmootherAlgo::calcEdgeWeights(), enrichedPatch::calcEnrichedFaces(), addPatchCellLayer::calcExtrudeInfo(), PatchToPatchInterpolation< FromPatch, ToPatch >::calcFaceAddressing(), CFCFaceToCellStencil::calcFaceBoundaryData(), FECCellToFaceStencil::calcFaceStencil(), polyTopoChange::calcFaceZonePointMap(), polyDualMesh::calcFeatures(), meshSurfaceEngine::calcGlobalBoundaryEdgeLabels(), meshSurfaceEngine::calcGlobalBoundaryPointLabels(), globalMeshData::calcGlobalEdgeSlaves(), globalMeshData::calcGlobalPointBoundaryCells(), globalMeshData::calcGlobalPointBoundaryFaces(), globalMeshData::calcGlobalPointEdges(), displacementInterpolationMotionSolver::calcInterpolation(), LeastSquaresVectors< Stencil >::calcLeastSquaresVectors(), enrichedPatch::calcLocalFaces(), PrimitivePatch< labelledTri, List, pointField, point >::calcLocalPointOrder(), PrimitivePatch< labelledTri, List, pointField, point >::calcLocalPoints(), distributedTriSurfaceMesh::calcLocalQueries(), zone::calcLookupMap(), cellCuts::calcLoopsAndAddressing(), lduAddressing::calcLosortStart(), mappedPatchBase::calcMapping(), enrichedPatch::calcMasterPointFaces(), blockMesh::calcMergeInfo(), autoSnapDriver::calcNearestFace(), autoSnapDriver::calcNearestFacePointProperties(), meshRefinement::calcNeighbourData(), regionSplit::calcNonCompactRegionSplit(), AMIInterpolation< SourcePatch, TargetPatch >::calcOverlappingProcs(), lduAddressing::calcOwnerStart(), polyLine::calcParam(), triSurface::calcPatches(), polyTopoChange::calcPatchPointMap(), mapDistributePolyMesh::calcPatchSizes(), PatchToPatchInterpolation< FromPatch, ToPatch >::calcPointAddressing(), CPCCellToCellStencil::calcPointBoundaryData(), meshReader::calcPointCells(), primitiveMesh::calcPointCells(), globalMeshData::calcPointConnectivity(), intersectedSurface::calcPointEdgeAddressing(), edgeMesh::calcPointEdges(), PrimitivePatch< labelledTri, List, pointField, point >::calcPointEdges(), primitiveMesh::calcPointEdges(), PrimitivePatch< labelledTri, List, pointField, point >::calcPointFaces(), attachDetach::calcPointMatchMap(), primitiveMesh::calcPointOrder(), enrichedPatch::calcPointPoints(), primitiveMesh::calcPointPoints(), AMIInterpolation< SourcePatch, TargetPatch >::calcProcMap(), meshToMesh::calcProcMap(), surfaceSlipDisplacementPointPatchVectorField::calcProjection(), surfaceDisplacementPointPatchVectorField::calcProjection(), calcProximityOfFeatureEdges(), calcProximityOfFeaturePoints(), regionSplit::calcRegionSplit(), polyLineSet::calcSamples(), faceOnlySet::calcSamples(), uniformSet::calcSamples(), globalMeshData::calcSharedEdges(), globalMeshData::calcSharedPoints(), isoSurfaceCell::calcSnappedCc(), isoSurfaceCell::calcSnappedPoint(), triSurface::calcSortedEdgeFaces(), cellFeatures::calcSuperFaces(), thresholdCellFaces::calculate(), faceShading::calculate(), faceHeatShading::calculate(), correctedCellVolumeWeightMethod::calculate(), partialFaceAreaWeightAMI< SourcePatch, TargetPatch >::calculate(), directAMI< SourcePatch, TargetPatch >::calculate(), mapNearestAMI< SourcePatch, TargetPatch >::calculate(), faceAreaWeightAMI< SourcePatch, TargetPatch >::calculate(), viewFactor::calculate(), meshSurfaceEngine::calculateBoundaryNodes(), meshToMesh0::calculateCellToCellAddressing(), meshSurfacePartitioner::calculateCornersEdgesAndAddressing(), medialAxisMeshMover::calculateDisplacement(), meshSurfaceEngine::calculateEdgeFacesAddressing(), meshRefinement::calculateEdgeWeights(), boundaryLayerOptimisation::calculateHairEdges(), meshToMesh0::calculateInverseDistanceWeights(), meshToMesh0::calculateInverseVolumeWeights(), renameBoundaryPatches::calculateNewBoundary(), featureEdgesNeiOp::calculateNumberOfEdgesAtPoint(), meshSurfaceEngine::calculatePointFaces(), meshSurfaceEngine::calculatePointPoints(), solarLoad::calculateQdiff(), solarHeatLoad::calculateQdiff(), GAMGAgglomeration::calculateRegionMaster(), globalPoints::calculateSharedPoints(), hierarchGeomDecomp::calculateSortedWeightedSizes(), edgeExtractor::calculateValence(), tetOverlapVolume::cellCellOverlapMinDecomp(), polyMesh::cellShapePointCells(), dynamicRefineFvMesh::cellToPoint(), displacementLayeredMotionMotionSolver::cellZoneSolve(), repatchPolyTopoChanger::changeAnchorPoint(), boundaryMesh::changeFaces(), layerAdditionRemoval::changeTopology(), cellCuts::check(), faceZone::checkAddressing(), checkIrregularSurfaceConnections::checkAndFixCellGroupsAtBndVertices(), checkMeshDict::checkAnisotropicSources(), blockMesh::checkBlockMesh(), hexRef8::checkBoundaryOrientation(), primitiveMesh::checkCellsZipUp(), chemkinReader::checkCoeffs(), primitiveMesh::checkCommonOrder(), edgeExtractor::checkConcaveEdgeCells(), edgeExtractor::checkCorners(), Foam::checkCoupledPoints(), canopySource::checkData(), attachDetach::checkDefinition(), primitiveMesh::checkDuplicateFaces(), triSurface::checkEdges(), polyTopoChange::checkFace(), primitiveMesh::checkFaceAngles(), decomposeCells::checkFaceConnections(), primitiveMeshGeometry::checkFaceDotProduct(), Foam::polyMeshGenChecks::checkFaceDotProduct(), polyMeshGeometry::checkFaceFlatness(), primitiveMesh::checkFaceFlatness(), Foam::polyMeshGenChecks::checkFaceFlatness(), checkIrregularSurfaceConnections::checkFaceGroupsAtBndVertices(), primitiveMesh::checkFaceOrthogonality(), edgeExtractor::checkFacePatchesGeometry(), MeshedSurface< Foam::face >::checkFaces(), Foam::polyMeshGenChecks::checkFaceSkewness(), primitiveMeshGeometry::checkFaceTwist(), polyMeshGeometry::checkFaceTwist(), Foam::polyMeshGenChecks::checkFaceUniformity(), Foam::polyMeshGenChecks::checkFaceVertices(), primitiveMesh::checkFaceVertices(), sampledSurface::checkFieldSize(), checkFlatRegionEdge(), regIOobject::checkIn(), hexRef8::checkInternalOrientation(), searchableSurfaces::checkIntersection(), autoLayerDriver::checkManifold(), hexRef8::checkMesh(), checkMeshDict::checkObjectRefinements(), externalCoupledFunctionObject::checkOrder(), PatchTools::checkOrientation(), ZoneMesh< cellZone, polyMesh >::checkParallelSync(), polyBoundaryMesh::checkParallelSync(), checkMeshDict::checkPatchCellSize(), GAMGAgglomeration::checkRestriction(), checkMeshDict::checkSubsetCellSize(), Foam::checkTopology(), PrimitivePatch< labelledTri, List, pointField, point >::checkTopology(), boundaryLayers::checkTopologyOfBoundaryFaces(), polyMeshGeometry::checkTriangleTwist(), Foam::polyMeshGenChecks::checkUpperTriangular(), primitiveMesh::checkUpperTriangular(), MeshedSurface< Foam::face >::checkZones(), surfMesh::checkZones(), ensightPartFaces::classify(), extendedEdgeMesh::classifyEdge(), meshSurfaceCheckEdgeTypes::classifyEdges(), surfaceFeatures::classifyFeatureAngles(), extendedEdgeMesh::classifyFeaturePoint(), sampledSurfaces::classifyFields(), sampledSets::classifyFields(), CloudFunctionObjectList< KinematicCloud< CloudType > >::CloudFunctionObjectList(), Foam::cmptAv(), Foam::cmptMag(), Foam::cmptMax(), Foam::cmptMin(), cellShape::collapsedFaces(), triSurfaceTools::collapseEdges(), edgeCollapser::collapseFace(), isoSurfaceCell::collapseSurface(), edgeCollapser::collapseToEdge(), extendedCellToFaceStencil::collectData(), extendedFaceToCellStencil::collectData(), polyDualMesh::collectPatchInternalFace(), polyDualMesh::collectPatchSideFace(), mappedPatchBase::collectSamples(), DSMCCloud< DSMCParcel< ParcelType > >::collisions(), zoneToCell::combine(), zoneToFace::combine(), faceZoneToCell::combine(), rotatedBoxToCell::combine(), faceToCell::combine(), pointToFace::combine(), faceSource::combineMeshGeometry(), sampledSets::combineSampledSets(), sampledSets::combineSampledValues(), commSchedule::commSchedule(), polyTopoChange::compact(), mapDistributeBase::compact(), polyTopoChange::compactAndReorder(), face::compare(), removeFaces::compatibleRemoves(), externalCoupledFunctionObject::compositeName(), faceDecomposition::concaveVertex(), cellCuts::conservativeValidLoop(), edgeCollapser::consistentCollapse(), hexRef8::consistentSlowRefinement(), hexRef8::consistentSlowRefinement2(), meshToMesh::constructFromCuttingPatches(), vtkPV3Foam::convertFaceField(), vtkPV4Foam::convertFaceField(), vtkPV3Foam::convertPointField(), vtkPV4Foam::convertPointField(), triSurface::convertToTri(), vtkPV3Foam::convertVolField(), vtkPV4Foam::convertVolField(), coordinateModifier::coordinateModifier(), meshCutter::copyFace(), inversePointDistanceDiffusivity::correct(), limitTemperature::correct(), directionalPressureGradientExplicitSource::correct(), cellDistFuncs::correctBoundaryPointCells(), immersedBoundaryFvPatchField< Type >::correctDiag(), Histogram< List >::count(), localPointRegion::countPointRegions(), cyclicPolyPatch::coupledEdges(), cyclicPolyPatch::coupledPoints(), slidingInterface::coupleInterface(), Foam::cp(), meshRefinement::createBaffles(), tetCreatorOctree::createFaceCentreLabels(), Foam::help::createFaceFromRemovedPart(), boundaryLayers::createLayerCells(), triSurfaceMetaData::createMetaData(), boundaryLayers::createNewPartitionVerticesParallel(), boundaryLayers::createNewVertices(), meshOctreeAddressing::createOctreeFaces(), partTetMesh::createParallelAddressing(), edgeExtractor::cornerEvaluator::createParallelAddressing(), thermalBaffleFvPatchScalarField::createPatchMesh(), partTetMesh::createPointsAndTets(), partTriMesh::createPointsAndTrias(), meshReader::createPolyBoundary(), meshReader::createPolyCells(), createReconstructMap(), createShellMesh::createShellMesh(), tetCreatorOctree::createTetsFromFacesWithCentreNode(), meshRefinement::createZoneBaffles(), csvTableReader< Type >::csvTableReader(), displacementInterpolationMotionSolver::curPoints(), curvatureSeparation::curvatureSeparation(), hexCellLooper::cut(), cuttingPlane::cut(), geomCellLooper::cut(), topoCellLooper::cut(), extendedEdgeMesh::cut(), Foam::meshTools::cutDirToEdge(), autoRefineDriver::danglingCellRefine(), multiLevelDecomp::decompose(), manualDecomp::decompose(), noDecomp::decompose(), decompositionMethod::decompose(), correctEdgesBetweenPatches::decomposeConcaveFaces(), decomposeFaces::decomposeConcaveInternalFaces(), faceDecomposition::decomposeFace(), faceDecomposition::decomposeFaceIntoTriangles(), domainDecomposition::decomposeMesh(), decomposeFaces::decomposeMeshFaces(), scotchDecomp::decomposeOneProc(), slidingInterface::decoupleInterface(), triSurfaceTools::delaunay2D(), cellZoneSet::deleteSet(), pointZoneSet::deleteSet(), faceZoneSet::deleteSet(), attachDetach::detachInterface(), autoSnapDriver::detectWarpedFaces(), autoSnapDriver::determineBaffleFeatures(), refineBoundaryLayers::refineEdgeHexCell::determineFacesInDirections(), refineBoundaryLayers::refineCornerHexCell::determineFacesInDirections(), dimensionSets::dimensionSets(), refinementHistory::distribute(), mapDistributeBase::distribute(), distributedTriSurfaceMesh::distribute(), mapDistribute::distribute(), meshToMesh::distributeAndMergeCells(), AMIInterpolation< SourcePatch, TargetPatch >::distributeAndMergePatches(), meshSurfaceEdgeExtractor2D::distributeBoundaryFaces(), edgeExtractor::distributeBoundaryFaces(), meshToMesh::distributeCells(), meshOctreeModifier::distributeLeavesToProcessors(), AMIInterpolation< SourcePatch, TargetPatch >::distributePatches(), distributedTriSurfaceMesh::distributeSegments(), indexedOctree< Foam::treeDataFace >::divide(), autoLayerDriver::doLayers(), triSurfaceTools::doRefine(), fvMeshDistribute::doRemoveCells(), meshRefinement::doRemovePoints(), meshRefinement::doRestorePoints(), meshRefinement::doSplitFaces(), RaviPetersen::dPolynomial(), polyDualMesh::dualPatch(), meshRefinement::dumpIntersections(), Foam::duplicateOrder(), dynamicRefineFvMesh::dynamicRefineFvMesh(), extendedEdgeMesh::edgeBaffles(), primitiveMesh::edgeFaces(), extendedEdgeMesh::edgeNormals(), PatchTools::edgeOwner(), cellModel::edges(), edgeCollapser::edgesFromPoints(), triSurfaceTools::edgeSide(), edgeSurface::edgeSurface(), orientedSurface::edgeToFace(), triSurfaceMesh::edgeTree(), globalIndexAndTransform::encodeTransformIndex(), meshOctreeModifier::ensureCorrectRegularity(), meshOctreeModifier::ensureCorrectRegularitySons(), directionInfo::enterDomain(), Pstream::exchange(), mapDistributeBase::exchangeAddressing(), Foam::help::exchangeMap(), meshOctree::exchangeRequestsWithNeighbourProcessors(), fieldValueDelta::execute(), extendedEdgeMesh::extendedEdgeMesh(), extendedFeatureEdgeMesh::extendedFeatureEdgeMesh(), extendedUpwindCellToFaceStencil::extendedUpwindCellToFaceStencil(), vtkUnstructuredReader::extractCells(), extrudedMesh::extrudedCells(), extrudedMesh::extrudedFaces(), extrudePatchMesh::extrudeMesh(), extrudePatchMesh::extrudePatchMesh(), faceCoupleInfo::faceCoupleInfo(), primitiveMesh::faceEdges(), fvMeshSubset::faceFlipMap(), hexRef8::faceLevel(), meshSurfaceMapper::faceMetricInPatch(), combineFaces::faceNeighboursValid(), mappedPatchBase::facePoint(), polyTopoChange::facePoints(), FacePostProcessing< CloudType >::FacePostProcessing(), cellModel::faces(), searchableSurfacesQueries::facesIntersection(), hexMatcher::faceSizeMatch(), prismMatcher::faceSizeMatch(), pyrMatcher::faceSizeMatch(), tetMatcher::faceSizeMatch(), tetWedgeMatcher::faceSizeMatch(), wedgeMatcher::faceSizeMatch(), orientedSurface::faceToEdge(), PrimitivePatchInterpolation< Patch >::faceToEdgeInterpolate(), displacementLayeredMotionMotionSolver::faceZoneEvaluate(), autoSnapDriver::featureAttractionUsingReconstruction(), featureEdgeMesh::featureEdgeMesh(), autoRefineDriver::featureEdgeRefine(), extendedEdgeMesh::featurePointNormals(), Foam::fftRenumberRecurse(), cellClassification::fillRegionEdges(), surfaceIntersection::filterEdges(), surfaceIntersection::filterLabels(), parLagrangianRedistributor::filterObjects(), refinementSurfaces::findAllHigherIntersections(), searchableSurfacesQueries::findAllIntersections(), hierarchGeomDecomp::findBinary(), surfaceMorpherCells::findBoundaryVertices(), immersedBoundaryFvPatch::findCellCells(), checkNonMappableCellConnections::findCells(), meshRefinement::findCellZoneInsideWalk(), Time::findClosestTime(), parLagrangianRedistributor::findClouds(), edgeExtractor::findCornerCandidates(), fvMeshDistribute::findCouples(), meshCutAndRemove::findCutCell(), meshCutter::findCutCell(), faceTriangulation::findDiagonal(), autoSnapDriver::findDiagonalAttraction(), localPointRegion::findDuplicateFacePairs(), edgeExtractor::findEdgeCandidates(), meshRefinement::findEdgeConnectedProblemCells(), patchProbes::findElements(), Foam::findEtcFile(), edgeExtractor::findFeatureEdgesNearEdge(), detectBoundaryLayers::findHairsForFace(), refinementSurfaces::findHigherIntersection(), refinementSurfaces::findHigherLevel(), ignitionSite::findIgnitionCells(), cellVolumeWeightMethod::findInitialSeeds(), mapNearestMethod::findInitialSeeds(), directMethod::findInitialSeeds(), Time::findInstance(), meshSurfaceOptimizer::findInvertedVertices(), distributedTriSurfaceMesh::findLine(), searchableSurfaceWithGaps::findLine(), distributedTriSurfaceMesh::findLineAll(), faceCoupleInfo::findMappedEdges(), autoSnapDriver::findMultiPatchPoint(), distributedTriSurfaceMesh::findNearest(), meshRefinement::findNearest(), refinementSurfaces::findNearestRegion(), meshUntangler::cutRegion::findNewFaces(), triangulateNonPlanarBaseFaces::findNonPlanarBoundaryFaces(), coupleGroupIdentifier::findOtherPatchID(), boundaryLayers::findPatchesToBeTreatedTogether(), polyMeshAdder::findSharedPoints(), faceTriangulation::findStart(), interpolationCellPointFace< Type >::findTet(), pointToPointPlanarInterpolation::findTime(), Time::findTimes(), interpolationCellPointFace< Type >::findTriangle(), meshOctreeAddressing::findUsedBoxes(), polyMeshGen2DEngine::findZMaxOffsetPoints(), polyMeshGen2DEngine::findZMaxPointLabels(), polyMeshGen2DEngine::findZMinOffsetPoints(), polyMeshGen2DEngine::findZMinPointLabels(), GatherBase::flatten(), forceList::forceList(), meshRefinement::freeStandingBaffles(), FreeStream< CloudType >::FreeStream(), faceCorrectedSnGrad< Type >::fullGradCorrection(), autoRefineDriver::gapOnlyRefine(), globalIndex::gather(), lduPrimitiveMesh::gather(), externalCoupledFunctionObject::gatherAndCombine(), GAMGAgglomeration::gatherList(), Pstream::gatherList(), GAMGSolver::gatherMatrices(), gaussConvectionScheme< Type >::gaussConvectionScheme(), Foam::gAverage(), refineBoundaryLayers::generateNewCells(), refineBoundaryLayers::generateNewFaces(), isoSurface::generateTriPoints(), genericFvPatchField< Type >::genericFvPatchField(), isoSurfaceCell::genPointTris(), midPointSet::genSamples(), coupledPolyPatch::getAnchorPoints(), autoLayerDriver::getBafflesOnAddedMesh(), STARCD::getCellTable(), meshRefinement::getChangedFaces(), triSurfaceTools::getCollapsedFaces(), polyDualMesh::getFaceOrder(), polyMeshAdder::getFaceOrder(), getFaceOrder(), polyTopoChange::getFaceOrder(), searchableSurfaceCollection::getField(), triSurfaceMesh::getField(), distributedTriSurfaceMesh::getField(), oldCyclicPolyPatch::getGeometricHalves(), meshRefinement::getIntersections(), autoLayerDriver::getLayerCellsFaces(), hexRef8::getLevel0EdgeLength(), meshRefinement::getMasterEdges(), meshRefinement::getMasterPoints(), triSurfaceTools::getMergedEdges(), combineFaces::getMergeSets(), polyTopoChange::getMergeSets(), walkPatch::getNeighbour(), searchablePlane::getNormal(), searchableSphere::getNormal(), searchablePlate::getNormal(), searchableDisk::getNormal(), searchableCylinder::getNormal(), searchableSurfaceCollection::getNormal(), searchableBox::getNormal(), triSurfaceMesh::getNormal(), searchableCone::getNormal(), distributedTriSurfaceMesh::getNormal(), combineFaces::getOutsideFace(), patchCorrectedInterpolation::getPatchGroups(), getPatchIds(), ParSortableList< Type >::getPivots(), cellDistFuncs::getPointNeighbours(), triSurfaceMeshPointSet::getRefPoint(), searchablePlane::getRegion(), searchableSphere::getRegion(), searchablePlate::getRegion(), searchableDisk::getRegion(), searchableCylinder::getRegion(), searchableRotatedBox::getRegion(), searchableSurfaceCollection::getRegion(), searchableBox::getRegion(), triSurfaceMesh::getRegion(), searchableCone::getRegion(), distributedTriSurfaceMesh::getRegion(), getRegionFaceOrder(), coupledPolyPatch::getRotation(), hexRef8::getSplitPoints(), topoCellLooper::getSuperEdge(), removePoints::getUnrefimentSet(), cellLooper::getVertEdgesNonFace(), triSurfaceTools::getVertexTriangles(), addPatchCellLayer::globalEdgeFaces(), triSurfaceTools::greenRefine(), autoLayerDriver::growNoExtrusion(), boundaryLayerOptimisation::hairEdgesAtBndFace(), FaceCellWave< Type, int >::handleAMICyclicPatches(), PointEdgeWave< Type, TrackingData >::handleCollocatedPoints(), medialAxisMeshMover::handleFeatureAngleLayerTerminations(), autoLayerDriver::handleNonManifolds(), FaceCellWave< Type, int >::handleProcPatches(), autoLayerDriver::handleWarpedFaces(), polyTopoChange::hasValidPoints(), hexRef8::hexRef8(), immersedBoundaryFvPatchField< Type >::imposeDirichletCondition(), immersedBoundaryFvPatchField< Type >::imposeNeumannCondition(), Distribution::index(), FreeStream< CloudType >::inflow(), diffusionMulticomponent< CombThermoType, ThermoType >::init(), singleLayerRegion::initialise(), contactAngleForce::initialise(), DSMCCloud< DSMCParcel< ParcelType > >::initialise(), directionalPressureGradientExplicitSource::initialise(), externalCoupledFunctionObject::initialise(), effectivenessHeatExchangerSource::initialise(), faceSource::initialise(), fluxSummary::initialiseCellZoneAndDirection(), fluxSummary::initialiseFaceZone(), fluxSummary::initialiseFaceZoneAndDirection(), moleculeCloud::initialiseMolecules(), LduMatrix< Type, DType, LUType >::initMatrixInterfaces(), lduMatrix::initMatrixInterfaces(), polyMesh::initMesh(), processorPolyPatch::initOrder(), InjectionModelList< Foam::KinematicCloud< Foam::DSMCCloud > >::InjectionModelList(), edgeIntersections::inlinePerturb(), searchableCone::insertHit(), distribution::insertMissingKeys(), polyMeshAdder::insertVertices(), polynomialFunction::integrate(), linearInterpolationWeights::integrationWeights(), interpolationCellPointFace< Type >::interpolate(), singleCellFvMesh::interpolate(), fvMeshSubset::interpolate(), Foam::interpolatePointToCell(), lookupProfile::interpolateWeights(), bladeModel::interpolateWeights(), edgeIntersections::intersectEdges(), cuttingPlane::intersectEdges(), intersectedSurface::intersectedSurface(), RaviPetersen::interval(), gradingDescriptors::inv(), pyrMatcher::isA(), tetWedgeMatcher::isA(), hexMatcher::isA(), prismMatcher::isA(), tetMatcher::isA(), wedgeMatcher::isA(), localPointRegion::isDuplicate(), autoSnapDriver::isFeaturePoint(), ensightPart::isFieldDefined(), isoSurface::isoSurface(), isoSurfaceCell::isoSurfaceCell(), meshStructure::isStructuredCell(), cell::labels(), landuseClass::LAD(), lduPrimitiveMesh::lduPrimitiveMesh(), lineDivide::lineDivide(), Pstream::listCombineGather(), meshOctreeCreator::loadDistribution(), meshOctreeModifier::loadDistribution(), Foam::loadOrCreateMesh(), globalPoints::localToMeshPoint(), basicThermo::lookupThermo(), cellCuts::loopAnchorConsistent(), cellCuts::loopPoints(), meshCutAndRemove::loopToFace(), meshCutter::loopToFace(), cellCuts::loopWeights(), Foam::mag(), Foam::magSqr(), main(), polyMeshGenAddressing::makeCellCentresAndVols(), primitiveMesh::makeCellCentresAndVols(), polyTopoChange::makeCells(), sampledSurface::makeCf(), hexCellLooper::makeFace(), polyMeshGenAddressing::makeFaceCentresAndAreas(), primitiveMesh::makeFaceCentresAndAreas(), PrimitivePatchInterpolation< Patch >::makeFaceToPointWeights(), immersedBoundaryFvPatch::makeIbCellCells(), immersedBoundaryFvPatch::makeIbFaces(), immersedBoundaryFvPatch::makeIbPointsAndNormals(), immersedBoundaryFvPatch::makeIbSamplingWeights(), volPointInterpolation::makeInternalWeights(), immersedBoundaryFvPatch::makeInvDirichletMatrices(), immersedBoundaryFvPatch::makeInvNeumannMatrices(), autoLayerDriver::makeLayerDisplacementField(), ParticleCollector< CloudType >::makeLogFile(), sampledSurface::makeMagSf(), faceCoupleInfo::makeMap(), makePatchFromSubset(), pointConstraints::makePatchPatchAddressing(), sampledSurface::makeSf(), immersedBoundaryFvPatch::makeTriAddressing(), immersedBoundaryFvPatch::makeTriSf(), mapDistribute::mapDistribute(), mapDistributeBase::mapDistributeBase(), fvMesh::mapFields(), Foam::MapLagrangianFields(), meshToMesh::mapSrcToTgt(), fvMeshAdder::MapSurfaceField(), meshToMesh::mapTgtToSrc(), meshSurfaceMapper::mapVerticesOntoSurface(), meshSurfaceMapper::mapVerticesOntoSurfacePatches(), fvMeshAdder::MapVolField(), cellClassification::markCells(), refinementHistory::markCommonCells(), meshRefinement::markFacesOnProblemCells(), meshRefinement::markFeatureCellLevel(), meshOctreeInsideOutside::markInsideCubes(), meshRefinement::markInternalDistanceToFeatureRefinement(), meshRefinement::markInternalGapRefinement(), meshRefinement::markInternalRefinement(), edgeCollapser::markMergeEdges(), edgeExtractor::markPatchPoints(), meshRefinement::markPatchZones(), meshRefinement::markProximityRefinement(), meshRefinement::markSurfaceCurvatureRefinement(), meshRefinement::markSurfaceGapRefinement(), meshRefinement::markSurfaceRefinement(), patchZones::markZone(), PatchTools::markZone(), boundaryMesh::markZone(), triSurface::markZone(), PatchTools::markZones(), triSurface::markZones(), momentOfInertia::massPropertiesShell(), momentOfInertia::massPropertiesSolid(), degenerateMatcher::match(), faceCoupleInfo::matchEdgeFaces(), processorPolyPatch::matchFace(), faceCoupleInfo::matchFaces(), hexRef8::matchHexShape(), faceCoupleInfo::matchPointsThroughFaces(), Foam::max(), refinementSurfaces::maxGapLevel(), Foam::maxMagSqr(), distribution::median(), Distribution::median(), cellToCellStencil::merge(), cellToFaceStencil::merge(), edgeIntersections::merge(), distributedTriSurfaceMesh::merge(), meshRefinement::mergeBaffles(), meshRefinement::mergeEdgesUndo(), removeFaces::mergeFaces(), polyMeshAdder::mergeFaceZones(), meshRefinement::mergeFreeStandingBaffles(), VRWGraphSMPModifier::mergeGraphs(), VRWGraph::mergeGraphs(), searchableSurfacesQueries::mergeHits(), globalPoints::mergeInfo(), booleanSurface::mergePatches(), meshRefinement::mergePatchFaces(), meshRefinement::mergePatchFacesUndo(), triSurfaceTools::mergePoints(), globalMeshData::mergePoints(), extendedEdgeMesh::mergePointsAndSort(), polyMeshAdder::mergePrimitives(), mergeSurfacePatches(), meshRefinement::mergeZoneBaffles(), cellShape::meshEdges(), PrimitivePatch< labelledTri, List, pointField, point >::meshEdges(), MeshedSurface< Foam::face >::MeshedSurface(), cellShape::meshFaces(), momentOfInertia::meshInertia(), meshOctreeInsideOutside::meshOctreeInsideOutside(), meshTriangulation::meshTriangulation(), Foam::min(), Foam::minMagSqr(), fieldSmoother::minSmoothField(), Foam::help::modifyFacesToShareOneEdge(), attachDetach::modifyMotionPoints(), slidingInterface::modifyMotionPoints(), surfaceMorpherCells::morphInternalFaces(), surfaceMorpherCells::morphMesh(), searchableSurfacesQueries::morphTet(), Cloud< streamLineParticle >::move(), regionModel1D::moveMesh(), primitiveMesh::movePoints(), edgeExtractor::moveVerticesTowardsDiscontinuities(), multiDirRefinement::multiDirRefinement(), Foam::multiply(), multiSolidBodyMotionFvMesh::multiSolidBodyMotionFvMesh(), addPatchCellLayer::nbrFace(), surfaceFeatures::nearestEdges(), surfaceFeatures::nearestFeatEdge(), meshRefinement::nearestPatch(), surfaceFeatures::nearestSamples(), surfaceFeatures::nearestSurfEdge(), cellModel::nEdges(), PrimitivePatch< labelledTri, List, pointField, point >::nEdges(), primitiveMesh::nEdges(), polyBoundaryMesh::neighbourEdges(), basicChemistryModel::New(), basicSolidChemistryModel::New(), fvMeshTools::newMesh(), cellModel::nFaces(), vtkMesh::nFieldCells(), vtkMesh::nFieldPoints(), potential::nIds(), surfaceFeatures::nInternalEdges(), cellCuts::nonAnchorPoints(), surfaceLocation::normal(), distribution::normalisedShifted(), meshToMesh::normaliseWeights(), AMIInterpolation< SourcePatch, TargetPatch >::normaliseWeights(), PrimitivePatch< labelledTri, List, pointField, point >::nPoints(), refinementSurfaces::nRegions(), GatherBase::offset(), offsetSurface::offsetSurface(), dlLibraryTable::open(), polynomialFunction::operator+=(), polynomialFunction::operator-=(), Foam::operator<<(), cellListPMG::operator=(), faceListPMG::operator=(), cellTable::operator=(), Foam::operator==(), Foam::operator>>(), cell::opposingFace(), cell::opposingFaceLabel(), tetMeshOptimisation::optimiseUsingKnuppMetric(), tetMeshOptimisation::optimiseUsingMeshUntangler(), processorPolyPatch::order(), cellCuts::orientPlanesAndLoops(), extrudeLayer::addressingCalculator::origPoint(), extrudeLayer::addressingCalculator::origPointLabel(), triSurfaceTools::otherFace(), distributedTriSurfaceMesh::overlappingSurface(), argList::parse(), ParticleCollector< CloudType >::ParticleCollector(), ParticleForceList< KinematicCloud< CloudType > >::ParticleForceList(), partTetMesh::partTetMesh(), correctEdgesBetweenPatches::patchCorrection(), boundaryMesh::patchify(), patchInjection::patchInjectedMassTotals(), subTriSurfaceMesh::patchNames(), triSurfFacets::patchNames(), patchWriter::patchWriter(), patchZones::patchZones(), KinematicCloud< CloudType >::penetration(), faceCoupleInfo::perfectPointMatch(), pointFieldReconstructor::pointFieldReconstructor(), polyMesh::pointInCell(), pointMVCWeight::pointMVCWeight(), PatchTools::pointNormals(), primitiveMesh::pointPoints(), cell::points(), PrimitivePatchInterpolation< Patch >::pointToFaceInterpolate(), polyAddFace::polyAddFace(), polyMesh::polyMesh(), polyMeshGenFaces::polyMeshGenFaces(), Foam::polyMeshZipUpCells(), polyModifyFace::polyModifyFace(), Foam::pow(), meshSurfaceMapper::preMapVertices(), ptscotchDecomp::prepend(), sampledPatchInternalField::print(), sampledPatch::print(), dynamicIndexedOctree::print(), indexedOctree< Foam::treeDataFace >::print(), printAllSets(), vtkUnstructuredReader::printFieldStats(), mapDistribute::printLayout(), printMeshData(), fvMeshDistribute::printMeshInfo(), GAMGProcAgglomeration::printStats(), Foam::printTable(), GAMGAgglomeration::procAgglomerateRestrictAddressing(), domainDecomposition::processInterCyclics(), procFacesGAMGProcAgglomeration::processorAgglomeration(), fvFieldDecomposer::processorVolPatchFieldDecomposer::processorVolPatchFieldDecomposer(), profileModelList::profileModelList(), slidingInterface::projectPoints(), booleanSurface::propagateEdgeSide(), volPointInterpolation::pushUntransformedData(), pyrolysisModelCollection::pyrolysisModelCollection(), refinementFeatures::read(), VTKsurfaceFormat< Face >::read(), tabulated6DoFAcceleration::read(), VTKedgeFormat::read(), TRIsurfaceFormat< Face >::read(), STARCDsurfaceFormat< Face >::read(), FTRsurfaceFormat< Face >::read(), tabulated6DoFMotion::read(), runTimeControl::read(), STARCDedgeFormat::read(), cloudSolution::read(), STLsurfaceFormat< Face >::read(), explicitPorositySource::read(), polyMeshGenFaces::read(), canopySource::read(), vtkUnstructuredReader::read(), boundaryMesh::read(), STARCD::readBoundary(), STARCD::readCells(), graph::readCurves(), externalCoupledFunctionObject::readData(), dynamicRefineFvMesh::readDict(), Foam::readDir(), Foam::readFields(), ReactingParcel::readFields(), ReactingMultiphaseParcel::readFields(), readFields(), parLagrangianRedistributor::readLagrangianFields(), blockMesh::readPatches(), readProcAddressing(), triSurf::readSurface(), tetherPotentialList::readTetherPotentialDict(), triSurface::readTRI(), boundaryMesh::readTriSurface(), surfMesh::readUpdate(), CSV::readValue(), csvTableReader< Type >::readValue(), triSurface::readVTK(), ensightParts::recalculate(), mapDistributeBase::receive(), fvMeshDistribute::receiveFields(), fvMeshDistribute::receiveMesh(), InteractionLists< typename CloudType::parcelType >::receiveReferredData(), ensightPart::reconstruct(), reconstructLagrangian(), processorMeshes::reconstructPoints(), triSurfaceTools::redGreenRefine(), parLagrangianRedistributor::redistributeLagrangianFieldFields(), parLagrangianRedistributor::redistributeLagrangianFields(), parLagrangianRedistributor::redistributeLagrangianPositions(), dynamicRefineFvMesh::refine(), meshOctreeAutomaticRefinement::refineBasedOnContainedCorners(), meshOctreeCreator::refineBoxesContainedInObjects(), meshOctreeCreator::refineBoxesIntersectingEdgeMeshes(), meshOctreeCreator::refineBoxesIntersectingSurfaces(), meshOctreeCreator::refineBoxesNearDataBoxes(), refineBoundaryLayers::refineFace(), multiDirRefinement::refineHex8(), refinementHistory::refinementHistory(), autoRefineDriver::refinementInterfaceRefine(), refinementParameters::refinementParameters(), refineImmersedBoundaryMesh::refineMesh(), faceCoupleInfo::regionEdge(), regionModelFunctionObjectList::regionModelFunctionObjectList(), regionRenumber(), edgeMesh::regions(), MeshedSurface< Foam::face >::remapFaces(), globalPoints::remove(), layerAdditionRemoval::removeCellLayer(), polyMeshGenModifier::removeCells(), surfaceMorpherCells::removeCellsWithAllVerticesAtTheBoundary(), edgeIntersections::removeDegenerates(), Foam::help::removeEdgesFromFace(), fvMeshTools::removeEmptyPatches(), polyMeshGenModifier::removeFaces(), undoableMeshCutter::removeSplitFaces(), randomRenumber::renumber(), manualRenumber::renumber(), zoltanRenumber::renumber(), SloanRenumber::renumber(), structuredRenumber::renumber(), springRenumber::renumber(), renumberMethod::renumber(), slidingInterface::renumberAttachedAddressing(), polyMeshGenModifier::renumberMesh(), phaseProperties::reorder(), polyTopoChange::reorderCoupledFaces(), reorderMesh(), polyMeshGenModifier::replaceBoundary(), polyMesh::resetPrimitives(), polyTopoChange::resetZones(), processorLduInterface::resizeBuf(), GAMGAgglomeration::restrictFaceField(), pairPatchAgglomeration::restrictField(), GAMGAgglomeration::restrictField(), face::reverseFace(), meshOctreeInsideOutside::reviseDataBoxes(), autoLayerDriver::sameEdgeNeighbour(), face::sameVertices(), cachedRandom::scalar01(), globalIndex::scatter(), Pstream::scatterList(), mapDistributeBase::schedule(), searchableSurfaces::searchableSurfaces(), timeSelector::select(), extendedEdgeMesh::select(), scalarRanges::selected(), timeSelector::selected(), subTriSurfaceMesh::selectedRegions(), meshRefinement::selectGapCandidates(), extendedUpwindCellToFaceStencil::selectOppositeFaces(), dynamicRefineFvMesh::selectRefineCells(), dynamicRefineFvMesh::selectUnrefinePoints(), mapDistributeBase::send(), fvMeshDistribute::sendMesh(), InteractionLists< typename CloudType::parcelType >::sendReferredData(), pairPatchAgglomeration::setBasedEdgeWeights(), Foam::setBlockFaceCorrespondence(), fvMeshSubset::setCellSubset(), cellSource::setCellZoneCells(), Time::setControls(), faceCoupleInfo::setCutEdgeToPoints(), triSurface::setDefaultPatches(), blockDescriptor::setEdge(), pairPatchAgglomeration::setEdgeWeights(), faceSource::setFaceZoneFaces(), boundaryMesh::setFeatureEdges(), faceSource::setFieldValues(), cellCuts::setFromCellLoop(), cellCuts::setFromCellLoops(), immersedBoundaryVelocityWallFunctionFvPatchVectorField::setIbCellValues(), immersedBoundaryWallFunctionFvPatchField< Type >::setIbCellValues(), immersedBoundaryFvPatchField< Type >::setIbCellValues(), pointPatchField< Type >::setInInternalField(), fvMeshSubset::setLargeCellSubset(), layerAdditionRemoval::setLayerPairing(), cellVolumeWeightMethod::setNextCells(), faceAreaWeightAMI< SourcePatch, TargetPatch >::setNextFaces(), mapNearestMethod::setNextNearestCells(), autoLayerDriver::setNumLayers(), CellZoneInjection< CloudType >::setPositions(), duplicatePoints::setRefinement(), removeCells::setRefinement(), refinementIterator::setRefinement(), perfectInterface::setRefinement(), faceCollapser::setRefinement(), boundaryCutter::setRefinement(), combineFaces::setRefinement(), createShellMesh::setRefinement(), tetDecomposer::setRefinement(), removeFaces::setRefinement(), meshCutAndRemove::setRefinement(), meshCutter::setRefinement(), edgeCollapser::setRefinement(), addPatchCellLayer::setRefinement(), hexRef8::setRefinement(), meshOctreeCreator::setRootCubeSizeAndRefParameters(), sampledSet::setSamples(), data::setSolverPerformance(), polyMesh::setTopology(), removePoints::setUnrefinement(), combineFaces::setUnrefinement(), hexRef8::setUnrefinement(), autoRefineDriver::shellRefine(), shellSurfaces::shellSurfaces(), fvFieldDecomposer::patchFieldDecomposer::size(), pointFieldDecomposer::patchFieldDecomposer::size(), treeDataTriSurface::size(), distributedWeightedFvPatchFieldMapper::size(), singleCellFvMesh::agglomPatchFieldMapper::size(), fvFieldDecomposer::processorVolPatchFieldDecomposer::size(), solidMixtureProperties::size(), liquidMixtureProperties::size(), treeDataPoint::size(), facePointPatch::size(), fvFieldDecomposer::processorSurfacePatchFieldDecomposer::size(), treeDataEdge::size(), treeDataCell::size(), treeDataFace::size(), meshToMesh0::patchFieldInterpolator::size(), GAMGInterface::size(), featureEdgesNeiOp::size(), CompactListList::sizes(), SLGThermo::SLGThermo(), autoRefineDriver::smallFeatureRefine(), fieldSmoother::smoothLambdaMuDisplacement(), fieldSmoother::smoothNormals(), autoSnapDriver::smoothPatchDisplacement(), fieldSmoother::smoothPatchNormals(), solidBodyMotionFvMesh::solidBodyMotionFvMesh(), solidMixtureProperties::solidMixtureProperties(), solidReaction::solidReactionStrLeft(), solidReaction::solidReactionStrRight(), hierarchGeomDecomp::sortComponent(), PatchTools::sortedEdgeFaces(), Foam::sortedOrder(), extendedEdgeMesh::sortedOrder(), PatchTools::sortedPointEdges(), UnsortedMeshedSurface< Face >::sortedZones(), extendedEdgeMesh::sortPointsAndEdges(), faceTriangulation::split(), autoRefineDriver::splitAndMergeBaffles(), autoSnapDriver::splitDiagonals(), boundaryCutter::splitFace(), polyDualMesh::splitFace(), meshCutAndRemove::splitFace(), meshCutter::splitFace(), intersectedSurface::splitFace(), meshRefinement::splitFacesUndo(), meshRefinement::splitMesh(), meshRefinement::splitMeshRegions(), multiDirRefinement::splitOffHex(), Foam::sqr(), MeshedSurface< Foam::face >::stitchFaces(), isoSurfaceCell::stitchTriPoints(), isoSurface::stitchTriPoints(), hexRef8::storeData(), streamLineParticle::streamLineParticle(), subTriSurfaceMesh::subset(), cellZoneSet::subset(), pointZoneSet::subset(), faceZoneSet::subset(), refinementHistory::subset(), hexRef8::subset(), meshRefinement::subsetBaffles(), multiLevelDecomp::subsetGlobalCellCells(), PatchTools::subsetMap(), distributedTriSurfaceMesh::subsetMesh(), isoSurfaceCell::subsetMesh(), UnsortedMeshedSurface< Face >::subsetMesh(), triSurface::subsetMesh(), isoSurface::subsetMesh(), MeshedSurface< Foam::face >::subsetMesh(), triSurface::subsetMeshMap(), Foam::ListListOps::subSizes(), Foam::sum(), Foam::sumCmptMag(), Foam::sumMag(), Foam::sumSqr(), surfaceFeatures::surfaceFeatures(), surfaceMeshWriter::surfaceMeshWriter(), autoRefineDriver::surfaceOnlyRefine(), PrimitivePatch< labelledTri, List, pointField, point >::surfaceType(), edgeExtractor::surfaceWithPatches(), globalMeshData::syncData(), syncTools::syncEdgeList(), syncTools::syncEdgeMap(), createShellMesh::syncEdges(), syncTools::syncPointList(), syncTools::syncPointMap(), syncPoints(), isoSurface::syncUnseparatedPoints(), pointConstraints::syncUntransformedData(), testEdgeSync(), tetIndices::tetIndices(), thirdBodyEfficiencies::thirdBodyEfficiencies(), Time::Time(), pointToPointPlanarInterpolation::timeNames(), immersedBoundaryFvPatch::toIbPoints(), immersedBoundaryFvPatch::toSamplingPoints(), surfaceFeatures::toStatus(), immersedBoundaryFvPatch::toTriFaces(), particle< Type >::trackToFace(), MeshedSurface< Foam::face >::transcribe(), fft::transform(), globalIndexAndTransform::transformPatches(), cylindrical::transformTensor(), extendedUpwindCellToFaceStencil::transportStencil(), indexedOctree< Foam::treeDataFace >::traverseNode(), dynamicIndexedOctree::traverseNode(), surfaceFeatures::trimFeatures(), streamLineBase::trimToBox(), isoSurface::trimToBox(), triSurface::triSurfInstance(), autoLayerDriver::truncateDisplacement(), uniformInterpolatedDisplacementPointPatchVectorField::uniformInterpolatedDisplacementPointPatchVectorField(), Foam::uniqueOrder(), Foam::unitSet(), unmarkBaffles(), dynamicRefineFvMesh::unrefine(), meshSurfaceOptimizer::untangleSurface(), meshSurfaceOptimizer::untangleSurface2D(), medialAxisMeshMover::update(), sampledTriSurfaceMesh::update(), dynamicRefineFvMesh::update(), AMIInterpolation< SourcePatch, TargetPatch >::update(), vtkPV3blockMesh::updateBoolListStatus(), vtkPV4blockMesh::updateBoolListStatus(), directionInfo::updateCell(), polyMeshGeometry::updateCellCentresAndVols(), immersedBoundaryEpsilonWallFunctionFvPatchScalarField::updateCoeffs(), immersedBoundaryOmegaWallFunctionFvPatchScalarField::updateCoeffs(), externalWallHeatFluxTemperatureFvPatchScalarField::updateCoeffs(), meshOctreeModifier::updateCommunicationPattern(), patchEdgeFaceRegions::updateFace(), updateFaceLabels(), sampledThresholdCellFaces::updateGeometry(), meshSurfaceEngineModifier::updateGeometry(), sampledIsoSurfaceCell::updateGeometry(), polyMeshGenAddressing::updateGeometry(), meshRefinement::updateIntersections(), topoSet::updateLabels(), meshRefinement::updateList(), LduMatrix< Type, DType, LUType >::updateMatrixInterfaces(), lduMatrix::updateMatrixInterfaces(), processorPolyPatch::updateMesh(), componentDisplacementMotionSolver::updateMesh(), CellZoneInjection< CloudType >::updateMesh(), cellZoneSet::updateMesh(), removePoints::updateMesh(), pointZoneSet::updateMesh(), boundaryCutter::updateMesh(), faceZoneSet::updateMesh(), displacementMotionSolver::updateMesh(), refinementHistory::updateMesh(), addPatchCellLayer::updateMesh(), hexRef8::updateMesh(), meshRefinement::updateMesh(), edgeExtractor::updateMeshPatches(), cellZoneSet::updateSet(), pointZoneSet::updateSet(), faceZoneSet::updateSet(), thermoSingleLayer::updateSurfaceTemperatures(), kinematicSingleLayer::updateSurfaceVelocities(), partTriMesh::updateVertices(), PackedBoolList::used(), MeshedSurfaceProxy::useFaceMap(), USERD_get_gold_variable_info(), USERD_set_filenames(), combineFaces::validFace(), cellCuts::validLoop(), polynomialFunction::value(), splineInterpolationWeights::valueWeights(), linearInterpolationWeights::valueWeights(), vtkTopo::vtkTopo(), topoCellLooper::walkAcrossFace(), intersectedSurface::walkFace(), cellCuts::walkFace(), topoCellLooper::walkSplitHex(), displacementLayeredMotionMotionSolver::walkStructured(), wallBoundedStreamLineParticle::wallBoundedStreamLineParticle(), wallLayerCells::wallLayerCells(), meshReader::warnDuplicates(), meshRefinement::weightedSum(), vtkTools::write(), writeFuns::write(), vtkSetWriter< Type >::write(), X3DsurfaceFormat< Face >::write(), WRLsurfaceFormat< Face >::write(), rawSetWriter< Type >::write(), gnuplotSetWriter< Type >::write(), xmgraceSetWriter< Type >::write(), SMESHsurfaceFormat< Face >::write(), foamFileSurfaceWriter::write(), GTSsurfaceFormat< Face >::write(), OBJsurfaceFormat< Face >::write(), csvSetWriter< Type >::write(), VTKsurfaceFormat< Face >::write(), OBJedgeFormat::write(), AC3DsurfaceFormat< Face >::write(), OFFsurfaceFormat< Face >::write(), TRIsurfaceFormat< Face >::write(), rawSurfaceWriter::write(), STARCDsurfaceFormat< Face >::write(), OFSsurfaceFormat< Face >::write(), STARCDedgeFormat::write(), OBJstream::write(), writer< Type >::write(), writeRegisteredObject::write(), nastranSurfaceWriter::write(), streamLineBase::write(), immersedBoundaryFvPatchField< Type >::write(), triSurface::writeAC(), STLsurfaceFormat< Face >::writeAscii(), STLsurfaceFormat< Face >::writeBinary(), forces::writeBinnedForceMoment(), STARCD::writeCells(), ensightPartCells::writeConnectivity(), ensightPartFaces::writeConnectivity(), externalCoupledFunctionObject::writeData(), domainDecomposition::writeDecomposition(), triSurface::writeDXGeometry(), writeEdgeFaces(), writeEdges(), writeFaceFaces(), fpmaMesh::writeFaces(), rotorDiskSource::writeField(), ensightPart::writeFieldList(), ReactingParcel::writeFields(), fieldValueDelta::writeFileHeader(), vtkSurfaceWriter::writeGeometry(), dxSurfaceWriter::writeGeometry(), nastranSurfaceWriter::writeGeometry(), externalCoupledFunctionObject::writeGeometry(), triSurface::writeGTS(), surfaceIntersection::writeIntersectedEdges(), autoLayerDriver::writeLayerData(), triSurface::writeOBJ(), Foam::meshTools::writeOBJ(), triSurface::writeOFF(), writeProcAddressing(), InteractionLists< typename CloudType::parcelType >::writeReferredWallFaces(), ensightPart::writeScalarField(), triSurface::writeSMESH(), searchableSurfaces::writeStats(), writeStats(), extendedCellToFaceStencil::writeStencilStats(), writeStencilStats(), boundaryDataSurfaceWriter::writeTemplate(), nastranSurfaceWriter::writeTemplate(), triSurface::writeTRI(), ensightPart::writeVectorField(), triSurface::writeVTK(), PrimitivePatch< labelledTri, List, pointField, point >::writeVTK(), PrimitivePatch< labelledTri, List, pointField, point >::writeVTKNormals(), interpolation2DTable< Type >::Xi(), polyMeshGenModifier::zipUpCells(), refinementParameters::zonedLocations(), autoRefineDriver::zonify(), and meshRefinement::zonify().

◆ null()

const Foam::List< T > & null ( )
inlinestatic

Return a null List.

Definition at line 43 of file ListI.H.

Referenced by FieldMapper::addressing(), structuredDecomp::decompose(), scotchDecomp::decompose(), and ptscotchDecomp::decompose().

Here is the caller graph for this function:

◆ clone()

Foam::autoPtr< Foam::List< T > > clone ( ) const
inline

Clone.

Definition at line 34 of file ListI.H.

◆ size() [2/2]

label size ( ) const
inline

◆ resize() [1/2]

void resize ( const  label)
inline

◆ resize() [2/2]

void resize ( const  label,
const T  
)
inline

◆ setSize() [1/2]

void setSize ( const  label)

Reset size of List.

Referenced by preserveBafflesConstraint::add(), preserveFaceZonesConstraint::add(), preservePatchesConstraint::add(), singleProcessorFaceSetsConstraint::add(), polyMeshAdder::add(), refinementHistory::add(), multiDirRefinement::addCells(), polyMeshGenModifier::addCells(), cellTable::addCellZones(), cellCuts::addCut(), addPatchCellLayer::addedCells(), meshCutAndRemove::addEdgeCutsToFace(), meshCutter::addEdgeCutsToFace(), mapPatchChange::addedPatches(), lduPrimitiveMesh::addInterfaces(), edgeSurface::addIntersectionEdges(), autoLayerDriver::addLayers(), chemkinReader::addPressureDependentReaction(), mixerFvMesh::addZonesAndModifiers(), movingConeTopoFvMesh::addZonesAndModifiers(), AMIInterpolation< SourcePatch, TargetPatch >::agglomerate(), GAMGAgglomeration::agglomerateLduAddressing(), singleCellFvMesh::agglomerateMesh(), extendedEdgeMesh::allNearestFeatureEdges(), triSurfacePatchManipulator::allocateFeatureEdges(), refineBoundaryLayers::analyseLayers(), ptscotchDecomp::append(), domainDecomposition::append(), attachPolyTopoChanger::attach(), FreeStream< CloudType >::autoMap(), fvPatchField< Type >::autoMap(), extendedEdgeMesh::autoMap(), meshRefinement::baffleAndSplitMesh(), meshRefinement::balance(), triangle< Foam::Vector, Foam::Vector >::barycentric(), tetrahedron::barycentric(), bladeModel::bladeModel(), InteractionLists< typename CloudType::parcelType >::buildInteractionLists(), InteractionLists< typename CloudType::parcelType >::buildMap(), cachedRandom::cachedRandom(), fvSurfaceMapper::calcAddressing(), twoDPointCorrector::calcAddressing(), cellMapper::calcAddressing(), fvPatchMapper::calcAddressing(), pointMapper::calcAddressing(), faceMapper::calcAddressing(), meshToMesh0::calcAddressing(), nearWallFields::calcAddressing(), PrimitivePatch< labelledTri, List, pointField, point >::calcAddressing(), isoSurfaceCell::calcAddressing(), volPointInterpolation::calcBoundaryAddressing(), meshRefinement::calcCellCellRays(), primitiveMesh::calcCellCells(), decompositionMethod::calcCellCells(), polyTopoChange::calcCellInflationMaps(), cellCuts::calcCellLoops(), primitiveMesh::calcCells(), CFCCellToCellStencil::calcCellStencil(), CFCFaceToCellStencil::calcCellStencil(), CPCCellToCellStencil::calcCellStencil(), CECCellToCellStencil::calcCellStencil(), cuttingPlane::calcCutCells(), isoSurface::calcCutTypes(), polyDualMesh::calcDual(), PrimitivePatch< labelledTri, List, pointField, point >::calcEdgeLoops(), primitiveMesh::calcEdges(), polyMeshGenAddressing::calcEdges(), addPatchCellLayer::calcExtrudeInfo(), CFCCellToCellStencil::calcFaceBoundaryData(), CFCFaceToCellStencil::calcFaceBoundaryData(), cellCuts::calcFaceCuts(), polyTopoChange::calcFaceInflationMaps(), FECCellToFaceStencil::calcFaceStencil(), cellToFaceStencil::calcFaceStencil(), polyTopoChange::calcFaceZonePointMap(), CentredFitSnGradData< Polynomial >::calcFit(), FitData< CentredFitSnGradData< Polynomial >, extendedCentredCellToFaceStencil, Polynomial >::calcFit(), meshSurfaceEngine::calcGlobalBoundaryEdgeLabels(), meshSurfaceEngine::calcGlobalBoundaryPointLabels(), globalMeshData::calcGlobalEdgeOrientation(), globalMeshData::calcGlobalEdgeSlaves(), polyMeshGenAddressing::calcGlobalFaceLabels(), globalMeshData::calcGlobalPointBoundaryCells(), globalMeshData::calcGlobalPointBoundaryFaces(), globalMeshData::calcGlobalPointEdges(), polyMeshGenAddressing::calcGlobalPointLabels(), displacementInterpolationMotionSolver::calcInterpolation(), enrichedPatch::calcLocalFaces(), distributedTriSurfaceMesh::calcLocalQueries(), lduAddressing::calcLosort(), blockMesh::calcMergeInfo(), blockMesh::calcMergeInfoFast(), PrimitivePatch< labelledTri, List, pointField, point >::calcMeshData(), autoSnapDriver::calcNearestFace(), autoSnapDriver::calcNearestFacePointProperties(), autoSnapDriver::calcNearestSurfaceFeature(), regionSplit::calcNonCompactRegionSplit(), AMIInterpolation< SourcePatch, TargetPatch >::calcOverlappingProcs(), polyLine::calcParam(), meshRefinement::calcPatchNumMasterFaces(), polyTopoChange::calcPatchPointMap(), mapDistributePolyMesh::calcPatchSizes(), globalMeshData::calcPointBoundaryFaces(), meshReader::calcPointCells(), primitiveMesh::calcPointCells(), globalMeshData::calcPointConnectivity(), edgeSurface::calcPointEdges(), PrimitivePatch< labelledTri, List, pointField, point >::calcPointEdges(), primitiveMesh::calcPointEdges(), PrimitivePatch< labelledTri, List, pointField, point >::calcPointFaces(), primitiveMesh::calcPointOrder(), primitiveMesh::calcPointPoints(), localPointRegion::calcPointRegions(), createShellMesh::calcPointRegions(), AMIInterpolation< SourcePatch, TargetPatch >::calcProcMap(), meshToMesh::calcProcMap(), regionSplit::calcRegionSplit(), globalMeshData::calcSharedEdges(), isoSurfaceCell::calcSnappedCc(), isoSurface::calcSnappedCc(), isoSurfaceCell::calcSnappedPoint(), isoSurface::calcSnappedPoint(), correctedCellVolumeWeightMethod::calculate(), meshSurfaceEngine::calculateBoundaryNodes(), triSurfacePartitioner::calculateCornersAndAddressing(), meshSurfacePartitioner::calculateCornersEdgesAndAddressing(), triSurfacePartitioner::calculateEdgeGroups(), meshSurfaceEngine::calculateEdgesAndAddressing(), boundaryLayerOptimisation::calculateHairEdges(), meshToMesh0::calculateInverseDistanceWeights(), meshToMesh0::calculateInverseVolumeWeights(), renameBoundaryPatches::calculateNewBoundary(), featureEdgesNeiOp::calculateNumberOfEdgesAtPoint(), meshOptimizer::calculatePointLocations(), GAMGAgglomeration::calculateRegionMaster(), globalPoints::calculateSharedPoints(), triSurfaceCurvatureEstimator::calculateSurfaceCurvatures(), meshSurfaceOptimizer::calculateTrianglesAndAddressing(), fvMotionSolverCore::cellMotionBoundaryTypes(), boundaryMesh::changeFaces(), ParSortableList< Type >::checkAndSend(), Foam::checkCoupledPoints(), MeshedSurface< Foam::face >::checkFaces(), triSurfaceClassifyEdges::checkOrientation(), polyBoundaryMesh::checkParallelSync(), GAMGAgglomeration::checkRestriction(), ensightPartFaces::classify(), meshSurfaceCheckEdgeTypes::classifyEdges(), triSurfaceClassifyEdges::classifyEdgesTypes(), cellClassification::classifyPoints(), refinementHistory::clone(), cellShape::collapsedFaces(), triSurfaceTools::collapseEdges(), extendedCellToFaceStencil::collectData(), extendedFaceToCellStencil::collectData(), mappedPatchBase::collectSamples(), boundaryMesh::collectSegment(), faceSource::combineMeshGeometry(), polyMeshAdder::combinePatches(), polyTopoChange::compact(), mapDistributeBase::compact(), polyTopoChange::compactAndReorder(), pairPatchAgglomeration::compactLevels(), GAMGAgglomeration::compactLevels(), removeFaces::compatibleRemoves(), fvPatch::constraintTypes(), polyPatch::constraintTypes(), triSurfaceCopyParts::copySurfaceMesh(), inverseFaceDistanceDiffusivity::correct(), inversePointDistanceDiffusivity::correct(), meshStructure::correct(), searchableSurfaceWithGaps::countMisses(), localPointRegion::countPointRegions(), removePoints::countPointUsage(), cyclicPolyPatch::coupledEdges(), cyclicPolyPatch::coupledPoints(), slidingInterface::coupleInterface(), voronoiMeshExtractor::createAddressing(), blockMesh::createCellShapes(), meshSurfaceEdgeExtractor::createEdgeVertices(), meshUntangler::cutRegion::createInitialConfiguration(), boundaryLayers::createLayerCells(), boundaryLayers::createNewFacesAndCells(), boundaryLayers::createNewFacesParallel(), boundaryLayers::createNewVertices(), meshOctreeAddressing::createOctreeFaces(), triSurfacePatchManipulator::createPatches(), blockMesh::createPatchFaces(), meshReader::createPolyBoundary(), meshReader::createPolyCells(), tetMeshExtractorOctree::createPolyMesh(), meshRefinement::createZoneBaffles(), motionSmootherAlgo::curPoints(), hexCellLooper::cut(), geomCellLooper::cut(), simpleGeomDecomp::decompose(), faceDecomposition::decomposeFace(), faceDecomposition::decomposeFaceIntoTriangles(), domainDecomposition::decomposeMesh(), scotchDecomp::decomposeOneProc(), cartesianMeshExtractor::decomposeSplitHexesIntoTetsAndPyramids(), triSurfaceTools::delaunay2D(), mapPatchChange::deletedPatches(), autoSnapDriver::detectWarpedFaces(), autoSnapDriver::determineBaffleFeatures(), interpolationLookUpTable< scalar >::dimensionTable(), mapDistributeBase::distribute(), distributedTriSurfaceMesh::distribute(), meshToMesh::distributeAndMergeCells(), AMIInterpolation< SourcePatch, TargetPatch >::distributeAndMergePatches(), edgeExtractor::distributeBoundaryFaces(), meshToMesh::distributeCells(), meshOctreeModifier::distributeLeavesToProcessors(), AMIInterpolation< SourcePatch, TargetPatch >::distributePatches(), distributedTriSurfaceMesh::distributeSegments(), indexedOctree< Foam::treeDataFace >::divide(), Foam::duplicateOrder(), cell::edges(), edgeCollapser::edgesFromPoints(), patchZones::edgeToFace(), orientedSurface::edgeToFace(), boundaryMesh::edgeToFace(), Pstream::exchange(), mapDistributeBase::exchangeAddressing(), forceCoeffs::execute(), extendedEdgeMesh::extendedEdgeMesh(), extrudedMesh::extrudedCells(), extrudePatchMesh::extrudeMesh(), cellModel::faces(), boundBox::faces(), patchZones::faceToEdge(), orientedSurface::faceToEdge(), boundaryMesh::faceToEdge(), walkPatch::faceToFace(), autoSnapDriver::featureAttractionUsingFeatureEdges(), autoSnapDriver::featureAttractionUsingReconstruction(), searchablePlateFeatures::features(), surfaceIntersection::filterEdges(), removeFaces::filterFace(), edgeCollapser::filterFace(), surfaceIntersection::filterLabels(), refinementSurfaces::findAllHigherIntersections(), searchableSurfacesQueries::findAllIntersections(), searchableSurfacesQueries::findAnyIntersection(), checkBoundaryFacesSharingTwoEdges::findBndFacesAtBndVertex(), surfaceMorpherCells::findBoundaryCells(), surfaceMorpherCells::findBoundaryVertices(), checkNonMappableCellConnections::findCells(), checkNonMappableCellConnections::findCellTypes(), parLagrangianRedistributor::findClouds(), fvMeshDistribute::findCouples(), autoSnapDriver::findDiagonalAttraction(), edgeExtractor::findEdgeCandidates(), patchProbes::findElements(), probes::findElements(), InteractionLists< typename CloudType::parcelType >::findExtendedProcBbsInRange(), checkBoundaryFacesSharingTwoEdges::findFacesAtBndEdge(), shellSurfaces::findHigherGapLevel(), refinementSurfaces::findHigherIntersection(), refinementFeatures::findHigherLevel(), shellSurfaces::findHigherLevel(), ignitionSite::findIgnitionCells(), coordinateSystems::findIndices(), ZoneMesh< cellZone, polyMesh >::findIndices(), refinementSurfaces::findInside(), findCellsIntersectingSurface::findIntersectedCells(), meshSurfaceOptimizer::findInvertedVertices(), meshOctree::findLeavesContainedInBox(), shellSurfaces::findLevel(), triSurfaceSearch::findLine(), searchablePlane::findLine(), distributedTriSurfaceMesh::findLine(), searchableSphere::findLine(), searchablePlate::findLine(), searchableDisk::findLine(), searchableCylinder::findLine(), searchableRotatedBox::findLine(), searchableSurfaceCollection::findLine(), searchableBox::findLine(), searchableSurfaceWithGaps::findLine(), searchableCone::findLine(), triSurfaceSearch::findLineAll(), searchablePlane::findLineAll(), searchableSphere::findLineAll(), searchablePlate::findLineAll(), searchableDisk::findLineAll(), searchableCylinder::findLineAll(), searchableRotatedBox::findLineAll(), searchableSurfaceCollection::findLineAll(), searchableBox::findLineAll(), searchableSurfaceWithGaps::findLineAll(), searchableCone::findLineAll(), distributedTriSurfaceMesh::findLineAll(), triSurfaceSearch::findLineAny(), searchableSphere::findLineAny(), searchableCylinder::findLineAny(), searchableRotatedBox::findLineAny(), searchableBox::findLineAny(), searchableCone::findLineAny(), meshSurfaceMapper::findMappingDistance(), searchableSurfaceCollection::findNearest(), triSurfaceRegionSearch::findNearest(), triSurfaceSearch::findNearest(), searchablePlane::findNearest(), searchableSphere::findNearest(), searchablePlate::findNearest(), searchableDisk::findNearest(), searchableSurfacesQueries::findNearest(), searchableCylinder::findNearest(), searchableRotatedBox::findNearest(), searchableBox::findNearest(), searchableCone::findNearest(), distributedTriSurfaceMesh::findNearest(), meshRefinement::findNearest(), refinementFeatures::findNearestEdge(), searchableSurfacesQueries::findNearestIntersection(), refinementSurfaces::findNearestIntersection(), refinementFeatures::findNearestPoint(), refinementSurfaces::findNearestRegion(), refinementFeatures::findNearestRegionEdge(), boundaryLayers::findPatchesToBeTreatedTogether(), boundaryLayers::findPatchVertices(), faceCoupleInfo::findPerfectMatchingFaces(), mappedPatchBase::findSamples(), polyMeshAdder::findSharedPoints(), Time::findTimes(), meshRefinement::freeStandingBaffles(), FreeStream< CloudType >::FreeStream(), autoRefineDriver::gapOnlyRefine(), globalIndex::gather(), GAMGAgglomeration::gatherList(), GAMGSolver::gatherMatrices(), midPointSet::genSamples(), midPointAndFaceSet::genSamples(), surfaceZonesInfo::getAllClosedNamedSurfaces(), meshRefinement::getBafflePatches(), polyTopoChange::getCellOrder(), surfaceZonesInfo::getClosedNamedSurfaces(), getFaceOrder(), polyTopoChange::getFaceOrder(), meshTriangulation::getFaces(), searchableSurfaceCollection::getField(), triSurfaceMesh::getField(), distributedTriSurfaceMesh::getField(), oldCyclicPolyPatch::getGeometricHalves(), surfaceZonesInfo::getInsidePointNamedSurfaces(), meshRefinement::getIntersections(), autoLayerDriver::getLayerCellsFaces(), combineFaces::getMergeSets(), polyTopoChange::getMergeSets(), cellClassification::getMeshOutside(), surfaceZonesInfo::getNamedSurfaces(), MGridGenGAMGAgglomeration::getNbrAgglom(), fvMeshDistribute::getNeighbourData(), boundaryMesh::getNTris(), ParSortableList< Type >::getPivots(), meshRefinement::getRefineCandidateFaces(), searchablePlane::getRegion(), searchableSphere::getRegion(), searchablePlate::getRegion(), searchableDisk::getRegion(), searchableCylinder::getRegion(), searchableRotatedBox::getRegion(), searchableSurfaceCollection::getRegion(), searchableBox::getRegion(), triSurfaceMesh::getRegion(), searchableCone::getRegion(), distributedTriSurfaceMesh::getRegion(), Foam::vtkPV3Readers::getSelectedArrayEntries(), Foam::vtkPV4Readers::getSelectedArrayEntries(), vtkPV4blockMesh::getSelectedArrayEntries(), vtkPV3blockMesh::getSelectedArrayEntries(), vtkPV3Foam::getSelectedArrayEntries(), vtkPV4Foam::getSelectedArrayEntries(), surfaceZonesInfo::getStandaloneNamedSurfaces(), topoCellLooper::getSuperEdge(), surfaceZonesInfo::getUnclosedNamedSurfaces(), surfaceZonesInfo::getUnnamedSurfaces(), removePoints::getUnrefimentSet(), cellLooper::getVertEdgesNonFace(), triSurfaceTools::getVertexTriangles(), cellLooper::getVertFacesNonEdge(), searchableSphere::getVolumeType(), searchableCylinder::getVolumeType(), searchableBox::getVolumeType(), triSurfaceMesh::getVolumeType(), searchableCone::getVolumeType(), GAMGProcAgglomeration::globalCellCells(), addPatchCellLayer::globalEdgeFaces(), Foam::help::groupMarking(), medialAxisMeshMover::handleFeatureAngleLayerTerminations(), hashedWordList::hashedWordList(), distributedTriSurfaceMesh::independentlyDistributedBbs(), Distribution::index(), sortLabelledTri::indices(), meshToMeshMethod::initialise(), AMIMethod< SourcePatch, TargetPatch >::initialise(), directionalPressureGradientExplicitSource::initialise(), effectivenessHeatExchangerSource::initialise(), fluxSummary::initialiseFaceArea(), polyMesh::initMesh(), globalMeshData::initProcAddr(), searchableCone::insertHit(), linearInterpolationWeights::integrationWeights(), GAMGInterface::interfaceInternalField(), AMIInterpolation< SourcePatch, TargetPatch >::interpolateToSource(), AMIInterpolation< SourcePatch, TargetPatch >::interpolateToTarget(), edgeIntersections::intersectEdges(), cuttingPlane::intersectEdges(), cellZoneSet::invert(), pointZoneSet::invert(), faceZoneSet::invert(), Foam::invertManyToMany(), Foam::invertOneToMany(), isoSurface::isoSurface(), isoSurfaceCell::isoSurfaceCell(), dictionary::keys(), lduPrimitiveMesh::lduPrimitiveMesh(), meshOctreeModifier::loadDistribution(), basicThermo::lookupThermo(), meshCutAndRemove::loopToFace(), meshCutter::loopToFace(), main(), volPointInterpolation::makeBoundaryWeights(), polyTopoChange::makeCells(), MGridGenGAMGAgglomeration::makeCompactCellFaceAddressingAndFaceWeights(), immersedBoundaryFvPatch::makeDeadFaces(), hexCellLooper::makeFace(), PrimitivePatchInterpolation< Patch >::makeFaceToPointWeights(), immersedBoundaryFvPatch::makeIbCellCells(), immersedBoundaryFvPatch::makeIbSamplingWeights(), volPointInterpolation::makeInternalWeights(), pointConstraints::makePatchPatchAddressing(), immersedBoundaryFvPatch::makeTriAddressing(), mapDistribute::mapDistribute(), mapDistributeBase::mapDistributeBase(), refinementHistory::markCommonCells(), isoSurfaceCell::markDanglingTriangles(), boundaryMesh::markFaces(), triSurfaceCopyParts::markFacetsForCopying(), triSurfaceRemoveFacets::markFacetsForRemoval(), meshRefinement::markFeatureCellLevel(), meshRefinement::markInternalGapRefinement(), edgeExtractor::markPatchPoints(), meshRefinement::markPatchZones(), PatchTools::markZones(), triSurface::markZones(), PatchTools::matchEdges(), regExp::matchGrouping(), Foam::matchPoints(), PatchTools::matchPoints(), faceCoupleInfo::matchPointsThroughFaces(), cellToFaceStencil::merge(), cellToCellStencil::merge(), edgeIntersections::merge(), distributedTriSurfaceMesh::merge(), meshRefinement::mergeBaffles(), polyMeshAdder::mergeCellZones(), polyMeshAdder::mergeFaceZones(), searchableSurfacesQueries::mergeHits(), globalPoints::mergeInfo(), booleanSurface::mergePatches(), meshRefinement::mergePatchFaces(), meshRefinement::mergePatchFacesUndo(), polyMeshAdder::mergePatchNames(), Foam::mergePoints(), triSurfaceTools::mergePoints(), globalMeshData::mergePoints(), extendedEdgeMesh::mergePointsAndSort(), polyMeshAdder::mergePointZones(), polyMeshAdder::mergePrimitives(), MeshedSurface< Foam::face >::MeshedSurface(), meshTriangulation::meshTriangulation(), Foam::help::modifyFacesToShareOneEdge(), surfaceMorpherCells::morphInternalFaces(), engineValve::movingPatchIDs(), multiSolidBodyMotionFvMesh::multiSolidBodyMotionFvMesh(), IOobjectList::names(), objectRegistry::names(), extendedEdgeMesh::nearestFeatureEdge(), extendedEdgeMesh::nearestFeatureEdgeByType(), meshRefinement::nearestPatch(), surfaceFeatures::nearestSurfEdge(), polyBoundaryMesh::neighbourEdges(), basicChemistryModel::New(), basicSolidChemistryModel::New(), cellCuts::nonAnchorPoints(), sampledTriSurfaceMesh::nonCoupledboundaryTree(), Distribution::normalised(), transformPositionList::operator()(), polynomialFunction::operator+=(), polynomialFunction::operator-=(), tetMeshOptimisation::optimiseUsingKnuppMetric(), tetMeshOptimisation::optimiseUsingMeshUntangler(), tetMeshOptimisation::optimiseUsingVolumeOptimizer(), regionCoupledBase::order(), oldCyclicPolyPatch::order(), processorPolyPatch::order(), cyclicPolyPatch::order(), cyclicAMIPolyPatch::order(), argList::parse(), KinematicCloud< CloudType >::penetration(), phaseProperties::phaseProperties(), pointFieldReconstructor::pointFieldReconstructor(), PatchTools::pointNormals(), Foam::polyMeshZipUpCells(), meshSurfaceMapper::preMapVertices(), ptscotchDecomp::prepend(), autoSnapDriver::preSmoothPatch(), autoSnapDriver::preventFaceSqueeze(), printMeshData(), Foam::printTable(), domainDecomposition::processInterCyclics(), ProcessorTopology< Container, ProcPatch >::procNeighbours(), edgeExtractor::projectDeterminedFeatureVertices(), Distribution::raw(), GTSsurfaceFormat< Face >::read(), writeDictionary::read(), explicitPorositySource::read(), polyMeshGenFaces::read(), functionObjectList::read(), vtkUnstructuredReader::read(), vtkUnstructuredReader::readBlock(), STARCD::readBoundary(), blockMesh::readBoundary(), STARCD::readCells(), externalCoupledFunctionObject::readColumns(), Foam::readDir(), triSurface::readOBJ(), blockMesh::readPatches(), triSurface::readTRI(), boundaryMesh::readTriSurface(), ensightParts::recalculate(), mapDistributeBase::receive(), ensightPart::reconstruct(), parLagrangianRedistributor::redistributeLagrangianPositions(), meshOctreeModifier::reduceMemoryConsumption(), meshRefinement::refineCandidates(), refinementParameters::refinementParameters(), meshOctreeAutomaticRefinement::refineSelectedBoxes(), searchablePlane::regions(), searchableBox::regions(), searchableSphere::regions(), searchableDisk::regions(), searchablePlate::regions(), searchableCylinder::regions(), searchableSurfaceCollection::regions(), triSurfaceMesh::regions(), searchableCone::regions(), edgeMesh::regions(), polyMeshGenModifier::removeCells(), edgeIntersections::removeDegenerates(), surfaceIntersection::removeDuplicates(), Foam::help::removeEdgesFromFace(), fvMeshTools::removeEmptyPatches(), checkBoundaryFacesSharingTwoEdges::removeExcessiveVertices(), polyMeshGenModifier::removeFaces(), meshSurfaceEdgeExtractor::removeOldBoundaryFaces(), polyTopoChange::renumberCompact(), polyMeshGenModifier::reorderBoundaryFaces(), polyMeshGenModifier::replaceBoundary(), PackedList< 2 >::reserve(), polyTopoChange::resetZones(), processorLduInterface::resizeBuf(), Foam::help::reverseAddressingSMP(), autoSnapDriver::reverseAttractMeshPoints(), mapDistributeBase::schedule(), searchableSurfaces::searchableSurfaces(), extendedEdgeMesh::select(), subTriSurfaceMesh::selectedRegions(), tetCreatorOctree::selectElements(), polyTopoChange::selectFaces(), meshRefinement::selectGapCandidates(), PackedList< 2 >::setCapacity(), fvMeshSubset::setCellSubset(), decompositionMethod::setConstraints(), blockDescriptor::setEdge(), cellCuts::setFromCellLoops(), polyBoundaryMesh::setGroup(), fvMeshSubset::setLargeCellSubset(), MRFZone::setMRFFaces(), duplicatePoints::setRefinement(), refinementIterator::setRefinement(), removePoints::setRefinement(), boundaryCutter::setRefinement(), tetDecomposer::setRefinement(), addPatchCellLayer::setRefinement(), hexRef8::setRefinement(), meshOctreeCreator::setRootCubeSizeAndRefParameters(), cellListPMG::setSize(), cellSets::setSize(), faceListPMG::setSize(), data::setSolverPerformance(), polyMesh::setTopology(), removePoints::setUnrefinement(), PackedList< 2 >::shrink(), meshSurfaceOptimizer::smoothEdgePoints(), meshSurfaceOptimizer::smoothLaplacianFC(), autoSnapDriver::smoothPatchDisplacement(), ParSortableList< Type >::sort(), Foam::sortedOrder(), extendedEdgeMesh::sortedOrder(), searchableSurfaceCollection::sortHits(), extendedEdgeMesh::sortPointsAndEdges(), meshCutAndRemove::splitFace(), meshCutter::splitFace(), meshRefinement::splitFacesUndo(), meshRefinement::splitMeshRegions(), multiDirRefinement::splitOffHex(), MeshedSurface< Foam::face >::stitchFaces(), triSurface::stitchTriangles(), isoSurfaceCell::stitchTriPoints(), isoSurface::stitchTriPoints(), streamLineParticle::streamLineParticle(), NamedEnum< directionType, 3 >::strings(), fvMeshDistribute::subsetBoundaryData(), multiLevelDecomp::subsetGlobalCellCells(), PatchTools::subsetMap(), distributedTriSurfaceMesh::subsetMesh(), isoSurfaceCell::subsetMesh(), isoSurface::subsetMesh(), distributedTriSurfaceMesh::subsetMeshMap(), triSurface::subsetMeshMap(), surfZoneIOList::surfZoneIOList(), syncTools::swapBoundaryCellList(), syncTools::swapBoundaryCellPositions(), edgeCollapser::syncCollapse(), globalIndexAndTransform::transformIndicesForPatches(), meshSurfaceOptimizer::transformIntoPlane(), extendedUpwindCellToFaceStencil::transportStencil(), extendedUpwindCellToFaceStencil::transportStencils(), boundaryMesh::triangulate(), boundaryMesh::triangulateLocal(), streamLineBase::trimToBox(), isoSurface::trimToBox(), Foam::uniqueOrder(), sampledTriSurfaceMesh::update(), vtkPV3blockMesh::updateBoolListStatus(), vtkPV4blockMesh::updateBoolListStatus(), updateFaceLabels(), vtkPV3Foam::updateInfoFields(), vtkPV4Foam::updateInfoFields(), edgeVertex::updateLabels(), cellZoneSet::updateMesh(), removePoints::updateMesh(), pointZoneSet::updateMesh(), boundaryCutter::updateMesh(), faceZoneSet::updateMesh(), faceZone::updateMesh(), addPatchCellLayer::updateMesh(), lduPrimitiveMesh::upperTriOrder(), PackedBoolList::used(), cellToFaceStencil::validBoundaryFaces(), cellToCellStencil::validBoundaryFaces(), splineInterpolationWeights::valueWeights(), linearInterpolationWeights::valueWeights(), vtkTopo::vtkTopo(), cellCuts::walkCell(), wallBoundedStreamLineParticle::wallBoundedStreamLineParticle(), immersedBoundaryVelocityWallFunctionFvPatchVectorField::wallMask(), NamedEnum< directionType, 3 >::words(), streamLineBase::write(), ensightSurfaceWriter::writeCollated(), domainDecomposition::writeDecomposition(), externalCoupledFunctionObject::writeGeometry(), triSurf::writeToFMS(), polyMeshGenModifier::zipUpCells(), and meshRefinement::zonify().

◆ setSize() [2/2]

void setSize ( const  label,
const T  
)

Reset size of List and value for new elements.

◆ clear()

void clear ( )

Clear the list, i.e. set size to zero.

Definition at line 379 of file List.C.

Referenced by boundaryLayers::addLayerForAllPatches(), boundaryLayers::addLayerForPatch(), Cloud< streamLineParticle >::autoMap(), PrimitivePatch< labelledTri, List, pointField, point >::calcAddressing(), FECCellToFaceStencil::calcFaceStencil(), globalMeshData::calcGlobalPointBoundaryCells(), globalMeshData::calcGlobalPointBoundaryFaces(), localPointRegion::calcPointRegions(), regionSplit::calcRegionSplit(), meshSurfacePartitioner::calculateCornersEdgesAndAddressing(), primitiveMesh::cellCells(), primitiveMesh::cellEdges(), primitiveMesh::cellPoints(), sampledSurfaces::mergeInfo::clear(), fvSchemes::clear(), hashedWordList::clear(), SortableList::clear(), TRIsurfaceFormatCore::clear(), STLsurfaceFormatCore::clear(), MeshedSurfaceIOAllocator::clear(), vtkPV3Foam::polyDecomp::clear(), vtkPV4Foam::polyDecomp::clear(), PackedList< 2 >::clearStorage(), DSMCCloud< DSMCParcel< ParcelType > >::collisions(), localPointRegion::countPointRegions(), removePoints::countPointUsage(), boundaryLayers::createNewFacesFromPointsParallel(), meshReader::createPolyCells(), meshRefinement::createZoneBaffles(), refinementHistory::distribute(), Foam::duplicateOrder(), primitiveMesh::edgeFaces(), extractSurface(), primitiveMesh::faceEdges(), refinementSurfaces::findAllHigherIntersections(), meshRefinement::findCellZoneInsideWalk(), meshRefinement::findCellZoneTopo(), probes::findElements(), searchablePlane::findLineAll(), searchableSphere::findLineAll(), searchablePlate::findLineAll(), searchableDisk::findLineAll(), searchableCylinder::findLineAll(), searchableRotatedBox::findLineAll(), searchableSurfaceCollection::findLineAll(), searchableBox::findLineAll(), searchableSurfaceWithGaps::findLineAll(), searchableCone::findLineAll(), distributedTriSurfaceMesh::findLineAll(), particle< Type >::findTris(), STARCD::getCellTable(), coordinateSystem::init(), main(), volPointInterpolation::makeBoundaryWeights(), volPointInterpolation::makeInternalWeights(), meshRefinement::markInternalGapRefinement(), meshRefinement::markProximityRefinement(), meshRefinement::markSmallFeatureRefinement(), meshRefinement::markSurfaceCurvatureRefinement(), meshRefinement::markSurfaceGapRefinement(), regExp::matchGrouping(), mergeSurfacePatches(), Cloud< streamLineParticle >::move(), edgeMesh::operator=(), tetMeshOptimisation::optimiseBoundarySurfaceLaplace(), tetMeshOptimisation::optimiseBoundaryVolumeOptimizer(), tetMeshOptimisation::optimiseUsingKnuppMetric(), tetMeshOptimisation::optimiseUsingMeshUntangler(), tetMeshOptimisation::optimiseUsingVolumeOptimizer(), primitiveMesh::pointPoints(), triSurfPoints::pointsInSubset(), polyMeshGenPoints::pointsInSubset(), TRIsurfaceFormat< Face >::read(), STARCDsurfaceFormat< Face >::read(), FTRsurfaceFormat< Face >::read(), STARCDedgeFormat::read(), STLsurfaceFormat< Face >::read(), vtkUnstructuredReader::read(), boundaryMesh::readTriSurface(), ensightPart::reconstruct(), surfMesh::removeZones(), decompositionMethod::setConstraints(), SortableList::shrink(), Foam::sortedOrder(), MeshedSurface< Foam::face >::sortFacesAndStore(), meshRefinement::splitMesh(), MeshedSurface< Foam::face >::stitchFaces(), UnsortedMeshedSurface< Face >::subsetMesh(), MeshedSurface< Foam::face >::subsetMesh(), surfaceFeatures::surfaceFeatures(), edgeCollapser::syncCollapse(), sampledTriSurfaceMesh::update(), polyMeshGenModifier::zipUpCells(), and meshRefinement::zonify().

◆ append() [1/3]

void append ( const T )
inline

Append an element at the end of the list.

Referenced by singleProcessorFaceSetsConstraint::add(), cellTable::addCellZones(), Foam::debug::addDebugObject(), Foam::debug::addDimensionedConstantObject(), Foam::debug::addDimensionSetObject(), Foam::debug::addInfoObject(), Foam::debug::addOptimisationObject(), AMIInterpolation< SourcePatch, TargetPatch >::agglomerate(), hashedWordList::append(), AMIInterpolation< SourcePatch, TargetPatch >::append(), InteractionLists< typename CloudType::parcelType >::buildInteractionLists(), PrimitivePatch< labelledTri, List, pointField, point >::calcAddressing(), PrimitivePatch< labelledTri, List, pointField, point >::calcEdgeLoops(), distributedTriSurfaceMesh::calcLocalQueries(), autoSnapDriver::calcNearestFacePointProperties(), PrimitivePatch< labelledTri, List, pointField, point >::calcPointEdges(), PrimitivePatch< labelledTri, List, pointField, point >::calcPointFaces(), AMIInterpolation< SourcePatch, TargetPatch >::calcProcMap(), meshToMesh::calcProcMap(), cellFeatures::calcSuperFaces(), UPstream::calcTreeComm(), directAMI< SourcePatch, TargetPatch >::calculate(), mapNearestAMI< SourcePatch, TargetPatch >::calculate(), correctedCellVolumeWeightMethod::calculateAddressing(), cellVolumeWeightMethod::calculateAddressing(), mapNearestMethod::calculateAddressing(), directMethod::calculateAddressing(), triSurfaceCurvatureEstimator::calculateSurfaceCurvatures(), primitiveMesh::cellCells(), Foam::polyMeshGenChecks::checkFaceFlatness(), checkIrregularSurfaceConnections::checkFaceGroupsAtBndVertices(), GAMGAgglomeration::checkRestriction(), DSMCCloud< DSMCParcel< ParcelType > >::collisions(), commSchedule::commSchedule(), slidingInterface::coupleInterface(), partTetMesh::createPointsAndTets(), decompositionMethod::decompositionMethod(), distributedTriSurfaceMesh::distributeSegment(), indexedOctree< Foam::treeDataFace >::divide(), edgeSurface::edgeSurface(), meshOctree::exchangeRequestsWithNeighbourProcessors(), walkPatch::faceToFace(), Foam::findEtcFiles(), findMatches(), autoSnapDriver::findNearFeatureEdge(), meshUntangler::cutRegion::findNewFaces(), particle< Type >::findTris(), refineBoundaryLayers::generateNewCellsPrism(), primitiveMesh::getEdge(), fluxSummary::initialiseCellZoneAndDirection(), main(), meshOctreeModifier::markAdditionalLayers(), meshRefinement::markSurfaceCurvatureRefinement(), PatchTools::markZone(), triSurface::markZone(), polyMeshAdder::mergeCellZones(), polyMeshAdder::mergeFaceZones(), polyMeshAdder::mergePointZones(), mergeSurfacePatches(), findCellParticle::move(), Cloud< streamLineParticle >::move(), boundaryMesh::patchify(), polyPatch::polyPatch(), parLagrangianRedistributor::redistributeLagrangianFieldFields(), parLagrangianRedistributor::redistributeLagrangianPositions(), refineBoundaryLayers::refineFace(), refinementParameters::refinementParameters(), meshOctreeModifier::refineSelectedBoxesAndAdditionalLayers(), timeSelector::select0(), PatchEdgeFaceWave< PrimitivePatchType, Type, TrackingData >::setEdgeInfo(), polyBoundaryMesh::setGroup(), potential::setSiteIdList(), surfaceIntersection::surfaceIntersection(), PatchEdgeFaceWave< PrimitivePatchType, Type, TrackingData >::syncEdges(), and domainDecomposition::writeDecomposition().

◆ append() [2/3]

void append ( const UList< T > &  )
inline

Append a List at the end of this list.

◆ append() [3/3]

void append ( const UIndirectList< T > &  )
inline

Append a UIndirectList at the end of this list.

◆ transfer() [1/5]

void transfer ( List< T > &  )

Transfer the contents of the argument List into this list.

and annul the argument list.

Referenced by boundaryCutter::addEdgeCutsToFace(), cellZoneSet::addSet(), pointZoneSet::addSet(), faceZoneSet::addSet(), MGridGenGAMGAgglomeration::agglomerate(), extendedEdgeMesh::allNearestFeatureEdges(), extendedEdgeMesh::allNearestFeaturePoints(), searchableSurfaceToFaceZone::applyToSet(), faceZoneToFaceZone::applyToSet(), setToCellZone::applyToSet(), setToPointZone::applyToSet(), setToFaceZone::applyToSet(), setAndNormalToFaceZone::applyToSet(), setsToFaceZone::applyToSet(), extendedEdgeMesh::autoMap(), PrimitivePatch< labelledTri, List, pointField, point >::calcAddressing(), cellCuts::calcAnchors(), primitiveMesh::calcCellEdges(), enrichedPatch::calcCutFaces(), PrimitivePatch< labelledTri, List, pointField, point >::calcEdgeLoops(), primitiveMesh::calcEdges(), enrichedPatch::calcEnrichedFaces(), polyDualMesh::calcFeatures(), globalMeshData::calcGlobalEdgeSlaves(), globalMeshData::calcGlobalPointBoundaryCells(), distributedTriSurfaceMesh::calcLocalQueries(), enrichedPatch::calcMasterPointFaces(), enrichedPatch::calcPointPoints(), createShellMesh::calcPointRegions(), AMIInterpolation< SourcePatch, TargetPatch >::calcProcMap(), meshToMesh::calcProcMap(), globalMeshData::calcSharedEdges(), cellFeatures::calcSuperFaces(), faceHeatShading::calculate(), faceShading::calculate(), partialFaceAreaWeightAMI< SourcePatch, TargetPatch >::calculate(), directAMI< SourcePatch, TargetPatch >::calculate(), mapNearestAMI< SourcePatch, TargetPatch >::calculate(), faceAreaWeightAMI< SourcePatch, TargetPatch >::calculate(), correctedCellVolumeWeightMethod::calculateAddressing(), cellVolumeWeightMethod::calculateAddressing(), mapNearestMethod::calculateAddressing(), directMethod::calculateAddressing(), CECCellToFaceStencil::CECCellToFaceStencil(), polyMesh::cellShapePointCells(), CFCCellToFaceStencil::CFCCellToFaceStencil(), edgeExtractor::checkConcaveEdgeCells(), edgeExtractor::checkFacePatchesTopology(), ensightPartFaces::classify(), polyDualMesh::collectPatchInternalFace(), indexedOctree< Foam::treeDataFace >::compactContents(), removeFaces::compatibleRemoves(), slidingInterface::coupleInterface(), CPCCellToFaceStencil::CPCCellToFaceStencil(), geomCellLooper::cut(), topoCellLooper::cut(), extendedEdgeMesh::cut(), cyclicACMIGAMGInterface::cyclicACMIGAMGInterface(), cyclicAMIGAMGInterface::cyclicAMIGAMGInterface(), slidingInterface::decoupleInterface(), cellZoneSet::deleteSet(), pointZoneSet::deleteSet(), faceZoneSet::deleteSet(), fvMeshDistribute::distribute(), mapDistributeBase::distribute(), edgeExtractor::distributeBoundaryFacesNormalAlignment(), distributedTriSurfaceMesh::distributeSegments(), indexedOctree< Foam::treeDataFace >::divide(), FECCellToFaceStencil::FECCellToFaceStencil(), parLagrangianRedistributor::filterObjects(), triSurfaceSearch::findLineAll(), searchableRotatedBox::findLineAll(), searchableBox::findLineAll(), autoRefineDriver::gapOnlyRefine(), PatchTools::gatherAndMerge(), autoLayerDriver::growNoExtrusion(), polyMeshAdder::insertVertices(), cuttingPlane::intersectEdges(), isoSurface::isoSurface(), isoSurfaceCell::isoSurfaceCell(), main(), PatchTools::markZone(), triSurface::markZone(), momentOfInertia::massPropertiesPatch(), polyBoundaryMesh::matchGroups(), hexRef8::matchHexShape(), cellToFaceStencil::merge(), cellToCellStencil::merge(), removeFaces::mergeFaces(), globalPoints::mergeInfo(), MeshedSurface< Foam::face >::MeshedSurface(), streamLineParticle::move(), wallBoundedStreamLineParticle::move(), multiSolidBodyMotionFvMesh::multiSolidBodyMotionFvMesh(), functionObjectState::objectResultEntries(), boundaryLayerOptimisation::optimiseThicknessVariation(), tetMeshOptimisation::optimiseUsingKnuppMetric(), tetMeshOptimisation::optimiseUsingMeshUntangler(), GAMGAgglomeration::procAgglomerateRestrictAddressing(), OBJedgeFormat::read(), FTRsurfaceFormat< Face >::read(), STARCDCore::readPoints(), surfMesh::readUpdate(), edgeMesh::regions(), UnsortedMeshedSurface< Face >::remapFaces(), cuttingPlane::remapFaces(), polyMeshGenModifier::removeCells(), edgeIntersections::removeDegenerates(), polyMeshGenModifier::renumberMesh(), hexRef8::reorder(), polyMeshGenModifier::reorderProcBoundaryFaces(), polyMeshGenModifier::replaceBoundary(), polyTopoChange::resetZones(), SortableList::reverseSort(), faceSource::setFaceZoneFaces(), cellCuts::setFromCellLoop(), hexRef8::setRefinement(), meshOctreeCreator::setRootCubeSizeAndRefParameters(), potential::setSiteIdList(), cellListPMG::setSize(), faceListPMG::setSize(), solidBodyMotionFvMesh::solidBodyMotionFvMesh(), SortableList::sort(), MeshedSurface< Foam::face >::sortFacesAndStore(), extendedEdgeMesh::sortPointsAndEdges(), boundaryCutter::splitFace(), meshRefinement::splitMesh(), multiDirRefinement::splitOffHex(), isoSurfaceCell::stitchTriPoints(), isoSurface::stitchTriPoints(), hexRef8::storeMidPointInfo(), cellZoneSet::subset(), pointZoneSet::subset(), faceZoneSet::subset(), hexRef8::subset(), hashedWordList::transfer(), PackedList< 2 >::transfer(), extendedUpwindCellToFaceStencil::transportStencils(), isoSurface::trimToBox(), updateFaceLabels(), sampledThresholdCellFaces::updateGeometry(), meshRefinement::updateList(), cellZoneSet::updateMesh(), pointZoneSet::updateMesh(), faceZoneSet::updateMesh(), hexRef8::updateMesh(), and streamLineBase::write().

◆ transfer() [2/5]

void transfer ( DynamicList< T, SizeInc, SizeMult, SizeDiv > &  a)

Transfer the contents of the argument List into this list.

and annul the argument list.

Definition at line 405 of file List.C.

◆ transfer() [3/5]

void transfer ( SortableList< T > &  )

Transfer the contents of the argument List into this list.

and annul the argument list.

◆ xfer()

Foam::Xfer< Foam::List< T > > xfer ( )
inline

◆ newElmt()

T & newElmt ( const label  i)
inline

◆ operator=() [1/6]

void operator= ( const UList< T > &  )

◆ operator=() [2/6]

void operator= ( const List< T > &  )

Assignment operator. Takes linear time.

◆ operator=() [3/6]

void operator= ( const SLList< T > &  )

Assignment from SLList operator. Takes linear time.

◆ operator=() [4/6]

void operator= ( const UIndirectList< T > &  )

Assignment from UIndirectList operator. Takes linear time.

◆ operator=() [5/6]

void operator= ( const BiIndirectList< T > &  )

Assignment from BiIndirectList operator. Takes linear time.

◆ operator=() [6/6]

void operator= ( const T )
inline

Assignment of all entries to the given value.

◆ transfer() [4/5]

void transfer ( List< T > &  a)

Definition at line 390 of file List.C.

◆ transfer() [5/5]

void transfer ( SortableList< T > &  a)

Definition at line 417 of file List.C.

Friends And Related Function Documentation

◆ operator>>

Istream& operator>> ( Istream ,
List< T > &   
)
friend

Read List from Istream, discarding contents of existing List.


The documentation for this class was generated from the following files: