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 >, cellShape, cellToCellStencil, faceTriangulation, IOList< T >, ITstream, polynomialFunction [private], pTraits< List< T > >, regionSplit, regionSplit2D, thirdBodyEfficiencies, zone, and zoneCellStencils.

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 Foam::zero)
 Construct with given size initializing all elements to zero. More...
 
 List (const Foam::one, const T &val)
 Construct with length=1, copying the value as the only content. More...
 
 List (const Foam::one, T &&val)
 Construct with length=1, moving the value as the only content. More...
 
 List (const Foam::one, const Foam::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 &indices)
 Copy construct subset of list. More...
 
template<unsigned N>
 List (const UList< T > &list, const FixedList< label, N > &indices)
 Copy construct subset of list. 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...
 
template<unsigned N>
void operator= (const FixedList< T, N > &list)
 Copy assignment from FixedList. 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 Foam::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 63 of file BitOps.H.

Member Typedef Documentation

◆ subList

typedef SubList<T> subList

Declare type of subList.

Definition at line 114 of file List.H.

Constructor & Destructor Documentation

◆ List() [1/23]

constexpr List ( )
inlineconstexprnoexcept

Null constructor.

Definition at line 94 of file ListI.H.

◆ List() [2/23]

List ( const label  len)
explicit

Construct with given size.

Definition at line 94 of file List.C.

◆ List() [3/23]

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/23]

List ( const label  len,
const Foam::zero   
)

Construct with given size initializing all elements to zero.

Definition at line 135 of file List.C.

◆ List() [5/23]

List ( const Foam::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/23]

List ( const Foam::one  ,
T &&  val 
)

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

Definition at line 169 of file List.C.

◆ List() [7/23]

List ( const Foam::one  ,
const Foam::zero   
)

Construct with length=1, initializing content to zero.

Definition at line 178 of file List.C.

◆ List() [8/23]

List ( const List< T > &  a)

Copy construct from list.

Definition at line 220 of file List.C.

◆ List() [9/23]

List ( const UList< T > &  a)
explicit

Copy construct contents from list.

Definition at line 187 of file List.C.

◆ List() [10/23]

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

Construct as copy or re-use as specified.

Definition at line 253 of file List.C.

◆ List() [11/23]

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

Copy construct subset of list.

Definition at line 295 of file List.C.

◆ List() [12/23]

List ( const UList< T > &  list,
const FixedList< label, N > &  indices 
)

Copy construct subset of list.

Definition at line 318 of file List.C.

◆ List() [13/23]

List ( InputIterator  begIter,
InputIterator  endIter 
)

Construct given begin/end iterators.

Uses std::distance for the size.

Definition at line 340 of file List.C.

◆ List() [14/23]

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

Construct as copy of FixedList<T, N>

Definition at line 348 of file List.C.

◆ List() [15/23]

List ( const PtrList< T > &  list)
explicit

Construct as copy of PtrList<T>

Definition at line 358 of file List.C.

◆ List() [16/23]

List ( const SLList< T > &  list)
explicit

Construct as copy of SLList<T>

Definition at line 368 of file List.C.

◆ List() [17/23]

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

Construct as copy of IndirectList contents.

Definition at line 376 of file List.C.

◆ List() [18/23]

List ( std::initializer_list< T list)

Construct from an initializer list.

Definition at line 386 of file List.C.

◆ List() [19/23]

List ( List< T > &&  list)

Move construct from List.

Definition at line 393 of file List.C.

◆ List() [20/23]

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

Move construct from DynamicList.

Definition at line 404 of file List.C.

◆ List() [21/23]

List ( SortableList< T > &&  list)

Move construct from SortableList.

Definition at line 413 of file List.C.

◆ List() [22/23]

List ( SLList< T > &&  list)

Move construct from SLList.

Definition at line 422 of file List.C.

◆ List() [23/23]

List ( Istream is)

Construct from Istream.

Definition at line 38 of file ListIO.C.

◆ ~List()

~List ( )

Destructor.

Definition at line 433 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.

Referenced by basicThermo::splitThermoName().

Here is the caller graph for this function:

◆ 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(), isoSurfaceBase::calcCellCuts(), polyLine::calcParam(), topoSetSource::check(), MeshedSurface< Foam::face >::checkFaces(), cellShape::collapsedFaces(), directions::directions(), Foam::duplicateOrder(), cell::edges(), Foam::etcDirs(), NASCore::faceDecomposition(), ABAQUSCore::faceDecomposition(), searchableDisk::findLine(), searchableSphere::findLine(), searchableSphere::findLineAll(), searchableSphere::findLineAny(), namesList< solutionEntry >::findNames(), searchableDisk::findNearest(), searchableSphere::findNearest(), lumpedPointMovement::forcesAndMoments(), Foam::exprTools::getList(), searchableDisk::getRegion(), searchableSphere::getRegion(), searchableSphere::getVolumeType(), Foam::invertOneToMany(), isoSurfaceTopo::isoSurfaceTopo(), dictionary::keys(), dlLibraryTable::loaded(), basicThermo::lookupThermo(), wordRes::matching(), scalars::matching(), basicSolidChemistryModel::New(), Foam::nonProcessorPatchNames(), polynomialFunction::operator+=(), polynomialFunction::operator-=(), Foam::operator>>(), argList::parse(), sampledPatch::patchIDs(), Foam::prependList(), Foam::printTable(), ABAQUSsurfaceFormat< Face >::read(), pointNoise::read(), multiphaseMangrovesTurbulenceModel::read(), writeObjects::read(), surfaceNoise::read(), explicitPorositySource::read(), derivedFields::read(), areaWrite::read(), functionObjectList::read(), Foam::readDir(), functionEntry::readStringList(), isoAlpha::reconstruct(), searchableDisk::regions(), searchablePlate::regions(), searchableSphere::regions(), PackedList< 2 >::reserve(), SortList< T >::reset(), PDRblock::gridControl::resize(), SortList< T >::reverseSort(), Foam::BitOps::set(), List< substance >::set(), PackedList< 2 >::setCapacity(), fvMeshSubset::setCellSubset(), lumpedPointMovement::setInterpolator(), lumpedPointMovement::setPatchControl(), edgeCollapser::setRefinement(), PackedList< 2 >::shrink(), LUscalarMatrix::solve(), SortList< T >::sort(), Foam::sortedOrder(), MeshedSurface< Foam::face >::stitchFaces(), surfZoneIOList::surfZoneIOList(), syncTools::swapBoundaryCellList(), syncTools::swapBoundaryCellPositions(), HashTable< Foam::phase * >::tocEntries(), HashTable< Foam::phase * >::tocKeys(), HashTable< Foam::phase * >::tocValues(), topoBoolSet::topoBoolSet(), faceAreaIntersect::triangulate(), hashedWordList::uniq(), Foam::uniqueOrder(), sampledFaceZone::update(), sampledPatch::update(), ensightFaces::write(), lumpedPointMovement::writeStateVTP(), and zeroATCcells::zeroATCcells().

◆ 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 445 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(), cyclicAMIPolyPatch::addAMIFaces(), cellTable::addCellZones(), addPatchCellLayer::addedCells(), lduPrimitiveMesh::addInterfaces(), edgeSurface::addIntersectionEdges(), snappyLayerDriver::addLayers(), regIOobject::addWatch(), adjointSolverManager::adjointSolverManager(), AMIInterpolation::agglomerate(), GAMGAgglomeration::agglomerateLduAddressing(), extendedEdgeMesh::allNearestFeatureEdges(), 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(), primitiveMesh::calcPointOrder(), createShellMesh::calcPointRegions(), waveMethod::calculate(), correctedCellVolumeWeightMethod::calculate(), surfaceNoise::calculate(), GAMGAgglomeration::calculateRegionMaster(), fvMotionSolver::cellMotionBoundaryTypes(), boundaryMesh::changeFaces(), extractEulerianParticles::checkFaceZone(), GAMGAgglomeration::checkRestriction(), refinementHistory::clone(), 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(), Pstream::exchange(), mapDistributeBase::exchangeAddressing(), Pstream::exchangeSizes(), forceCoeffs::execute(), extendedUpwindCellToFaceStencil::extendedUpwindCellToFaceStencil(), primitiveMesh::faceEdges(), 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(), searchableCylinder::findLine(), searchableSurfaceCollection::findLine(), searchableBox::findLine(), searchableSurfaceWithGaps::findLine(), searchableRotatedBox::findLine(), searchableCone::findLine(), triSurfaceSearch::findLineAll(), searchablePlane::findLineAll(), searchablePlate::findLineAll(), searchableDisk::findLineAll(), searchableCylinder::findLineAll(), searchableSurfaceCollection::findLineAll(), searchableBox::findLineAll(), searchableSurfaceWithGaps::findLineAll(), searchableRotatedBox::findLineAll(), searchableCone::findLineAll(), distributedTriSurfaceMesh::findLineAll(), triSurfaceSearch::findLineAny(), searchableCylinder::findLineAny(), searchableBox::findLineAny(), searchableRotatedBox::findLineAny(), searchableCone::findLineAny(), mappedPatchBase::findLocalSamples(), searchableSurfacesQueries::findNearest(), triSurfaceRegionSearch::findNearest(), triSurfaceSearch::findNearest(), searchablePlane::findNearest(), searchableExtrudedCircle::findNearest(), searchablePlate::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(), FreeStream< CloudType >::FreeStream(), decomposedBlockData::gather(), globalIndex::gather(), externalCoupled::gatherAndCombine(), PatchTools::gatherAndMerge(), GAMGAgglomeration::gatherList(), decomposedBlockData::gatherSlaveData(), globalIndex::get(), combineFaces::getMergeSets(), boundaryMesh::getNTris(), weightedPosition::getPoints(), searchablePlane::getRegion(), searchableExtrudedCircle::getRegion(), searchablePlate::getRegion(), searchableCylinder::getRegion(), searchableSurfaceCollection::getRegion(), searchableBox::getRegion(), searchableRotatedBox::getRegion(), searchableCone::getRegion(), triSurfaceMesh::getRegion(), distributedTriSurfaceMesh::getRegion(), removePoints::getUnrefimentSet(), cellLooper::getVertEdgesNonFace(), triSurfaceTools::getVertexTriangles(), searchableCylinder::getVolumeType(), searchableBox::getVolumeType(), searchableCone::getVolumeType(), triSurfaceMesh::getVolumeType(), distributedTriSurfaceMesh::getVolumeType(), meshRefinement::getZoneFaces(), cellCellStencil::globalCellCells(), addPatchCellLayer::globalEdgeFaces(), triSurfaceTools::greenRefine(), Distribution< Type >::index(), dynamicMultiMotionSolverFvMesh::init(), calculatedProcessorFvPatchField< Type >::initEvaluate(), meshToMeshMethod::initialise(), InjectedParticleDistributionInjection< CloudType >::initialise(), surfaceNoise::initialise(), fluxSummary::initialiseSurfaceAndDirection(), calculatedProcessorFvPatchField< Type >::initInterfaceMatrixUpdate(), linearInterpolationWeights::integrationWeights(), GAMGInterface::interfaceInternalField(), AMIInterpolation::interpolateToSource(), AMIInterpolation::interpolateToTarget(), intersectedSurface::intersectedSurface(), isoSurfaceCell::isoSurfaceCell(), isoSurfacePoint::isoSurfacePoint(), 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(), 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(), objectiveManager::objectiveManager(), UList< Foam::wordRe >::operator[](), oldCyclicPolyPatch::order(), processorPolyPatch::order(), cyclicPolyPatch::order(), cyclicAMIPolyPatch::order(), distributedTriSurfaceMesh::overlappingSurface(), ParticleCollector< CloudType >::ParticleCollector(), PatchParticleHistogram< CloudType >::PatchParticleHistogram(), SprayCloud< Foam::DSMCCloud >::penetration(), pointCells::pointCells(), pointFieldReconstructor::pointFieldReconstructor(), PatchTools::pointNormals(), Foam::polyMeshZipUpCells(), snappySnapDriver::preSmoothPatch(), Distribution< Type >::raw(), VTKedgeFormat::read(), writeDictionary::read(), cloudSolution::read(), runTimeControl::read(), multiphaseMangrovesSource::read(), multiphaseMangrovesTurbulenceModel::read(), explicitPorositySource::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(), searchableCylinder::regions(), searchableSurfaceCollection::regions(), searchableCone::regions(), triSurfaceMesh::regions(), edgeMesh::regions(), fvMeshTools::removeEmptyPatches(), mapDistributeBase::schedule(), searchableSurfaces::searchableSurfaces(), extendedEdgeMesh::select(), fvMeshSubset::setCellSubset(), decompositionMethod::setConstraints(), polyBoundaryMesh::setGroup(), weightedPosition::setPoints(), box::setRefineFlags(), duplicatePoints::setRefinement(), refinementIterator::setRefinement(), removePoints::setRefinement(), boundaryCutter::setRefinement(), tetDecomposer::setRefinement(), addPatchCellLayer::setRefinement(), hexRef8::setRefinement(), SortableListDRGEP< Type >::setSize(), SortableListEFA< Type >::setSize(), data::setSolverPerformance(), removePoints::setUnrefinement(), ParSortableList< Type >::sort(), extendedEdgeMesh::sortedOrder(), extendedEdgeMesh::sortPointsAndEdges(), meshRefinement::splitFacesUndo(), leastSquares::stencilWeights(), cellVolumeWeight::stencilWeights(), inverseDistance::stencilWeights(), streamLineParticle::streamLineParticle(), 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(), faceZone::updateMesh(), addPatchCellLayer::updateMesh(), faMesh::updateMesh(), lduPrimitiveMesh::upperTriOrder(), zoneCellStencils::validBoundaryFaces(), cellToCellStencil::validBoundaryFaces(), cellToFaceStencil::validBoundaryFaces(), splineInterpolationWeights::valueWeights(), linearInterpolationWeights::valueWeights(), volBSplinesBase::volBSplinesBase(), wallBoundedStreamLineParticle::wallBoundedStreamLineParticle(), 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(), ensightPart::clear(), hashedWordList::clear(), SortableList< T >::clear(), IListStreamAllocator::clearStorage(), PackedList< 2 >::clearStorage(), polySurface::copySurface(), surfMesh::copySurface(), removePoints::countPointUsage(), distanceSurface::createGeometry(), box::createMap(), meshRefinement::createZoneBaffles(), Foam::duplicateOrder(), Field< Foam::Vector2D >::Field(), refinementSurfaces::findAllIntersections(), probes::findElements(), searchablePlane::findLineAll(), searchablePlate::findLineAll(), searchableDisk::findLineAll(), searchableCylinder::findLineAll(), searchableSurfaceCollection::findLineAll(), searchableBox::findLineAll(), searchableSurfaceWithGaps::findLineAll(), searchableRotatedBox::findLineAll(), searchableCone::findLineAll(), searchableSphere::findLineAll(), distributedTriSurfaceMesh::findLineAll(), triSurfaceMesh::isSurfaceClosed(), Cloud< passivePositionParticle >::move(), argList::parse(), RecycleInteraction< CloudType >::postEvolve(), STARCDsurfaceFormat< Face >::read(), TRIsurfaceFormat< Face >::read(), STARCDedgeFormat::read(), STLsurfaceFormat< Face >::read(), ensightWrite::read(), STARCDMeshReader::readCells(), Time::readDict(), boundaryMesh::readTriSurface(), surfMesh::removeZones(), decompositionMethod::setConstraints(), lumpedPointMovement::setInterpolator(), Foam::sortedOrder(), hexRef8::storeData(), PatchTools::subsetMap(), trackingInverseDistance::update(), cellVolumeWeight::update(), inverseDistance::update(), zoneCellStencils::updateMesh(), 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::agglomerate(), hashedWordList::append(), PDRblock::gridControl::append(), AMIInterpolation::append(), Foam::appendNamedEntry(), Foam::bandCompression(), createShellMesh::calcPointRegions(), waveMethod::calculate(), correctedCellVolumeWeightMethod::calculateAddressing(), cellVolumeWeightMethod::calculateAddressing(), GAMGAgglomeration::checkRestriction(), probes::classifyFields(), refinementHistory::clone(), commSchedule::commSchedule(), mappedPatchBase::communicator(), 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(), blockMesh::mesh(), meshRefinement::meshedPatches(), findCellParticle::move(), combustionModel::New(), chemistryTabulationMethod< ReactionThermo, ThermoType >::New(), chemistryReductionMethod< ReactionThermo, ThermoType >::New(), UList< Foam::wordRe >::operator[](), boundaryMesh::patchify(), polyPatch::polyPatch(), RecycleInteraction< CloudType >::postEvolve(), 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 459 of file List.C.

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(), removeFaces::compatibleRemoves(), distanceSurface::createGeometry(), inverseDistance::createStencil(), geomCellLooper::cut(), topoCellLooper::cut(), extendedEdgeMesh::cut(), cyclicACMIGAMGInterface::cyclicACMIGAMGInterface(), cyclicAMIGAMGInterface::cyclicAMIGAMGInterface(), fvMeshDistribute::distribute(), triSurfaceSearch::findLineAll(), searchableBox::findLineAll(), searchableRotatedBox::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(), stateFunctionObject::objectResultEntries(), SortableList< T >::operator=(), hashedWordList::operator=(), SortableList< T >::partialReverseSort(), SortableList< T >::partialSort(), OBJedgeFormat::read(), STARCDCore::readPoints(), edgeMesh::regions(), cuttingSurfaceBase::remapFaces(), SortableList< T >::reverseSort(), box::setRefineFlags(), hexRef8::setRefinement(), SortableListDRGEP< Type >::sort(), SortableListEFA< Type >::sort(), SortableList< T >::sort(), extendedEdgeMesh::sortPointsAndEdges(), SortableListEFA< Type >::stableSort(), SortableListDRGEP< Type >::stableSort(), hashedWordList::transfer(), PackedList< 2 >::transfer(), 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 478 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 490 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/12]

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

Assignment to UList operator. Takes linear time.

Definition at line 501 of file List.C.

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

Here is the caller graph for this function:

◆ operator=() [2/12]

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

Assignment operator. Takes linear time.

Definition at line 537 of file List.C.

◆ operator=() [3/12]

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

Assignment to SLList operator. Takes linear time.

Definition at line 549 of file List.C.

◆ operator=() [4/12]

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

Assignment from IndirectList. Takes linear time.

Definition at line 586 of file List.C.

◆ operator=() [5/12]

void operator= ( const FixedList< T, N > &  list)

Copy assignment from FixedList.

Definition at line 570 of file List.C.

◆ operator=() [6/12]

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

Assignment to an initializer list.

Definition at line 605 of file List.C.

◆ operator=() [7/12]

void operator= ( const T val)
inline

Assignment of all entries to the given value.

Definition at line 238 of file ListI.H.

◆ operator=() [8/12]

void operator= ( const Foam::zero  )
inline

Assignment of all entries to zero.

Definition at line 245 of file ListI.H.

◆ operator=() [9/12]

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

Move assignment. Takes constant time.

Definition at line 625 of file List.C.

◆ operator=() [10/12]

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

Move assignment. Takes constant time.

Definition at line 638 of file List.C.

◆ operator=() [11/12]

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

Move assignment. Takes constant time.

Definition at line 645 of file List.C.

◆ operator=() [12/12]

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

Move assignment. Takes constant time.

Definition at line 652 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: