List< T > Class Template 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 >, cellToFaceStencil, faceTriangulation, IOList< T >, ITstream, polynomialFunction [private], ProcessorTopology< Container, ProcPatch >, pTraits< List< T > >, thirdBodyEfficiencies, and zone.

Public Types

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

Public Member Functions

constexpr List () noexcept
 Null constructor. More...
 
 List (const label len)
 Construct with given size. More...
 
 List (const label len, const T &val)
 Construct with given size and value for all elements. More...
 
 List (const label len, const zero)
 Construct with given size initializing all elements to zero. More...
 
 List (const one, const T &val)
 Construct with length=1, copying the value as the only content. More...
 
 List (const one, T &&val)
 Construct with length=1, moving the value as the only content. More...
 
 List (const one, const zero)
 Construct with length=1, initializing content to zero. More...
 
 List (const List< T > &a)
 Copy construct from list. More...
 
 List (const UList< T > &a)
 Copy construct contents from list. More...
 
 List (List< T > &a, bool reuse)
 Construct as copy or re-use as specified. More...
 
 List (const UList< T > &list, const labelUList &mapAddressing)
 Construct as subset. More...
 
template<class InputIterator >
 List (InputIterator begIter, InputIterator endIter)
 Construct given begin/end iterators. More...
 
template<unsigned N>
 List (const FixedList< T, N > &list)
 Construct as copy of FixedList<T, N> More...
 
 List (const PtrList< T > &list)
 Construct as copy of PtrList<T> More...
 
 List (const SLList< T > &list)
 Construct as copy of SLList<T> More...
 
template<class Addr >
 List (const IndirectListBase< T, Addr > &list)
 Construct as copy of IndirectList contents. More...
 
 List (std::initializer_list< T > list)
 Construct from an initializer list. More...
 
 List (List< T > &&list)
 Move construct from List. More...
 
template<int SizeMin>
 List (DynamicList< T, SizeMin > &&list)
 Move construct from DynamicList. More...
 
 List (SortableList< T > &&list)
 Move construct from SortableList. More...
 
 List (SLList< T > &&list)
 Move construct from SLList. More...
 
 List (Istream &is)
 Construct from Istream. More...
 
autoPtr< List< T > > clone () const
 Clone. More...
 
 ~List ()
 Destructor. More...
 
void resize (const label newSize)
 Adjust allocated size of list. More...
 
void resize (const label newSize, const T &val)
 Adjust allocated size of list and set val for new elements. More...
 
void setSize (const label newSize)
 Alias for resize(const label) More...
 
void setSize (const label newSize, const T &val)
 Alias for resize(const label, const T&) More...
 
void clear ()
 Clear the list, i.e. set size to zero. More...
 
void append (const T &val)
 Append an element at the end of the list. More...
 
void append (T &&val)
 Move append an element at the end of the list. More...
 
void append (const UList< T > &list)
 Append a List to the end of this list. More...
 
template<class Addr >
void append (const IndirectListBase< T, Addr > &list)
 Append IndirectList contents at the end of this list. More...
 
void transfer (List< T > &list)
 
template<int SizeMin>
void transfer (DynamicList< T, SizeMin > &list)
 
void transfer (SortableList< T > &list)
 
TnewElmt (const label i)
 
void operator= (const UList< T > &a)
 Assignment to UList operator. Takes linear time. More...
 
void operator= (const List< T > &list)
 Assignment operator. Takes linear time. More...
 
void operator= (const SLList< T > &list)
 Assignment to SLList operator. Takes linear time. More...
 
template<class Addr >
void operator= (const IndirectListBase< T, Addr > &list)
 Assignment from IndirectList. Takes linear time. More...
 
void operator= (std::initializer_list< T > list)
 Assignment to an initializer list. More...
 
void operator= (const T &val)
 Assignment of all entries to the given value. More...
 
void operator= (const zero)
 Assignment of all entries to zero. More...
 
void operator= (List< T > &&list)
 Move assignment. Takes constant time. More...
 
template<int SizeMin>
void operator= (DynamicList< T, SizeMin > &&list)
 Move assignment. Takes constant time. More...
 
void operator= (SortableList< T > &&list)
 Move assignment. Takes constant time. More...
 
void operator= (SLList< T > &&list)
 Move assignment. Takes constant time. More...
 
void shallowCopy (const UList< T > &)=delete
 No shallowCopy permitted. More...
 
template<class TypeT = T>
std::enable_if< std::is_same< bool, TypeT >::value, bool >::type set (const label i, bool val=true)
 A bitSet::set() method for a list of bool. More...
 
template<>
void resize (const label newSize)
 

Static Public Member Functions

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

Friends

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

Detailed Description

template<class T>
class Foam::List< T >

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

Storage is allocated on free-store during construction.

Source files

Definition at line 102 of file HashTable.H.

Member Typedef Documentation

◆ subList

typedef SubList<T> subList

Declare type of subList.

Definition at line 117 of file List.H.

Constructor & Destructor Documentation

◆ List() [1/22]

constexpr List ( )
inlineconstexprnoexcept

Null constructor.

Definition at line 94 of file ListI.H.

◆ List() [2/22]

List ( const label  len)
explicit

Construct with given size.

Definition at line 94 of file List.C.

◆ List() [3/22]

List ( const label  len,
const T val 
)

Construct with given size and value for all elements.

Definition at line 110 of file List.C.

◆ List() [4/22]

List ( const label  len,
const  zero 
)

Construct with given size initializing all elements to zero.

Definition at line 135 of file List.C.

◆ List() [5/22]

List ( const  one,
const T val 
)

Construct with length=1, copying the value as the only content.

Definition at line 160 of file List.C.

◆ List() [6/22]

List ( const  one,
T &&  val 
)

Construct with length=1, moving the value as the only content.

Definition at line 169 of file List.C.

◆ List() [7/22]

List ( const  one,
const  zero 
)

Construct with length=1, initializing content to zero.

Definition at line 178 of file List.C.

◆ List() [8/22]

List ( const List< T > &  a)

Copy construct from list.

Definition at line 220 of file List.C.

◆ List() [9/22]

List ( const UList< T > &  a)
explicit

Copy construct contents from list.

Definition at line 187 of file List.C.

◆ List() [10/22]

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

Construct as copy or re-use as specified.

Definition at line 253 of file List.C.

◆ List() [11/22]

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

Construct as subset.

Definition at line 295 of file List.C.

◆ List() [12/22]

List ( InputIterator  begIter,
InputIterator  endIter 
)

Construct given begin/end iterators.

Uses std::distance for the size.

Definition at line 317 of file List.C.

◆ List() [13/22]

List ( const FixedList< T, N > &  list)
explicit

Construct as copy of FixedList<T, N>

Definition at line 325 of file List.C.

◆ List() [14/22]

List ( const PtrList< T > &  list)
explicit

Construct as copy of PtrList<T>

Definition at line 335 of file List.C.

◆ List() [15/22]

List ( const SLList< T > &  list)
explicit

Construct as copy of SLList<T>

Definition at line 345 of file List.C.

◆ List() [16/22]

List ( const IndirectListBase< T, Addr > &  list)
explicit

Construct as copy of IndirectList contents.

Definition at line 353 of file List.C.

◆ List() [17/22]

List ( std::initializer_list< T list)

Construct from an initializer list.

Definition at line 363 of file List.C.

◆ List() [18/22]

List ( List< T > &&  list)

Move construct from List.

Definition at line 370 of file List.C.

◆ List() [19/22]

List ( DynamicList< T, SizeMin > &&  list)

Move construct from DynamicList.

Definition at line 381 of file List.C.

◆ List() [20/22]

List ( SortableList< T > &&  list)

Move construct from SortableList.

Definition at line 390 of file List.C.

◆ List() [21/22]

List ( SLList< T > &&  list)

Move construct from SLList.

Definition at line 399 of file List.C.

◆ List() [22/22]

List ( Istream is)

Construct from Istream.

Definition at line 38 of file ListIO.C.

◆ ~List()

~List ( )

Destructor.

Definition at line 410 of file List.C.

Member Function Documentation

◆ null()

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

Return a null List.

Definition at line 108 of file ListI.H.

◆ clone()

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

Clone.

Definition at line 99 of file ListI.H.

◆ resize() [1/3]

void resize ( const label  newSize)
inline

Adjust allocated size of list.

The boolList version fills new memory with false.

Definition at line 139 of file ListI.H.

Referenced by preservePatches::add(), singleProcessorFaceSets::add(), geometric::add(), polyTopoChange::addMesh(), topoSetSource::check(), ensightMesh::correct(), Foam::duplicateOrder(), Foam::etcDirs(), Foam::exprTools::getList(), searchableDisk::getRegion(), Foam::indicesImpl(), ZoneMesh< cellZone, polyMesh >::indicesImpl(), Foam::invertManyToMany(), Foam::invertOneToMany(), dictionary::keys(), basicThermo::lookupThermo(), wordRes::matching(), scalars::matching(), Foam::namesImpl(), ZoneMesh< cellZone, polyMesh >::namesImpl(), basicSolidChemistryModel::New(), Foam::operator>>(), argList::parse(), Foam::printTable(), pointNoise::read(), explicitPorositySource::read(), multiphaseMangrovesTurbulenceModel::read(), derivedFields::read(), writeObjects::read(), surfaceNoise::read(), areaWrite::read(), Foam::readDir(), functionEntry::readStringList(), regionSplit::reduceRegions(), searchableSphere::regions(), PackedList< 2 >::reserve(), SortList< T >::reset(), SortList< T >::reverseSort(), List< substance >::set(), PackedList< 2 >::setCapacity(), fvMeshSubset::setCellSubset(), edgeCollapser::setRefinement(), PackedList< 2 >::shrink(), LUscalarMatrix::solve(), SortList< T >::sort(), Foam::sortedOrder(), syncTools::swapBoundaryCellList(), syncTools::swapBoundaryCellPositions(), HashTable< Foam::phase * >::tocEntries(), HashTable< Foam::phase * >::tocKeys(), HashTable< Foam::phase * >::tocValues(), topoBoolSet::topoBoolSet(), faceAreaIntersect::triangulate(), wordRes::uniq(), hashedWordList::uniq(), and Foam::uniqueOrder().

◆ resize() [2/3]

void resize ( const label  newSize,
const T val 
)

Adjust allocated size of list and set val for new elements.

Definition at line 422 of file List.C.

◆ setSize() [1/2]

void setSize ( const label  newSize)
inline

Alias for resize(const label)

Definition at line 146 of file ListI.H.

Referenced by preserveBaffles::add(), preserveFaceZones::add(), refinementHistory::add(), fvMeshPrimitiveLduAddressing::addAddressing(), cellTable::addCellZones(), addPatchCellLayer::addedCells(), lduPrimitiveMesh::addInterfaces(), edgeSurface::addIntersectionEdges(), snappyLayerDriver::addLayers(), regIOobject::addWatch(), MeshedSurface< Foam::face >::addZones(), adjointSolverManager::adjointSolverManager(), GAMGAgglomeration::agglomerateLduAddressing(), extendedEdgeMesh::allNearestFeatureEdges(), conjugateGradient::allocateFields(), SR1::allocateMatrices(), DBFGS::allocateMatrices(), LBFGS::allocateMatrices(), BFGS::allocateMatrices(), face::areaInContact(), sensitivitySurfacePoints::assembleSensitivities(), FreeStream< CloudType >::autoMap(), extendedEdgeMesh::autoMap(), meshRefinement::balance(), Bezier::Bezier(), bladeModel::bladeModel(), booleanSurface::booleanSurface(), nearWallFields::calcAddressing(), decompositionMethod::calcCellCells(), primitiveMesh::calcCells(), addPatchCellLayer::calcExtrudeInfo(), cellToFaceStencil::calcFaceStencil(), CentredFitSnGradData< Polynomial >::calcFit(), FitData< CentredFitSnGradData< Polynomial >, extendedCentredCellToFaceStencil, Polynomial >::calcFit(), polyLine::calcParam(), primitiveMesh::calcPointOrder(), createShellMesh::calcPointRegions(), waveMethod::calculate(), correctedCellVolumeWeightMethod::calculate(), mapNearestAMI< SourcePatch, TargetPatch >::calculate(), surfaceNoise::calculate(), GAMGAgglomeration::calculateRegionMaster(), fvMotionSolver::cellMotionBoundaryTypes(), boundaryMesh::changeFaces(), MeshedSurface< Foam::face >::checkFaces(), extractEulerianParticles::checkFaceZone(), GAMGAgglomeration::checkRestriction(), refinementHistory::clone(), cellShape::collapsedFaces(), extendedCellToFaceStencil::collectData(), extendedFaceToCellStencil::collectData(), mappedPatchBase::collectSamples(), mapDistributeBase::compact(), GAMGAgglomeration::compactLevels(), removeFaces::compatibleRemoves(), NURBS3DVolume::computeParametricCoordinates(), inverseFaceDistanceDiffusivity::correct(), inversePointDistanceDiffusivity::correct(), removePoints::countPointUsage(), cyclicPolyPatch::coupledPoints(), box::createLODMap(), meshRefinement::createZoneBaffles(), motionSmootherAlgo::curPoints(), hexCellLooper::cut(), geomCellLooper::cut(), simpleGeomDecomp::decompose(), mapPatchChange::deletedPatches(), meshRefinement::directionalRefineCandidates(), mapDistributeBase::distribute(), distributedTriSurfaceMesh::distribute(), cell::edges(), Pstream::exchange(), mapDistributeBase::exchangeAddressing(), Pstream::exchangeSizes(), forceCoeffs::execute(), extendedEdgeMesh::extendedEdgeMesh(), extendedUpwindCellToFaceStencil::extendedUpwindCellToFaceStencil(), primitiveMesh::faceEdges(), cellModel::faces(), faceZone::faceZone(), faMesh::faMesh(), 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(), searchableSphere::findLine(), searchableDisk::findLine(), searchableCylinder::findLine(), searchableSurfaceCollection::findLine(), searchableBox::findLine(), searchableRotatedBox::findLine(), searchableSurfaceWithGaps::findLine(), searchableCone::findLine(), triSurfaceSearch::findLineAll(), searchablePlane::findLineAll(), searchablePlate::findLineAll(), searchableSphere::findLineAll(), searchableDisk::findLineAll(), searchableCylinder::findLineAll(), searchableSurfaceCollection::findLineAll(), searchableBox::findLineAll(), searchableRotatedBox::findLineAll(), searchableSurfaceWithGaps::findLineAll(), searchableCone::findLineAll(), distributedTriSurfaceMesh::findLineAll(), triSurfaceSearch::findLineAny(), searchableSphere::findLineAny(), searchableCylinder::findLineAny(), searchableBox::findLineAny(), searchableRotatedBox::findLineAny(), searchableCone::findLineAny(), namesList< solutionEntry >::findNames(), searchableSurfacesQueries::findNearest(), triSurfaceRegionSearch::findNearest(), triSurfaceSearch::findNearest(), searchablePlane::findNearest(), searchableExtrudedCircle::findNearest(), searchablePlate::findNearest(), searchableSphere::findNearest(), searchableDisk::findNearest(), searchableCylinder::findNearest(), searchableBox::findNearest(), searchableRotatedBox::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(), lumpedPointMovement::forcesAndMoments(), FreeStream< CloudType >::FreeStream(), decomposedBlockData::gather(), globalIndex::gather(), externalCoupled::gatherAndCombine(), PatchTools::gatherAndMerge(), GAMGAgglomeration::gatherList(), decomposedBlockData::gatherSlaveData(), globalIndex::get(), combineFaces::getMergeSets(), boundaryMesh::getNTris(), searchablePlane::getRegion(), searchableExtrudedCircle::getRegion(), searchablePlate::getRegion(), searchableSphere::getRegion(), searchableCylinder::getRegion(), searchableSurfaceCollection::getRegion(), searchableBox::getRegion(), searchableRotatedBox::getRegion(), searchableCone::getRegion(), triSurfaceMesh::getRegion(), distributedTriSurfaceMesh::getRegion(), removePoints::getUnrefimentSet(), cellLooper::getVertEdgesNonFace(), triSurfaceTools::getVertexTriangles(), searchableSphere::getVolumeType(), searchableCylinder::getVolumeType(), searchableBox::getVolumeType(), searchableCone::getVolumeType(), triSurfaceMesh::getVolumeType(), distributedTriSurfaceMesh::getVolumeType(), cellCellStencil::globalCellCells(), addPatchCellLayer::globalEdgeFaces(), triSurfaceTools::greenRefine(), Distribution< Type >::index(), calculatedProcessorFvPatchField< Type >::initEvaluate(), meshToMeshMethod::initialise(), AMIMethod< SourcePatch, TargetPatch >::initialise(), InjectedParticleDistributionInjection< CloudType >::initialise(), surfaceNoise::initialise(), fluxSummary::initialiseSurfaceAndDirection(), calculatedProcessorFvPatchField< Type >::initInterfaceMatrixUpdate(), linearInterpolationWeights::integrationWeights(), GAMGInterface::interfaceInternalField(), AMIInterpolation< SourcePatch, TargetPatch >::interpolateToSource(), AMIInterpolation< SourcePatch, TargetPatch >::interpolateToTarget(), intersectedSurface::intersectedSurface(), foamPvCore::arrayRange::intersection(), isoSurface::isoSurface(), isoSurfaceCell::isoSurfaceCell(), isoSurfaceTopo::isoSurfaceTopo(), lduPrimitiveMesh::lduPrimitiveMesh(), triSurfaceLoader::load(), distributedTriSurfaceMesh::localQueries(), voxelMeshSearch::makeMesh(), processorFaPatch::makeNonGlobalPatchPoints(), mapDistribute::mapDistribute(), mapDistributeBase::mapDistributeBase(), trackingInverseDistance::markDonors(), inverseDistance::markDonors(), boundaryMesh::markFaces(), PatchTools::markZones(), triSurface::markZones(), PatchTools::matchEdges(), Foam::matchPoints(), PatchTools::matchPoints(), cellToFaceStencil::merge(), edgeIntersections::merge(), meshRefinement::mergeBaffles(), meshRefinement::mergePatchFacesUndo(), Foam::mergePoints(), globalMeshData::mergePoints(), extendedEdgeMesh::mergePointsAndSort(), fileOperation::mergeTimes(), engineValve::movingPatchIDs(), extendedEdgeMesh::nearestFeatureEdge(), extendedEdgeMesh::nearestFeatureEdgeByType(), surfaceFeatures::nearestSurfEdge(), polyBoundaryMesh::neighbourEdges(), faPatch::ngbPolyPatchFaces(), cellCuts::nonAnchorPoints(), Distribution< Type >::normalised(), mapNearestAMI< SourcePatch, TargetPatch >::normaliseWeights(), objectiveManager::objectiveManager(), polynomialFunction::operator+=(), polynomialFunction::operator-=(), UList< Foam::wordRe >::operator[](), oldCyclicPolyPatch::order(), processorPolyPatch::order(), cyclicPolyPatch::order(), cyclicAMIPolyPatch::order(), distributedTriSurfaceMesh::overlappingSurface(), ParticleCollector< CloudType >::ParticleCollector(), SprayCloud< Foam::DSMCCloud >::penetration(), pointCells::pointCells(), pointFieldReconstructor::pointFieldReconstructor(), PatchTools::pointNormals(), Foam::polyMeshZipUpCells(), snappySnapDriver::preSmoothPatch(), Distribution< Type >::raw(), GTSsurfaceFormat< Face >::read(), VTKedgeFormat::read(), writeDictionary::read(), cloudSolution::read(), runTimeControl::read(), multiphaseMangrovesSource::read(), explicitPorositySource::read(), multiphaseMangrovesTurbulenceModel::read(), regIOobject::read(), STARCDMeshReader::readBoundary(), STARCDMeshReader::readCells(), FIREMeshReader::readFaces(), reader::readField(), masterUncollatedFileOperation::readHeader(), surfaceNoise::readSurfaceData(), boundaryMesh::readTriSurface(), meshRefinement::refineCandidates(), searchablePlane::regions(), searchableExtrudedCircle::regions(), searchableBox::regions(), searchableDisk::regions(), searchablePlate::regions(), searchableCylinder::regions(), searchableSurfaceCollection::regions(), searchableCone::regions(), edgeMesh::regions(), triSurfaceMesh::regions(), fvMeshTools::removeEmptyPatches(), mapDistributeBase::schedule(), searchableSurfaces::searchableSurfaces(), extendedEdgeMesh::select(), fvMeshSubset::setCellSubset(), decompositionMethod::setConstraints(), polyBoundaryMesh::setGroup(), lumpedPointMovement::setMapping(), box::setRefineFlags(), duplicatePoints::setRefinement(), refinementIterator::setRefinement(), boundaryCutter::setRefinement(), removePoints::setRefinement(), tetDecomposer::setRefinement(), addPatchCellLayer::setRefinement(), hexRef8::setRefinement(), SortableListDRGEP< Type >::setSize(), SortableListEFA< Type >::setSize(), data::setSolverPerformance(), removePoints::setUnrefinement(), discreteSurface::setZoneMap(), sampledTriSurfaceMesh::setZoneMap(), ParSortableList< Type >::sort(), extendedEdgeMesh::sortedOrder(), extendedEdgeMesh::sortPointsAndEdges(), meshRefinement::splitFacesUndo(), leastSquares::stencilWeights(), cellVolumeWeight::stencilWeights(), inverseDistance::stencilWeights(), MeshedSurface< Foam::face >::stitchFaces(), streamLineParticle::streamLineParticle(), triSurface::subsetMeshMap(), surfZoneIOList::surfZoneIOList(), triSurfaceRegionSearch::treeByRegion(), boundaryMesh::triangulate(), triSurfaceTools::triangulate(), triSurfaceTools::triangulateFaceCentre(), boundaryMesh::triangulateLocal(), AMIMethod< SourcePatch, TargetPatch >::triangulatePatch(), triSurface::triFaceFaces(), streamLineBase::trimToBox(), trackingInverseDistance::update(), inverseDistance::update(), dynamicOversetFvMesh::updateAddressing(), edgeVertex::updateLabels(), removePoints::updateMesh(), boundaryCutter::updateMesh(), faceZone::updateMesh(), addPatchCellLayer::updateMesh(), faMesh::updateMesh(), lduPrimitiveMesh::upperTriOrder(), cellToFaceStencil::validBoundaryFaces(), cellToCellStencil::validBoundaryFaces(), NamedEnum< EnumType, nEnum >::values(), splineInterpolationWeights::valueWeights(), linearInterpolationWeights::valueWeights(), volBSplinesBase::volBSplinesBase(), wallBoundedStreamLineParticle::wallBoundedStreamLineParticle(), NamedEnum< EnumType, nEnum >::words(), decomposedBlockData::writeBlocks(), and streamLineBase::writeToFile().

◆ setSize() [2/2]

void setSize ( const label  newSize,
const T val 
)
inline

Alias for resize(const label, const T&)

Definition at line 153 of file ListI.H.

◆ clear()

void clear ( )
inline

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

Definition at line 115 of file ListI.H.

Referenced by correctedCellVolumeWeightMethod::calculateAddressing(), cellVolumeWeightMethod::calculateAddressing(), SortableList< T >::clear(), IListStreamAllocator::clearStorage(), PackedList< 2 >::clearStorage(), polySurface::copySurface(), surfMesh::copySurface(), removePoints::countPointUsage(), box::createMap(), meshRefinement::createZoneBaffles(), Foam::duplicateOrder(), Field< Foam::Vector2D >::Field(), refinementSurfaces::findAllIntersections(), probes::findElements(), searchablePlane::findLineAll(), searchablePlate::findLineAll(), searchableSphere::findLineAll(), searchableDisk::findLineAll(), searchableCylinder::findLineAll(), searchableSurfaceCollection::findLineAll(), searchableBox::findLineAll(), searchableRotatedBox::findLineAll(), searchableSurfaceWithGaps::findLineAll(), searchableCone::findLineAll(), distributedTriSurfaceMesh::findLineAll(), geometryPatches::gatherPatchPieces(), surface::gatherSurfacePieces(), triSurfaceMesh::isSurfaceClosed(), Cloud< passivePositionParticle >::move(), edgeMesh::operator=(), argList::parse(), STARCDsurfaceFormat< Face >::read(), TRIsurfaceFormat< Face >::read(), STARCDedgeFormat::read(), STLsurfaceFormat< Face >::read(), ensightWrite::read(), STARCDMeshReader::readCells(), Time::readDict(), boundaryMesh::readTriSurface(), surfMesh::removeZones(), decompositionMethod::setConstraints(), Foam::sortedOrder(), MeshedSurface< Foam::face >::sortFacesAndStore(), hexRef8::storeData(), PatchTools::subsetMap(), MeshedSurface< Foam::face >::triangulate(), trackingInverseDistance::update(), cellVolumeWeight::update(), inverseDistance::update(), and surfaceNoise::writeSurfaceData().

◆ append() [1/4]

void append ( const T val)
inline

Append an element at the end of the list.

Definition at line 182 of file ListI.H.

Referenced by singleProcessorFaceSets::add(), cellTable::addCellZones(), snappyLayerDriver::addLayers(), AMIInterpolation< SourcePatch, TargetPatch >::append(), Foam::appendNamedEntry(), Foam::bandCompression(), createShellMesh::calcPointRegions(), waveMethod::calculate(), correctedCellVolumeWeightMethod::calculateAddressing(), cellVolumeWeightMethod::calculateAddressing(), GAMGAgglomeration::checkRestriction(), probes::classifyFields(), refinementHistory::clone(), commSchedule::commSchedule(), removeFaces::compatibleRemoves(), hexRef8::consistentSlowRefinement(), hexRef8::consistentSlowRefinement2(), box::createMap(), curvatureSeparation::curvatureSeparation(), snappyLayerDriver::doLayers(), edgeSurface::edgeSurface(), faceCells::faceCells(), shellSurfaces::findDirectionalLevel(), localPointRegion::findDuplicateFacePairs(), Foam::findEtcEntries(), distributedTriSurfaceMesh::findNearest(), for(), removeCells::getExposedFaces(), meshRefinement::getZones(), triSurfaceTools::greenRefine(), InjectedParticleDistributionInjection< CloudType >::initialise(), fluxSummary::initialiseCellZoneAndDirection(), fluxSummary::initialiseFaceZone(), fluxSummary::initialiseFaceZoneAndDirection(), fluxSummary::initialiseSurface(), fluxSummary::initialiseSurfaceAndDirection(), triSurfaceLoader::load(), LuoSvendsen::LuoSvendsen(), trackingInverseDistance::markDonors(), inverseDistance::markDonors(), PatchTools::markZone(), triSurface::markZone(), meshRefinement::meshedPatches(), findCellParticle::move(), combustionModel::New(), chemistryTabulationMethod< ReactionThermo, ThermoType >::New(), chemistryReductionMethod< ReactionThermo, ThermoType >::New(), UList< Foam::wordRe >::operator[](), boundaryMesh::patchify(), polyPatch::polyPatch(), surfaceFieldValue::read(), functionObjectList::readFunctionObject(), lagrangianReconstructor::reconstructFieldFields(), refinementParameters::refinementParameters(), edgeMesh::regions(), regionSplit2D::regionSplit2D(), timeSelector::select0(), polyBoundaryMesh::setGroup(), edgeCollapser::setRefinement(), hexRef8::setRefinement(), masterUncollatedFileOperation::setTime(), faceZoneSet::subset(), meshRefinement::subsetBaffles(), faceZoneSet::sync(), triSurfaceTools::triangulate(), triSurfaceTools::triangulateFaceCentre(), dynamicOversetFvMesh::updateAddressing(), externalDisplacementMeshMover::updateMesh(), solverFieldSelection::updateSelection(), particleDistribution::write(), and fieldValueDelta::writeFileHeader().

◆ append() [2/4]

void append ( T &&  val)
inline

Move append an element at the end of the list.

Definition at line 189 of file ListI.H.

◆ append() [3/4]

void append ( const UList< T > &  list)
inline

Append a List to the end of this list.

Definition at line 199 of file ListI.H.

◆ append() [4/4]

void append ( const IndirectListBase< T, Addr > &  list)
inline

Append IndirectList contents at the end of this list.

Definition at line 221 of file ListI.H.

◆ transfer() [1/3]

void transfer ( List< T > &  list)

Transfer the contents of the argument List into this list and annul the argument list

Definition at line 436 of file List.C.

Referenced by geometric::add(), extendedEdgeMesh::allNearestFeatureEdges(), extendedEdgeMesh::allNearestFeaturePoints(), setToCellZone::applyToSet(), faceZoneToFaceZone::applyToSet(), setToPointZone::applyToSet(), setToFaceZone::applyToSet(), setAndNormalToFaceZone::applyToSet(), setsToFaceZone::applyToSet(), searchableSurfaceToFaceZone::applyToSet(), extendedEdgeMesh::autoMap(), box::box(), polyDualMesh::calcFeatures(), createShellMesh::calcPointRegions(), 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(), CFCCellToFaceStencil::CFCCellToFaceStencil(), removeFaces::compatibleRemoves(), CPCCellToFaceStencil::CPCCellToFaceStencil(), inverseDistance::createStencil(), geomCellLooper::cut(), topoCellLooper::cut(), extendedEdgeMesh::cut(), cyclicACMIGAMGInterface::cyclicACMIGAMGInterface(), cyclicAMIGAMGInterface::cyclicAMIGAMGInterface(), fvMeshDistribute::distribute(), FECCellToFaceStencil::FECCellToFaceStencil(), triSurfaceSearch::findLineAll(), searchableBox::findLineAll(), searchableRotatedBox::findLineAll(), distributedTriSurfaceMesh::findNearest(), PatchTools::gatherAndMerge(), InjectedParticleInjection< CloudType >::initialise(), InjectedParticleDistributionInjection< CloudType >::initialise(), objectivePtLosses::initialize(), isoSurface::isoSurface(), isoSurfaceCell::isoSurfaceCell(), triSurfaceLoader::load(), voxelMeshSearch::makeMesh(), mapDistributeBase::mapDistributeBase(), PatchTools::markZone(), momentOfInertia::massPropertiesPatch(), polyBoundaryMesh::matchGroups(), cellToCellStencil::merge(), fileOperation::mergeTimes(), MeshedSurface< Foam::face >::MeshedSurface(), streamLineParticle::move(), wallBoundedStreamLineParticle::move(), stateFunctionObject::objectResultEntries(), SortableList< T >::operator=(), SortableList< T >::partialReverseSort(), SortableList< T >::partialSort(), OBJedgeFormat::read(), STARCDCore::readPoints(), edgeMesh::regions(), SortableList< T >::reverseSort(), box::setRefineFlags(), hexRef8::setRefinement(), SortableListDRGEP< Type >::sort(), SortableListEFA< Type >::sort(), SortableList< T >::sort(), extendedEdgeMesh::sortPointsAndEdges(), SortableListEFA< Type >::stableSort(), SortableListDRGEP< Type >::stableSort(), PackedList< 2 >::transfer(), MeshedSurface< Foam::face >::triangulate(), trackingInverseDistance::update(), inverseDistance::update(), topoBoolSet::updateLabels(), meshRefinement::updateList(), hexRef8Data::updateMesh(), boundaryCutter::updateMesh(), localPointRegion::updateMesh(), hexRef8::updateMesh(), meshRefinement::updateMesh(), solverFieldSelection::updateSelection(), volFieldSelection::updateSelection(), and fileFieldSelection::updateSelection().

◆ transfer() [2/3]

void transfer ( DynamicList< T, SizeMin > &  list)

Transfer the contents of the argument List into this list and annul the argument list

Definition at line 455 of file List.C.

◆ transfer() [3/3]

void transfer ( SortableList< T > &  list)

Transfer the contents of the argument List into this list and annul the argument list

Definition at line 467 of file List.C.

◆ newElmt()

T & newElmt ( const label  i)
inline

Return subscript-checked element of UList and resizing the list if required.

Definition at line 160 of file ListI.H.

◆ operator=() [1/11]

void operator= ( const UList< T > &  a)

Assignment to UList operator. Takes linear time.

Definition at line 478 of file List.C.

Referenced by SortableListDRGEP< Type >::operator=(), SortableListEFA< Type >::operator=(), and SortableList< T >::operator=().

Here is the caller graph for this function:

◆ operator=() [2/11]

void operator= ( const List< T > &  list)

Assignment operator. Takes linear time.

Definition at line 514 of file List.C.

◆ operator=() [3/11]

void operator= ( const SLList< T > &  list)

Assignment to SLList operator. Takes linear time.

Definition at line 526 of file List.C.

◆ operator=() [4/11]

void operator= ( const IndirectListBase< T, Addr > &  list)

Assignment from IndirectList. Takes linear time.

Definition at line 548 of file List.C.

◆ operator=() [5/11]

void operator= ( std::initializer_list< T list)

Assignment to an initializer list.

Definition at line 567 of file List.C.

◆ operator=() [6/11]

void operator= ( const T val)
inline

Assignment of all entries to the given value.

Definition at line 238 of file ListI.H.

◆ operator=() [7/11]

void operator= ( const  zero)
inline

Assignment of all entries to zero.

Definition at line 245 of file ListI.H.

◆ operator=() [8/11]

void operator= ( List< T > &&  list)

Move assignment. Takes constant time.

Definition at line 588 of file List.C.

◆ operator=() [9/11]

void operator= ( DynamicList< T, SizeMin > &&  list)

Move assignment. Takes constant time.

Definition at line 601 of file List.C.

◆ operator=() [10/11]

void operator= ( SortableList< T > &&  list)

Move assignment. Takes constant time.

Definition at line 608 of file List.C.

◆ operator=() [11/11]

void operator= ( SLList< T > &&  list)

Move assignment. Takes constant time.

Definition at line 615 of file List.C.

◆ shallowCopy()

void shallowCopy ( const UList< T > &  )
delete

No shallowCopy permitted.

Referenced by ODESolver::resizeField().

Here is the caller graph for this function:

◆ set()

◆ resize() [3/3]

void resize ( const label  newSize)
inline

Definition at line 131 of file ListI.H.

Friends And Related Function Documentation

◆ operator>>

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

Read List from Istream, discarding contents of existing List.


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