Bugfix: renamed dynamicLabelList

This commit is contained in:
Hrvoje Jasak 2016-01-05 14:22:20 +00:00
parent 75a529a8e6
commit e965014962
169 changed files with 598 additions and 552 deletions

View file

@ -446,7 +446,7 @@ void Foam::cellTable::addCellZones
) const
{
Map<label> typeToZone = zoneMap();
List<DynamicList<label> > zoneCells(size());
List<dynamicLabelList > zoneCells(size());
forAll(tableIds, cellI)
{

View file

@ -230,7 +230,7 @@ Foam::labelList Foam::polyDualMesh::collectPatchSideFace
label meshPointI = patch.meshPoints()[pointI];
const labelList& pFaces = patch.pointFaces()[pointI];
DynamicList<label> dualFace;
dynamicLabelList dualFace;
if (pointToDualPoint[meshPointI] >= 0)
{
@ -345,9 +345,9 @@ void Foam::polyDualMesh::collectPatchInternalFace
const labelList& pFaces = patch.pointFaces()[pointI];
// Vertices of dualFace
DynamicList<label> dualFace(pFaces.size());
dynamicLabelList dualFace(pFaces.size());
// Indices in dualFace of vertices added because of feature edge
DynamicList<label> featEdgeIndices(dualFace.size());
dynamicLabelList featEdgeIndices(dualFace.size());
label edgeI = startEdgeI;
@ -440,9 +440,9 @@ void Foam::polyDualMesh::splitFace
const labelList& featEdgeIndices,
DynamicList<face>& dualFaces,
DynamicList<label>& dualOwner,
DynamicList<label>& dualNeighbour,
DynamicList<label>& dualRegion
dynamicLabelList& dualOwner,
dynamicLabelList& dualNeighbour,
dynamicLabelList& dualRegion
)
{
@ -522,7 +522,7 @@ void Foam::polyDualMesh::splitFace
// number of feature edges > 2.
// Storage for new face
DynamicList<label> subFace(dualFace.size());
dynamicLabelList subFace(dualFace.size());
forAll(featEdgeIndices, featI)
{
@ -587,9 +587,9 @@ void Foam::polyDualMesh::dualPatch
const pointField& dualPoints,
DynamicList<face>& dualFaces,
DynamicList<label>& dualOwner,
DynamicList<label>& dualNeighbour,
DynamicList<label>& dualRegion
dynamicLabelList& dualOwner,
dynamicLabelList& dualNeighbour,
dynamicLabelList& dualRegion
)
{
const labelList& meshEdges = patch.meshEdges();
@ -885,9 +885,9 @@ void Foam::polyDualMesh::calcDual
// Dynamic sized since we don't know size.
DynamicList<face> dynDualFaces(mesh.nEdges());
DynamicList<label> dynDualOwner(mesh.nEdges());
DynamicList<label> dynDualNeighbour(mesh.nEdges());
DynamicList<label> dynDualRegion(mesh.nEdges());
dynamicLabelList dynDualOwner(mesh.nEdges());
dynamicLabelList dynDualNeighbour(mesh.nEdges());
dynamicLabelList dynDualRegion(mesh.nEdges());
// Generate faces from edges on the boundary
@ -950,7 +950,7 @@ void Foam::polyDualMesh::calcDual
// Now walk from startFaceI to cell to face to cell etc. until endFaceI
DynamicList<label> dualFace;
dynamicLabelList dualFace;
if (edgeToDualPoint[edgeI] >= 0)
{
@ -1084,7 +1084,7 @@ void Foam::polyDualMesh::calcDual
}
// Walk face-cell-face until starting face reached.
DynamicList<label> dualFace(mesh.edgeCells()[edgeI].size());
dynamicLabelList dualFace(mesh.edgeCells()[edgeI].size());
label faceI = startFaceI;
@ -1566,7 +1566,7 @@ void Foam::polyDualMesh::calcFeatures
const labelListList& pointEdges = allBoundary.pointEdges();
DynamicList<label> allFeaturePoints(pointEdges.size());
dynamicLabelList allFeaturePoints(pointEdges.size());
forAll(pointEdges, pointI)
{
@ -1620,7 +1620,7 @@ void Foam::polyDualMesh::calcFeatures
)
);
DynamicList<label> allFeatureEdges(isFeatureEdge.size());
dynamicLabelList allFeatureEdges(isFeatureEdge.size());
forAll(isFeatureEdge, edgeI)
{
if (isFeatureEdge[edgeI])

View file

@ -119,9 +119,9 @@ class polyDualMesh
const labelList& featEdgeIndices,
DynamicList<face>& dualFaces,
DynamicList<label>& dualOwner,
DynamicList<label>& dualNeighbour,
DynamicList<label>& dualRegion
dynamicLabelList& dualOwner,
dynamicLabelList& dualNeighbour,
dynamicLabelList& dualRegion
);
static void dualPatch
@ -134,9 +134,9 @@ class polyDualMesh
const pointField& dualPoints,
DynamicList<face>& dualFaces,
DynamicList<label>& dualOwner,
DynamicList<label>& dualNeighbour,
DynamicList<label>& dualRegion
dynamicLabelList& dualOwner,
dynamicLabelList& dualNeighbour,
dynamicLabelList& dualRegion
);
void calcDual

View file

@ -341,7 +341,7 @@ void Foam::decompositionMethod::calcCellCells
) << "Only valid for mesh agglomeration." << exit(FatalError);
}
List<DynamicList<label> > dynCellCells(nCoarse);
List<dynamicLabelList > dynCellCells(nCoarse);
forAll(mesh.faceNeighbour(), faceI)
{

View file

@ -665,7 +665,7 @@ Foam::labelList Foam::parMetisDecomp::decompose
labelListList globalRegionRegions;
{
List<DynamicList<label> > dynRegionRegions(regionPoints.size());
List<dynamicLabelList > dynRegionRegions(regionPoints.size());
// Internal faces first
forAll(faceNeighbour, faceI)

View file

@ -695,7 +695,7 @@ labelList dynamicRefineFvMesh::selectRefineCells
label nCandidates = returnReduce(count(candidateCell, 1), sumOp<label>());
// Collect all cells
DynamicList<label> candidates(nCells());
dynamicLabelList candidates(nCells());
if (nCandidates < nTotToRefine)
{
@ -771,7 +771,7 @@ labelList dynamicRefineFvMesh::selectUnrefinePoints
// All points that can be unrefined
const labelList splitPoints(meshCutter_.getSplitPoints());
DynamicList<label> newSplitPoints(splitPoints.size());
dynamicLabelList newSplitPoints(splitPoints.size());
forAll(splitPoints, i)
{

View file

@ -195,7 +195,7 @@ void Foam::boundaryMesh::markEdges
const label edgeI,
const label distance,
labelList& minDistance,
DynamicList<label>& visited
dynamicLabelList& visited
) const
{
if (distance < maxDistance)
@ -868,8 +868,8 @@ Foam::labelList Foam::boundaryMesh::getNearest
// Divide faces into two bins acc. to normal
// - left of splitNormal
// - right ,,
DynamicList<label> leftFaces(mesh().size()/2);
DynamicList<label> rightFaces(mesh().size()/2);
dynamicLabelList leftFaces(mesh().size()/2);
dynamicLabelList rightFaces(mesh().size()/2);
forAll(mesh(), bFaceI)
{
@ -1241,7 +1241,7 @@ void Foam::boundaryMesh::patchify
if (newPatchPtrList.size() > 0)
{
List<DynamicList<label> > patchFaces(nNewPatches);
List<dynamicLabelList > patchFaces(nNewPatches);
// Give reasonable estimate for size of patches
label nAvgFaces =
@ -1505,7 +1505,7 @@ void Foam::boundaryMesh::setExtraEdges(const label edgeI)
// All edge labels encountered
DynamicList<label> visitedEdges;
dynamicLabelList visitedEdges;
// Floodfill from edgeI starting from distance 0. Stop at distance.
markEdges(8, edgeI, 0, minDistance, visitedEdges);

View file

@ -132,7 +132,7 @@ class boundaryMesh
const label edgeI,
const label distance,
labelList& minDistance,
DynamicList<label>& visited
dynamicLabelList& visited
) const;
//- Get index of polypatch by name

View file

@ -235,7 +235,7 @@ bool Foam::combineFaces::faceNeighboursValid
// to be 3 or more.
// Unregioned neighbouring faces
DynamicList<label> neighbourFaces(cFaces.size());
dynamicLabelList neighbourFaces(cFaces.size());
// Regioned neighbouring faces
labelHashSet neighbourRegions;

View file

@ -38,7 +38,7 @@ SourceFiles
#define edgeCollapser_H
#include "labelList.H"
#include "DynamicList.H"
#include "dynamicLabelList.H"
#include "typeInfo.H"
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
@ -67,7 +67,7 @@ class edgeCollapser
labelList pointRegion_;
//- -1 or master vertex for region number
DynamicList<label> pointRegionMaster_;
dynamicLabelList pointRegionMaster_;
//- Stack of free region numbers. Corresponds to -1 in pointRegionMaster
SLList<label> freeRegions_;
@ -139,7 +139,7 @@ public:
//- For every region the master (i.e. the point the region will
// be replaced by)
const DynamicList<label>& pointRegionMaster() const
const dynamicLabelList& pointRegionMaster() const
{
return pointRegionMaster_;
}

View file

@ -103,7 +103,7 @@ void Foam::faceCollapser::filterFace
const labelList& fEdges = mesh_.faceEdges()[faceI];
// Space for replaced vertices and split edges.
DynamicList<label> newFace(10 * f.size());
dynamicLabelList newFace(10 * f.size());
forAll(f, fp)
{
@ -416,7 +416,7 @@ void Foam::faceCollapser::setRefinement
label sorted1 = sortedFp[fp1];
// Get indices in increasing order
DynamicList<label> edgePoints(f.size());
dynamicLabelList edgePoints(f.size());
// Whether edgePoints are from fp to fp1
bool fpToFp1;

View file

@ -881,7 +881,7 @@ void Foam::hexRef8::insertEdgeSplit
const labelList& edgeMidPoint,
const label p0,
const label p1,
DynamicList<label>& verts
dynamicLabelList& verts
) const
{
if (p0 < mesh_.nPoints() && p1 < mesh_.nPoints())
@ -994,7 +994,7 @@ Foam::label Foam::hexRef8::storeMidPointInfo
// might be marked for splitting. Note that these edge splits cannot
// be between cellMid and face mids.
DynamicList<label> newFaceVerts(4);
dynamicLabelList newFaceVerts(4);
if (faceOrder == (mesh_.faceOwner()[faceI] == cellI))
{
newFaceVerts.append(faceMidPointI);
@ -1388,7 +1388,7 @@ void Foam::hexRef8::walkFaceToMid
const label cLevel,
const label faceI,
const label startFp,
DynamicList<label>& faceVerts
dynamicLabelList& faceVerts
) const
{
const face& f = mesh_.faces()[faceI];
@ -1437,7 +1437,7 @@ void Foam::hexRef8::walkFaceFromMid
const label cLevel,
const label faceI,
const label startFp,
DynamicList<label>& faceVerts
dynamicLabelList& faceVerts
) const
{
const face& f = mesh_.faces()[faceI];
@ -2104,7 +2104,7 @@ Foam::labelList Foam::hexRef8::consistentSlowRefinement
// Labels of seed faces
DynamicList<label> seedFaces(mesh_.nFaces()/100);
dynamicLabelList seedFaces(mesh_.nFaces()/100);
// refinementLevel data on seed faces
DynamicList<refinementData> seedFacesInfo(mesh_.nFaces()/100);
@ -2597,7 +2597,7 @@ Foam::labelList Foam::hexRef8::consistentSlowRefinement2
// Labels of seed faces
DynamicList<label> seedFaces(mesh_.nFaces()/100);
dynamicLabelList seedFaces(mesh_.nFaces()/100);
// refinementLevel data on seed faces
DynamicList<refinementDistanceData> seedFacesInfo(mesh_.nFaces()/100);
@ -2988,12 +2988,12 @@ Foam::labelListList Foam::hexRef8::setRefinement
// New point/cell level. Copy of pointLevel for existing points.
DynamicList<label> newCellLevel(cellLevel_.size());
dynamicLabelList newCellLevel(cellLevel_.size());
forAll(cellLevel_, cellI)
{
newCellLevel.append(cellLevel_[cellI]);
}
DynamicList<label> newPointLevel(pointLevel_.size());
dynamicLabelList newPointLevel(pointLevel_.size());
forAll(pointLevel_, pointI)
{
newPointLevel.append(pointLevel_[pointI]);
@ -3608,7 +3608,7 @@ Foam::labelListList Foam::hexRef8::setRefinement
{
// point is anchor. Start collecting face.
DynamicList<label> faceVerts(4);
dynamicLabelList faceVerts(4);
faceVerts.append(pointI);
@ -3740,7 +3740,7 @@ Foam::labelListList Foam::hexRef8::setRefinement
const face& f = mesh_.faces()[faceI];
const labelList& fEdges = mesh_.faceEdges()[faceI];
DynamicList<label> newFaceVerts(f.size());
dynamicLabelList newFaceVerts(f.size());
forAll(f, fp)
{

View file

@ -217,7 +217,7 @@ class hexRef8
const labelList& edgeMidPoint,
const label p0,
const label p1,
DynamicList<label>& verts
dynamicLabelList& verts
) const;
//- Store in maps correspondence from midpoint to anchors and faces.
@ -277,7 +277,7 @@ class hexRef8
const label cLevel,
const label faceI,
const label startFp,
DynamicList<label>& faceVerts
dynamicLabelList& faceVerts
) const;
//- Same as walkFaceToMid but now walk back.
@ -287,7 +287,7 @@ class hexRef8
const label cLevel,
const label faceI,
const label startFp,
DynamicList<label>& faceVerts
dynamicLabelList& faceVerts
) const;
//- Updates refineCell so consistent 2:1 refinement. Returns local

View file

@ -144,7 +144,7 @@ Foam::labelList Foam::removeCells::getExposedFaces
// 2 : unaffected internal face
// unaffected coupled boundary face
DynamicList<label> exposedFaces(mesh_.nFaces()/10);
dynamicLabelList exposedFaces(mesh_.nFaces()/10);
for (label faceI = 0; faceI < mesh_.nInternalFaces(); faceI++)
{

View file

@ -339,7 +339,7 @@ void Foam::removeFaces::mergeFaces
}
DynamicList<label> faceVerts(edgeLoop.size());
dynamicLabelList faceVerts(edgeLoop.size());
forAll(edgeLoop, i)
{
@ -740,7 +740,7 @@ Foam::label Foam::removeFaces::compatibleRemoves
}
// Recreate facesToRemove to be consistent with the cellRegions.
DynamicList<label> allFacesToRemove(facesToRemove.size());
dynamicLabelList allFacesToRemove(facesToRemove.size());
for (label faceI = 0; faceI < mesh_.nInternalFaces(); faceI++)
{

View file

@ -60,7 +60,7 @@ const Foam::point Foam::directTopoChange::greatPoint
void Foam::directTopoChange::renumber
(
const labelList& map,
DynamicList<label>& elems
dynamicLabelList& elems
)
{
forAll (elems, elemI)
@ -77,7 +77,7 @@ void Foam::directTopoChange::renumber
void Foam::directTopoChange::renumberReverseMap
(
const labelList& map,
DynamicList<label>& elems
dynamicLabelList& elems
)
{
forAll (elems, elemI)

View file

@ -125,11 +125,11 @@ class directTopoChange
DynamicList<point> points_;
//- Original point label (or masterpoint for added points)
DynamicList<label> pointMap_;
dynamicLabelList pointMap_;
//- For all original and added points contains new point label.
// (used to map return value of addPoint to new mesh point)
DynamicList<label> reversePointMap_;
dynamicLabelList reversePointMap_;
//- Zone of point
Map<label> pointZone_;
@ -144,21 +144,21 @@ class directTopoChange
DynamicList<face> faces_;
//- Patch for every external face (-1 for internal faces)
DynamicList<label> region_;
dynamicLabelList region_;
//- Owner for all faces
DynamicList<label> faceOwner_;
dynamicLabelList faceOwner_;
//- Neighbour for internal faces (-1 for external faces)
DynamicList<label> faceNeighbour_;
dynamicLabelList faceNeighbour_;
//- Original face label. Or master face for added-from-faces;
// -1 for faces added-from-edge or added-from-point)
DynamicList<label> faceMap_;
dynamicLabelList faceMap_;
//- For all original and added faces contains new face label
// (used to map return value of addFace to new mesh face)
DynamicList<label> reverseFaceMap_;
dynamicLabelList reverseFaceMap_;
//- Faces added from point (corresponding faceMap_ will
// be -1)
@ -185,11 +185,11 @@ class directTopoChange
//- Original cell label or master cell for added-from-cell;
// -1 for cells added from face or edge.
DynamicList<label> cellMap_;
dynamicLabelList cellMap_;
//- For all original and added cells contains new cell label
// (used to map return value of addCell to new mesh cell)
DynamicList<label> reverseCellMap_;
dynamicLabelList reverseCellMap_;
//- Cells added from point
Map<label> cellFromPoint_;
@ -201,7 +201,7 @@ class directTopoChange
Map<label> cellFromFace_;
//- Zone of cell
DynamicList<label> cellZone_;
dynamicLabelList cellZone_;
// Private Member Functions
@ -215,10 +215,10 @@ class directTopoChange
static void renumberKey(const labelList& map, Map<T>&);
//- Renumber elements of list according to map
static void renumber(const labelList&, DynamicList<label>&);
static void renumber(const labelList&, dynamicLabelList&);
static void renumber(const labelList&, labelHashSet&);
//- Special handling of reverse maps which have <-1 in them
static void renumberReverseMap(const labelList&, DynamicList<label>&);
static void renumberReverseMap(const labelList&, dynamicLabelList&);
//- Renumber & compact elements of list according to map
static void renumberCompact(const labelList&, labelList&);
@ -430,19 +430,19 @@ public:
return faces_;
}
const DynamicList<label>& region() const
const dynamicLabelList& region() const
{
return region_;
}
//- Owner
const DynamicList<label>& faceOwner() const
const dynamicLabelList& faceOwner() const
{
return faceOwner_;
}
//- Neighbour
const DynamicList<label>& faceNeighbour()const
const dynamicLabelList& faceNeighbour()const
{
return faceNeighbour_;
}

View file

@ -1352,8 +1352,8 @@ bool Foam::cellCuts::calcAnchors
walkEdges(cellI, cPoints[uncutIndex], 2, edgeStatus, pointStatus);
// Collect both sets in lists.
DynamicList<label> connectedPoints(cPoints.size());
DynamicList<label> otherPoints(cPoints.size());
dynamicLabelList connectedPoints(cPoints.size());
dynamicLabelList otherPoints(cPoints.size());
forAllConstIter(Map<label>, pointStatus, iter)
{
@ -2238,7 +2238,7 @@ void Foam::cellCuts::setFromCellCutter
scalarField cellLoopWeights;
// For debugging purposes
DynamicList<label> invalidCutCells(2);
dynamicLabelList invalidCutCells(2);
DynamicList<labelList> invalidCutLoops(2);
DynamicList<scalarField> invalidCutLoopWeights(2);
@ -2355,7 +2355,7 @@ void Foam::cellCuts::setFromCellCutter
scalarField cellLoopWeights;
// For debugging purposes
DynamicList<label> invalidCutCells(2);
dynamicLabelList invalidCutCells(2);
DynamicList<labelList> invalidCutLoops(2);
DynamicList<scalarField> invalidCutLoopWeights(2);

View file

@ -280,7 +280,7 @@ bool Foam::geomCellLooper::cut
// Size overly big.
label nEstCuts = 2*mesh().cells()[cellI].size();
DynamicList<label> localLoop(nEstCuts);
dynamicLabelList localLoop(nEstCuts);
DynamicList<scalar> localLoopWeights(nEstCuts);
// Points checked. Used to make sure we don't cut edge and edge endpoints

View file

@ -386,7 +386,7 @@ void Foam::topoCellLooper::walkSplitHex
const label fromEdgeI,
const label fromVertI,
DynamicList<label>& loop,
dynamicLabelList& loop,
DynamicList<scalar>& loopWeights
) const
{
@ -770,7 +770,7 @@ bool Foam::topoCellLooper::cut
label nEstCuts = 2*mesh().cells()[cellI].size();
DynamicList<label> localLoop(nEstCuts);
dynamicLabelList localLoop(nEstCuts);
DynamicList<scalar> localLoopWeights(nEstCuts);
walkSplitHex

View file

@ -139,7 +139,7 @@ class topoCellLooper
const label fromEdgeI,
const label fromVertI,
DynamicList<label>& loop,
dynamicLabelList& loop,
DynamicList<scalar>& loopWeights
) const;

View file

@ -92,7 +92,7 @@ Foam::face Foam::boundaryCutter::addEdgeCutsToFace
const labelList& fEdges = mesh_.faceEdges()[faceI];
// Storage for face
DynamicList<label> newFace(2 * f.size());
dynamicLabelList newFace(2 * f.size());
forAll(f, fp)
{
@ -339,7 +339,7 @@ bool Foam::boundaryCutter::splitFace
// Storage for new face
DynamicList<label> newFace(extendedFace.size());
dynamicLabelList newFace(extendedFace.size());
label fp = startFp;
@ -683,7 +683,7 @@ void Foam::boundaryCutter::setRefinement
// Replace existing face by newFace from fp0 to fp1 and add new one
// from fp1 to fp0.
DynamicList<label> newVerts(newFace.size());
dynamicLabelList newVerts(newFace.size());
// Get vertices from fp0 to (and including) fp1
label fp = fp0;

View file

@ -357,7 +357,7 @@ Foam::labelList Foam::undoableMeshCutter::getSplitFaces() const
<< abort(FatalError);
}
DynamicList<label> liveSplitFaces(liveSplitCells_.size());
dynamicLabelList liveSplitFaces(liveSplitCells_.size());
forAllConstIter(Map<splitCell*>, liveSplitCells_, iter)
{

View file

@ -562,7 +562,7 @@ void Foam::faceCoupleInfo::setCutEdgeToPoints(const labelList& cutToMasterEdges)
// String up the edges between e[0] and e[1]. Store the points
// inbetween e[0] and e[1] (all in cutFaces() labels)
DynamicList<label> splitPoints(stringedEdges.size()-1);
dynamicLabelList splitPoints(stringedEdges.size()-1);
// Unsplit edge endpoints
const edge unsplitEdge
@ -766,7 +766,7 @@ bool Foam::faceCoupleInfo::matchPointsThroughFaces
// Compaction list for cut points: either -1 or index into master which
// gives the point to compact to.
labelList cutPointRegion(cutPoints.size(), -1);
DynamicList<label> cutPointRegionMaster;
dynamicLabelList cutPointRegionMaster;
forAll(patchFaces, patchFaceI)
{
@ -1327,7 +1327,7 @@ Foam::label Foam::faceCoupleInfo::matchEdgeFaces
// the current set of master faces.
const labelList& masterFaces = fnd();
DynamicList<label> newCandidates(masterFaces.size());
dynamicLabelList newCandidates(masterFaces.size());
forAll(masterEFaces, j)
{

View file

@ -43,7 +43,7 @@ void Foam::polyMeshAdder::append
(
const labelList& map,
const labelList& lst,
DynamicList<label>& dynLst
dynamicLabelList& dynLst
)
{
dynLst.setSize(dynLst.size() + lst.size());
@ -427,7 +427,7 @@ void Foam::polyMeshAdder::insertVertices
const labelList& masterToCutPoints,
const face& masterF,
DynamicList<label>& workFace,
dynamicLabelList& workFace,
face& allF
)
{
@ -797,7 +797,7 @@ void Foam::polyMeshAdder::mergePrimitives
masterCutFaces.insert(meshFaceI);
}
DynamicList<label> workFace(100);
dynamicLabelList workFace(100);
forAll(from0ToAllFaces, face0)
{
@ -896,7 +896,7 @@ void Foam::polyMeshAdder::mergePointZones
DynamicList<word>& zoneNames,
labelList& from1ToAll,
List<DynamicList<label> >& pzPoints
List<dynamicLabelList >& pzPoints
)
{
zoneNames.setSize(pz0.size() + pz1.size());
@ -917,7 +917,7 @@ void Foam::polyMeshAdder::mergePointZones
forAll(pz0, zoneI)
{
DynamicList<label>& newZone = pzPoints[zoneI];
dynamicLabelList& newZone = pzPoints[zoneI];
newZone.setSize(pz0[zoneI].size());
@ -928,7 +928,7 @@ void Foam::polyMeshAdder::mergePointZones
forAll(pz1, zoneI)
{
// Relabel all points of zone and add to correct pzPoints.
DynamicList<label>& newZone = pzPoints[from1ToAll[zoneI]];
dynamicLabelList& newZone = pzPoints[from1ToAll[zoneI]];
newZone.setSize(newZone.size() + pz1[zoneI].size());
@ -951,7 +951,7 @@ void Foam::polyMeshAdder::mergeFaceZones
DynamicList<word>& zoneNames,
labelList& from1ToAll,
List<DynamicList<label> >& fzFaces,
List<dynamicLabelList >& fzFaces,
List<DynamicList<bool> >& fzFlips
)
{
@ -973,7 +973,7 @@ void Foam::polyMeshAdder::mergeFaceZones
fzFlips.setSize(zoneNames.size());
forAll(fz0, zoneI)
{
DynamicList<label>& newZone = fzFaces[zoneI];
dynamicLabelList& newZone = fzFaces[zoneI];
DynamicList<bool>& newFlip = fzFlips[zoneI];
newZone.setSize(fz0[zoneI].size());
@ -997,7 +997,7 @@ void Foam::polyMeshAdder::mergeFaceZones
// Now we have full addressing for faces so do the faceZones of mesh1.
forAll(fz1, zoneI)
{
DynamicList<label>& newZone = fzFaces[from1ToAll[zoneI]];
dynamicLabelList& newZone = fzFaces[from1ToAll[zoneI]];
DynamicList<bool>& newFlip = fzFlips[from1ToAll[zoneI]];
newZone.setSize(newZone.size() + fz1[zoneI].size());
@ -1034,7 +1034,7 @@ void Foam::polyMeshAdder::mergeCellZones
DynamicList<word>& zoneNames,
labelList& from1ToAll,
List<DynamicList<label> >& czCells
List<dynamicLabelList >& czCells
)
{
zoneNames.setSize(cz0.size() + cz1.size());
@ -1062,7 +1062,7 @@ void Foam::polyMeshAdder::mergeCellZones
// Cell mapping is trivial.
forAll(cz1, zoneI)
{
DynamicList<label>& newZone = czCells[from1ToAll[zoneI]];
dynamicLabelList& newZone = czCells[from1ToAll[zoneI]];
newZone.setSize(newZone.size() + cz1[zoneI].size());
@ -1088,14 +1088,14 @@ void Foam::polyMeshAdder::mergeZones
const labelList& from1ToAllCells,
DynamicList<word>& pointZoneNames,
List<DynamicList<label> >& pzPoints,
List<dynamicLabelList >& pzPoints,
DynamicList<word>& faceZoneNames,
List<DynamicList<label> >& fzFaces,
List<dynamicLabelList >& fzFaces,
List<DynamicList<bool> >& fzFlips,
DynamicList<word>& cellZoneNames,
List<DynamicList<label> >& czCells
List<dynamicLabelList >& czCells
)
{
labelList from1ToAllPZones;
@ -1142,14 +1142,14 @@ void Foam::polyMeshAdder::mergeZones
void Foam::polyMeshAdder::addZones
(
const DynamicList<word>& pointZoneNames,
const List<DynamicList<label> >& pzPoints,
const List<dynamicLabelList >& pzPoints,
const DynamicList<word>& faceZoneNames,
const List<DynamicList<label> >& fzFaces,
const List<dynamicLabelList >& fzFaces,
const List<DynamicList<bool> >& fzFlips,
const DynamicList<word>& cellZoneNames,
const List<DynamicList<label> >& czCells,
const List<dynamicLabelList >& czCells,
polyMesh& mesh
)
@ -1295,14 +1295,14 @@ Foam::autoPtr<Foam::polyMesh> Foam::polyMeshAdder::add
// ~~~~~
DynamicList<word> pointZoneNames;
List<DynamicList<label> > pzPoints;
List<dynamicLabelList > pzPoints;
DynamicList<word> faceZoneNames;
List<DynamicList<label> > fzFaces;
List<dynamicLabelList > fzFaces;
List<DynamicList<bool> > fzFlips;
DynamicList<word> cellZoneNames;
List<DynamicList<label> > czCells;
List<dynamicLabelList > czCells;
mergeZones
(
@ -1508,14 +1508,14 @@ Foam::autoPtr<Foam::mapAddedPolyMesh> Foam::polyMeshAdder::add
// ~~~~~
DynamicList<word> pointZoneNames;
List<DynamicList<label> > pzPoints;
List<dynamicLabelList > pzPoints;
DynamicList<word> faceZoneNames;
List<DynamicList<label> > fzFaces;
List<dynamicLabelList > fzFaces;
List<DynamicList<bool> > fzFlips;
DynamicList<word> cellZoneNames;
List<DynamicList<label> > czCells;
List<dynamicLabelList > czCells;
mergeZones
(

View file

@ -74,7 +74,7 @@ private:
(
const labelList& map,
const labelList& lst,
DynamicList<label>&
dynamicLabelList&
);
//- Index of patch in allPatches. Add if nonexisting.
@ -139,7 +139,7 @@ private:
const labelList& masterToCutPoints,
const face& masterFace,
DynamicList<label>& workFace,
dynamicLabelList& workFace,
face& f
);
@ -180,7 +180,7 @@ private:
DynamicList<word>& zoneNames,
labelList& from1ToAll,
List<DynamicList<label> >& pzPoints
List<dynamicLabelList >& pzPoints
);
//- Merge face zones
@ -193,7 +193,7 @@ private:
DynamicList<word>& zoneNames,
labelList& from1ToAll,
List<DynamicList<label> >& fzFaces,
List<dynamicLabelList >& fzFaces,
List<DynamicList<bool> >& fzFlips
);
@ -206,7 +206,7 @@ private:
DynamicList<word>& zoneNames,
labelList& from1ToAll,
List<DynamicList<label> >& czCells
List<dynamicLabelList >& czCells
);
//- Merge point/face/cell zone information
@ -221,28 +221,28 @@ private:
const labelList& from1ToAllCells,
DynamicList<word>& pointZoneNames,
List<DynamicList<label> >& pzPoints,
List<dynamicLabelList >& pzPoints,
DynamicList<word>& faceZoneNames,
List<DynamicList<label> >& fzFaces,
List<dynamicLabelList >& fzFaces,
List<DynamicList<bool> >& fzFlips,
DynamicList<word>& cellZoneNames,
List<DynamicList<label> >& czCells
List<dynamicLabelList >& czCells
);
//- Create new zones and add to new mesh.
static void addZones
(
const DynamicList<word>& pointZoneNames,
const List<DynamicList<label> >& pzPoints,
const List<dynamicLabelList >& pzPoints,
const DynamicList<word>& faceZoneNames,
const List<DynamicList<label> >& fzFaces,
const List<dynamicLabelList >& fzFaces,
const List<DynamicList<bool> >& fzFlips,
const DynamicList<word>& cellZoneNames,
const List<DynamicList<label> >& czCells,
const List<dynamicLabelList >& czCells,
polyMesh& mesh
);

View file

@ -110,7 +110,7 @@ void Foam::attachDetach::checkDefinition()
{
const labelList& addr = mesh.faceZones()[faceZoneID_.index()];
DynamicList<label> bouFacesInZone(addr.size());
dynamicLabelList bouFacesInZone(addr.size());
forAll (addr, faceI)
{
@ -178,7 +178,7 @@ void Foam::attachDetach::checkDefinition()
{
const labelList& addr = mesh.faceZones()[faceZoneID_.index()];
DynamicList<label> zoneProblemFaces(addr.size());
dynamicLabelList zoneProblemFaces(addr.size());
forAll (addr, faceI)
{

View file

@ -250,8 +250,8 @@ void Foam::slidingInterface::coupleInterface(polyTopoChange& ref) const
// For every master and slave edge make a list of points to be added into
// that edge.
List<DynamicList<label> > pointsIntoMasterEdges(masterEdges.size());
List<DynamicList<label> > pointsIntoSlaveEdges(slaveEdges.size());
List<dynamicLabelList > pointsIntoMasterEdges(masterEdges.size());
List<dynamicLabelList > pointsIntoSlaveEdges(slaveEdges.size());
// Add all points from the slave patch that have hit the edge
forAll (slavePointEdgeHits, pointI)
@ -1304,7 +1304,7 @@ void Foam::slidingInterface::coupleInterface(polyTopoChange& ref) const
// Pout<< "old rich master face: " << oldRichFace
// << " old face: " << oldFace << endl;
DynamicList<label> newFaceLabels(2*oldFace.size());
dynamicLabelList newFaceLabels(2*oldFace.size());
forAll (oldFace, pointI)
{
@ -1579,7 +1579,7 @@ void Foam::slidingInterface::coupleInterface(polyTopoChange& ref) const
oldFace.setSize(nOldFace);
DynamicList<label> newFaceLabels(2*oldFace.size());
dynamicLabelList newFaceLabels(2*oldFace.size());
// Pout << "old rich slave face: " << oldRichFace << " old face: " << oldFace << endl;
forAll (oldFace, pointI)

View file

@ -188,7 +188,7 @@ void Foam::slidingInterface::decoupleInterface
const face& oldFace = faces[curFaceID];
DynamicList<label> newFaceLabels(oldFace.size());
dynamicLabelList newFaceLabels(oldFace.size());
bool changed = false;
@ -305,7 +305,7 @@ void Foam::slidingInterface::decoupleInterface
const face& oldFace = faces[curFaceID];
DynamicList<label> newFaceLabels(oldFace.size());
dynamicLabelList newFaceLabels(oldFace.size());
bool changed = false;

View file

@ -75,8 +75,8 @@ void Foam::enrichedPatch::calcCutFaces() const
// Prepare the storage
DynamicList<face> cf(2*lf.size());
DynamicList<label> cfMaster(2*lf.size());
DynamicList<label> cfSlave(2*lf.size());
dynamicLabelList cfMaster(2*lf.size());
dynamicLabelList cfSlave(2*lf.size());
// Algorithm
// Go through all the faces
@ -184,8 +184,8 @@ void Foam::enrichedPatch::calcCutFaces() const
// Pout << "Trying new edge (" << mp[curEdge.start()] << ", " << mp[curEdge.end()] << ") seed: " << curEdge << " used: " << edgesUsedTwice.found(curEdge) << endl;
// Estimate the size of cut face as twice the size of original face
DynamicList<label> cutFaceGlobalPoints(2*curLocalFace.size());
DynamicList<label> cutFaceLocalPoints(2*curLocalFace.size());
dynamicLabelList cutFaceGlobalPoints(2*curLocalFace.size());
dynamicLabelList cutFaceLocalPoints(2*curLocalFace.size());
// Found unused edge.
label prevPointLabel = curEdge.start();

View file

@ -98,7 +98,7 @@ void Foam::enrichedPatch::calcEnrichedFaces
// << oldLocalFace.points(slavePatch_.localPoints()) << endl;
const labelList& curEdges = slaveFaceEdges[faceI];
DynamicList<label> newFace(oldFace.size()*enrichedFaceRatio_);
dynamicLabelList newFace(oldFace.size()*enrichedFaceRatio_);
// Note: The number of points and edges in a face is always identical
// so both can be done is the same loop
@ -265,7 +265,7 @@ void Foam::enrichedPatch::calcEnrichedFaces
// Pout << "old master face: " << oldFace << endl;
const labelList& curEdges = masterFaceEdges[faceI];
DynamicList<label> newFace(oldFace.size()*enrichedFaceRatio_);
dynamicLabelList newFace(oldFace.size()*enrichedFaceRatio_);
// Note: The number of points and edges in a face is always identical
// so both can be done is the same loop

View file

@ -57,7 +57,7 @@ void Foam::enrichedPatch::calcMasterPointFaces() const
// Master face points lists the points of the enriched master face plus
// points projected into the master face
Map<DynamicList<label> > mpf(meshPoints().size());
Map<dynamicLabelList > mpf(meshPoints().size());
const faceList& ef = enrichedFaces();
@ -68,7 +68,7 @@ void Foam::enrichedPatch::calcMasterPointFaces() const
// Pout << "Cur face in pfAddr: " << curFace << endl;
forAll (curFace, pointI)
{
Map<DynamicList<label> >::iterator mpfIter =
Map<dynamicLabelList >::iterator mpfIter =
mpf.find(curFace[pointI]);
if (mpfIter == mpf.end())
@ -77,7 +77,7 @@ void Foam::enrichedPatch::calcMasterPointFaces() const
mpf.insert
(
curFace[pointI],
DynamicList<label>(primitiveMesh::facesPerPoint_)
dynamicLabelList(primitiveMesh::facesPerPoint_)
);
// Iterator is invalidated - have to find again
@ -107,7 +107,7 @@ void Foam::enrichedPatch::calcMasterPointFaces() const
const label mergedSmp =
pointMergeMap().find(slaveMeshPoints[pointI])();
Map<DynamicList<label> >::iterator mpfIter =
Map<dynamicLabelList >::iterator mpfIter =
mpf.find(mergedSmp);
if (mpfIter == mpf.end())
@ -116,7 +116,7 @@ void Foam::enrichedPatch::calcMasterPointFaces() const
mpf.insert
(
mergedSmp,
DynamicList<label>(primitiveMesh::facesPerPoint_)
dynamicLabelList(primitiveMesh::facesPerPoint_)
);
// Iterator is invalidated - have to find again

View file

@ -72,6 +72,7 @@ SourceFiles
#define refinementHistory_H
#include "DynamicList.H"
#include "dynamicLabelList.H"
#include "labelList.H"
#include "FixedList.H"
#include "SLList.H"
@ -182,7 +183,7 @@ private:
DynamicList<splitCell8> splitCells_;
//- Unused indices in splitCells
DynamicList<label> freeSplitCells_;
dynamicLabelList freeSplitCells_;
//- Currently visible cells. Indices into splitCells.
labelList visibleCells_;
@ -271,7 +272,7 @@ public:
}
//- Cache of unused indices in splitCells
const DynamicList<label>& freeSplitCells() const
const dynamicLabelList& freeSplitCells() const
{
return freeSplitCells_;
}

View file

@ -82,10 +82,10 @@ class changeMap
DynamicList<objectMap> addedCells_;
// Entities that were removed during the operation
DynamicList<label> removedPoints_;
DynamicList<label> removedEdges_;
DynamicList<label> removedFaces_;
DynamicList<label> removedCells_;
dynamicLabelList removedPoints_;
dynamicLabelList removedEdges_;
dynamicLabelList removedFaces_;
dynamicLabelList removedCells_;
public:

View file

@ -2217,7 +2217,7 @@ const changeMap dynamicTopoFvMesh::insertCells(const label mIndex)
}
// Build a list of mapping entities on this processor
DynamicList<label> mapCells(10);
dynamicLabelList mapCells(10);
if (is2D())
{
@ -3197,7 +3197,7 @@ const changeMap dynamicTopoFvMesh::insertCells(const label mIndex)
// Accumulate stats in case of failure
scalar minDist = GREAT;
vector minPoint = vector::zero;
DynamicList<label> checkedFaces;
dynamicLabelList checkedFaces;
if (debug > 2)
{
@ -4943,7 +4943,7 @@ void dynamicTopoFvMesh::syncCoupledPatches(labelHashSet& entities)
}
// Buffer for cell-removal
DynamicList<label> rCellList(10);
dynamicLabelList rCellList(10);
forAll(procIndices_, pI)
{
@ -5238,7 +5238,7 @@ void dynamicTopoFvMesh::syncCoupledPatches(labelHashSet& entities)
// Accumulate stats in case of failure
scalar minDist = GREAT;
vector minPoint = vector::zero;
DynamicList<label> checkedFaces;
dynamicLabelList checkedFaces;
if (debug > 2)
{
@ -9540,7 +9540,7 @@ bool dynamicTopoFvMesh::coupledFillTables
// Need to build alternate addressing / point-list
// for swaps across processors.
DynamicList<point> parPts(10);
DynamicList<label> parVtx(10);
dynamicLabelList parVtx(10);
bool closed = true;
label nPoints = 0, nProcs = 0;
@ -9897,7 +9897,7 @@ void dynamicTopoFvMesh::computeCoupledWeights
if (dimension == 2)
{
DynamicList<label> faceParents(10);
dynamicLabelList faceParents(10);
label patchIndex = whichPatch(index);
@ -9995,7 +9995,7 @@ void dynamicTopoFvMesh::computeCoupledWeights
else
if (dimension == 3)
{
DynamicList<label> cellParents(10);
dynamicLabelList cellParents(10);
forAll(procIndices_, pI)
{

View file

@ -1303,7 +1303,7 @@ void dynamicTopoFvMesh::buildVertexHull
if (failMode)
{
// Prepare edgeCells
DynamicList<label> eCells(10);
dynamicLabelList eCells(10);
forAll(eFaces, faceI)
{

View file

@ -524,7 +524,7 @@ class dynamicTopoFvMesh
const point& oldPoint,
const label pointIndex,
const label cellIndex,
DynamicList<label>& cellsChecked,
dynamicLabelList& cellsChecked,
scalar& collapseQuality,
bool forceOp = false
) const;

View file

@ -710,7 +710,7 @@ void dynamicTopoFvMesh::writeEdgeConnectivity
2, false, true
);
DynamicList<label> edgeCells(10);
dynamicLabelList edgeCells(10);
forAll(eFaces, faceI)
{
@ -896,7 +896,7 @@ void dynamicTopoFvMesh::writeVTK
meshSubDict.subDict("spatialDebug").lookup("debugBoundBox")
);
DynamicList<label> cSubList(10);
dynamicLabelList cSubList(10);
forAll(cList, cellI)
{
@ -1464,7 +1464,7 @@ void dynamicTopoFvMesh::checkConnectivity(const label maxErrors) const
}
label nInternalEdges = 0;
DynamicList<label> bPatchIDs(10);
dynamicLabelList bPatchIDs(10);
labelList patchInfo(boundaryMesh().size(), 0);
forAll(edgeFaces_, edgeI)
@ -2189,7 +2189,7 @@ bool dynamicTopoFvMesh::checkCollapse
const point& oldPoint,
const label pointIndex,
const label cellIndex,
DynamicList<label>& cellsChecked,
dynamicLabelList& cellsChecked,
scalar& collapseQuality,
bool forceOp
) const

View file

@ -655,7 +655,7 @@ void dynamicTopoFvMesh::setCellMapping
}
// Update cell-parents information
DynamicList<label> masterCells(5);
dynamicLabelList masterCells(5);
forAll(mapCells, cellI)
{
@ -801,7 +801,7 @@ void dynamicTopoFvMesh::setFaceMapping
}
// Update face-parents information
DynamicList<label> masterFaces(5);
dynamicLabelList masterFaces(5);
forAll(mapFaces, faceI)
{

View file

@ -3499,7 +3499,7 @@ const changeMap dynamicTopoFvMesh::bisectEdge
if (coupledModification_)
{
// Build a list of boundary edges / faces for mapping
DynamicList<label> checkEdges(8), checkFaces(4);
dynamicLabelList checkEdges(8), checkFaces(4);
const labelList& oeFaces = edgeFaces_[eIndex];
const labelList& neFaces = edgeFaces_[newEdgeIndex];
@ -4164,7 +4164,7 @@ scalar dynamicTopoFvMesh::computeBisectionQuality
point midPoint = 0.5 * (a + c);
point oldPoint = 0.5 * (aOld + cOld);
DynamicList<label> eCells(10);
dynamicLabelList eCells(10);
const labelList& eFaces = edgeFaces_[eIndex];
@ -4902,7 +4902,7 @@ const changeMap dynamicTopoFvMesh::addCellLayer
Map<labelPair> addedCells;
// Allocate a list of patch faces
DynamicList<label> patchFaces(patchSizes_[patchID]);
dynamicLabelList patchFaces(patchSizes_[patchID]);
// Loop through all patch faces and create a cell for each
for (label faceI = nOldInternalFaces_; faceI < faces_.size(); faceI++)

View file

@ -1652,7 +1652,7 @@ const changeMap dynamicTopoFvMesh::collapseQuadFace
FixedList<label,4> edgeToKeep(-1), edgeToThrow(-1);
// Maintain a list of modified faces for mapping
DynamicList<label> modifiedFaces(10);
dynamicLabelList modifiedFaces(10);
// Case 2 & 3 use identical connectivity,
// but different point locations
@ -4493,7 +4493,7 @@ const changeMap dynamicTopoFvMesh::collapseEdge
{
// Point-based coupling
scalar slaveCollapseQuality(GREAT);
DynamicList<label> cellsChecked(10);
dynamicLabelList cellsChecked(10);
// Check cells connected to coupled point
const labelList& pEdges = sMesh.pointEdges_[mag(sIndex)];
@ -4995,7 +4995,7 @@ const changeMap dynamicTopoFvMesh::collapseEdge
// Also, keep track of resulting cell quality,
// if collapse is indeed feasible
scalar collapseQuality(GREAT);
DynamicList<label> cellsChecked(10);
dynamicLabelList cellsChecked(10);
// Add all hull cells as 'checked',
// and therefore, feasible
@ -5284,7 +5284,7 @@ const changeMap dynamicTopoFvMesh::collapseEdge
}
// Maintain a list of modified faces for mapping
DynamicList<label> modifiedFaces(10);
dynamicLabelList modifiedFaces(10);
// Renumber all hull faces and edges
forAll(faceHull, indexI)
@ -5999,7 +5999,7 @@ const changeMap dynamicTopoFvMesh::collapseEdge
// Check for duplicate edges connected to the replacePoint
const labelList& rpEdges = pointEdges_[replacePoint];
DynamicList<label> mergeFaces(10);
dynamicLabelList mergeFaces(10);
forAll(rpEdges, edgeI)
{
@ -6199,7 +6199,7 @@ const changeMap dynamicTopoFvMesh::collapseEdge
if (coupledModification_)
{
// Build a list of boundary edges / faces for mapping
DynamicList<label> checkEdges(10), checkFaces(10);
dynamicLabelList checkEdges(10), checkFaces(10);
const labelList& pEdges = pointEdges_[replacePoint];
@ -7321,7 +7321,7 @@ const changeMap dynamicTopoFvMesh::removeCellLayer
labelHashSet edgesToRemove, facesToRemove;
Map<labelPair> pointsToRemove, edgesToKeep;
DynamicList<label> patchFaces(patchSizes_[patchID]);
dynamicLabelList patchFaces(patchSizes_[patchID]);
DynamicList<labelPair> cellsToRemove(patchSizes_[patchID]);
DynamicList<labelPair> hFacesToRemove(patchSizes_[patchID]);
@ -7847,7 +7847,7 @@ const changeMap dynamicTopoFvMesh::mergeBoundaryFaces
Pout<< " mergePairs: " << mergePairs << endl;
}
DynamicList<label> checkEdges(10);
dynamicLabelList checkEdges(10);
forAll(mergePairs, pairI)
{

View file

@ -2948,7 +2948,7 @@ const changeMap dynamicTopoFvMesh::swap32
// Determine the three faces to be removed
FixedList<label,3> facesForRemoval;
DynamicList<label> cellRemovalList(3);
dynamicLabelList cellRemovalList(3);
forAll(facesForRemoval, faceI)
{

View file

@ -235,7 +235,7 @@ inline bool lengthScaleEstimator::testProximity
// Reset input
proxDistance = GREAT;
DynamicList<label> posIndices(20);
dynamicLabelList posIndices(20);
scalar minDeviation = -0.9;
label nD = spatialRes_, binSize = proximityBins_.size();

View file

@ -408,7 +408,7 @@ inline bool Dijkstra
// Step 2: Build a list of points adjacent to pointIndex
// but not in the visited list
DynamicList<label> adjacentPoints(10);
dynamicLabelList adjacentPoints(10);
const labelList& pEdges = localPointEdges[pointIndex];
@ -468,7 +468,7 @@ inline bool Dijkstra
{
if (foundEndPoint)
{
DynamicList<label> pathNodes(50);
dynamicLabelList pathNodes(50);
label currentPoint = endPoint;

View file

@ -2398,12 +2398,12 @@ void mesquiteMotionSolver::initMesquiteParallelArrays()
// Make a rough estimate for cellToNode
Map<label> addedCells;
DynamicList<label> myCellToNode(50);
dynamicLabelList myCellToNode(50);
labelList nSharedPoints(procIndices_.size(), 0);
List<labelList> myFixFlags(procIndices_.size());
List<labelList> neiFixFlags(procIndices_.size());
List<labelList> neiTypes(procIndices_.size());
List<DynamicList<label> > myTypes(procIndices_.size());
List<dynamicLabelList > myTypes(procIndices_.size());
const dictionary& optionsDict = subDict("mesquiteOptions");
@ -4127,7 +4127,7 @@ void mesquiteMotionSolver::correctInvalidCells()
// Obtain point-positions after smoothing
pointField newField = refPoints_;
DynamicList<label> invCells(50);
dynamicLabelList invCells(50);
forAll(pIDs_, patchI)
{

View file

@ -46,6 +46,26 @@ namespace solidBodyMotionFunctions
};
// * * * * * * * * * * * * * Private Member Functions * * * * * * * * * * * //
Foam::scalar Foam::solidBodyMotionFunctions::translation::rampFactor() const
{
if (rampTime_ > 0)
{
// Calculate ramp-up factor
const scalar t = time_.value();
return sin(2*pi/(4*rampTime_)*Foam::min(rampTime_, t));
}
else
{
return 1;
}
}
// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
Foam::solidBodyMotionFunctions::translation::translation
@ -55,7 +75,8 @@ Foam::solidBodyMotionFunctions::translation::translation
)
:
solidBodyMotionFunction(SBMFCoeffs, runTime),
velocity_(SBMFCoeffs_.lookup("velocity"))
velocity_(SBMFCoeffs_.lookup("velocity")),
rampTime_(readScalar(SBMFCoeffs_.lookup("rampTime")))
{}
@ -72,10 +93,12 @@ Foam::solidBodyMotionFunctions::translation::transformation() const
{
scalar time = time_.value();
septernion TR(velocity_*time, quaternion::I);
septernion TR(rampFactor()*velocity_*time, quaternion::I);
Info<< "solidBodyMotionFunctions::translation::transformation(): "
<< "Time = " << time << " transformation: " << TR << endl;
<< "Time = " << time << " velocity = " << rampFactor()*velocity_
<< " transformation = " << TR
<< endl;
return TR;
}
@ -86,7 +109,7 @@ Foam::solidBodyMotionFunctions::translation::velocity() const
{
scalar time = time_.value();
septernion TV(velocity_, quaternion::zero);
septernion TV(rampFactor()*velocity_, quaternion::zero);
Info<< "solidBodyMotionFunctions::translation::transformation(): "
<< "Time = " << time << " velocity: " << TV << endl;
@ -102,7 +125,7 @@ bool Foam::solidBodyMotionFunctions::translation::read
{
solidBodyMotionFunction::read(SBMFCoeffs);
SBMFCoeffs_.lookup("velocity") >> velocity_;
rampTime_ = readScalar(SBMFCoeffs_.lookup("rampTime"));
return true;
}

View file

@ -57,6 +57,9 @@ class translation
//- Velocity
vector velocity_;
//- Ramping time scale
scalar rampTime_;
// Private Member Functions
@ -67,6 +70,10 @@ class translation
void operator=(const translation&);
//- Ramping factor resulting from rampTime_ value
scalar rampFactor() const;
public:
//- Runtime type information

View file

@ -66,7 +66,7 @@ class tetMotionSolver
tetPointVectorField motionU_;
//- List of constrained points
DynamicList<label> fixedPoints_;
dynamicLabelList fixedPoints_;
//- List of constrained velocities
DynamicList<vector> fixedVelocity_;

View file

@ -125,7 +125,7 @@ Foam::label Foam::edgeMesh::regions(labelList& edgeRegion) const
while (edgesToVisit.size())
{
// neighbours of current edgesToVisit
DynamicList<label> newEdgesToVisit(edgesToVisit.size());
dynamicLabelList newEdgesToVisit(edgesToVisit.size());
// Mark all point connected edges with current region.
forAll(edgesToVisit, i)

View file

@ -73,7 +73,7 @@ bool Foam::accordionEngineMesh::update()
# include "setPistonMotionBoundaryConditionAccordionEngineMesh.H"
Info << "piston motion" << endl;
DynamicList<label> constrainedPoints(mSolver.curPoints()().size()/100);
dynamicLabelList constrainedPoints(mSolver.curPoints()().size()/100);
DynamicList<vector> constrainedVelocity
(
mSolver.curPoints()().size()/100

View file

@ -70,7 +70,7 @@ bool Foam::deformingEngineMesh::update()
# include "setPistonMotionBoundaryConditionDeformingEngineMesh.H"
Info << "piston motion" << endl;
DynamicList<label> constrainedPoints(mSolver.curPoints()().size()/100);
dynamicLabelList constrainedPoints(mSolver.curPoints()().size()/100);
DynamicList<vector> constrainedVelocity
(
mSolver.curPoints()().size()/100

View file

@ -20,12 +20,12 @@
const vectorField& areas = Sf().internalField();
DynamicList<label> df;
dynamicLabelList df;
{
label headFaces = 0;
label ndf = 0;
DynamicList<label> headList;
dynamicLabelList headList;
label nHead = 0;
const polyPatch& detachPatch =

View file

@ -437,7 +437,7 @@ bool Foam::engineValveSliding::update()
# include "setMotionBoundaryConditionEngineValveSliding.H"
DynamicList<label> constrainedPoints(mSolver.curPoints()().size()/100);
dynamicLabelList constrainedPoints(mSolver.curPoints()().size()/100);
DynamicList<vector> constrainedVelocity
(
mSolver.curPoints()().size()/100

View file

@ -186,10 +186,10 @@ void Foam::layerAR::addZonesAndModifiers()
// Points which don't move (= cylinder head)
DynamicList<label> headPoints(nPoints() / 10);
dynamicLabelList headPoints(nPoints() / 10);
// Points below the piston which moves with the piston displacement
DynamicList<label> pistonPoints(nPoints() / 10);
dynamicLabelList pistonPoints(nPoints() / 10);
label nHeadPoints = 0;
@ -263,10 +263,10 @@ void Foam::layerAR::addZonesAndModifiers()
scalar zPistV = max(boundary()[pistonPatchID].patch().localPoints()).z();
// Points which don't move (= cylinder head)
DynamicList<label> headPoints(nPoints() / 10);
dynamicLabelList headPoints(nPoints() / 10);
// Points below the piston which moves with the piston displacement
DynamicList<label> pistonPoints(nPoints() / 10);
dynamicLabelList pistonPoints(nPoints() / 10);
label nHeadPoints = 0;

View file

@ -187,10 +187,10 @@ void Foam::layerARGambit::addZonesAndModifiers()
// Points which don't move (= cylinder head)
DynamicList<label> headPoints(nPoints() / 10);
dynamicLabelList headPoints(nPoints() / 10);
// Points below the piston which moves with the piston displacement
DynamicList<label> pistonPoints(nPoints() / 10);
dynamicLabelList pistonPoints(nPoints() / 10);
label nHeadPoints = 0;
@ -264,10 +264,10 @@ void Foam::layerARGambit::addZonesAndModifiers()
scalar zPistV = max(boundary()[pistonPatchID].patch().localPoints()).z();
// Points which don't move (= cylinder head)
DynamicList<label> headPoints(nPoints() / 10);
dynamicLabelList headPoints(nPoints() / 10);
// Points below the piston which moves with the piston displacement
DynamicList<label> pistonPoints(nPoints() / 10);
dynamicLabelList pistonPoints(nPoints() / 10);
label nHeadPoints = 0;

View file

@ -19,11 +19,11 @@
const vectorField& areas = Sf().internalField();
DynamicList<label> df;
dynamicLabelList df;
{
label ndf = 0;
DynamicList<label> headList;
dynamicLabelList headList;
label nHead = 0;
const polyPatch& detachPatch =
@ -119,12 +119,12 @@
const vectorField& areas = Sf().internalField();
DynamicList<label> df;
dynamicLabelList df;
{
label headFaces = 0;
label ndf = 0;
DynamicList<label> headList;
dynamicLabelList headList;
label nHead = 0;
const polyPatch& detachPatch =

View file

@ -125,10 +125,10 @@
// Points which don't move (= cylinder head)
DynamicList<label> headPoints(nPoints() / 10);
dynamicLabelList headPoints(nPoints() / 10);
// Points below the piston which moves with the piston displacement
DynamicList<label> pistonPoints(nPoints() / 10);
dynamicLabelList pistonPoints(nPoints() / 10);
label nHeadPoints = 0;
@ -215,10 +215,10 @@
scalar zPistV = max(boundary()[pistonPatchID].patch().localPoints()).z();
// Points which don't move (= cylinder head)
DynamicList<label> headPoints(nPoints() / 10);
dynamicLabelList headPoints(nPoints() / 10);
// Points below the piston which moves with the piston displacement
DynamicList<label> pistonPoints(nPoints() / 10);
dynamicLabelList pistonPoints(nPoints() / 10);
label nHeadPoints = 0;
@ -408,7 +408,7 @@
// Points below the piston which moves with the piston displacement
DynamicList<label> pistonPoints(nPoints() / 10);
dynamicLabelList pistonPoints(nPoints() / 10);
forAll (points(), pointI)
{

View file

@ -186,10 +186,10 @@ void Foam::noEngineMesh::addZonesAndModifiers()
// Points which don't move (= cylinder head)
DynamicList<label> headPoints(nPoints() / 10);
dynamicLabelList headPoints(nPoints() / 10);
// Points below the piston which moves with the piston displacement
DynamicList<label> pistonPoints(nPoints() / 10);
dynamicLabelList pistonPoints(nPoints() / 10);
label nHeadPoints = 0;
@ -263,10 +263,10 @@ void Foam::noEngineMesh::addZonesAndModifiers()
max(boundary()[pistonPatchID].patch().localPoints()).z();
// Points which don't move (= cylinder head)
DynamicList<label> headPoints(nPoints() / 10);
dynamicLabelList headPoints(nPoints() / 10);
// Points below the piston which moves with the piston displacement
DynamicList<label> pistonPoints(nPoints() / 10);
dynamicLabelList pistonPoints(nPoints() / 10);
label nHeadPoints = 0;

View file

@ -699,7 +699,7 @@ labelList pistonRefine::selectRefineCells
label nCandidates = returnReduce(count(candidateCell, 1), sumOp<label>());
// Collect all cells
DynamicList<label> candidates(nCells());
dynamicLabelList candidates(nCells());
if (nCandidates < nTotToRefine)
{
@ -775,7 +775,7 @@ labelList pistonRefine::selectUnrefinePoints
// All points that can be unrefined
const labelList splitPoints(meshCutter_.getSplitPoints());
DynamicList<label> newSplitPoints(splitPoints.size());
dynamicLabelList newSplitPoints(splitPoints.size());
forAll(splitPoints, i)
{

View file

@ -20,12 +20,12 @@
const vectorField& areas = Sf().internalField();
DynamicList<label> df;
dynamicLabelList df;
{
label headFaces = 0;
label ndf = 0;
DynamicList<label> headList;
dynamicLabelList headList;
label nHead = 0;
const polyPatch& detachPatch =

View file

@ -296,7 +296,7 @@
nCellZones++;
// valve top points (move all with valve displacement)
DynamicList<label> valvePistonPoints(nPoints() / 10);
dynamicLabelList valvePistonPoints(nPoints() / 10);
List<bool> valvePistonPoint(nPoints(), false);
bool foundOne = false;
@ -396,7 +396,7 @@
nCellZones++;
// valve top points (move all with valve displacement)
DynamicList<label> pistonPoints(nPoints() / 10);
dynamicLabelList pistonPoints(nPoints() / 10);
List<bool> pistonPoint(nPoints(), false);
bool foundOne = false;

View file

@ -51,7 +51,7 @@
nCellZones++;
// valve top points (move all with valve displacement)
DynamicList<label> valveTopPoints(nPoints() / 10);
dynamicLabelList valveTopPoints(nPoints() / 10);
List<bool> valveTopPoint(nPoints(), false);
bool foundOne = false;
@ -169,7 +169,7 @@
// valve bottom points (move all with valve displacement)
DynamicList<label> valveBottomPoints(nPoints() / 10);
dynamicLabelList valveBottomPoints(nPoints() / 10);
List<bool> valveBottomPoint(nPoints(), false);
bool foundOne = false;

View file

@ -477,7 +477,7 @@ bool Foam::pistonSliding::update()
# include "setValveMotionBoundaryConditionPistonSliding.H"
DynamicList<label> constrainedPoints(mSolver.curPoints()().size()/100);
dynamicLabelList constrainedPoints(mSolver.curPoints()().size()/100);
DynamicList<vector> constrainedVelocity
(
mSolver.curPoints()().size()/100

View file

@ -209,7 +209,7 @@ void Foam::simpleTwoStroke::addZonesAndModifiers()
nFaceZones++;
// Points which don't move (= cylinder head)
DynamicList<label> headPoints(nPoints() / 10);
dynamicLabelList headPoints(nPoints() / 10);
label nHeadPoints = 0;
forAll (points(), pointI)

View file

@ -33,13 +33,13 @@
const vectorField& areas = Sf().internalField();
DynamicList<label> df;
dynamicLabelList df;
{
label headFaces = 0;
label ndf = 0;
DynamicList<label> headList;
dynamicLabelList headList;
label nHead = 0;
const polyPatch& detachPatch =
@ -142,13 +142,13 @@
const vectorField& areas = Sf().internalField();
DynamicList<label> df;
dynamicLabelList df;
{
label headFaces = 0;
label ndf = 0;
DynamicList<label> headList;
dynamicLabelList headList;
label nHead = 0;
const polyPatch& detachPatch =

View file

@ -123,7 +123,7 @@
// Points below the piston which moves with the piston displacement
DynamicList<label> pistonPoints(nPoints() / 10);
dynamicLabelList pistonPoints(nPoints() / 10);
forAll (points(), pointI)
{
@ -187,7 +187,7 @@
scalar zPistV = max(boundary()[pistonPatchID].patch().localPoints()).z();
// Points below the piston which moves with the piston displacement
DynamicList<label> pistonPoints(nPoints() / 10);
dynamicLabelList pistonPoints(nPoints() / 10);
forAll (points(), pointI)
{

View file

@ -350,7 +350,7 @@ bool Foam::thoboisMesh::update()
motionU.correctBoundaryConditions();
DynamicList<label> constrainedPoints(mSolver.curPoints()().size()/100);
dynamicLabelList constrainedPoints(mSolver.curPoints()().size()/100);
DynamicList<vector> constrainedVelocity
(
mSolver.curPoints()().size()/100
@ -404,7 +404,7 @@ bool Foam::thoboisMesh::update()
{
# include "setValveMotionBoundaryConditionThobois.H"
# include "setPistonMotionBoundaryConditionThobois.H"
DynamicList<label> constrainedPoints(mSolver.curPoints()().size()/100);
dynamicLabelList constrainedPoints(mSolver.curPoints()().size()/100);
DynamicList<vector> constrainedVelocity
(
mSolver.curPoints()().size()/100

View file

@ -20,12 +20,12 @@
const vectorField& areas = Sf().internalField();
DynamicList<label> df;
dynamicLabelList df;
{
label headFaces = 0;
label ndf = 0;
DynamicList<label> headList;
dynamicLabelList headList;
label nHead = 0;
const polyPatch& detachPatch =

View file

@ -296,7 +296,7 @@
nCellZones++;
// valve top points (move all with valve displacement)
DynamicList<label> valvePistonPoints(nPoints() / 10);
dynamicLabelList valvePistonPoints(nPoints() / 10);
List<bool> valvePistonPoint(nPoints(), false);
bool foundOne = false;
@ -396,7 +396,7 @@
nCellZones++;
// valve top points (move all with valve displacement)
DynamicList<label> pistonPoints(nPoints() / 10);
dynamicLabelList pistonPoints(nPoints() / 10);
List<bool> pistonPoint(nPoints(), false);
bool foundOne = false;

View file

@ -51,7 +51,7 @@
nCellZones++;
// valve top points (move all with valve displacement)
DynamicList<label> valveTopPoints(nPoints() / 10);
dynamicLabelList valveTopPoints(nPoints() / 10);
List<bool> valveTopPoint(nPoints(), false);
bool foundOne = false;
@ -169,7 +169,7 @@
// valve bottom points (move all with valve displacement)
DynamicList<label> valveBottomPoints(nPoints() / 10);
dynamicLabelList valveBottomPoints(nPoints() / 10);
List<bool> valveBottomPoint(nPoints(), false);
bool foundOne = false;

View file

@ -466,7 +466,7 @@ bool Foam::thoboisSliding::update()
# include "setValveMotionBoundaryConditionThoboisSliding.H"
DynamicList<label> constrainedPoints(mSolver.curPoints()().size()/100);
dynamicLabelList constrainedPoints(mSolver.curPoints()().size()/100);
DynamicList<vector> constrainedVelocity
(
mSolver.curPoints()().size()/100

View file

@ -107,7 +107,7 @@ void Foam::twoStrokeEngine::checkMotionFluxes()
sumMeshPhi /= V();
DynamicList<label> checkMeshPhi;
dynamicLabelList checkMeshPhi;
label checkMeshPhiSize = 0;
forAll(calculatedMeshPhi, i)

View file

@ -25,11 +25,11 @@
const vectorField& areas = Sf().internalField();
DynamicList<label> df;
dynamicLabelList df;
{
label ndf = 0;
DynamicList<label> headList;
dynamicLabelList headList;
label nHead = 0;
const polyPatch& detachPatch =

View file

@ -36,7 +36,7 @@ void Foam::extendedUpwindCellToFaceStencil::selectOppositeFaces
const scalar minOpposedness,
const label faceI,
const label cellI,
DynamicList<label>& oppositeFaces
dynamicLabelList& oppositeFaces
) const
{
const vectorField& areas = mesh_.faceAreas();
@ -111,7 +111,7 @@ void Foam::extendedUpwindCellToFaceStencil::transportStencil
const label cellI,
const bool stencilHasNeighbour,
DynamicList<label>& oppositeFaces,
dynamicLabelList& oppositeFaces,
labelHashSet& faceStencilSet,
labelList& transportedStencil
) const
@ -213,7 +213,7 @@ void Foam::extendedUpwindCellToFaceStencil::transportStencils
const labelList& nei = mesh_.faceNeighbour();
// Work arrays
DynamicList<label> oppositeFaces;
dynamicLabelList oppositeFaces;
labelHashSet faceStencilSet;
@ -453,7 +453,7 @@ Foam::extendedUpwindCellToFaceStencil::extendedUpwindCellToFaceStencil
const List<point>& points = stencilPoints[faceI];
const labelList& stencil = ownStencil_[faceI];
DynamicList<label> newStencil(stencil.size());
dynamicLabelList newStencil(stencil.size());
forAll(points, i)
{
if (((points[i]-fc) & fArea) < 0)
@ -482,7 +482,7 @@ Foam::extendedUpwindCellToFaceStencil::extendedUpwindCellToFaceStencil
const List<point>& points = stencilPoints[faceI];
const labelList& stencil = neiStencil_[faceI];
DynamicList<label> newStencil(stencil.size());
dynamicLabelList newStencil(stencil.size());
forAll(points, i)
{
if (((points[i]-fc) & fArea) > 0)
@ -537,8 +537,8 @@ Foam::extendedUpwindCellToFaceStencil::extendedUpwindCellToFaceStencil
const List<point>& points = stencilPoints[faceI];
const labelList& stencil = ownStencil_[faceI];
DynamicList<label> newOwnStencil(stencil.size());
DynamicList<label> newNeiStencil(stencil.size());
dynamicLabelList newOwnStencil(stencil.size());
dynamicLabelList newNeiStencil(stencil.size());
forAll(points, i)
{
if (((points[i]-fc) & fArea) > 0)

View file

@ -85,7 +85,7 @@ class extendedUpwindCellToFaceStencil
const scalar minOpposedness,
const label faceI,
const label cellI,
DynamicList<label>& oppositeFaces
dynamicLabelList& oppositeFaces
) const;
//- Transport (centred) face stencil to 'opposite' face.
@ -98,7 +98,7 @@ class extendedUpwindCellToFaceStencil
const label cellI,
const bool stencilHasNeighbour,
DynamicList<label>& oppositeFaces,
dynamicLabelList& oppositeFaces,
labelHashSet& faceStencilSet,
labelList& transportedStencil
) const;

View file

@ -168,8 +168,8 @@ void Foam::FECCellToFaceStencil::calcFaceStencil
// Do remaining edges by looping over all faces
// Work arrays
DynamicList<label> fEdgesSet;
DynamicList<label> eFacesSet;
dynamicLabelList fEdgesSet;
dynamicLabelList eFacesSet;
labelHashSet faceStencilSet;
for (label faceI = 0; faceI < mesh().nInternalFaces(); faceI++)

View file

@ -124,7 +124,7 @@ void Foam::CFCFaceToCellStencil::calcCellStencil(labelListList& globalCellFaces)
// Determine faces of cellCells in global numbering
// ~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
DynamicList<label> allGlobalFaces(100);
dynamicLabelList allGlobalFaces(100);
globalCellFaces.setSize(mesh().nCells());
forAll(globalCellFaces, cellI)

View file

@ -299,7 +299,7 @@ void Foam::singleCellFvMesh::agglomerateMesh
{
const cellZone& oldFz = mesh.cellZones()[zoneI];
DynamicList<label> newAddressing;
dynamicLabelList newAddressing;
//Note: uncomment if you think it makes sense. Note that value
// of cell0 is the average.
@ -329,7 +329,7 @@ void Foam::singleCellFvMesh::agglomerateMesh
{
const faceZone& oldFz = mesh.faceZones()[zoneI];
DynamicList<label> newAddressing(oldFz.size());
dynamicLabelList newAddressing(oldFz.size());
DynamicList<bool> newFlipMap(oldFz.size());
forAll(oldFz, i)
@ -365,7 +365,7 @@ void Foam::singleCellFvMesh::agglomerateMesh
{
const pointZone& oldFz = mesh.pointZones()[zoneI];
DynamicList<label> newAddressing(oldFz.size());
dynamicLabelList newAddressing(oldFz.size());
forAll(oldFz, i)
{

View file

@ -153,7 +153,7 @@ void Foam::indexedOctree<Type>::divide
labelListList& result
) const
{
List<DynamicList<label> > subIndices(8);
List<dynamicLabelList > subIndices(8);
for (label octant = 0; octant < subIndices.size(); octant++)
{
subIndices[octant].setCapacity(indices.size()/8);

View file

@ -41,7 +41,7 @@ SourceFiles
#define Stack_H
#include "label.H"
#include "DynamicList.H"
#include "dynamicLabelList.H"
#include "multiThreader.H"
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
@ -58,7 +58,7 @@ class Stack
// Private data
//- Internal list
DynamicList<label> stack_;
dynamicLabelList stack_;
//- Mutex for multi-threading
Mutex stackMutex_;

View file

@ -111,11 +111,11 @@ void Foam::Pstream::calcLinearComm(const label nProcs)
void Foam::Pstream::collectReceives
(
const label procID,
const List<DynamicList<label> >& receives,
DynamicList<label>& allReceives
const List<dynamicLabelList >& receives,
dynamicLabelList& allReceives
)
{
const DynamicList<label>& myChildren = receives[procID];
const dynamicLabelList& myChildren = receives[procID];
forAll(myChildren, childI)
{
@ -159,7 +159,7 @@ void Foam::Pstream::calcTreeComm(label nProcs)
nLevels++;
}
List<DynamicList<label> > receives(nProcs);
List<dynamicLabelList > receives(nProcs);
labelList sends(nProcs, -1);
// Info<< "Using " << nLevels << " communication levels" << endl;
@ -190,7 +190,7 @@ void Foam::Pstream::calcTreeComm(label nProcs)
// For all processors find the processors it receives data from
// (and the processors they receive data from etc.)
List<DynamicList<label> > allReceives(nProcs);
List<dynamicLabelList > allReceives(nProcs);
for (label procID = 0; procID < nProcs; procID++)
{
collectReceives(procID, receives, allReceives[procID]);

View file

@ -45,6 +45,7 @@ SourceFiles
#include "HashTable.H"
#include "foamString.H"
#include "NamedEnum.H"
#include "dynamicLabelList.H"
#include "optimisationSwitch.H"
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
@ -185,8 +186,8 @@ private:
static void collectReceives
(
const label procID,
const List<DynamicList<label> >& receives,
DynamicList<label>& allReceives
const dynamicLabelListList& receives,
dynamicLabelList& allReceives
);
//- Initialize all communication schedules. Callback from

View file

@ -1,4 +1,4 @@
/*---------------------------------------------------------------------------* \
/*---------------------------------------------------------------------------*\
========= |
\\ / F ield | foam-extend: Open Source CFD
\\ / O peration | Version: 3.2

View file

@ -1,4 +1,4 @@
/*---------------------------------------------------------------------------* \
/*---------------------------------------------------------------------------*\
========= |
\\ / F ield | foam-extend: Open Source CFD
\\ / O peration | Version: 3.2

View file

@ -150,7 +150,7 @@ void Foam::extendedLduAddressing::calcExtendedLowerUpper() const
// Allocate dynamic lists for extended owner/neighbour, which are later
// used to define ordinary labelLists (extendedLower, extendedUpper)
// Helper type definition
typedef DynamicList<label> DynamicLabelList;
typedef dynamicLabelList DynamicLabelList;
// Get the number of faces
const label nFaces = upperAddr().size();

View file

@ -44,7 +44,7 @@ Description
invoke the correct List\<T\>::transfer(DynamicList\<T\>&) method.
@code
DynamicList<label> dynLst;
dynamicLabelList dynLst;
...
labelList plainLst( xferMoveTo<labelList>(dynLst) );
@endcode
@ -54,7 +54,7 @@ Description
It would thus be simpler (and clearer) just to use the following code:
@code
DynamicList<label> dynLst;
dynamicLabelList dynLst;
...
labelList plainLst(dynLst.xfer());
@endcode
@ -183,7 +183,7 @@ inline Xfer<To> xferCopyTo(const From&);
*
* @par Example Use
* @code
* DynamicList<label> dynLst;
* dynamicLabelList dynLst;
* ...
* labelList plainLst( xferMoveTo<labelList>(dynLst) );
* @endcode

View file

@ -41,7 +41,7 @@ defineTypeNameAndDebug(Foam::commSchedule, 0);
Foam::label Foam::commSchedule::outstandingComms
(
const labelList& commToSchedule,
DynamicList<label>& procComms
dynamicLabelList& procComms
) const
{
label nOutstanding = 0;
@ -70,7 +70,7 @@ Foam::commSchedule::commSchedule
procSchedule_(nProcs)
{
// Determine comms per processor.
List<DynamicList<label> > procToComms(nProcs);
List<dynamicLabelList > procToComms(nProcs);
forAll(comms, commI)
{

View file

@ -50,7 +50,7 @@ SourceFiles
#ifndef commSchedule_H
#define commSchedule_H
#include "DynamicList.H"
#include "dynamicLabelList.H"
#include "labelPair.H"
#include "labelList.H"
@ -77,7 +77,7 @@ class commSchedule
//- Count the number of outstanding communications for a single
// processor
label outstandingComms(const labelList&, DynamicList<label>&) const;
label outstandingComms(const labelList&, dynamicLabelList&) const;
public:

View file

@ -361,8 +361,8 @@ void Foam::globalMeshData::calcSharedEdges() const
nGlobalEdges_ = globalShared.size();
DynamicList<label> dynSharedEdgeLabels(globalShared.size());
DynamicList<label> dynSharedEdgeAddr(globalShared.size());
dynamicLabelList dynSharedEdgeLabels(globalShared.size());
dynamicLabelList dynSharedEdgeAddr(globalShared.size());
for
(

View file

@ -71,8 +71,8 @@ void Foam::globalPoints::addToSend
const label patchPointI,
const procPointList& knownInfo,
DynamicList<label>& patchFaces,
DynamicList<label>& indexInFace,
dynamicLabelList& patchFaces,
dynamicLabelList& indexInFace,
DynamicList<procPointList>& allInfo
)
{
@ -105,7 +105,7 @@ bool Foam::globalPoints::mergeInfo
)
{
// Indices of entries in nbrInfo not yet in myInfo.
DynamicList<label> newInfo(nbrInfo.size());
dynamicLabelList newInfo(nbrInfo.size());
forAll(nbrInfo, i)
{
@ -275,9 +275,9 @@ void Foam::globalPoints::sendPatchPoints(const labelHashSet& changedPoints)
{
// Information to send:
// patch face
DynamicList<label> patchFaces(pp.nPoints());
dynamicLabelList patchFaces(pp.nPoints());
// index in patch face
DynamicList<label> indexInFace(pp.nPoints());
dynamicLabelList indexInFace(pp.nPoints());
// all information I currently hold about this patchPoint
DynamicList<procPointList> allInfo(pp.nPoints());

View file

@ -161,8 +161,8 @@ class globalPoints
const primitivePatch&,
const label patchPointI,
const procPointList&,
DynamicList<label>& patchFaces,
DynamicList<label>& indexInFace,
dynamicLabelList& patchFaces,
dynamicLabelList& indexInFace,
DynamicList<procPointList>& allInfo
);

View file

@ -62,18 +62,18 @@ Foam::overlapGgiPolyPatch::expandData(const Field<Type>& pf) const
Field<Type>& expandField = texpandField();
label nFaces = 0;
for (label copyI = 0; copyI < ncp; copyI++)
{
// Calculate transform
const tensor curRotation =
RodriguesRotation(rotationAxis_, copyI*myAngle);
RodriguesRotation(rotationAxis_, copyI*myAngle);
const label offset = copyI*zone().size();
forAll (pf, faceI)
{
expandField[nFaces] = transform(curRotation, pf[faceI]);
nFaces++;
const label zId = zone().whichFace(start() + faceI);
expandField[offset + zId] = transform(curRotation, pf[faceI]);
}
}

View file

@ -60,7 +60,7 @@ Foam::PatchTools::markZone
while (true)
{
// Pick up neighbours of changedFaces
DynamicList<label> newChangedFaces(2*changedFaces.size());
dynamicLabelList newChangedFaces(2*changedFaces.size());
forAll(changedFaces, i)
{

View file

@ -105,7 +105,7 @@ calcAddressing() const
// faceFaces created using a dynamic list. Cannot guess size because
// of multiple connections
List<DynamicList<label> > ff(locFcs.size());
List<dynamicLabelList > ff(locFcs.size());
faceEdgesPtr_ = new labelListList(locFcs.size());
labelListList& faceEdges = *faceEdgesPtr_;
@ -148,8 +148,8 @@ calcAddressing() const
const edgeList& curEdges = faceIntoEdges[faceI];
// Record the neighbour face. Multiple connectivity allowed
List<DynamicList<label> > neiFaces(curF.size());
List<DynamicList<label> > edgeOfNeiFace(curF.size());
List<dynamicLabelList > neiFaces(curF.size());
List<dynamicLabelList > edgeOfNeiFace(curF.size());
label nNeighbours = 0;
@ -234,8 +234,8 @@ calcAddressing() const
// Set face-edge and face-neighbour-edge to current face label
faceEdges[faceI][nextNei] = nEdges;
DynamicList<label>& cnf = neiFaces[nextNei];
DynamicList<label>& eonf = edgeOfNeiFace[nextNei];
dynamicLabelList& cnf = neiFaces[nextNei];
dynamicLabelList& eonf = edgeOfNeiFace[nextNei];
// Set edge-face addressing
labelList& curEf = edgeFaces[nEdges];

View file

@ -112,7 +112,7 @@ calcEdgeLoops() const
}
// Temporary storage for vertices of current loop
DynamicList<label> loop(nBdryEdges);
dynamicLabelList loop(nBdryEdges);
// Walk from first all the way round, assigning loops
label currentVertI = patchEdges[currentEdgeI].start();

View file

@ -150,7 +150,7 @@ class primitiveMesh
// On-the-fly edge addresing storage
//- Temporary storage for addressing.
mutable DynamicList<label> labels_;
mutable dynamicLabelList labels_;
//- Temporary storage for addressing
mutable labelHashSet labelSet_;
@ -214,7 +214,7 @@ class primitiveMesh
// return (after optional creation) edge between two points
static label getEdge
(
List<DynamicList<label> >&,
List<dynamicLabelList >&,
DynamicList<edge>&,
const label,
const label
@ -687,7 +687,7 @@ public:
const labelList& cellCells
(
const label cellI,
DynamicList<label>&
dynamicLabelList&
) const;
const labelList& cellCells(const label cellI) const;
@ -696,7 +696,7 @@ public:
const labelList& cellPoints
(
const label cellI,
DynamicList<label>&
dynamicLabelList&
) const;
const labelList& cellPoints(const label cellI) const;
@ -705,7 +705,7 @@ public:
const labelList& pointCells
(
const label pointI,
DynamicList<label>&
dynamicLabelList&
) const;
const labelList& pointCells(const label pointI) const;
@ -714,7 +714,7 @@ public:
const labelList& pointPoints
(
const label pointI,
DynamicList<label>&
dynamicLabelList&
) const;
const labelList& pointPoints(const label pointI) const;
@ -723,7 +723,7 @@ public:
const labelList& faceEdges
(
const label faceI,
DynamicList<label>&
dynamicLabelList&
) const;
const labelList& faceEdges(const label faceI) const;
@ -732,7 +732,7 @@ public:
const labelList& edgeFaces
(
const label edgeI,
DynamicList<label>&
dynamicLabelList&
) const;
const labelList& edgeFaces(const label edgeI) const;
@ -741,7 +741,7 @@ public:
const labelList& edgeCells
(
const label edgeI,
DynamicList<label>&
dynamicLabelList&
) const;
const labelList& edgeCells(const label edgeI) const;
@ -750,7 +750,7 @@ public:
const labelList& cellEdges
(
const label cellI,
DynamicList<label>&
dynamicLabelList&
) const;
const labelList& cellEdges(const label cellI) const;

View file

@ -111,7 +111,7 @@ const Foam::labelListList& Foam::primitiveMesh::cellCells() const
const Foam::labelList& Foam::primitiveMesh::cellCells
(
const label cellI,
DynamicList<label>& storage
dynamicLabelList& storage
) const
{
if (hasCellCells())

View file

@ -58,7 +58,7 @@ const Foam::labelListList& Foam::primitiveMesh::cellPoints() const
const Foam::labelList& Foam::primitiveMesh::cellPoints
(
const label cellI,
DynamicList<label>& storage
dynamicLabelList& storage
) const
{
if (hasCellPoints())

View file

@ -58,7 +58,7 @@ const Foam::labelListList& Foam::primitiveMesh::edgeCells() const
const Foam::labelList& Foam::primitiveMesh::edgeCells
(
const label edgeI,
DynamicList<label>& storage
dynamicLabelList& storage
) const
{
if (hasEdgeCells())
@ -71,7 +71,7 @@ const Foam::labelList& Foam::primitiveMesh::edgeCells
const labelList& nei = faceNeighbour();
// Construct edgeFaces
DynamicList<label> eFacesStorage;
dynamicLabelList eFacesStorage;
const labelList& eFaces = edgeFaces(edgeI, eFacesStorage);
storage.clear();

View file

@ -58,7 +58,7 @@ const Foam::labelListList& Foam::primitiveMesh::edgeFaces() const
const Foam::labelList& Foam::primitiveMesh::edgeFaces
(
const label edgeI,
DynamicList<label>& storage
dynamicLabelList& storage
) const
{
if (hasEdgeFaces())

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