STYLE: avoid implicit cast of UList to List

This commit is contained in:
Mark Olesen 2025-04-08 11:00:11 +02:00
parent 0be19b7fae
commit 59f3c55871
119 changed files with 298 additions and 336 deletions

View File

@ -60,13 +60,10 @@ template<class Type>
void zeroCells
(
GeometricField<Type, fvPatchField, volMesh>& vf,
const labelList& cells
const labelUList& cells
)
{
forAll(cells, i)
{
vf[cells[i]] = Zero;
}
UIndirectList<Type>(vf.primitiveField(), cells) = Zero;
}

View File

@ -103,8 +103,8 @@ dimensionedScalar alphaMax
laminarTransport
);
const labelList& inletCells = mesh.boundary()["inlet"].faceCells();
//const labelList& outletCells = mesh.boundary()["outlet"].faceCells();
const labelUList& inletCells = mesh.boundary()["inlet"].faceCells();
//const labelUList& outletCells = mesh.boundary()["outlet"].faceCells();
volScalarField alpha
(

View File

@ -55,7 +55,7 @@ if (mesh.changing())
dimensionedScalar rAUf("rAUf", dimTime, 1.0);
const cellCellStencilObject& overlap = Stencil::New(mesh);
const labelList& cellTypes = overlap.cellTypes();
const labelUList& cellTypes = overlap.cellTypes();
const labelIOList& zoneIDs = overlap.zoneID();
while (pimple.correctNonOrthogonal())

View File

@ -210,7 +210,7 @@ void VoFPatchTransfer::correct
film().toRegion(patchi, Vp);
const polyPatch& pp = pbm[patchi];
const labelList& faceCells = pp.faceCells();
const labelUList& faceCells = pp.faceCells();
// Accumulate the total mass removed from patch
scalar dMassPatch = 0;

View File

@ -65,7 +65,7 @@
dimensionedScalar rAUf("rAUf", dimTime/rho.dimensions(), 1.0);
const cellCellStencilObject& overlap = Stencil::New(mesh);
const labelList& cellTypes = overlap.cellTypes();
const labelUList& cellTypes = overlap.cellTypes();
const labelIOList& zoneIDs = overlap.zoneID();
while (pimple.correctNonOrthogonal())

View File

@ -1674,10 +1674,9 @@ int main(int argc, char *argv[])
// Add cell zones to patch zone list
forAll(bPatches, pI)
{
const labelList& faceCells = bPatches[pI].faceCells();
forAll(faceCells, fcI)
for (const label celli : bPatches[pI].faceCells())
{
if (zoneCell.test(faceCells[fcI]))
if (zoneCell.test(celli))
{
boundaryZones[pI].append(name);
break;

View File

@ -161,8 +161,7 @@ void Foam::fluentFvMesh::writeFluentMesh() const
{
const faceUList& patchFaces = boundaryMesh()[patchi];
const labelList& patchFaceCells =
boundaryMesh()[patchi].faceCells();
const labelUList& patchFaceCells = boundaryMesh()[patchi].faceCells();
// The face group will be offset by 10 from the patch label

View File

@ -1506,7 +1506,7 @@ int main(int argc, char *argv[])
// Go through all the patchFaces and find corresponding face in pp.
forAll(patchFaces, patchi)
{
const DynamicList<face>& pFaces = patchFaces[patchi];
const auto& pFaces = patchFaces[patchi];
Info<< "Finding faces of patch " << patchi << endl;

View File

@ -42,7 +42,7 @@ template<class Triangulation>
Foam::autoPtr<Foam::mapDistribute>
Foam::DistributedDelaunayMesh<Triangulation>::buildMap
(
const List<label>& toProc
const labelUList& toProc
)
{
// Determine send map
@ -431,7 +431,7 @@ void Foam::DistributedDelaunayMesh<Triangulation>::markVerticesToRefer
template<class Triangulation>
Foam::label Foam::DistributedDelaunayMesh<Triangulation>::referVertices
(
const DynamicList<label>& targetProcessor,
const labelUList& targetProcessor,
DynamicList<Vb>& parallelVertices,
PtrList<labelPairHashSet>& referralVertices,
labelPairHashSet& receivedVertices

View File

@ -115,7 +115,7 @@ private:
label referVertices
(
const DynamicList<label>& targetProcessor,
const labelUList& targetProcessor,
DynamicList<Vb>& parallelVertices,
PtrList<labelPairHashSet>& referralVertices,
labelPairHashSet& receivedVertices
@ -160,7 +160,7 @@ public:
// Member Functions
//- Build a mapDistribute for the supplied destination processor data
static autoPtr<mapDistribute> buildMap(const List<label>& toProc);
static autoPtr<mapDistribute> buildMap(const labelUList& toProc);
//-
bool distribute(const boundBox& bb);

View File

@ -47,7 +47,7 @@ namespace Foam
Foam::autoPtr<Foam::mapDistribute> Foam::backgroundMeshDecomposition::buildMap
(
const List<label>& toProc
const labelUList& toProc
)
{
// Determine send map

View File

@ -213,7 +213,7 @@ public:
// Member Functions
//- Build a mapDistribute for the supplied destination processor data
static autoPtr<mapDistribute> buildMap(const List<label>& toProc);
static autoPtr<mapDistribute> buildMap(const labelUList& toProc);
//- Redistribute the background mesh based on a supplied weight field,
// returning a map to use to redistribute vertices.

View File

@ -945,7 +945,7 @@ Foam::labelHashSet Foam::conformalVoronoiMesh::findOffsetPatchFaces
const faceList& localFaces = patch.localFaces();
const pointField& localPoints = patch.localPoints();
const labelList& fCell = patch.faceCells();
const labelUList& fCell = patch.faceCells();
forAll(localFaces, pLFI)
{

View File

@ -117,7 +117,7 @@ template<class Triangulation>
inline bool Foam::pointPairs<Triangulation>::addPointPair
(
const labelPair& master,
const DynamicList<labelPair>& slaves
const UList<labelPair>& slaves
)
{
for (const labelPair& slave : slaves)

View File

@ -130,7 +130,7 @@ public:
inline bool addPointPair
(
const labelPair& master,
const DynamicList<labelPair>& slaves
const UList<labelPair>& slaves
);
inline bool addPointPair

View File

@ -262,10 +262,10 @@ private:
// and write the inserted point locations to the given file.
void insertPointPairs
(
const DynamicList<point2D>& nearSurfacePoints,
const DynamicList<point2D>& surfacePoints,
const DynamicList<label>& surfaceTris,
const DynamicList<label>& surfaceHits,
const UList<point2D>& nearSurfacePoints,
const UList<point2D>& surfacePoints,
const labelUList& surfaceTris,
const labelUList& surfaceHits,
const fileName fName
);

View File

@ -75,10 +75,10 @@ bool Foam::CV2D::dualCellSurfaceIntersection
void Foam::CV2D::insertPointPairs
(
const DynamicList<point2D>& nearSurfacePoints,
const DynamicList<point2D>& surfacePoints,
const DynamicList<label>& surfaceTris,
const DynamicList<label>& surfaceHits,
const UList<point2D>& nearSurfacePoints,
const UList<point2D>& surfacePoints,
const labelUList& surfaceTris,
const labelUList& surfaceHits,
const fileName fName
)
{

View File

@ -80,10 +80,10 @@ void Foam::shortEdgeFilter2D::updateEdgeRegionMap
label region = -1;
const DynamicList<label>& startPtRegions =
const labelUList& startPtRegions =
boundaryPtRegions[surfPtToBoundaryPt[meshPoints[e.first()]]];
const DynamicList<label>& endPtRegions =
const labelUList& endPtRegions =
boundaryPtRegions[surfPtToBoundaryPt[meshPoints[e.second()]]];
if (startPtRegions.size() > 1 && endPtRegions.size() > 1)
@ -363,9 +363,9 @@ void Foam::shortEdgeFilter2D::filter()
&& !flagDegenerateFace
)
{
const DynamicList<label>& startVertexRegions =
const labelUList& startVertexRegions =
boundaryPointRegions[meshPoints[startVertex]];
const DynamicList<label>& endVertexRegions =
const labelUList& endVertexRegions =
boundaryPointRegions[meshPoints[endVertex]];
if (startVertexRegions.size() && endVertexRegions.size())

View File

@ -294,7 +294,7 @@ void Foam::mergeAndWrite
forAll(pbm, patchi)
{
const polyPatch& pp = pbm[patchi];
const labelList& fc = pp.faceCells();
const labelUList& fc = pp.faceCells();
forAll(fc, i)
{
bndInSet[pp.start()+i-mesh.nInternalFaces()] = isInSet[fc[i]];
@ -319,7 +319,7 @@ void Foam::mergeAndWrite
forAll(pbm, patchi)
{
const polyPatch& pp = pbm[patchi];
const labelList& fc = pp.faceCells();
const labelUList& fc = pp.faceCells();
if (pp.coupled())
{
forAll(fc, i)

View File

@ -33,6 +33,7 @@ License
#include "mapPolyMesh.H"
#include "edgeFaceCirculator.H"
#include "mergePoints.H"
#include "DynamicList.H"
#include "OFstream.H"
// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
@ -98,20 +99,14 @@ void Foam::meshDualiser::dumpPolyTopoChange
Info<< "Dumping current polyTopoChange. Faces to " << str1.name()
<< " , points and edges to " << str2.name() << endl;
const DynamicList<point>& points = meshMod.points();
forAll(points, pointi)
for (const auto& p : meshMod.points())
{
meshTools::writeOBJ(str1, points[pointi]);
meshTools::writeOBJ(str2, points[pointi]);
meshTools::writeOBJ(str1, p);
meshTools::writeOBJ(str2, p);
}
const DynamicList<face>& faces = meshMod.faces();
forAll(faces, facei)
for (const face& f : meshMod.faces())
{
const face& f = faces[facei];
str1<< 'f';
forAll(f, fp)
{
@ -210,7 +205,7 @@ Foam::label Foam::meshDualiser::addInternalFace
const bool edgeOrder,
const label dualCell0,
const label dualCell1,
const DynamicList<label>& verts,
const labelUList& verts,
polyTopoChange& meshMod
) const
{
@ -326,7 +321,7 @@ Foam::label Foam::meshDualiser::addBoundaryFace
const label dualCelli,
const label patchi,
const DynamicList<label>& verts,
const labelUList& verts,
polyTopoChange& meshMod
) const
{

View File

@ -46,10 +46,9 @@ SourceFiles
\*---------------------------------------------------------------------------*/
#ifndef meshDualiser_H
#define meshDualiser_H
#ifndef Foam_meshDualiser_H
#define Foam_meshDualiser_H
#include "DynamicList.H"
#include "bitSet.H"
#include "boolList.H"
#include "typeInfo.H"
@ -124,7 +123,7 @@ class meshDualiser
const bool edgeOrder,
const label dualCell0,
const label dualCell1,
const DynamicList<label>& verts,
const labelUList& verts,
polyTopoChange& meshMod
) const;
@ -137,7 +136,7 @@ class meshDualiser
const label dualCelli,
const label patchi,
const DynamicList<label>& verts,
const labelUList& verts,
polyTopoChange& meshMod
) const;

View File

@ -191,10 +191,8 @@ int main(int argc, char *argv[])
}
forAll(groupToPatches, groupI)
for (const auto& patchIDs : groupToPatches)
{
const DynamicList<label>& patchIDs = groupToPatches[groupI];
if (patchIDs.size() > 1)
{
// Check if part of a group

View File

@ -76,7 +76,7 @@ void Foam::writeFluentField
const scalarField& phiInternal = phi;
// Get reference to internal cells
const labelList emptyFaceCells =
const auto& emptyFaceCells =
phi.boundaryField()[patchi].patch().patch().faceCells();
// Writing cells for empty patch

View File

@ -78,10 +78,10 @@ Foam::scalarListList Foam::VF::viewFactor2AI::calculate
const labelListList& visibleFaceFaces,
const pointField& compactCf,
const vectorField& compactSf,
const List<List<vector>>& compactFineSf,
const List<List<point>>& compactFineCf,
const DynamicList<List<point>>& compactPoints,
const DynamicList<label>& compactPatchId
const UList<List<vector>>& compactFineSf,
const UList<List<point>>& compactFineCf,
const UList<List<point>>& compactPoints,
const UList<label>& compactPatchId
) const
{
// Fill local view factor matrix

View File

@ -85,10 +85,10 @@ protected:
const labelListList& visibleFaceFaces,
const pointField& compactCf,
const vectorField& compactSf,
const List<List<vector>>& compactFineSf,
const List<List<point>>& compactFineCf,
const DynamicList<List<point>>& compactPoints,
const DynamicList<label>& compactPatchId
const UList<List<vector>>& compactFineSf,
const UList<List<point>>& compactFineCf,
const UList<List<point>>& compactPoints,
const UList<label>& compactPatchId
) const;

View File

@ -84,10 +84,10 @@ Foam::scalarListList Foam::VF::viewFactor2LI::calculate
const labelListList& visibleFaceFaces,
const pointField& compactCf,
const vectorField& compactSf,
const List<List<vector>>& compactFineSf,
const List<List<point>>& compactFineCf,
const DynamicList<List<point>>& compactPoints,
const DynamicList<label>& compactPatchId
const UList<List<vector>>& compactFineSf,
const UList<List<point>>& compactFineCf,
const UList<List<point>>& compactPoints,
const UList<label>& compactPatchId
) const
{
// Fill local view factor matrix

View File

@ -98,10 +98,10 @@ protected:
const labelListList& visibleFaceFaces,
const pointField& compactCf,
const vectorField& compactSf,
const List<List<vector>>& compactFineSf,
const List<List<point>>& compactFineCf,
const DynamicList<List<point>>& compactPoints,
const DynamicList<label>& compactPatchId
const UList<List<vector>>& compactFineSf,
const UList<List<point>>& compactFineCf,
const UList<List<point>>& compactPoints,
const UList<label>& compactPatchId
) const;

View File

@ -63,10 +63,10 @@ Foam::scalarListList Foam::VF::viewFactorHottel::calculate
const labelListList& visibleFaceFaces,
const pointField& compactCf,
const vectorField& compactSf,
const List<List<vector>>& compactFineSf,
const List<List<point>>& compactFineCf,
const DynamicList<List<point>>& compactPoints,
const DynamicList<label>& compactPatchId
const UList<List<vector>>& compactFineSf,
const UList<List<point>>& compactFineCf,
const UList<List<point>>& compactPoints,
const UList<label>& compactPatchId
) const
{
// Fill local view factor matrix

View File

@ -103,10 +103,10 @@ protected:
const labelListList& visibleFaceFaces,
const pointField& compactCf,
const vectorField& compactSf,
const List<List<vector>>& compactFineSf,
const List<List<point>>& compactFineCf,
const DynamicList<List<point>>& compactPoints,
const DynamicList<label>& compactPatchId
const UList<List<vector>>& compactFineSf,
const UList<List<point>>& compactFineCf,
const UList<List<point>>& compactPoints,
const UList<label>& compactPatchId
) const;

View File

@ -117,10 +117,10 @@ protected:
const labelListList& visibleFaceFaces,
const pointField& compactCoarseCf,
const vectorField& compactCoarseSf,
const List<List<vector>>& compactFineSf,
const List<List<point>>& compactFineCf,
const DynamicList<List<point>>& compactPoints,
const DynamicList<label>& compactPatchId
const UList<List<vector>>& compactFineSf,
const UList<List<point>>& compactFineCf,
const UList<List<point>>& compactPoints,
const labelUList& compactPatchId
) const = 0;

View File

@ -55,7 +55,7 @@ Description
void isoFacesToFile
(
const DynamicList<List<point>>& faces,
const UList<List<point>>& faces,
const word& fileName
)
{
@ -65,7 +65,7 @@ void isoFacesToFile
if (Pstream::parRun())
{
// Collect points from all the processors
List<DynamicList<List<point>>> allProcFaces(Pstream::nProcs());
List<List<List<point>>> allProcFaces(Pstream::nProcs());
allProcFaces[Pstream::myProcNo()] = faces;
Pstream::gatherList(allProcFaces);
@ -73,9 +73,9 @@ void isoFacesToFile
{
Info<< "Writing file: " << fileName << endl;
for (const DynamicList<List<point>>& procFaces : allProcFaces)
for (const auto& procFaces : allProcFaces)
{
for (const List<point>& facePts : procFaces)
for (const auto& facePts : procFaces)
{
os.writeFace(facePts);
}
@ -86,7 +86,7 @@ void isoFacesToFile
{
Info<< "Writing file: " << fileName << endl;
for (const List<point>& facePts : faces)
for (const auto& facePts : faces)
{
os.writeFace(facePts);
}

View File

@ -424,8 +424,14 @@ public:
// out-of-range element returns false without ill-effects
inline const T& operator[](const label i) const;
//- Allow cast to a const List<T>&
inline operator const Foam::List<T>&() const;
//- Allow cast to a const List<T>&.
// \note Marked as "strictly" deprecated.
// Currently (2025-04) code still depends on this cast.
FOAM_DEPRECATED_STRICTER(2025-04, "dereference as UList, not List")
operator const Foam::List<T>&() const
{
return *reinterpret_cast<const List<T>*>(this);
}
//- Assignment of all entries to the given value
inline void operator=(const T& val);

View File

@ -385,13 +385,6 @@ inline const T& Foam::UList<T>::operator[](const label i) const
}
template<class T>
inline Foam::UList<T>::operator const Foam::List<T>&() const
{
return *reinterpret_cast<const List<T>*>(this);
}
// * * * * * * * * * * * * * * STL Member Functions * * * * * * * * * * * * //
template<class T>

View File

@ -80,7 +80,7 @@ void Foam::lduAddressing::calcLosort() const
forAll(cellNbrFaces, celli)
{
const labelList& curNbr = cellNbrFaces[celli];
const labelUList& curNbr = cellNbrFaces[celli];
forAll(curNbr, curNbrI)
{
@ -100,7 +100,7 @@ void Foam::lduAddressing::calcOwnerStart() const
<< abort(FatalError);
}
const labelList& own = lowerAddr();
const labelUList& own = lowerAddr();
ownerStartPtr_ = std::make_unique<labelList>(size() + 1, own.size());
auto& ownStart = *ownerStartPtr_;
@ -139,9 +139,9 @@ void Foam::lduAddressing::calcLosortStart() const
losortStartPtr_ = std::make_unique<labelList>(size() + 1, Foam::zero{});
auto& lsrtStart = *losortStartPtr_;
const labelList& nbr = upperAddr();
const labelUList& nbr = upperAddr();
const labelList& lsrt = losortAddr();
const labelUList& lsrt = losortAddr();
// Set up first lookup by hand
lsrtStart[0] = 0;

View File

@ -99,7 +99,7 @@ void Foam::lduCalculatedProcessorField<Type>::initInterfaceMatrixUpdate
}
// Bypass patchInternalField since uses fvPatch addressing
const labelList& fc = lduAddr.patchAddr(patchId);
const labelUList& fc = lduAddr.patchAddr(patchId);
scalarSendBuf_.resize_nocopy(fc.size());
forAll(fc, i)

View File

@ -162,7 +162,7 @@ void Foam::cyclicGAMGInterfaceField::updateInterfaceMatrix
{
// Get neighbouring field
const labelList& nbrFaceCells =
const auto& nbrFaceCells =
lduAddr.patchAddr
(
cyclicInterface_.neighbPatchID()
@ -172,7 +172,7 @@ void Foam::cyclicGAMGInterfaceField::updateInterfaceMatrix
transformCoupleField(pnf, cmpt);
const labelList& faceCells = lduAddr.patchAddr(patchId);
const auto& faceCells = lduAddr.patchAddr(patchId);
this->addToInternalField(result, !add, faceCells, coeffs, pnf);
}

View File

@ -105,8 +105,8 @@ Foam::Ostream& Foam::operator<<
// Print actual contents
if (lduMesh::debug)
{
const labelList& l = addr.lowerAddr();
const labelList& u = addr.upperAddr();
const labelUList& l = addr.lowerAddr();
const labelUList& u = addr.upperAddr();
forAll(l, facei)
{
os << " face:" << facei << " l:" << l[facei]

View File

@ -49,7 +49,7 @@ namespace Foam
static label outstandingComms
(
const labelUList& commToSchedule,
const DynamicList<label>& procComms
const labelUList& procComms
)
{
label nOutstanding = 0;

View File

@ -86,7 +86,7 @@ tmp<scalarField> atmNutWallFunctionFvPatchScalarField::calcNut() const
}
#endif
const labelList& faceCells = patch().faceCells();
const labelUList& faceCells = patch().faceCells();
forAll(nutw, facei)
{

View File

@ -84,7 +84,7 @@ tmp<scalarField> atmNutkWallFunctionFvPatchScalarField::calcNut() const
}
#endif
const labelList& faceCells = patch().faceCells();
const labelUList& faceCells = patch().faceCells();
// (HW:Eq. 5)
forAll(nutw, facei)

View File

@ -113,7 +113,7 @@ Foam::interfaceTrackingFvMesh::pointDisplacement()
aMesh().boundary()[patchI].ngbPolyPatchFaceNormals()
);
const labelList& eFaces =
const labelUList& eFaces =
aMesh().boundary()[patchI].edgeFaces();
// Correct N according to specified contact angle

View File

@ -733,12 +733,13 @@ void Foam::interfaceTrackingFvMesh::initializeControlPointsPosition()
<< abort(FatalError);
}
const labelList& eFaces =
aMesh().boundary()[fixedPatchID].edgeFaces();
forAll(eFaces, edgeI)
for
(
const label facei
: aMesh().boundary()[fixedPatchID].edgeFaces()
)
{
deltaH[eFaces[edgeI]] *= 2.0;
deltaH[facei] *= 2.0;
}
}
@ -789,12 +790,13 @@ void Foam::interfaceTrackingFvMesh::smoothFreeSurfaceMesh()
<< abort(FatalError);
}
const labelList& eFaces =
aMesh().boundary()[fixedPatchID].edgeFaces();
forAll(eFaces, edgeI)
for
(
const label facei
: aMesh().boundary()[fixedPatchID].edgeFaces()
)
{
deltaHf[eFaces[edgeI]] *= 2.0;
deltaHf[facei] *= 2.0;
}
}
@ -1060,7 +1062,7 @@ void Foam::interfaceTrackingFvMesh::correctPointDisplacement
const labelList& pLabels =
aMesh().boundary()[fixedPatchID].pointLabels();
const labelList& eFaces =
const labelUList& eFaces =
aMesh().boundary()[fixedPatchID].edgeFaces();
labelHashSet pointSet;
@ -1147,7 +1149,7 @@ void Foam::interfaceTrackingFvMesh::correctPointDisplacement
const labelList& pLabels =
aMesh().boundary()[nonReflectingPatchID].pointLabels();
const labelList& eFaces =
const labelUList& eFaces =
aMesh().boundary()[nonReflectingPatchID].edgeFaces();
labelList corrPoints = pLabels;
@ -2123,12 +2125,13 @@ bool Foam::interfaceTrackingFvMesh::update()
<< abort(FatalError);
}
const labelList& eFaces =
aMesh().boundary()[fixedPatchID].edgeFaces();
forAll(eFaces, edgeI)
for
(
const label facei
: aMesh().boundary()[fixedPatchID].edgeFaces()
)
{
deltaHf[eFaces[edgeI]] *= 2.0;
deltaHf[facei] *= 2.0;
}
}

View File

@ -110,8 +110,8 @@ void Foam::attachDetach::attachInterface
}
// Modify the faces from the master patch
const labelList& masterFaceCells = masterPatch.faceCells();
const labelList& slaveFaceCells = slavePatch.faceCells();
const labelUList& masterFaceCells = masterPatch.faceCells();
const labelUList& slaveFaceCells = slavePatch.faceCells();
const boolList& mfFlip = mesh.faceZones()[faceZoneID_.index()].flipMap();

View File

@ -1339,14 +1339,14 @@ void Foam::polyMeshAdder::mergeZones
void Foam::polyMeshAdder::addZones
(
const DynamicList<word>& pointZoneNames,
const UList<word>& pointZoneNames,
const List<DynamicList<label>>& pzPoints,
const DynamicList<word>& faceZoneNames,
const UList<word>& faceZoneNames,
const List<DynamicList<label>>& fzFaces,
const List<DynamicList<bool>>& fzFlips,
const DynamicList<word>& cellZoneNames,
const UList<word>& cellZoneNames,
const List<DynamicList<label>>& czCells,
polyMesh& mesh
@ -2423,9 +2423,9 @@ void Foam::polyMeshAdder::patchFacePairs
{
const auto& mesh = meshes[meshi];
const polyBoundaryMesh& pbm = mesh.boundaryMesh();
const DynamicList<label>& procPatches = localPatch[meshi];
const DynamicList<label>& procNbrs = remoteMesh[meshi];
const DynamicList<label>& procNbrPatches = remotePatch[meshi];
const labelUList& procPatches = localPatch[meshi];
const labelUList& procNbrs = remoteMesh[meshi];
const labelUList& procNbrPatches = remotePatch[meshi];
// Count number of processor faces

View File

@ -226,14 +226,14 @@ class polyMeshAdder
//- Create new zones and add to new mesh.
static void addZones
(
const DynamicList<word>& pointZoneNames,
const UList<word>& pointZoneNames,
const List<DynamicList<label>>& pzPoints,
const DynamicList<word>& faceZoneNames,
const UList<word>& faceZoneNames,
const List<DynamicList<label>>& fzFaces,
const List<DynamicList<bool>>& fzFlips,
const DynamicList<word>& cellZoneNames,
const UList<word>& cellZoneNames,
const List<DynamicList<label>>& czCells,
polyMesh& mesh

View File

@ -983,7 +983,7 @@ Foam::autoPtr<Foam::refinementHistory> Foam::refinementHistory::clone
Foam::autoPtr<Foam::refinementHistory> Foam::refinementHistory::clone
(
const IOobject& io,
const labelList& cellMap
const labelUList& cellMap
) const
{
if (active_)

View File

@ -341,7 +341,7 @@ public:
autoPtr<refinementHistory> clone
(
const IOobject& io,
const labelList& cellMap
const labelUList& cellMap
) const;
//- Update numbering for mesh changes

View File

@ -86,13 +86,13 @@ class enrichedPatch
mutable Map<label> pointMergeMap_;
//- Slave point point hits
const labelList& slavePointPointHits_;
const labelUList& slavePointPointHits_;
//- Slave point edge hits
const labelList& slavePointEdgeHits_;
const labelUList& slavePointEdgeHits_;
//- Slave point face hits
const List<objectHit>& slavePointFaceHits_;
const UList<objectHit>& slavePointFaceHits_;
// Demand-driven private data

View File

@ -63,7 +63,7 @@ void Foam::faPatchMapper::calcAddressing() const
}
// Go through new edgeFaces and for each edge try to locate old index
const labelList& ef = patch_.edgeFaces();
const labelUList& ef = patch_.edgeFaces();
forAll(ef, efI)
{

View File

@ -119,7 +119,7 @@ public:
coupledFaPatch
(
const word& name,
const labelList& edgeLabels,
const labelUList& edgeLabels,
const label index,
const faBoundaryMesh& bm,
const label nbrPolyPatchIndex,

View File

@ -84,7 +84,7 @@ Foam::expressions::patchExpr::parseDriver::field_cellSelection
// Not particularly efficient...
labelHashSet inSelection(tselected());
const labelList& faceCells = patch_.faceCells();
const labelUList& faceCells = patch_.faceCells();
auto tresult = tmp<boolField>::New(this->size(), false);
auto& result = tresult.ref();

View File

@ -129,7 +129,7 @@ void Foam::calculatedProcessorFvPatchField<Type>::initEvaluate
// Bypass patchInternalField since uses fvPatch addressing
{
const Field<Type>& iF = this->internalField();
const labelList& fc = procInterface_.faceCells();
const labelUList& fc = procInterface_.faceCells();
sendBuf_.resize_nocopy(fc.size());
forAll(fc, i)
{
@ -202,7 +202,7 @@ void Foam::calculatedProcessorFvPatchField<Type>::initInterfaceMatrixUpdate
}
// Bypass patchInternalField since uses fvPatch addressing
const labelList& fc = lduAddr.patchAddr(patchId);
const labelUList& fc = lduAddr.patchAddr(patchId);
scalarSendBuf_.resize_nocopy(fc.size());
forAll(fc, i)

View File

@ -222,7 +222,7 @@ void Foam::cyclicFvPatchField<Type>::updateInterfaceMatrix
const Pstream::commsTypes
) const
{
const labelList& nbrFaceCells =
const labelUList& nbrFaceCells =
lduAddr.patchAddr
(
this->cyclicPatch().neighbPatchID()

View File

@ -227,12 +227,12 @@ void Foam::activeBaffleVelocityFvPatchVectorField::updateCoeffs()
);
const fvPatch& cyclicPatch = patch().boundaryMesh()[cyclicPatchLabel_];
const labelList& cyclicFaceCells = cyclicPatch.patch().faceCells();
const labelUList& cyclicFaceCells = cyclicPatch.patch().faceCells();
const fvPatch& nbrPatch = refCast<const cyclicFvPatch>
(
cyclicPatch
).neighbFvPatch();
const labelList& nbrFaceCells = nbrPatch.patch().faceCells();
const labelUList& nbrFaceCells = nbrPatch.patch().faceCells();
scalar forceDiff = 0;

View File

@ -253,11 +253,11 @@ void Foam::activePressureForceBaffleVelocityFvPatchVectorField::updateCoeffs()
db().lookupObject<volScalarField>(pName_);
const fvPatch& cyclicPatch = patch().boundaryMesh()[cyclicPatchLabel_];
const labelList& cyclicFaceCells = cyclicPatch.patch().faceCells();
const labelUList& cyclicFaceCells = cyclicPatch.patch().faceCells();
const fvPatch& nbrPatch =
refCast<const cyclicFvPatch>(cyclicPatch).neighbFvPatch();
const labelList& nbrFaceCells = nbrPatch.patch().faceCells();
const labelUList& nbrFaceCells = nbrPatch.patch().faceCells();
scalar valueDiff = 0;
scalar area = 0;

View File

@ -272,7 +272,7 @@ void Foam::fvPatchField<Type>::autoMap
&& mapper.directAddressing().size()
)
{
const labelList& mapAddressing = mapper.directAddressing();
const labelUList& mapAddressing = mapper.directAddressing();
forAll(mapAddressing, i)
{

View File

@ -71,8 +71,8 @@ Foam::fv::faceCorrectedSnGrad<Type>::fullGradCorrection
const vectorField& Sf = mesh.Sf();
const vectorField& C = mesh.C();
const scalarField& magSf = mesh.magSf();
const labelList& owner = mesh.owner();
const labelList& neighbour = mesh.neighbour();
const auto& owner = mesh.owner();
const auto& neighbour = mesh.neighbour();
forAll(sfCorr, facei)
{

View File

@ -322,7 +322,7 @@ void Foam::MULES::limiterCorr
const fvPatchScalarField& psiPf = psiBf[patchi];
const scalarField& phiCorrPf = phiCorrBf[patchi];
const labelList& pFaceCells = mesh.boundary()[patchi].faceCells();
const labelUList& pFaceCells = mesh.boundary()[patchi].faceCells();
if (psiPf.coupled())
{
@ -441,7 +441,7 @@ void Foam::MULES::limiterCorr
scalarField& lambdaPf = lambdaBf[patchi];
const scalarField& phiCorrfPf = phiCorrBf[patchi];
const labelList& pFaceCells = mesh.boundary()[patchi].faceCells();
const labelUList& pFaceCells = mesh.boundary()[patchi].faceCells();
forAll(lambdaPf, pFacei)
{
@ -515,7 +515,7 @@ void Foam::MULES::limiterCorr
}
else if (psiPf.coupled())
{
const labelList& pFaceCells =
const labelUList& pFaceCells =
mesh.boundary()[patchi].faceCells();
forAll(lambdaPf, pFacei)
@ -536,7 +536,7 @@ void Foam::MULES::limiterCorr
}
else
{
const labelList& pFaceCells =
const labelUList& pFaceCells =
mesh.boundary()[patchi].faceCells();
const scalarField& phiPf = phiBf[patchi];

View File

@ -321,7 +321,7 @@ void Foam::MULES::limiter
const scalarField& phiBDPf = phiBDBf[patchi];
const scalarField& phiCorrPf = phiCorrBf[patchi];
const labelList& pFaceCells = mesh.boundary()[patchi].faceCells();
const labelUList& pFaceCells = mesh.boundary()[patchi].faceCells();
if (psiPf.coupled())
{
@ -469,7 +469,7 @@ void Foam::MULES::limiter
scalarField& lambdaPf = lambdaBf[patchi];
const scalarField& phiCorrfPf = phiCorrBf[patchi];
const labelList& pFaceCells = mesh.boundary()[patchi].faceCells();
const labelUList& pFaceCells = mesh.boundary()[patchi].faceCells();
forAll(lambdaPf, pFacei)
{
@ -542,7 +542,7 @@ void Foam::MULES::limiter
}
else if (psiPf.coupled())
{
const labelList& pFaceCells =
const labelUList& pFaceCells =
mesh.boundary()[patchi].faceCells();
forAll(lambdaPf, pFacei)

View File

@ -44,7 +44,7 @@ void Foam::pointMVCWeight::calcWeights
(
const Map<label>& toLocal,
const face& f,
const DynamicList<point>& u,
const UList<point>& u,
const scalarField& dist,
scalarField& weights
) const

View File

@ -86,7 +86,7 @@ protected:
(
const Map<label>& toLocal,
const face& f,
const DynamicList<point>& u,
const UList<point>& u,
const scalarField& dist,
scalarField& weights
) const;

View File

@ -61,8 +61,8 @@ Foam::linearUpwind<Type>::correction
const surfaceScalarField& faceFlux = this->faceFlux_;
const labelList& owner = mesh.owner();
const labelList& neighbour = mesh.neighbour();
const auto& owner = mesh.owner();
const auto& neighbour = mesh.neighbour();
const volVectorField& C = mesh.C();
const surfaceVectorField& Cf = mesh.Cf();
@ -172,8 +172,8 @@ Foam::linearUpwind<Foam::vector>::correction
const surfaceScalarField& faceFlux = this->faceFlux_;
const labelList& owner = mesh.owner();
const labelList& neighbour = mesh.neighbour();
const auto& owner = mesh.owner();
const auto& neighbour = mesh.neighbour();
const volVectorField& C = mesh.C();
const surfaceVectorField& Cf = mesh.Cf();

View File

@ -64,8 +64,8 @@ Foam::linearUpwindV<Type>::correction
const surfaceScalarField& faceFlux = this->faceFlux_;
const surfaceScalarField& w = mesh.weights();
const labelList& own = mesh.owner();
const labelList& nei = mesh.neighbour();
const auto& own = mesh.owner();
const auto& nei = mesh.neighbour();
const volVectorField& C = mesh.C();
const surfaceVectorField& Cf = mesh.Cf();

View File

@ -154,17 +154,14 @@ public:
(vf.boundaryField()[patchi])
)
{
const labelList& pFaceCells =
mesh_.boundary()[patchi].faceCells();
forAll(pFaceCells, pFacei)
for
(
const label celli
: mesh_.boundary()[patchi].faceCells()
)
{
const cell& pFaceCell = cells[pFaceCells[pFacei]];
forAll(pFaceCell, fi)
for (const label facei : cells[celli])
{
label facei = pFaceCell[fi];
if (mesh_.isInternalFace(facei))
{
// Apply upwind differencing
@ -213,17 +210,14 @@ public:
(vf.boundaryField()[patchi])
)
{
const labelList& pFaceCells =
mesh_.boundary()[patchi].faceCells();
forAll(pFaceCells, pFacei)
for
(
const label celli
: mesh_.boundary()[patchi].faceCells()
)
{
const cell& pFaceCell = cells[pFaceCells[pFacei]];
forAll(pFaceCell, fi)
for (const label facei : cells[celli])
{
label facei = pFaceCell[fi];
if (mesh_.isInternalFace(facei))
{
// Remove correction

View File

@ -56,8 +56,8 @@ correction
const pointField& C = mesh.C();
const faceList& faces = mesh.faces();
const scalarField& w = mesh.weights();
const labelList& owner = mesh.owner();
const labelList& neighbour = mesh.neighbour();
const auto& owner = mesh.owner();
const auto& neighbour = mesh.neighbour();
forAll(sfCorr, facei)
{

View File

@ -162,7 +162,7 @@ void Foam::functionObjects::fieldMinMax::calcMinMaxFieldType
{
const vectorField& Cfp = CfBoundary[patchi];
const labelList& faceCells =
const labelUList& faceCells =
fieldBoundary[patchi].patch().faceCells();
minMaxIds = findMinMax(fp);

View File

@ -314,7 +314,7 @@ void Foam::fv::cellSetOption::setCellSelection()
{
labelHashSet selectedCells;
const cellCellStencilObject& overlap = Stencil::New(mesh_);
const labelList& cellTypes = overlap.cellTypes();
const labelUList& cellTypes = overlap.cellTypes();
forAll(cellTypes, celli)
{
if (cellTypes[celli] == cellCellStencil::POROUS)

View File

@ -436,7 +436,7 @@ void Foam::PairCollision<CloudType>::wallInteraction()
template<class CloudType>
bool Foam::PairCollision<CloudType>::duplicatePointInList
(
const DynamicList<point>& existingPoints,
const UList<point>& existingPoints,
const point& pointToTest,
scalar duplicateRangeSqr
) const
@ -456,7 +456,7 @@ bool Foam::PairCollision<CloudType>::duplicatePointInList
template<class CloudType>
bool Foam::PairCollision<CloudType>::duplicatePointInList
(
const DynamicList<point>& existingPoints,
const UList<point>& existingPoints,
const point& pointToTest,
const scalarList& duplicateRangeSqr
) const

View File

@ -111,14 +111,14 @@ class PairCollision
bool duplicatePointInList
(
const DynamicList<point>& existingPoints,
const UList<point>& existingPoints,
const point& pointToTest,
scalar duplicateRangeSqr
) const;
bool duplicatePointInList
(
const DynamicList<point>& existingPoints,
const UList<point>& existingPoints,
const point& pointToTest,
const scalarList& duplicateRangeSqr
) const;

View File

@ -136,7 +136,7 @@ inline Foam::scalar Foam::SprayCloud<CloudType>::penetration
const SortList<scalar> sortedDist(dist);
const scalar mLimit = fraction*mTotal;
const labelList& indices = sortedDist.indices();
const labelUList& indices = sortedDist.indices();
if (mLimit > (mTotal - mass[indices.last()]))
{

View File

@ -163,7 +163,7 @@ Foam::faceList Foam::blockMesh::createPatchFaces
{
const blockList& blocks = *this;
labelList blockLabels = patchTopologyFaces.polyPatch::faceCells();
const labelUList& blockLabels = patchTopologyFaces.polyPatch::faceCells();
label nFaces = 0;

View File

@ -288,8 +288,8 @@ void Foam::meshRefinement::calcNeighbourData
void Foam::meshRefinement::calcCellCellRays
(
const pointField& neiCc,
const labelList& neiLevel,
const labelList& testFaces,
const labelUList& neiLevel,
const labelUList& testFaces,
pointField& start,
pointField& end,
labelList& minLevel
@ -358,7 +358,7 @@ void Foam::meshRefinement::calcCellCellRays
}
void Foam::meshRefinement::updateIntersections(const labelList& changedFaces)
void Foam::meshRefinement::updateIntersections(const labelUList& changedFaces)
{
// Stats on edges to test. Count proc faces only once.
bitSet isMasterFace(syncTools::getMasterFaces(mesh_));

View File

@ -259,8 +259,8 @@ private:
void calcCellCellRays
(
const pointField& neiCc,
const labelList& neiLevel,
const labelList& testFaces,
const labelUList& neiLevel,
const labelUList& testFaces,
pointField& start,
pointField& end,
labelList& minLevel
@ -1589,7 +1589,7 @@ public:
void selectSeparatedCoupledFaces(boolList&) const;
//- Find any intersection of surface. Store in surfaceIndex_.
void updateIntersections(const labelList& changedFaces);
void updateIntersections(const labelUList& changedFaces);
//- Calculate nearest intersection for selected mesh faces
void nearestIntersection

View File

@ -3097,7 +3097,7 @@ void Foam::snappyLayerDriver::printLayerData
label sumSize = pp.size();
// Number of layers
const labelList& faceCells = pp.faceCells();
const labelUList& faceCells = pp.faceCells();
label sumNLayers = 0;
forAll(faceCells, i)
{
@ -3265,7 +3265,7 @@ bool Foam::snappyLayerDriver::writeLayerData
{
label patchi = patchIDs[i];
const polyPatch& pp = pbm[patchi];
const labelList& faceCells = pp.faceCells();
const labelUList& faceCells = pp.faceCells();
scalarField pfld(faceCells.size());
forAll(faceCells, i)
{
@ -5536,9 +5536,9 @@ void Foam::snappyLayerDriver::doLayers
if (numLayers[patchi] > 0)
{
const polyPatch& pp = mesh.boundaryMesh()[patchi];
forAll(pp.faceCells(), i)
for (const label celli : pp.faceCells())
{
cellWeights[pp.faceCells()[i]] += numLayers[patchi];
cellWeights[celli] += numLayers[patchi];
}
}
}

View File

@ -327,8 +327,8 @@ class snappySnapDriver
) const;
void correctAttraction
(
const DynamicList<point>& surfacePoints,
const DynamicList<label>& surfaceCounts,
const UList<point>& surfacePoints,
const UList<label>& surfaceCounts,
const point& edgePt,
const vector& edgeNormal, // normalised normal
const point& pt,
@ -504,7 +504,7 @@ class snappySnapDriver
(
const point& pt,
const labelList& pfPatchID,
const DynamicList<vector>& surfaceNormals,
const UList<vector>& surfaceNormals,
const labelList& faceToNormalBin
) const;
@ -513,7 +513,7 @@ class snappySnapDriver
(
const scalar featureCos,
const vector& faceSurfaceNormal,
const DynamicList<vector>& surfaceNormals
const UList<vector>& surfaceNormals
) const;
//- Determine attraction and constraints for single point

View File

@ -757,8 +757,8 @@ void Foam::snappySnapDriver::calcNearestFacePointProperties
// and if so attracts the point to that non-dominant plane.
void Foam::snappySnapDriver::correctAttraction
(
const DynamicList<point>& surfacePoints,
const DynamicList<label>& surfaceCounts,
const UList<point>& surfacePoints,
const UList<label>& surfaceCounts,
const point& edgePt,
const vector& edgeNormal, // normalised normal
const point& pt,
@ -820,7 +820,7 @@ Foam::label Foam::snappySnapDriver::findNormal
(
const scalar featureCos,
const vector& n,
const DynamicList<vector>& surfaceNormals
const UList<vector>& surfaceNormals
) const
{
label index = -1;
@ -853,7 +853,7 @@ Foam::pointIndexHit Foam::snappySnapDriver::findMultiPatchPoint
(
const point& pt,
const labelList& patchIDs,
const DynamicList<vector>& surfaceNormals,
const UList<vector>& surfaceNormals,
const labelList& faceToNormalBin
) const
{

View File

@ -364,7 +364,7 @@ void Foam::advancingFrontAMI::appendNbrFaces
(
const label facei,
const primitivePatch& patch,
const DynamicList<label>& visitedFaces,
const labelUList& visitedFaces,
DynamicList<label>& faceIDs
) const
{

View File

@ -211,7 +211,7 @@ protected:
(
const label facei,
const primitivePatch& patch,
const DynamicList<label>& visitedFaces,
const labelUList& visitedFaces,
DynamicList<label>& faceIDs
) const;

View File

@ -63,7 +63,7 @@ namespace Foam
// Write out triangulated surfaces as OBJ files
OBJstream srcTriObj("srcTris_" + Foam::name(nAMI) + ".obj");
const pointField& srcPts = src.points();
for (const DynamicList<face>& faces : srcTris_)
for (const auto& faces : srcTris_)
{
for (const face& f : faces)
{
@ -76,7 +76,7 @@ namespace Foam
OBJstream tgtTriObj("tgtTris_" + Foam::name(nAMI) + ".obj");
const pointField& tgtPts = tgt.points();
for (const DynamicList<face>& faces : tgtTris_)
for (const auto& faces : tgtTris_)
{
for (const face& f : faces)
{
@ -258,7 +258,7 @@ bool Foam::faceAreaWeightAMI::setNextFaces
label& tgtFacei,
const bitSet& mapFlag,
labelList& seedFaces,
const DynamicList<label>& visitedFaces,
const labelUList& visitedFaces,
const bool errorOnNotFound
) const
{

View File

@ -118,7 +118,7 @@ protected:
label& tgtFacei,
const bitSet& mapFlag,
labelList& seedFaces,
const DynamicList<label>& visitedFaces,
const labelUList& visitedFaces,
const bool errorOnNotFound = true
) const;

View File

@ -202,7 +202,7 @@ void Foam::cyclicACMIGAMGInterfaceField::initInterfaceMatrixUpdate
}
// Get neighbouring field
const labelList& nbrFaceCells =
const labelUList& nbrFaceCells =
lduAddr.patchAddr(cyclicACMIInterface_.neighbPatchID());
solveScalarField pnf(psiInternal, nbrFaceCells);
@ -315,7 +315,7 @@ void Foam::cyclicACMIGAMGInterfaceField::updateInterfaceMatrix
else
{
// Get neighbouring field
const labelList& nbrFaceCells =
const labelUList& nbrFaceCells =
lduAddr.patchAddr(cyclicACMIInterface_.neighbPatchID());
solveScalarField pnf(psiInternal, nbrFaceCells);

View File

@ -203,7 +203,7 @@ void Foam::cyclicAMIGAMGInterfaceField::initInterfaceMatrixUpdate
}
// Get neighbouring field
const labelList& nbrFaceCells =
const labelUList& nbrFaceCells =
lduAddr.patchAddr(cyclicAMIInterface_.neighbPatchID());
solveScalarField pnf(psiInternal, nbrFaceCells);
@ -329,7 +329,7 @@ void Foam::cyclicAMIGAMGInterfaceField::updateInterfaceMatrix
else
{
// Get neighbouring field
const labelList& nbrFaceCells =
const labelUList& nbrFaceCells =
lduAddr.patchAddr(cyclicAMIInterface_.neighbPatchID());
solveScalarField work(psiInternal, nbrFaceCells);

View File

@ -188,10 +188,16 @@ public:
inline bool cacheTriangulation() const;
//- Const access to the triangulation
inline const DynamicList<triPoints> triangles() const;
const DynamicList<triPoints>& triangles() const noexcept
{
return triangles_;
}
//- Non-const access to the triangulation
inline DynamicList<triPoints>& triangles();
DynamicList<triPoints>& triangles() noexcept
{
return triangles_;
}
//- Decompose face into triangle fan
static inline void triangleFan

View File

@ -121,17 +121,4 @@ bool Foam::faceAreaIntersect::cacheTriangulation() const
}
const Foam::DynamicList<Foam::triPoints>
Foam::faceAreaIntersect::triangles() const
{
return triangles_;
}
Foam::DynamicList<Foam::triPoints>& Foam::faceAreaIntersect::triangles()
{
return triangles_;
}
// ************************************************************************* //

View File

@ -54,7 +54,7 @@ adjointBoundaryCondition<Type>::computePatchGrad(word name)
auto tresGrad = tmp<Field<GradType>>::New(patch_.size(), Zero);
auto& resGrad = tresGrad.ref();
const labelList& faceCells = patch_.faceCells();
const labelUList& faceCells = patch_.faceCells();
const fvMesh& mesh = patch_.boundaryMesh().mesh();
const cellList& cells = mesh.cells();

View File

@ -101,7 +101,7 @@ void Foam::adjointOutletVelocityFluxFvPatchVectorField::manipulateMatrix
);
vectorField& source = matrix.source();
const vectorField& Sf = patch().Sf();
const labelList& faceCells = patch().faceCells();
const labelUList& faceCells = patch().faceCells();
const scalarField& magSf = patch().magSf();
tmp<vectorField> tvelocitySource(boundaryContrPtr_->velocitySource());
const vectorField& velocitySource = tvelocitySource();

View File

@ -63,8 +63,8 @@ Foam::linearUpwindNormal<Type>::correction
const surfaceScalarField& faceFlux = this->faceFlux_;
const labelList& owner = mesh.owner();
const labelList& neighbour = mesh.neighbour();
const auto& owner = mesh.owner();
const auto& neighbour = mesh.neighbour();
const volVectorField& C = mesh.C();
const surfaceVectorField& Cf = mesh.Cf();

View File

@ -268,11 +268,7 @@ void Foam::topODesignVariables::initialize()
{
if (isA<wallFvPatch>(patch))
{
const labelList& faceCells = patch.faceCells();
forAll(faceCells, cI)
{
alpha[faceCells[cI]] = 1.;
}
UIndirectList<scalar>(alpha, patch.faceCells()) = 1;
}
}
}

View File

@ -907,7 +907,7 @@ tmp<volScalarField> adjointSpalartAllmaras::distanceSensitivities()
const scalarField rt(tsource() & tf);
const scalarField Uap_t(Uap & tf);
const labelList& faceCells = patch.faceCells();
const labelUList& faceCells = patch.faceCells();
forAll(faceCells, faceI)
{
label cellI = faceCells[faceI];

View File

@ -142,7 +142,7 @@ tmp<volScalarField> adjointkOmegaSST::zeroFirstCell()
if (isA<omegaWallFunctionFvPatchScalarField>(omegab))
{
const label patchi = patch.index();
const labelList& faceCells = patch.faceCells();
const labelUList& faceCells = patch.faceCells();
fvPatchScalarField& bf = zeroFirstCell.boundaryFieldRef()[patchi];
forAll(faceCells, faceI)
{
@ -180,7 +180,7 @@ tmp<volScalarField> adjointkOmegaSST::dR_dnut()
{
const fvPatch& patch = mesh_.boundary()[pI];
const fvPatchScalarField& nutb = nutRef().boundaryField()[pI];
const labelList& faceCells = patch.faceCells();
const labelUList& faceCells = patch.faceCells();
if (isA<nutkWallFunctionFvPatchScalarField>(nutb))
{
fvPatchScalarField& bf = dRdnut.boundaryFieldRef()[pI];
@ -716,7 +716,7 @@ tmp<volScalarField> adjointkOmegaSST::dNutdbMult
dev2(gradU_.boundaryField()[pI].patchInternalField())
);
const vectorField& Sfb = Sf.boundaryField()[pI];
const labelList& faceCells = mesh_.boundary()[pI].faceCells();
const labelUList& faceCells = mesh_.boundary()[pI].faceCells();
forAll(faceCells, fI)
{
const label celli = faceCells[fI];
@ -969,7 +969,7 @@ void adjointkOmegaSST::addWallFunctionTerms
const scalar Cmu25 = pow025(Cmu);
const labelList& faceCells = patch.faceCells();
const labelUList& faceCells = patch.faceCells();
const fvPatchScalarField& dR_dnutw =
dR_dnut.boundaryField()[patchi];
const fvPatchScalarField& omegaw = omega.boundaryField()[patchi];
@ -1845,7 +1845,7 @@ tmp<fvVectorMatrix> adjointkOmegaSST::divDevReff(volVectorField& Ua) const
const fvPatchScalarField& nuEffb = nuEff.boundaryField()[pI];
const vectorField nf = mesh_.boundary()[pI].nf();
const vectorField Uai = Ua.boundaryField()[pI].patchInternalField();
const labelList& faceCells = mesh_.boundary()[pI].faceCells();
const labelUList& faceCells = mesh_.boundary()[pI].faceCells();
const vectorField& Sfb = Sf.boundaryField()[pI];
forAll(faceCells, fI)
@ -1989,7 +1989,7 @@ tmp<volVectorField> adjointkOmegaSST::adjointMeanFlowSource()
const scalar kappa = wallCoeffs.kappa();
const scalar Cmu25 = pow025(Cmu);
const labelList& faceCells = patch.faceCells();
const labelUList& faceCells = patch.faceCells();
const fvPatchVectorField& Uw =
primalVars_.U().boundaryField()[patchi];

View File

@ -124,7 +124,7 @@ void Foam::kaqRWallFunctionFvPatchScalarField::manipulateMatrix
const scalar Cmu25 = pow025(Cmu);
const labelList& faceCells = patch().faceCells();
const labelUList& faceCells = patch().faceCells();
const fvPatchVectorField& Uw = boundaryContrPtr_->Ub();
const scalarField magGradUw(mag(Uw.snGrad()));

View File

@ -136,7 +136,7 @@ void waWallFunctionFvPatchScalarField::manipulateMatrix
FieldField<Field, scalar>& internalCoeffs = matrix.internalCoeffs();
FieldField<Field, scalar>& boundaryCoeffs = matrix.boundaryCoeffs();
const fvMesh& mesh = patch().boundaryMesh().mesh();
const labelList& faceCells = patch().faceCells();
const labelUList& faceCells = patch().faceCells();
// Add diag term from the omega expression next to the wall
for (const label celli : faceCells)

View File

@ -423,7 +423,7 @@ void Foam::cellCellStencil::setUpFrontOnOversetPatch
{
if (isA<oversetFvPatch>(fvm[patchi]))
{
const labelList& fc = fvm[patchi].faceCells();
const labelUList& fc = fvm[patchi].faceCells();
forAll(fc, i)
{
const label celli = fc[i];

View File

@ -46,7 +46,7 @@ void Foam::cellCellStencil::interpolate
}
const mapDistribute& map = overlap.cellInterpolationMap();
const labelList& cellIDs = overlap.interpolationCells();
const labelUList& cellIDs = overlap.interpolationCells();
const scalarList& factor = overlap.cellInterpolationWeight();
Field<T> work(psi);

View File

@ -197,16 +197,15 @@ void Foam::cellCellStencils::cellVolumeWeight::findHoles
//Pout<< "Proper patch " << fvp.name() << " of type " << fvp.type()
// << endl;
const labelList& fc = fvp.faceCells();
forAll(fc, i)
for (const label celli : fvp.faceCells())
{
label regionI = cellRegion[fc[i]];
label regionI = cellRegion[celli];
if (cellTypes[fc[i]] != HOLE && regionType[regionI] != 2)
if (cellTypes[celli] != HOLE && regionType[regionI] != 2)
{
//Pout<< "reachable region : " << regionI
// << " at cell " << mesh.cellCentres()[fc[i]]
// << " on zone " << zoneID[fc[i]] << endl;
// << " at cell " << mesh.cellCentres()[celli]
// << " on zone " << zoneID[celli] << endl;
regionType[regionI] = 2;
}
}
@ -301,7 +300,7 @@ void Foam::cellCellStencils::cellVolumeWeight::markPatchCells
forAll(pbm, patchI)
{
const fvPatch& fvp = pbm[patchI];
const labelList& fc = fvp.faceCells();
const labelUList& fc = fvp.faceCells();
if (isA<oversetFvPatch>(fvp))
{

View File

@ -181,7 +181,7 @@ void Foam::cellCellStencils::inverseDistance::markBoundaries
forAll(pbm, patchI)
{
const fvPatch& fvp = pbm[patchI];
const labelList& fc = fvp.faceCells();
const labelUList& fc = fvp.faceCells();
if (!fvPatch::constraintType(fvp.type()))
{
@ -209,7 +209,7 @@ void Foam::cellCellStencils::inverseDistance::markBoundaries
forAll(pbm, patchI)
{
const fvPatch& fvp = pbm[patchI];
const labelList& fc = fvp.faceCells();
const labelUList& fc = fvp.faceCells();
if (isA<oversetFvPatch>(fvp))
{
@ -1074,12 +1074,11 @@ void Foam::cellCellStencils::inverseDistance::findHoles
{}
else if (!fvPatch::constraintType(fvp.type()))
{
const labelList& fc = fvp.faceCells();
forAll(fc, i)
for (const label celli : fvp.faceCells())
{
label regionI = cellRegion[fc[i]];
label regionI = cellRegion[celli];
if (cellTypes[fc[i]] != HOLE && regionType[regionI] != 2)
if (cellTypes[celli] != HOLE && regionType[regionI] != 2)
{
regionType[regionI] = 2;
}

View File

@ -77,7 +77,7 @@ bool Foam::cellCellStencils::trackingInverseDistance::markBoundaries
forAll(pbm, patchi)
{
const fvPatch& fvp = pbm[patchi];
const labelList& fc = fvp.faceCells();
const labelUList& fc = fvp.faceCells();
if (!fvPatch::constraintType(fvp.type()))
{
@ -112,7 +112,7 @@ bool Foam::cellCellStencils::trackingInverseDistance::markBoundaries
forAll(pbm, patchi)
{
const fvPatch& fvp = pbm[patchi];
const labelList& fc = fvp.faceCells();
const labelUList& fc = fvp.faceCells();
if (isA<oversetFvPatch>(fvp))
{

View File

@ -30,7 +30,7 @@ Description
{
const cellCellStencilObject& overlap = Stencil::New(mesh);
const labelList& cellTypes = overlap.cellTypes();
const labelUList& cellTypes = overlap.cellTypes();
cellMask.primitiveFieldRef() = 1.0;
forAll(cellMask, cellI)

View File

@ -30,7 +30,7 @@ Description
{
const cellCellStencilObject& overlap = Stencil::New(mesh);
const labelList& cellTypes = overlap.cellTypes();
const labelUList& cellTypes = overlap.cellTypes();
interpolatedCells.primitiveFieldRef() = 1.0;
forAll(cellMask, cellI)

View File

@ -43,8 +43,8 @@ bool Foam::oversetAdjustPhi
{
const fvMesh& mesh = U.mesh();
const cellCellStencilObject& overlap = Stencil::New(mesh);
const labelList& cellTypes = overlap.cellTypes();
const labelList& zoneID = overlap.zoneID();
const labelUList& cellTypes = overlap.cellTypes();
const labelUList& zoneID = overlap.zoneID();
// Pass1: accumulate all fluxes, calculate correction factor

Some files were not shown because too many files have changed in this diff Show More