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, cellShape, cellToCellStencil, cellToFaceStencil, face, faceToCellStencil, faceTriangulation, faPatch, hashedWordList, ITstream, patchZones, PDRblock::gridControl, PDRblock::location, polynomialFunction [private]
, ProcessorTopology< Container, ProcPatch >, pTraits< List< T > >, regionSplit, regionSplit2D, surfZoneIOList, thirdBodyEfficiencies, zone, and zoneCellStencils.
Public Types | |
typedef SubList< T > | subList |
Public Member Functions | |
constexpr | List () noexcept |
List (const label len) | |
List (const label len, const T &val) | |
List (const label len, const Foam::zero) | |
List (const Foam::one, const T &val) | |
List (const Foam::one, T &&val) | |
List (const Foam::one, const Foam::zero) | |
List (const List< T > &a) | |
List (const UList< T > &a) | |
List (List< T > &a, bool reuse) | |
List (const UList< T > &list, const labelUList &indices) | |
template<unsigned N> | |
List (const UList< T > &list, const FixedList< label, N > &indices) | |
template<unsigned N> | |
List (const FixedList< T, N > &list) | |
List (const PtrList< T > &list) | |
List (const SLList< T > &list) | |
template<class Addr > | |
List (const IndirectListBase< T, Addr > &list) | |
List (std::initializer_list< T > list) | |
List (List< T > &&list) | |
template<int SizeMin> | |
List (DynamicList< T, SizeMin > &&list) | |
List (SortableList< T > &&list) | |
List (SLList< T > &&list) | |
List (Istream &is) | |
autoPtr< List< T > > | clone () const |
~List () | |
void | clear () |
void | resize (const label len) |
void | resize (const label len, const T &val) |
void | resize_nocopy (const label len) |
void | setSize (const label n) |
void | setSize (const label n, const T &val) |
void | append (const T &val) |
void | append (T &&val) |
void | append (const UList< T > &list) |
template<class Addr > | |
void | append (const IndirectListBase< T, Addr > &list) |
label | appendUniq (const T &val) |
void | transfer (List< T > &list) |
template<int SizeMin> | |
void | transfer (DynamicList< T, SizeMin > &list) |
void | transfer (SortableList< T > &list) |
T & | newElmt (const label i) |
void | operator= (const UList< T > &a) |
void | operator= (const List< T > &list) |
void | operator= (const SLList< T > &list) |
template<class Addr > | |
void | operator= (const IndirectListBase< T, Addr > &list) |
template<unsigned N> | |
void | operator= (const FixedList< T, N > &list) |
void | operator= (std::initializer_list< T > list) |
void | operator= (const T &val) |
void | operator= (const Foam::zero) |
void | operator= (List< T > &&list) |
template<int SizeMin> | |
void | operator= (DynamicList< T, SizeMin > &&list) |
void | operator= (SortableList< T > &&list) |
void | operator= (SLList< T > &&list) |
Istream & | readList (Istream &is) |
void | shallowCopy (const UList< T > &)=delete |
template<class TypeT = T> | |
std::enable_if< std::is_same< bool, TypeT >::value, bool >::type | set (const label i, bool val=true) |
template<class T > | |
List (const label len) | |
template<class T > | |
List (const label len, const T &val) | |
template<class T > | |
List (const label len, const Foam::zero) | |
template<class T > | |
List (const Foam::one, const T &val) | |
template<class T > | |
List (const Foam::one, T &&val) | |
template<class T > | |
List (const Foam::one, const Foam::zero) | |
template<class T > | |
List (const UList< T > &a) | |
template<class T > | |
List (const List< T > &a) | |
template<class T > | |
List (List< T > &a, bool reuse) | |
template<class T > | |
List (const UList< T > &list, const labelUList &indices) | |
template<class T > | |
List (const PtrList< T > &list) | |
template<class T > | |
List (const SLList< T > &list) | |
template<class T > | |
List (std::initializer_list< T > list) | |
template<class T > | |
List (List< T > &&list) | |
template<class T > | |
List (SortableList< T > &&list) | |
template<class T > | |
List (SLList< T > &&list) | |
template<class T > | |
void | transfer (List< T > &list) |
template<class T > | |
void | transfer (SortableList< T > &list) |
template<class T > | |
void | operator= (const UList< T > &a) |
template<class T > | |
void | operator= (const List< T > &list) |
template<class T > | |
void | operator= (const SLList< T > &list) |
template<class T > | |
void | operator= (std::initializer_list< T > list) |
template<class T > | |
void | operator= (List< T > &&list) |
template<class T > | |
void | operator= (SortableList< T > &&list) |
template<class T > | |
void | operator= (SLList< T > &&list) |
Istream & | readList (Istream &is) |
template<class T > | |
constexpr | List () noexcept |
void | resize (const label newLen) |
template<class T > | |
void | append (const T &val) |
template<class T > | |
void | append (T &&val) |
template<class T > | |
void | append (const UList< T > &list) |
template<class T > | |
void | operator= (const T &val) |
template<class T > | |
void | operator= (const Foam::zero) |
template<class T > | |
List (Istream &is) | |
Istream & | readList (Istream &is) |
Static Public Member Functions | |
static const List< T > & | null () |
Friends | |
Istream & | operator>> (Istream &is, List< T > &list) |
A 1D array of objects of type <T>, where the size of the vector is known and used for subscript bounds checking, etc.
|
inlineconstexprnoexcept |
|
explicit |
List | ( | const label | len, |
const Foam::zero | |||
) |
List | ( | const Foam::one | , |
const Foam::zero | |||
) |
List | ( | const UList< T > & | list, |
const labelUList & | indices | ||
) |
|
explicit |
List | ( | DynamicList< T, SizeMin > && | list | ) |
List | ( | SortableList< T > && | list | ) |
List | ( | const label | len, |
const Foam::zero | |||
) |
List | ( | const Foam::one | , |
const Foam::zero | |||
) |
List | ( | SortableList< T > && | list | ) |
|
inlinestatic |
Definition at line 102 of file ListI.H.
Referenced by FieldMapper::addressing(), faEdgeMapper::addressing(), faPatchMapper::addressing(), volRegion::cellIDs(), meshedSurfRef::clear(), meshedSurf::faceIds(), meshedSurf::emptySurface::faces(), faEdgeMapper::insertedObjectLabels(), ensightCells::uniqueMeshPoints(), FieldMapper::weights(), faEdgeMapper::weights(), faPatchMapper::weights(), lumpedPointMovement::writeVTP(), lumpedPointMovement::writeZonesVTP(), meshedSurf::zoneIds(), sampledNone::zoneIds(), sampledInterface::zoneIds(), sampledCuttingSurface::zoneIds(), sampledFaceZone::zoneIds(), sampledThresholdCellFaces::zoneIds(), sampledPlane::zoneIds(), sampledPatch::zoneIds(), sampledDistanceSurface::zoneIds(), sampledCuttingPlane::zoneIds(), and sampledIsoSurface::zoneIds().
|
inline |
|
inline |
Definition at line 109 of file ListI.H.
Referenced by polyMeshAdder::add(), ensightPart::clear(), hashedWordList::clear(), SortableList::clear(), IListStreamAllocator::clearStorage(), PackedList< 2 >::clearStorage(), polySurface::copySurface(), surfMesh::copySurface(), removePoints::countPointUsage(), distanceSurface::createGeometry(), box::createMap(), meshRefinement::createZoneBaffles(), refinementHistory::distribute(), Foam::duplicateOrder(), Field< Foam::Vector2D >::Field(), refinementSurfaces::findAllIntersections(), probes::findElements(), searchablePlane::findLineAll(), searchablePlate::findLineAll(), searchableDisk::findLineAll(), searchableCylinder::findLineAll(), searchableSurfaceCollection::findLineAll(), searchableSurfaceWithGaps::findLineAll(), searchableRotatedBox::findLineAll(), searchableBox::findLineAll(), searchableCone::findLineAll(), searchableSphere::findLineAll(), distributedTriSurfaceMesh::findLineAll(), searchableSurface::getField(), isoSurfaceTopo::isoSurfaceTopo(), Cloud< passivePositionParticle >::move(), argList::parse(), Foam::parseStream(), RecycleInteraction< CloudType >::postEvolve(), STARCDsurfaceFormat< Face >::read(), TRIsurfaceFormat< Face >::read(), STARCDedgeFormat::read(), VTKsurfaceFormat< Face >::read(), STLsurfaceFormat< Face >::read(), ensightWrite::read(), STARCDMeshReader::readCells(), Time::readDict(), ensightSurfaceReader::readField(), List< vectorField >::readList(), boundaryMesh::readTriSurface(), regionSplit::regionSplit(), surfMesh::removeZones(), FIREMeshReader::reorganize(), PtrListDetail< T >::resize(), decompositionMethod::setConstraints(), lumpedPointMovement::setInterpolator(), SortableList::shrink(), MeshedSurface< Foam::face >::stitchFaces(), hexRef8::storeData(), PatchTools::subsetMap(), surfaceFeatures::surfaceFeatures(), trackingInverseDistance::update(), cellVolumeWeight::update(), inverseDistance::update(), surfaceNoise::writeSurfaceData(), zoneToPoint::zones(), zoneToCell::zones(), and zoneToFace::zones().
|
inline |
Definition at line 132 of file ListI.H.
Referenced by preservePatches::add(), singleProcessorFaceSets::add(), geometric::add(), polyTopoChange::addMesh(), isoSurfaceBase::calcCellCuts(), globalIndex::calcListOffsets(), globalIndex::calcOffsets(), polyLine::calcParam(), globalIndex::calcRanges(), topoSetSource::check(), MeshedSurface< Foam::face >::checkFaces(), cellShape::collapsedFaces(), multiWorldConnections::comms(), faMeshDecomposition::decomposeMesh(), directions::directions(), Foam::duplicateOrder(), cell::edges(), Foam::etcDirs(), NASCore::faceDecomposition(), ABAQUSCore::faceDecomposition(), faceZone::faceZone(), searchableDisk::findLine(), searchableSphere::findLine(), searchableSphere::findLineAll(), searchableSphere::findLineAny(), namesList< solutionEntry >::findNames(), searchableDisk::findNearest(), searchableSphere::findNearest(), lumpedPointMovement::forcesAndMoments(), decomposedBlockData::gather(), decomposedBlockData::gatherSlaveData(), Foam::exprTools::getList(), searchableDisk::getRegion(), searchableSphere::getRegion(), searchableSphere::getVolumeType(), GAMGInterface::interfaceInternalField(), Foam::invertOneToMany(), isoSurfaceTopo::isoSurfaceTopo(), dictionary::keys(), UPstream::listGatherValues(), dlLibraryTable::loaded(), PatchTools::matchEdges(), wordRes::matching(), scalars::matching(), PatchTools::matchPoints(), globalIndex::mpiGather(), IOobjectList::namesImpl(), objectRegistry::namesImpl(), IOobjectList::namesTypeImpl(), objectRegistry::namesTypeImpl(), Foam::nonProcessorPatchNames(), polynomialFunction::operator+=(), polynomialFunction::operator-=(), Foam::operator>>(), scalarRanges::parse(), argList::parse(), Foam::parseStream(), sampledPatch::patchIDs(), Foam::prependList(), Foam::printTable(), globalIndex::ranges(), Foam::blockMeshTools::read(), ABAQUSsurfaceFormat< Face >::read(), pointNoise::read(), multiphaseMangrovesTurbulenceModel::read(), writeObjects::read(), surfaceNoise::read(), explicitPorositySource::read(), derivedFields::read(), areaWrite::read(), functionObjectList::read(), Foam::readBlock(), Foam::readDir(), List< vectorField >::readList(), functionEntry::readStringList(), isoAlpha::reconstruct(), searchableBox::regions(), searchableDisk::regions(), searchablePlate::regions(), searchableSphere::regions(), PackedList< 2 >::reserve(), SortList< T >::reset(), faMeshBoundaryHalo::reset(), option::resetApplied(), PtrListDetail< T >::resize(), PDRblock::gridControl::resize(), SortList< T >::reverseSort(), Foam::BitOps::set(), List< vectorField >::set(), PackedList< 2 >::setCapacity(), fvMeshSubset::setCellSubset(), ZoneMesh< cellZone, polyMesh >::setGroup(), polyBoundaryMesh::setGroup(), lumpedPointMovement::setInterpolator(), boundaryCutter::setRefinement(), List< vectorField >::setSize(), PackedList< 2 >::shrink(), globalIndex::sizes(), LUscalarMatrix::solve(), SortList< T >::sort(), fileOperation::sortTimes(), basicThermo::splitThermoName(), MeshedSurface< Foam::face >::stitchFaces(), surfZoneIOList::surfZoneIOList(), syncTools::swapBoundaryCellList(), syncTools::swapBoundaryCellPositions(), HashTable< Foam::autoPtr< Foam::interfaceCompositionModel > >::tocEntries(), HashTable< Foam::autoPtr< Foam::interfaceCompositionModel > >::tocKeys(), HashTable< Foam::autoPtr< Foam::interfaceCompositionModel > >::tocValues(), topoBoolSet::topoBoolSet(), faceAreaIntersect::triangulate(), hashedWordList::uniq(), PrimitivePatch<::Foam::List< labelledTri >, pointField >::uniqBoundaryFaces(), Foam::uniqueOrder(), sampledFaceZone::update(), sampledPatch::update(), cellZoneSet::updateMesh(), pointZoneSet::updateMesh(), faMesh::updateMesh(), ensightFaces::write(), multiFieldValue::write(), decomposedBlockData::writeBlocks(), lumpedPointMovement::writeStateVTP(), Foam::ensightOutput::writeVolField(), zeroATCcells::zeroATCcells(), zoneToCell::zones(), zoneToPoint::zones(), zoneToFace::zones(), and faceZoneToCell::zones().
|
inline |
Definition at line 139 of file ListI.H.
Referenced by globalIndex::gather(), globalIndex::get(), globalIndex::mpiGather(), and Foam::sortedOrder().
|
inline |
Definition at line 218 of file List.H.
Referenced by preserveBaffles::add(), preserveFaceZones::add(), fvMeshAdder::add(), polyMeshAdder::add(), refinementHistory::add(), fvMeshPrimitiveLduAddressing::addAddressing(), cyclicAMIPolyPatch::addAMIFaces(), cellTable::addCellZones(), object::addData(), addPatchCellLayer::addedCells(), mapPatchChange::addedPatches(), surfaceZonesInfo::addFaceZonesToMesh(), lduPrimitiveMesh::addInterfaces(), edgeSurface::addIntersectionEdges(), snappyLayerDriver::addLayers(), regIOobject::addWatch(), adjointSolverManager::adjointSolverManager(), AMIInterpolation::agglomerate(), GAMGAgglomeration::agglomerateLduAddressing(), extendedEdgeMesh::allNearestFeatureEdges(), face::areaInContact(), sensitivitySurfacePoints::assembleSensitivities(), attachPolyTopoChanger::attach(), FreeStream< CloudType >::autoMap(), fvPatchField< Type >::autoMap(), extendedEdgeMesh::autoMap(), meshRefinement::baffleAndSplitMesh(), meshRefinement::balance(), Bezier::Bezier(), bladeModel::bladeModel(), nearWallFields::calcAddressing(), decompositionMethod::calcCellCells(), primitiveMesh::calcCells(), addPatchCellLayer::calcExtrudeInfo(), cellToFaceStencil::calcFaceStencil(), CentredFitSnGradData< Polynomial >::calcFit(), FitData< CentredFitSnGradData< Polynomial >, extendedCentredCellToFaceStencil, Polynomial >::calcFit(), primitiveMesh::calcPointOrder(), createShellMesh::calcPointRegions(), waveMethod::calculate(), correctedCellVolumeWeightMethod::calculate(), surfaceNoise::calculate(), GAMGAgglomeration::calculateRegionMaster(), fvMotionSolver::cellMotionBoundaryTypes(), boundaryMesh::changeFaces(), extractEulerianParticles::checkFaceZone(), polyBoundaryMesh::checkParallelSync(), GAMGAgglomeration::checkRestriction(), refinementHistory::clone(), triSurfaceTools::collapseEdges(), extendedCellToFaceStencil::collectData(), extendedFaceToCellStencil::collectData(), mappedPatchBase::collectSamples(), mapDistributeBase::compact(), GAMGAgglomeration::compactLevels(), removeFaces::compatibleRemoves(), NURBS3DVolume::computeParametricCoordinates(), fvPatch::constraintTypes(), polyPatch::constraintTypes(), inverseFaceDistanceDiffusivity::correct(), inversePointDistanceDiffusivity::correct(), removePoints::countPointUsage(), cyclicPolyPatch::coupledEdges(), cyclicPolyPatch::coupledPoints(), box::createLODMap(), meshRefinement::createZoneBaffles(), motionSmootherAlgo::curPoints(), hexCellLooper::cut(), geomCellLooper::cut(), simpleGeomDecomp::decompose(), faMeshDecomposition::decomposeMesh(), triSurfaceTools::delaunay2D(), mapPatchChange::deletedPatches(), meshRefinement::directionalRefineCandidates(), fvMeshDistribute::distribute(), mapDistributeBase::distribute(), distributedTriSurfaceMesh::distribute(), Pstream::exchange(), mapDistributeBase::exchangeAddressing(), Pstream::exchangeSizes(), forceCoeffs::execute(), primitiveMesh::faceEdges(), searchablePlateFeatures::features(), searchableSurfacesQueries::findAllIntersections(), refinementSurfaces::findAllIntersections(), searchableSurfacesQueries::findAnyIntersection(), shellSurfaces::findDirectionalLevel(), patchProbes::findElements(), probes::findElements(), shellSurfaces::findHigherGapLevel(), refinementSurfaces::findHigherIntersection(), refinementSurfaces::findInside(), shellSurfaces::findLevel(), triSurfaceSearch::findLine(), searchablePlane::findLine(), searchablePlate::findLine(), searchableCylinder::findLine(), searchableSurfaceCollection::findLine(), searchableSurfaceWithGaps::findLine(), searchableRotatedBox::findLine(), searchableBox::findLine(), searchableCone::findLine(), triSurfaceSearch::findLineAll(), searchablePlane::findLineAll(), searchablePlate::findLineAll(), searchableDisk::findLineAll(), searchableCylinder::findLineAll(), searchableSurfaceCollection::findLineAll(), searchableSurfaceWithGaps::findLineAll(), searchableRotatedBox::findLineAll(), searchableBox::findLineAll(), searchableCone::findLineAll(), distributedTriSurfaceMesh::findLineAll(), triSurfaceSearch::findLineAny(), searchableCylinder::findLineAny(), searchableRotatedBox::findLineAny(), searchableBox::findLineAny(), searchableCone::findLineAny(), mappedPatchBase::findLocalSamples(), searchableSurfacesQueries::findNearest(), triSurfaceRegionSearch::findNearest(), triSurfaceSearch::findNearest(), searchablePlane::findNearest(), searchableExtrudedCircle::findNearest(), searchablePlate::findNearest(), searchableCylinder::findNearest(), searchableRotatedBox::findNearest(), searchableBox::findNearest(), searchableCone::findNearest(), distributedTriSurfaceMesh::findNearest(), refinementFeatures::findNearestEdge(), searchableSurfacesQueries::findNearestIntersection(), refinementSurfaces::findNearestIntersection(), refinementFeatures::findNearestPoint(), refinementSurfaces::findNearestRegion(), refinementFeatures::findNearestRegionEdge(), searchableExtrudedCircle::findParametricNearest(), NURBS3DVolume::findPointsInBox(), meshRefinement::findRegions(), mappedPatchBase::findSamples(), polyMeshAdder::findSharedPoints(), FreeStream< CloudType >::FreeStream(), decomposedBlockData::gather(), externalCoupled::gatherAndCombine(), PatchTools::gatherAndMerge(), GAMGAgglomeration::gatherList(), decomposedBlockData::gatherSlaveData(), surfaceZonesInfo::getAllClosedNamedSurfaces(), surfaceZonesInfo::getClosedNamedSurfaces(), searchableSurfaceCollection::getField(), triSurfaceMesh::getField(), distributedTriSurfaceMesh::getField(), surfaceZonesInfo::getInsidePointNamedSurfaces(), combineFaces::getMergeSets(), decompositionConstraint::getMinBoundaryValue(), surfaceZonesInfo::getNamedSurfaces(), boundaryMesh::getNTris(), weightedPosition::getPoints(), searchablePlane::getRegion(), searchableExtrudedCircle::getRegion(), searchablePlate::getRegion(), searchableCylinder::getRegion(), searchableSurfaceCollection::getRegion(), searchableRotatedBox::getRegion(), searchableBox::getRegion(), searchableCone::getRegion(), triSurfaceMesh::getRegion(), distributedTriSurfaceMesh::getRegion(), surfaceZonesInfo::getStandaloneNamedSurfaces(), surfaceZonesInfo::getUnclosedNamedSurfaces(), surfaceZonesInfo::getUnnamedSurfaces(), removePoints::getUnrefimentSet(), cellLooper::getVertEdgesNonFace(), triSurfaceTools::getVertexTriangles(), cellLooper::getVertFacesNonEdge(), searchableCylinder::getVolumeType(), searchableBox::getVolumeType(), searchableCone::getVolumeType(), triSurfaceMesh::getVolumeType(), distributedTriSurfaceMesh::getVolumeType(), meshRefinement::getZoneFaces(), GAMGProcAgglomeration::globalCellCells(), cellCellStencil::globalCellCells(), lduPrimitiveMesh::globalCellCells(), addPatchCellLayer::globalEdgeFaces(), Distribution::index(), LocalInteraction< CloudType >::info(), StandardWallInteraction< CloudType >::info(), RecycleInteraction< CloudType >::info(), dynamicMultiMotionSolverFvMesh::init(), calculatedProcessorFvPatchField< Type >::initEvaluate(), meshToMeshMethod::initialise(), InjectedParticleDistributionInjection< CloudType >::initialise(), surfaceNoise::initialise(), fluxSummary::initialiseSurfaceAndDirection(), linearInterpolationWeights::integrationWeights(), AMIInterpolation::interpolateToSource(), AMIInterpolation::interpolateToTarget(), intersectedSurface::intersectedSurface(), isoSurfaceCell::isoSurfaceCell(), isoSurfacePoint::isoSurfacePoint(), lduPrimitiveMesh::lduPrimitiveMesh(), triSurfaceLoader::load(), distributedTriSurfaceMesh::localQueries(), voxelMeshSearch::makeMesh(), processorFaPatch::makeNonGlobalPatchPoints(), mappedPolyPatch::mapCollocatedFaces(), mappedWallPolyPatch::mapCollocatedFaces(), cyclicACMIPolyPatch::mapCollocatedFaces(), cyclicPolyPatch::mapCollocatedFaces(), mapDistribute::mapDistribute(), mapDistributeBase::mapDistributeBase(), trackingInverseDistance::markDonors(), inverseDistance::markDonors(), boundaryMesh::markFaces(), PatchTools::markZones(), triSurface::markZones(), Foam::matchPoints(), cellToFaceStencil::merge(), edgeIntersections::merge(), meshRefinement::mergeBaffles(), edgeMesh::mergeEdges(), meshRefinement::mergePatchFaces(), meshRefinement::mergePatchFacesUndo(), Foam::mergePoints(), triSurfaceTools::mergePoints(), globalMeshData::mergePoints(), extendedEdgeMesh::mergePointsAndSort(), fileOperation::mergeTimes(), MeshedSurface< Foam::face >::MeshedSurface(), engineValve::movingPatchIDs(), extendedEdgeMesh::nearestFeatureEdge(), extendedEdgeMesh::nearestFeatureEdgeByType(), surfaceFeatures::nearestSurfEdge(), cellCuts::nonAnchorPoints(), meshSearch::nonCoupledBoundaryTree(), Distribution::normalised(), UList< Foam::wordRe >::operator[](), oldCyclicPolyPatch::order(), processorPolyPatch::order(), cyclicPolyPatch::order(), cyclicAMIPolyPatch::order(), distributedTriSurfaceMesh::overlappingSurface(), polyMeshAdder::patchFacePairs(), PatchParticleHistogram< CloudType >::PatchParticleHistogram(), SprayCloud::penetration(), pointCells::pointCells(), pointFieldReconstructor::pointFieldReconstructor(), PatchTools::pointNormals(), Foam::polyMeshZipUpCells(), powerLawLopesdaCostaZone::powerLawLopesdaCostaZone(), snappySnapDriver::preSmoothPatch(), Distribution::raw(), multiphaseMangrovesTurbulenceModel::read(), regIOobject::read(), STARCDMeshReader::readBoundary(), STARCDMeshReader::readCells(), FIREMeshReader::readFaces(), reader::readField(), masterUncollatedFileOperation::readHeader(), surfaceNoise::readSurfaceData(), meshRefinement::refineCandidates(), searchablePlane::regions(), searchableExtrudedCircle::regions(), searchableCylinder::regions(), searchableSurfaceCollection::regions(), searchableCone::regions(), triSurfaceMesh::regions(), edgeMesh::regions(), edgeIntersections::removeDegenerates(), fvMeshTools::removeEmptyPatches(), mapDistributeBase::schedule(), searchableSurfaces::searchableSurfaces(), extendedEdgeMesh::select(), fvMeshSubset::setCellSubset(), decompositionMethod::setConstraints(), weightedPosition::setPoints(), box::setRefineFlags(), duplicatePoints::setRefinement(), refinementIterator::setRefinement(), removePoints::setRefinement(), boundaryCutter::setRefinement(), tetDecomposer::setRefinement(), addPatchCellLayer::setRefinement(), hexRef8::setRefinement(), propellerInfo::setSampleDiskGeometry(), SortableListDRGEP< Type >::setSize(), SortableListEFA< Type >::setSize(), data::setSolverPerformance(), removePoints::setUnrefinement(), ParSortableList< Type >::sort(), extendedEdgeMesh::sortedOrder(), extendedEdgeMesh::sortPointsAndEdges(), meshRefinement::splitFacesUndo(), meshRefinement::splitMeshRegions(), leastSquares::stencilWeights(), cellVolumeWeight::stencilWeights(), inverseDistance::stencilWeights(), streamLineParticle::streamLineParticle(), globalIndexAndTransform::transformIndicesForPatches(), triSurfaceRegionSearch::treeByRegion(), boundaryMesh::triangulate(), triSurfaceTools::triangulate(), triSurfaceTools::triangulateFaceCentre(), boundaryMesh::triangulateLocal(), advancingFrontAMI::triangulatePatch(), triSurface::triFaceFaces(), streamLineBase::trimToBox(), trackingInverseDistance::update(), inverseDistance::update(), dynamicOversetFvMesh::updateAddressing(), edgeVertex::updateLabels(), removePoints::updateMesh(), boundaryCutter::updateMesh(), faceZoneSet::updateMesh(), faceZone::updateMesh(), addPatchCellLayer::updateMesh(), faMesh::updateMesh(), zoneCellStencils::validBoundaryFaces(), cellToFaceStencil::validBoundaryFaces(), cellToCellStencil::validBoundaryFaces(), splineInterpolationWeights::valueWeights(), linearInterpolationWeights::valueWeights(), wallBoundedStreamLineParticle::wallBoundedStreamLineParticle(), and streamLineBase::writeToFile().
|
inline |
Referenced by singleProcessorFaceSets::add(), cellTable::addCellZones(), unwatchedIOdictionary::addWatch(), AMIInterpolation::agglomerate(), hashedWordList::append(), PDRblock::gridControl::append(), AMIInterpolation::append(), Foam::appendNamedEntry(), faPatch::calcPointEdges(), correctedCellVolumeWeightMethod::calculateAddressing(), cellVolumeWeightMethod::calculateAddressing(), mapNearestMethod::calculateAddressing(), directMethod::calculateAddressing(), GAMGAgglomeration::checkRestriction(), probes::classifyFields(), commSchedule::commSchedule(), box::createMap(), faMeshDecomposition::decomposeMesh(), edgeSurface::edgeSurface(), faceCells::faceCells(), Foam::findEtcEntries(), distributedTriSurfaceMesh::findNearest(), MRFZoneList::getFromName(), meshRefinement::getZones(), globalIndexAndTransform::globalIndexAndTransform(), InjectedParticleDistributionInjection< CloudType >::initialise(), fluxSummary::initialiseCellZoneAndDirection(), fluxSummary::initialiseFaceZone(), fluxSummary::initialiseFaceZoneAndDirection(), fluxSummary::initialiseSurface(), fluxSummary::initialiseSurfaceAndDirection(), triSurfaceLoader::load(), LuoSvendsen::LuoSvendsen(), trackingInverseDistance::markDonors(), inverseDistance::markDonors(), blockMesh::mesh(), Cloud< passivePositionParticle >::move(), findCellParticle::move(), csvTableReader< Type >::operator()(), UList< Foam::wordRe >::operator[](), boundaryMesh::patchify(), RecycleInteraction< CloudType >::postEvolve(), ensightSurfaceReader::readCase(), ensightSurfaceReader::readField(), refinementParameters::refinementParameters(), timeSelector::select0(), masterUncollatedFileOperation::setTime(), surfaceIntersection::surfaceIntersection(), uniformInterpolatedDisplacementPointPatchVectorField::uniformInterpolatedDisplacementPointPatchVectorField(), dynamicOversetFvMesh::updateAddressing(), dynamicOversetFvMesh::write(), and particleDistribution::write().
|
inline |
|
inline |
|
inline |
Definition at line 225 of file ListI.H.
Referenced by polyPatch::polyPatch().
Referenced by geometric::add(), extendedEdgeMesh::allNearestFeatureEdges(), extendedEdgeMesh::allNearestFeaturePoints(), faceZoneToFaceZone::applyToSet(), setToCellZone::applyToSet(), setToPointZone::applyToSet(), setAndNormalToFaceZone::applyToSet(), setToFaceZone::applyToSet(), searchableSurfaceToFaceZone::applyToSet(), setsToFaceZone::applyToSet(), extendedEdgeMesh::autoMap(), PDRblock::blockMeshDict(), box::box(), polyDualMesh::calcFeatures(), createShellMesh::calcPointRegions(), correctedCellVolumeWeightMethod::calculateAddressing(), cellVolumeWeightMethod::calculateAddressing(), mapNearestMethod::calculateAddressing(), directMethod::calculateAddressing(), CECCellToFaceStencil::CECCellToFaceStencil(), CFCCellToFaceStencil::CFCCellToFaceStencil(), triSurface::compactPoints(), MeshedSurface< Foam::face >::compactPoints(), removeFaces::compatibleRemoves(), CPCCellToFaceStencil::CPCCellToFaceStencil(), distanceSurface::createGeometry(), inverseDistance::createStencil(), geomCellLooper::cut(), topoCellLooper::cut(), extendedEdgeMesh::cut(), cyclicACMIGAMGInterface::cyclicACMIGAMGInterface(), cyclicAMIGAMGInterface::cyclicAMIGAMGInterface(), fvMeshDistribute::distribute(), FECCellToFaceStencil::FECCellToFaceStencil(), triSurfaceSearch::findLineAll(), searchableRotatedBox::findLineAll(), searchableBox::findLineAll(), distributedTriSurfaceMesh::findNearest(), PatchTools::gatherAndMerge(), InjectedParticleInjection< CloudType >::initialise(), InjectedParticleDistributionInjection< CloudType >::initialise(), objectivePtLosses::initialize(), isoSurfaceCell::isoSurfaceCell(), isoSurfacePoint::isoSurfacePoint(), triSurfaceLoader::load(), voxelMeshSearch::makeMesh(), mapDistributeBase::mapDistributeBase(), PatchTools::markZone(), momentOfInertia::massPropertiesPatch(), polyBoundaryMesh::matchGroups(), cellToCellStencil::merge(), fileOperation::mergeTimes(), MeshedSurface< Foam::face >::MeshedSurface(), streamLineParticle::move(), wallBoundedStreamLineParticle::move(), properties::objectResultEntries(), PtrListDetail< T >::operator=(), SortableList::operator=(), hashedWordList::operator=(), cellZone::operator=(), pointZone::operator=(), SortableList::partialReverseSort(), SortableList::partialSort(), GAMGAgglomeration::procAgglomerateRestrictAddressing(), OBJedgeFormat::read(), ABAQUSsurfaceFormat< Face >::read(), List< vectorField >::readList(), UList< Foam::wordRe >::readList(), STARCDCore::readPoints(), edgeMesh::regions(), cuttingSurfaceBase::remapFaces(), UnsortedMeshedSurface< Face >::remapFaces(), edgeIntersections::removeDegenerates(), faceZone::resetAddressing(), SortableList::reverseSort(), box::setRefineFlags(), hexRef8::setRefinement(), SortableListEFA< Type >::sort(), SortableListDRGEP< Type >::sort(), SortableList::sort(), extendedEdgeMesh::sortPointsAndEdges(), SortableListDRGEP< Type >::stableSort(), SortableListEFA< Type >::stableSort(), hexRef8::subset(), hashedWordList::transfer(), PackedList< 2 >::transfer(), MeshedSurface< Foam::face >::transfer(), trackingInverseDistance::update(), inverseDistance::update(), topoBoolSet::updateLabels(), meshRefinement::updateList(), hexRef8Data::updateMesh(), hexRef8::updateMesh(), solverFieldSelection::updateSelection(), volFieldSelection::updateSelection(), fileFieldSelection::updateSelection(), and streamLineBase::writeToFile().
void transfer | ( | DynamicList< T, SizeMin > & | list | ) |
void transfer | ( | SortableList< T > & | list | ) |
|
inline |
Definition at line 146 of file ListI.H.
Referenced by Foam::parseStream().
Referenced by cellShape::collapse(), surfZoneIOList::operator=(), PtrListDetail< T >::operator=(), SortableListDRGEP< Type >::operator=(), SortableListEFA< Type >::operator=(), SortableList::operator=(), hashedWordList::operator=(), cellZone::operator=(), pointZone::operator=(), cellClassification::operator=(), ITstream::operator=(), and faceZone::resetAddressing().
void operator= | ( | const IndirectListBase< T, Addr > & | list | ) |
void operator= | ( | std::initializer_list< T > | list | ) |
|
inline |
|
inline |
void operator= | ( | DynamicList< T, SizeMin > && | list | ) |
void operator= | ( | SortableList< T > && | list | ) |
Referenced by Foam::operator>>(), and decomposedBlockData::readBlockEntry().
|
inline |
Definition at line 337 of file List.H.
Referenced by GAMGAgglomeration::agglomerateLduAddressing(), pointSet::distribute(), faceSet::distribute(), cellSet::distribute(), dynamicRefineFvMesh::init(), InjectedParticleDistributionInjection< CloudType >::initialise(), objectiveManager::objectiveManager(), GAMGAgglomeration::procAgglomerateLduAddressing(), boundaryMesh::readTriSurface(), Foam::BitOps::set(), PatchEdgeFaceWave< PrimitivePatchType, Type, TrackingData >::setEdgeInfo(), FaceCellWave< Type, int >::setFaceInfo(), lumpedPointMovement::setInterpolator(), pointSet::sync(), faceSet::sync(), and topoBoolSet::updateLabels().
void transfer | ( | SortableList< T > & | list | ) |
void operator= | ( | SortableList< T > && | list | ) |
Foam::Istream & readList | ( | Istream & | is | ) |
|
inline |
Definition at line 42 of file charList.C.
Copyright © 2011-2018 OpenFOAM | OPENFOAM® is a registered trademark of OpenCFD Ltd.