Public Types | Public Member Functions | Static Public Member Functions | Friends | List of all members
List Class Reference

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

Inherited by BinSum< IndexType, List, CombineOp >, cell, cellClassification, 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< TsubList
 

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)
 
TnewElmt (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)
 
IstreamreadList (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)
 
IstreamreadList (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)
 
IstreamreadList (Istream &is)
 

Static Public Member Functions

static const List< T > & null ()
 

Friends

Istreamoperator>> (Istream &is, List< T > &list)
 

Detailed Description

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

Storage is allocated on free-store during construction.

Source files

Definition at line 58 of file BitOps.H.

Member Typedef Documentation

◆ subList

typedef SubList<T> subList

Definition at line 108 of file List.H.

Constructor & Destructor Documentation

◆ List() [1/40]

constexpr List ( )
inlineconstexprnoexcept

◆ List() [2/40]

List ( const label  len)
explicit

◆ List() [3/40]

List ( const label  len,
const T val 
)

◆ List() [4/40]

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

◆ List() [5/40]

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

◆ List() [6/40]

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

◆ List() [7/40]

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

◆ List() [8/40]

List ( const List< T > &  a)

◆ List() [9/40]

List ( const UList< T > &  a)
explicit

◆ List() [10/40]

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

◆ List() [11/40]

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

◆ List() [12/40]

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

Definition at line 315 of file List.C.

◆ List() [13/40]

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

Definition at line 337 of file List.C.

◆ List() [14/40]

List ( const PtrList< T > &  list)
explicit

◆ List() [15/40]

List ( const SLList< T > &  list)
explicit

◆ List() [16/40]

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

Definition at line 365 of file List.C.

◆ List() [17/40]

List ( std::initializer_list< T list)

◆ List() [18/40]

List ( List< T > &&  list)

◆ List() [19/40]

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

Definition at line 393 of file List.C.

◆ List() [20/40]

List ( SortableList< T > &&  list)

◆ List() [21/40]

List ( SLList< T > &&  list)

◆ List() [22/40]

List ( Istream is)

◆ ~List()

~List ( )

Definition at line 422 of file List.C.

◆ List() [23/40]

List ( const label  len)

Definition at line 91 of file List.C.

◆ List() [24/40]

List ( const label  len,
const T val 
)

Definition at line 107 of file List.C.

◆ List() [25/40]

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

Definition at line 132 of file List.C.

◆ List() [26/40]

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

Definition at line 157 of file List.C.

◆ List() [27/40]

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

Definition at line 166 of file List.C.

◆ List() [28/40]

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

Definition at line 175 of file List.C.

◆ List() [29/40]

List ( const UList< T > &  a)

Definition at line 184 of file List.C.

◆ List() [30/40]

List ( const List< T > &  a)

Definition at line 217 of file List.C.

◆ List() [31/40]

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

Definition at line 250 of file List.C.

◆ List() [32/40]

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

Definition at line 292 of file List.C.

◆ List() [33/40]

List ( const PtrList< T > &  list)

Definition at line 347 of file List.C.

◆ List() [34/40]

List ( const SLList< T > &  list)

Definition at line 357 of file List.C.

◆ List() [35/40]

List ( std::initializer_list< T list)

Definition at line 375 of file List.C.

◆ List() [36/40]

List ( List< T > &&  list)

Definition at line 382 of file List.C.

◆ List() [37/40]

List ( SortableList< T > &&  list)

Definition at line 402 of file List.C.

◆ List() [38/40]

List ( SLList< T > &&  list)

Definition at line 411 of file List.C.

◆ List() [39/40]

constexpr List ( )
inlineconstexprnoexcept

Definition at line 88 of file ListI.H.

◆ List() [40/40]

List ( Istream is)

Definition at line 31 of file ListIO.C.

Member Function Documentation

◆ null()

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

◆ clone()

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

Definition at line 93 of file ListI.H.

◆ clear()

void clear ( )
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().

◆ resize() [1/3]

void resize ( const label  len)
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().

◆ resize() [2/3]

void resize ( const label  len,
const T val 
)

Definition at line 434 of file List.C.

◆ resize_nocopy()

void resize_nocopy ( const label  len)
inline

Definition at line 139 of file ListI.H.

Referenced by globalIndex::gather(), globalIndex::get(), globalIndex::mpiGather(), and Foam::sortedOrder().

Here is the caller graph for this function:

◆ setSize() [1/2]

void setSize ( const label  n)
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().

◆ setSize() [2/2]

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

Definition at line 221 of file List.H.

◆ append() [1/7]

void append ( const T val)
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().

◆ append() [2/7]

void append ( T &&  val)
inline

◆ append() [3/7]

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

◆ append() [4/7]

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

Definition at line 210 of file ListI.H.

◆ appendUniq()

Foam::label appendUniq ( const T val)
inline

Definition at line 225 of file ListI.H.

Referenced by polyPatch::polyPatch().

Here is the caller graph for this function:

◆ transfer() [1/5]

void transfer ( List< T > &  list)

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().

◆ transfer() [2/5]

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

Definition at line 468 of file List.C.

◆ transfer() [3/5]

void transfer ( SortableList< T > &  list)

◆ newElmt()

T & newElmt ( const label  i)
inline

Definition at line 146 of file ListI.H.

Referenced by Foam::parseStream().

Here is the caller graph for this function:

◆ operator=() [1/21]

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

◆ operator=() [2/21]

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

◆ operator=() [3/21]

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

◆ operator=() [4/21]

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

Definition at line 576 of file List.C.

◆ operator=() [5/21]

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

Definition at line 560 of file List.C.

◆ operator=() [6/21]

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

◆ operator=() [7/21]

void operator= ( const T val)
inline

◆ operator=() [8/21]

void operator= ( const Foam::zero  )
inline

◆ operator=() [9/21]

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

◆ operator=() [10/21]

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

Definition at line 628 of file List.C.

◆ operator=() [11/21]

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

◆ operator=() [12/21]

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

◆ readList() [1/3]

Istream& readList ( Istream is)

Referenced by Foam::operator>>(), and decomposedBlockData::readBlockEntry().

Here is the caller graph for this function:

◆ shallowCopy()

void shallowCopy ( const UList< T > &  )
delete

Referenced by ODESolver::resizeField().

Here is the caller graph for this function:

◆ set()

std::enable_if<std::is_same<bool, TypeT>::value, bool>::type set ( const label  i,
bool  val = true 
)
inline

◆ transfer() [4/5]

void transfer ( List< T > &  list)

Definition at line 449 of file List.C.

◆ transfer() [5/5]

void transfer ( SortableList< T > &  list)

Definition at line 480 of file List.C.

◆ operator=() [13/21]

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

Definition at line 491 of file List.C.

◆ operator=() [14/21]

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

Definition at line 527 of file List.C.

◆ operator=() [15/21]

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

Definition at line 539 of file List.C.

◆ operator=() [16/21]

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

Definition at line 595 of file List.C.

◆ operator=() [17/21]

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

Definition at line 615 of file List.C.

◆ operator=() [18/21]

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

Definition at line 635 of file List.C.

◆ operator=() [19/21]

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

Definition at line 642 of file List.C.

◆ readList() [2/3]

Foam::Istream & readList ( Istream is)

Definition at line 42 of file ListIO.C.

◆ resize() [3/3]

void resize ( const label  newLen)
inline

Definition at line 124 of file ListI.H.

◆ append() [5/7]

void append ( const T val)
inline

Definition at line 168 of file ListI.H.

◆ append() [6/7]

void append ( T &&  val)
inline

Definition at line 178 of file ListI.H.

◆ append() [7/7]

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

Definition at line 188 of file ListI.H.

◆ operator=() [20/21]

void operator= ( const T val)
inline

Definition at line 242 of file ListI.H.

◆ operator=() [21/21]

void operator= ( const Foam::zero  )
inline

Definition at line 249 of file ListI.H.

◆ readList() [3/3]

Istream & readList ( Istream is)

Definition at line 42 of file charList.C.

Friends And Related Function Documentation

◆ operator>>

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

Definition at line 380 of file List.H.


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