Merge branch 'nextRelease' of ssh://git.code.sf.net/p/foam-extend/foam-extend-4.0 into nextRelease

This commit is contained in:
Hrvoje Jasak 2019-04-25 11:09:35 +01:00
commit 84121da55f
164 changed files with 2506 additions and 923 deletions

View file

@ -72,8 +72,15 @@ SourceFiles
namespace Foam namespace Foam
{ {
// Forward declaration of classes
class sixDOFODE; class sixDOFODE;
// Forward declaration of friend functions and operators
class rotationalConstraint;
Ostream& operator<<(Ostream&, const rotationalConstraint&);
/*---------------------------------------------------------------------------*\ /*---------------------------------------------------------------------------*\
Class rotationalConstraint Declaration Class rotationalConstraint Declaration
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/

View file

@ -72,8 +72,15 @@ SourceFiles
namespace Foam namespace Foam
{ {
// Forward declaration of classes
class sixDOFODE; class sixDOFODE;
// Forward declaration of friend functions and operators
class translationalConstraint;
Ostream& operator<<(Ostream&, const translationalConstraint&);
/*---------------------------------------------------------------------------*\ /*---------------------------------------------------------------------------*\
Class translationalConstraint Declaration Class translationalConstraint Declaration
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/

View file

@ -54,8 +54,15 @@ SourceFiles
namespace Foam namespace Foam
{ {
// Forward declaration of classes
class sixDOFODE; class sixDOFODE;
// Forward declaration of friend functions and operators
class combinedRestraint;
Ostream& operator<<(Ostream&, const combinedRestraint&);
/*---------------------------------------------------------------------------*\ /*---------------------------------------------------------------------------*\
Class combinedRestraint Declaration Class combinedRestraint Declaration
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/

View file

@ -54,8 +54,15 @@ SourceFiles
namespace Foam namespace Foam
{ {
// Forward declaration of classes
class sixDOFODE; class sixDOFODE;
// Forward declaration of friend functions and operators
class rotationalRestraint;
Ostream& operator<<(Ostream&, const rotationalRestraint&);
/*---------------------------------------------------------------------------*\ /*---------------------------------------------------------------------------*\
Class rotationalRestraint Declaration Class rotationalRestraint Declaration
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/

View file

@ -54,8 +54,15 @@ SourceFiles
namespace Foam namespace Foam
{ {
// Forward declaration of classes
class sixDOFODE; class sixDOFODE;
// Forward declaration of friend functions and operators
class translationalRestraint;
Ostream& operator<<(Ostream&, const translationalRestraint&);
/*---------------------------------------------------------------------------*\ /*---------------------------------------------------------------------------*\
Class translationalRestraint Declaration Class translationalRestraint Declaration
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/

View file

@ -52,6 +52,12 @@ SourceFiles
namespace Foam namespace Foam
{ {
// Forward declaration of friend functions and operators
class sixDOFqODE;
Ostream& operator<<(Ostream&, const sixDOFqODE&);
/*---------------------------------------------------------------------------*\ /*---------------------------------------------------------------------------*\
Class sixDOFqODE Declaration Class sixDOFqODE Declaration
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/

View file

@ -51,6 +51,12 @@ SourceFiles
namespace Foam namespace Foam
{ {
// Forward declaration of friend functions and operators
class translationODE;
Ostream& operator<<(Ostream&, const translationODE&);
/*---------------------------------------------------------------------------*\ /*---------------------------------------------------------------------------*\
Class translationODE Declaration Class translationODE Declaration
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/

View file

@ -47,6 +47,17 @@ SourceFiles
namespace Foam namespace Foam
{ {
// Forward declaration of classes
class Istream;
class Ostream;
// Forward declaration of friend functions and operators
class memInfo;
Istream& operator>>(Istream&, memInfo&);
Ostream& operator<<(Ostream&, const memInfo&);
/*---------------------------------------------------------------------------*\ /*---------------------------------------------------------------------------*\
Class memInfo Declaration Class memInfo Declaration
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/

View file

@ -261,7 +261,7 @@ Foam::chtRcThermalDiffusivityFvPatchScalarField::calcThermalDiffusivity
const scalarField kOwn = fOwn/(1.0 - p.weights())/mld.magDelta(p.index()); const scalarField kOwn = fOwn/(1.0 - p.weights())/mld.magDelta(p.index());
const scalarField kNei = fNei/p.weights()/mld.magDelta(p.index()); const scalarField kNei = fNei/p.weights()/mld.magDelta(p.index());
tmp<scalarField> kTmp(new scalarField(p.size())); tmp<scalarField> kTmp(new scalarField(p.size()));
scalarField& k = kTmp(); scalarField& k = kTmp();

View file

@ -51,6 +51,13 @@ SourceFiles
namespace Foam namespace Foam
{ {
// Forward declaration of friend functions and operators
class ensightPart;
Ostream& operator<<(Ostream&, const ensightPart&);
ensightGeoFile& operator<<(ensightGeoFile&, const ensightPart&);
/*---------------------------------------------------------------------------*\ /*---------------------------------------------------------------------------*\
Class ensightPart Declaration Class ensightPart Declaration
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/

View file

@ -46,6 +46,12 @@ SourceFiles
namespace Foam namespace Foam
{ {
// Forward declaration of friend functions and operators
class ensightParts;
ensightGeoFile& operator<<(ensightGeoFile&, const ensightParts&);
/*---------------------------------------------------------------------------*\ /*---------------------------------------------------------------------------*\
Class ensightParts Declaration Class ensightParts Declaration
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/

View file

@ -184,6 +184,7 @@ void Foam::domainDecomposition::distributeCells()
{ {
const fvBoundaryMesh& patches = mesh_.boundary(); const fvBoundaryMesh& patches = mesh_.boundary();
// Send cellToProc data
forAll (patches, patchI) forAll (patches, patchI)
{ {
if (isA<processorFvPatch>(patches[patchI])) if (isA<processorFvPatch>(patches[patchI]))
@ -212,7 +213,43 @@ void Foam::domainDecomposition::distributeCells()
cpPatch.internalFieldTransfer cpPatch.internalFieldTransfer
( (
Pstream::blocking, Pstream::blocking,
cellToProc_ cellToProc_ // Dummy argument
);
}
}
// Send face cells for correct ordering of faces in parallel load
// balancing when certain processor faces become internal faces on a
// given processor
forAll (patches, patchI)
{
if (isA<processorFvPatch>(patches[patchI]))
// if (patches[patchI].coupled())
{
const lduInterface& cpPatch =
refCast<const lduInterface>(patches[patchI]);
cpPatch.initTransfer
(
Pstream::blocking,
patches[patchI].faceCells()
);
}
}
forAll (patches, patchI)
{
if (isA<processorFvPatch>(patches[patchI]))
// if (patches[patchI].coupled())
{
const lduInterface& cpPatch =
refCast<const lduInterface>(patches[patchI]);
patchNbrFaceCells_[patchI] =
cpPatch.transfer
(
Pstream::blocking,
patches[patchI].faceCells() // Dummy argument
); );
} }
} }

View file

@ -34,6 +34,7 @@ License
#include "OSspecific.H" #include "OSspecific.H"
#include "Map.H" #include "Map.H"
#include "DynamicList.H" #include "DynamicList.H"
#include "globalMeshData.H"
// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * // // * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
@ -53,8 +54,10 @@ Foam::domainDecomposition::domainDecomposition
nProcs_(readInt(decompositionDict_.lookup("numberOfSubdomains"))), nProcs_(readInt(decompositionDict_.lookup("numberOfSubdomains"))),
distributed_(false), distributed_(false),
gfIndex_(mesh_), gfIndex_(mesh_),
gpIndex_(mesh_),
cellToProc_(mesh_.nCells()), cellToProc_(mesh_.nCells()),
patchNbrCellToProc_(mesh_.boundaryMesh().size()), patchNbrCellToProc_(mesh_.boundaryMesh().size()),
patchNbrFaceCells_(mesh_.boundaryMesh().size()),
procPointAddressing_(nProcs_), procPointAddressing_(nProcs_),
procFaceAddressing_(nProcs_), procFaceAddressing_(nProcs_),
nInternalProcFaces_(nProcs_), nInternalProcFaces_(nProcs_),
@ -122,8 +125,8 @@ Foam::autoPtr<Foam::fvMesh> Foam::domainDecomposition::processorMesh
forAll (curFaceLabels, faceI) forAll (curFaceLabels, faceI)
{ {
// Mark the original face as used // Mark the original face as used
// Remember to decrement the index by one (turning index) // Remember to decrement the index by one (turning index) (see
// HJ, 5/Dec/2001 // procFaceAddressing_ data member comment). HJ, 5/Dec/2001
label curF = mag(curFaceLabels[faceI]) - 1; label curF = mag(curFaceLabels[faceI]) - 1;
faceLookup[curF] = faceI; faceLookup[curF] = faceI;
@ -174,8 +177,8 @@ Foam::autoPtr<Foam::fvMesh> Foam::domainDecomposition::processorMesh
// Note: loop over owner, not all faces: sizes are different // Note: loop over owner, not all faces: sizes are different
forAll (procOwner, faceI) forAll (procOwner, faceI)
{ {
// Remember to decrement the index by one (turning index) // Remember to decrement the index by one (turning index) (see
// HJ, 28/Mar/2009 // procFaceAddressing_ data member comment). HJ, 5/Dec/2001
label curF = mag(curFaceLabels[faceI]) - 1; label curF = mag(curFaceLabels[faceI]) - 1;
if (curFaceLabels[faceI] >= 0) if (curFaceLabels[faceI] >= 0)
@ -193,8 +196,8 @@ Foam::autoPtr<Foam::fvMesh> Foam::domainDecomposition::processorMesh
// Note: loop over neighbour, not all faces: sizes are different // Note: loop over neighbour, not all faces: sizes are different
forAll (procNeighbour, faceI) forAll (procNeighbour, faceI)
{ {
// Remember to decrement the index by one (turning index) // Remember to decrement the index by one (turning index) (see
// HJ, 28/Mar/2009 // procFaceAddressing_ data member comment). HJ, 5/Dec/2001
label curF = mag(curFaceLabels[faceI]) - 1; label curF = mag(curFaceLabels[faceI]) - 1;
if (curFaceLabels[faceI] >= 0) if (curFaceLabels[faceI] >= 0)
@ -285,6 +288,8 @@ Foam::autoPtr<Foam::fvMesh> Foam::domainDecomposition::processorMesh
forAll (patchGlobalIndex, fI) forAll (patchGlobalIndex, fI)
{ {
// Remember to decrement the index by one (turning index) (see
// procFaceAddressing_ data member comment). HJ, 5/Dec/2001
patchGlobalIndex[fI] = patchGlobalIndex[fI] =
globalIndex[mag(curFaceLabels[curPatchStart + fI]) - 1]; globalIndex[mag(curFaceLabels[curPatchStart + fI]) - 1];
} }
@ -503,6 +508,24 @@ Foam::autoPtr<Foam::fvMesh> Foam::domainDecomposition::processorMesh
} }
Foam::labelList Foam::domainDecomposition::globalPointIndex
(
const label procI
) const
{
const labelList& gppi = gpIndex_.globalLabel();
const labelList& ppAddr = procPointAddressing_[procI];
labelList globalPointIndex(ppAddr.size());
forAll (globalPointIndex, gpI)
{
globalPointIndex[gpI] = gppi[ppAddr[gpI]];
}
return globalPointIndex;
}
bool Foam::domainDecomposition::writeDecomposition() bool Foam::domainDecomposition::writeDecomposition()
{ {
Info<< "\nConstructing processor meshes" << endl; Info<< "\nConstructing processor meshes" << endl;

View file

@ -43,6 +43,7 @@ SourceFiles
#include "PtrList.H" #include "PtrList.H"
#include "point.H" #include "point.H"
#include "globalProcFaceIndex.H" #include "globalProcFaceIndex.H"
#include "globalProcPointIndex.H"
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
@ -72,6 +73,9 @@ class domainDecomposition
//- Global face index //- Global face index
globalProcFaceIndex gfIndex_; globalProcFaceIndex gfIndex_;
//- Global face index
globalProcPointIndex gpIndex_;
//- Processor label for each cell //- Processor label for each cell
labelList cellToProc_; labelList cellToProc_;
@ -79,6 +83,11 @@ class domainDecomposition
// Data is used when running decomposition in parallel // Data is used when running decomposition in parallel
labelListList patchNbrCellToProc_; labelListList patchNbrCellToProc_;
//- Face cells for neighbour cell for each processor boundary
// Data is used for correct upper triangular (neighbour list) ordering
// when running decomposition in parallel
labelListList patchNbrFaceCells_;
//- Labels of points for each processor //- Labels of points for each processor
labelListList procPointAddressing_; labelListList procPointAddressing_;
@ -87,9 +96,9 @@ class domainDecomposition
// Only the processor boundary faces are affected: if the sign of the // Only the processor boundary faces are affected: if the sign of the
// index is negative, the processor face is the reverse of the // index is negative, the processor face is the reverse of the
// original face. In order to do this properly, all face // original face. In order to do this properly, all face
// indices will be incremented by 1 and the decremented as // indices will be incremented by 1 and then decremented as
// necessary t avoid the problem of face number zero having no // necessary to avoid the problem of face number zero having no
// sign. HJ, 5/Dec/2001 // sign. HJ, 5/Dec/2001
labelListList procFaceAddressing_; labelListList procFaceAddressing_;
//- Number of internal faces for each processor //- Number of internal faces for each processor
@ -133,12 +142,28 @@ class domainDecomposition
//- Create cell-to processor list using domain decomposition tools //- Create cell-to processor list using domain decomposition tools
void distributeCells(); void distributeCells();
//- Helper function for decomposeMesh. Given two lists of inter processor
// boundaries and inter processor boundary faces, add neighbouring procJ
// to list of the procI. Also adds faceI into the procI list and return
// whether the procJ is already present in the list of visited
// processors (needed for error handling on cyclic patches)
bool addInterProcessorBoundaryData
(
const label& procI,
const label& procJ,
const label faceI,
List<SLList<label> >& interProcBoundaries,
List<SLList<SLList<label> > >& interProcBFaces
) const;
public: public:
// Declare name of the class and its debug switch // Declare name of the class and its debug switch
ClassName("domainDecomposition"); ClassName("domainDecomposition");
// Constructors // Constructors
//- Construct from mesh and dictionary //- Construct from mesh and dictionary
@ -205,6 +230,9 @@ public:
const bool createPassiveProcPatches = false const bool createPassiveProcPatches = false
) const; ) const;
//- Create and return global point index
labelList globalPointIndex(const label procI) const;
//- Return processor point addressing //- Return processor point addressing
const labelListList& procPointAddressing() const const labelListList& procPointAddressing() const
{ {

View file

@ -44,10 +44,10 @@ void Foam::fvFieldReconstructor::reconstructField
) const ) const
{ {
// Get references to internal and boundary field // Get references to internal and boundary field
Field<Type>& iField = reconField.internalField(); Field<Type>& iField = reconField;
typename GeometricField<Type, fvPatchField, volMesh>:: typename GeometricField<Type, fvPatchField, volMesh>::
GeometricBoundaryField& bouField = reconField.boundaryField(); GeometricBoundaryField& bouField = reconField.boundaryFieldNoStoreOldTimes();
forAll (procFields, procI) forAll (procFields, procI)
{ {
@ -143,10 +143,10 @@ void Foam::fvFieldReconstructor::reconstructField
) const ) const
{ {
// Create the internalField // Create the internalField
Field<Type>& iField = reconField.internalField(); Field<Type>& iField = reconField;
typename GeometricField<Type, fvsPatchField, surfaceMesh>:: typename GeometricField<Type, fvsPatchField, surfaceMesh>::
GeometricBoundaryField& bouField = reconField.boundaryField(); GeometricBoundaryField& bouField = reconField.boundaryFieldNoStoreOldTimes();
forAll (procFields, procI) forAll (procFields, procI)
{ {

View file

@ -437,15 +437,13 @@ Foam::processorMeshesReconstructor::reconstructMesh(const Time& db)
} }
} }
// Prepare patch reconstruction // Get first boundary mesh size
HashTable<label, word> patchNameLookup const label firstBndryMeshSize =
( meshes_[firstValidMesh()].boundaryMesh().size();
meshes_[firstValidMesh()].boundaryMesh().size()
); // Prepare patch reconstruction. Note: default key type is word in HashTable
DynamicList<word> patchTypeLookup HashTable<label> patchNameLookup(firstBndryMeshSize);
( DynamicList<word> patchTypeLookup(firstBndryMeshSize);
meshes_[firstValidMesh()].boundaryMesh().size()
);
label nReconPatches = 0; label nReconPatches = 0;
@ -459,35 +457,37 @@ Foam::processorMeshesReconstructor::reconstructMesh(const Time& db)
{ {
if (!isA<processorPolyPatch>(procPatches[patchI])) if (!isA<processorPolyPatch>(procPatches[patchI]))
{ {
const word& patchName = procPatches[patchI].name(); // Regular patch, get the patch and the name
const polyPatch& patch = procPatches[patchI];
const word& patchName = patch.name();
// Regular patch. Try to find it in a list // Insert the pair into the hash table
if (!patchNameLookup.found(patchName)) if (patchNameLookup.insert(patchName, nReconPatches))
{ {
// Patch not found. Add it // This is the first time we're inserting this patch,
patchNameLookup.insert(patchName, nReconPatches); // add its type into the list and increment the counter
patchTypeLookup.append(procPatches[patchI].type()); patchTypeLookup.append(patch.type());
nReconPatches++; ++nReconPatches;
} }
// else already present in the table
} }
} }
} }
} }
// Fill in patch names and types // Fill in patch names
wordList reconPatchNames(patchNameLookup.size()); wordList reconPatchNames(patchNameLookup.size());
wordList reconPatchTypes(patchNameLookup.size());
wordList patchNameToc = patchNameLookup.toc(); // Loop through all the patch names and collect names and types
forAllConstIter(HashTable<label>, patchNameLookup, iter)
forAll (patchNameToc, pnI)
{ {
const label pnIndex = patchNameLookup.find(patchNameToc[pnI])(); reconPatchNames[iter()] = iter.key();
reconPatchNames[pnIndex] = patchNameToc[pnI];
reconPatchTypes[pnIndex] = patchTypeLookup[pnIndex];
} }
// Transfer the contents of the patchTypeLookup dynamic list into the
// ordinary list. Note: the ordering remains the same
const wordList reconPatchTypes(patchTypeLookup.xfer());
// Prepare point, face and patch reconstruction // Prepare point, face and patch reconstruction
label nReconPoints = 0; label nReconPoints = 0;
label nReconFaces = 0; label nReconFaces = 0;
@ -498,30 +498,31 @@ Foam::processorMeshesReconstructor::reconstructMesh(const Time& db)
{ {
if (meshes_.set(procI)) if (meshes_.set(procI))
{ {
// Count total number of points and faces // Get current mesh
nReconPoints += meshes_[procI].nPoints(); const fvMesh& procMesh = meshes_[procI];
nReconFaces += meshes_[procI].allFaces().size();
nReconCells += meshes_[procI].nCells();
const polyBoundaryMesh& procPatches = meshes_[procI].boundaryMesh(); // Count total number of points and faces
nReconPoints += procMesh.nPoints();
nReconFaces += procMesh.allFaces().size();
nReconCells += procMesh.nCells();
const polyBoundaryMesh& procPatches = procMesh.boundaryMesh();
forAll (procPatches, patchI) forAll (procPatches, patchI)
{ {
if (!isA<processorPolyPatch>(procPatches[patchI])) if (!isA<processorPolyPatch>(procPatches[patchI]))
{ {
// Get current patch
const polyPatch& patch = procPatches[patchI];
// Find processor patch index in reconstructed boundary // Find processor patch index in reconstructed boundary
const label pnIndex = patchNameLookup.find const label pnIndex = patchNameLookup.find(patch.name())();
(
procPatches[patchI].name()
)();
// Check patch name and type // Check patch name and type
if if
( (
procPatches[patchI].name() patch.name() != reconPatchNames[pnIndex]
!= reconPatchNames[pnIndex] || patch.type() != reconPatchTypes[pnIndex]
|| procPatches[patchI].type()
!= reconPatchTypes[pnIndex]
) )
{ {
FatalErrorIn FatalErrorIn
@ -530,13 +531,12 @@ Foam::processorMeshesReconstructor::reconstructMesh(const Time& db)
"reconstructMesh(const Time& db)" "reconstructMesh(const Time& db)"
) << "Patch name and type does not match " ) << "Patch name and type does not match "
<< "across processors for patch " << "across processors for patch "
<< procPatches[patchI].name() << " type: " << patch.name() << " type: " << patch.type()
<< procPatches[patchI].type()
<< abort(FatalError); << abort(FatalError);
} }
// Record number of faces in patch // Record number of faces in patch
reconPatchSizes[pnIndex] += procPatches[patchI].size(); reconPatchSizes[pnIndex] += patch.size();
} }
} }
} }
@ -553,10 +553,11 @@ Foam::processorMeshesReconstructor::reconstructMesh(const Time& db)
forAll (reconPatchFaces, patchI) forAll (reconPatchFaces, patchI)
{ {
// Set size of reconstructed patch faces
reconPatchFaces[patchI].setSize(reconPatchSizes[patchI]); reconPatchFaces[patchI].setSize(reconPatchSizes[patchI]);
reconPatchOwner[patchI].setSize(reconPatchSizes[patchI]); // Set size of reconstructed patch face owners with default value of -1
reconPatchOwner[patchI] = -1; reconPatchOwner[patchI].setSize(reconPatchSizes[patchI], -1);
} }
// Size the mapping arrays // Size the mapping arrays
@ -652,10 +653,30 @@ Foam::processorMeshesReconstructor::reconstructMesh(const Time& db)
reconPatchSizes = 0; reconPatchSizes = 0;
// Prepare handling for globally shared points. This is equivalent // HR 21.12.18 : A bit of a hack for the moment in order to support the new
// to parallel processor points, but working on a PtrList of meshes // method (using global point addressing) and old method (syncing across
// on the same processor // processor BCs) of constructing the shared points. The old method is still
sharedPoints sharedData(meshes_); // needed since global point addressing does not exist when the sharedPoint
// object is constructed from reconstructParMesh.
//
// TODO: Unify the methods by constructing global point addressing from the
// mesh pieces when. Or even better, calculate procPointAddressing directly
// which will simplify the mesh merging immensely.
autoPtr<sharedPoints> sharedDataPtr;
if(globalPointIndex_.size())
{
// Determine globally shared points using global point
// adressing
sharedDataPtr.set(new sharedPoints(meshes_, globalPointIndex_));
}
else
{
// Prepare handling for globally shared points. This is equivalent
// to parallel processor points, but working on a PtrList of meshes
// on the same processor
sharedDataPtr.set(new sharedPoints(meshes_));
}
sharedPoints& sharedData = sharedDataPtr();
// Record global point index for shared points // Record global point index for shared points
labelList globalPointMapping(sharedData.nGlobalPoints(), -1); labelList globalPointMapping(sharedData.nGlobalPoints(), -1);
@ -784,7 +805,11 @@ Foam::processorMeshesReconstructor::reconstructMesh(const Time& db)
// Dump first valid mesh without checking // Dump first valid mesh without checking
{ {
const label fvmId = firstValidMesh(); const label fvmId = firstValidMesh();
Pout<< "Dump mesh " << fvmId << endl;
if (debug)
{
Pout<< "Dump mesh " << fvmId << endl;
}
cellOffset[fvmId] = 0; cellOffset[fvmId] = 0;
@ -874,14 +899,14 @@ Foam::processorMeshesReconstructor::reconstructMesh(const Time& db)
} }
} }
// Get sorting order. Note make a copy of indices because // Get sorting order. Note: make a copy of indices because
// sortable list will be deleted // sortable list will be deleted
labelList procVisitOrder = const labelList procVisitOrder =
SortableList<label>(nrbProcIndex).indices(); SortableList<label>(nrbProcIndex).indices();
forAll (procVisitOrder, pvoI) forAll (procVisitOrder, pvoI)
{ {
const label patchI = procVisitOrder[pvoI]; const label& patchI = procVisitOrder[pvoI];
if (isA<processorPolyPatch>(procPatches[patchI])) if (isA<processorPolyPatch>(procPatches[patchI]))
{ {
@ -944,15 +969,14 @@ Foam::processorMeshesReconstructor::reconstructMesh(const Time& db)
forAll (indices, i) forAll (indices, i)
{ {
// Location in reconstructed patch where the face // Location in reconstructed patch where the face is
// is inserted // inserted
const label insertSlot = indices[i]; const label& insertSlot = indices[i];
// Calculate face index depending on the ordering // Calculate face index depending on the ordering
const label faceI = patchStart + i; const label faceI = patchStart + i;
face newFace = curFaces[faceI]; face newFace = curFaces[faceI];
inplaceRenumber(ppAddr, newFace); inplaceRenumber(ppAddr, newFace);
// Insert into correct slot // Insert into correct slot
@ -1015,7 +1039,9 @@ Foam::processorMeshesReconstructor::reconstructMesh(const Time& db)
cpAddr[cellI] = cellI; // + cellOffset[firstValidMesh()]; cpAddr[cellI] = cellI; // + cellOffset[firstValidMesh()];
} }
// Set cell offset for the next mesh // Set cell offset for the next mesh. Note: if the next mesh is not
// valid, the cell offset is propagated to the next one in the processor
// loop below.
if (cellOffset.size() > firstValidMesh() + 1) if (cellOffset.size() > firstValidMesh() + 1)
{ {
cellOffset[firstValidMesh() + 1] = cellOffset[firstValidMesh() + 1] =
@ -1025,14 +1051,25 @@ Foam::processorMeshesReconstructor::reconstructMesh(const Time& db)
// Dump all other meshes, merging the processor boundaries // Dump all other meshes, merging the processor boundaries
for (label procI = firstValidMesh() + 1; procI < meshes_.size(); procI++) for (label procI = firstValidMesh() + 1; procI < meshes_.size(); procI++)
{ {
if (meshes_.set(procI)) if (!meshes_.set(procI))
{ {
Pout<< "Dump mesh " << procI // Next mesh is not valid: simply propagate cell offset
<< " cell offset: " << cellOffset[procI] if (cellOffset.size() > procI + 1)
<< endl; {
cellOffset[procI + 1] = cellOffset[procI];
}
}
else
{
// Valid mesh, combine it
if (debug)
{
Pout<< "Dump mesh " << procI
<< " cell offset: " << cellOffset[procI]
<< endl;
}
const polyMesh& curMesh = meshes_[procI]; const polyMesh& curMesh = meshes_[procI];
const polyBoundaryMesh& procPatches = curMesh.boundaryMesh(); const polyBoundaryMesh& procPatches = curMesh.boundaryMesh();
@ -1170,7 +1207,7 @@ Foam::processorMeshesReconstructor::reconstructMesh(const Time& db)
} }
} // End of "is neighbour" } // End of "is neighbour"
} // End of "is processor" } // End of "is processor"
} } // End for all patches
// Dump unmarked points into the global point list // Dump unmarked points into the global point list
label nMergedPoints = 0; label nMergedPoints = 0;
@ -1274,7 +1311,7 @@ Foam::processorMeshesReconstructor::reconstructMesh(const Time& db)
// Get sorting order. Note make a copy of indices because // Get sorting order. Note make a copy of indices because
// sortable list will be deleted // sortable list will be deleted
labelList procVisitOrder = const labelList procVisitOrder =
SortableList<label>(nrbProcIndex).indices(); SortableList<label>(nrbProcIndex).indices();
forAll (procVisitOrder, pvoI) forAll (procVisitOrder, pvoI)
@ -1347,13 +1384,14 @@ Foam::processorMeshesReconstructor::reconstructMesh(const Time& db)
faceI++ faceI++
) )
{ {
label faceInPatch = faceI - patchStart; const label faceInPatch = faceI - patchStart;
// Calculate master index // Calculate master index
label masterIndex = masterProcPatch.start() const label masterIndex =
+ faceInPatch; masterProcPatch.start() + faceInPatch;
label masterFp = masterFaceAddr[masterIndex] - 1; const label masterFp =
masterFaceAddr[masterIndex] - 1;
// Record face-cells for the neighbour // Record face-cells for the neighbour
fpAddr[faceI] = -masterFaceAddr[masterIndex]; fpAddr[faceI] = -masterFaceAddr[masterIndex];
@ -1470,14 +1508,6 @@ Foam::processorMeshesReconstructor::reconstructMesh(const Time& db)
cellOffset[procI + 1] = cellOffset[procI] + meshes_[procI].nCells(); cellOffset[procI + 1] = cellOffset[procI] + meshes_[procI].nCells();
} }
} }
else
{
// No valid mesh. Propagate cell offset
if (cellOffset.size() > procI + 1)
{
cellOffset[procI + 1] = cellOffset[procI];
}
}
} }
// Resize the lists // Resize the lists
@ -1519,12 +1549,24 @@ Foam::processorMeshesReconstructor::reconstructMesh(const Time& db)
// Mesh assembly completed // Mesh assembly completed
Info<< "Global mesh size (final): " << nl if (!Pstream::parRun())
<< " nPoints = " << reconPoints.size() << nl {
<< " nFaces = " << reconFaces.size() << nl Info<< "Global mesh size (final): " << nl
<< " nCells = " << nReconCells << nl << " nPoints = " << reconPoints.size() << nl
<< " nPatches = " << reconPatchSizes.size() << nl << " nFaces = " << reconFaces.size() << nl
<< " nPatchFaces = " << reconPatchSizes << endl; << " nCells = " << nReconCells << nl
<< " nPatches = " << reconPatchSizes.size() << nl
<< " nPatchFaces = " << reconPatchSizes << endl;
}
else if (debug)
{
Pout<< "Local mesh size (final): " << nl
<< " nPoints = " << reconPoints.size() << nl
<< " nFaces = " << reconFaces.size() << nl
<< " nCells = " << nReconCells << nl
<< " nPatches = " << reconPatchSizes.size() << nl
<< " nPatchFaces = " << reconPatchSizes << endl;
}
// Renumber the face-processor addressing list for all pieces // Renumber the face-processor addressing list for all pieces
// now that the number of internal faces is known // now that the number of internal faces is known

View file

@ -25,6 +25,11 @@ License
#include "processorMeshesReconstructor.H" #include "processorMeshesReconstructor.H"
// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
defineTypeNameAndDebug(Foam::processorMeshesReconstructor, 0);
// * * * * * * * * * * * * * Private Member Functions * * * * * * * * * * * // // * * * * * * * * * * * * * Private Member Functions * * * * * * * * * * * //
void Foam::processorMeshesReconstructor::readMeshes(PtrList<Time>& databases) void Foam::processorMeshesReconstructor::readMeshes(PtrList<Time>& databases)
@ -71,6 +76,7 @@ Foam::processorMeshesReconstructor::processorMeshesReconstructor
: :
meshName_(meshName), meshName_(meshName),
meshes_(), meshes_(),
globalPointIndex_(),
pointProcAddressing_(), pointProcAddressing_(),
faceProcAddressing_(), faceProcAddressing_(),
cellProcAddressing_(), cellProcAddressing_(),
@ -86,6 +92,7 @@ Foam::processorMeshesReconstructor::processorMeshesReconstructor
: :
meshName_(meshName), meshName_(meshName),
meshes_(databases.size()), meshes_(databases.size()),
globalPointIndex_(),
pointProcAddressing_(), pointProcAddressing_(),
faceProcAddressing_(), faceProcAddressing_(),
cellProcAddressing_(), cellProcAddressing_(),

View file

@ -29,8 +29,6 @@ Description
matching processor boundaries and build a single combined mesh by matching processor boundaries and build a single combined mesh by
matching processor patches to each other. matching processor patches to each other.
In order to
Author Author
Hrvoje Jasak, Wikki Ltd. All rights reserved. Hrvoje Jasak, Wikki Ltd. All rights reserved.
@ -72,6 +70,9 @@ class processorMeshesReconstructor
//- List of processor meshes //- List of processor meshes
PtrList<fvMesh> meshes_; PtrList<fvMesh> meshes_;
//- global point index per sub-mesh
labelListList globalPointIndex_;
//- List of processor point addressing lists //- List of processor point addressing lists
PtrList<labelIOList> pointProcAddressing_; PtrList<labelIOList> pointProcAddressing_;
@ -121,6 +122,10 @@ class processorMeshesReconstructor
public: public:
//- Declare name of the class and its debug switch
ClassName("processorMeshesReconstructor");
// Constructors // Constructors
//- Construct given name. Set meshes later //- Construct given name. Set meshes later
@ -161,6 +166,12 @@ public:
return meshes_; return meshes_;
} }
//- Return to global point index
labelListList& globalPointIndex()
{
return globalPointIndex_;
}
//- Return point-processor addressing arrays //- Return point-processor addressing arrays
const PtrList<labelIOList>& pointProcAddressing() const; const PtrList<labelIOList>& pointProcAddressing() const;

View file

@ -451,9 +451,160 @@ void Foam::sharedPoints::calcSharedPoints()
} }
void Foam::sharedPoints::calcSharedPoints
(
const labelListList& globalPointIndex
)
{
typedef HashTable<Pair<label>, label, Hash<label> > markTable;
markTable marker;
List<labelHashSet> procSharedPoints(meshes_.size());
// Mark up points for the first time
forAll (meshes_, meshI)
{
if (meshes_.set(meshI))
{
const labelList& curGlobalPointIndex = globalPointIndex[meshI];
labelHashSet& sharedPoints = procSharedPoints[meshI];
forAll (curGlobalPointIndex, pI)
{
const label gpi = curGlobalPointIndex[pI];
markTable::iterator iter = marker.find(gpi);
if (iter == Map<label>::end())
{
// Record meshI and pI
marker.insert(gpi, Pair<label>(-meshI - 1, pI));
}
else
{
if (iter().first() < 0)
{
if(iter().first() != -meshI - 1)
{
// Shared point detected. Add for both meshes
// Add for first mesh
const label firstMesh = -iter().first() - 1;
const label firstPointI = iter().second();
procSharedPoints[firstMesh].insert(firstPointI);
// Add for current mesh
sharedPoints.insert(pI);
// Count shared points and update bookkeeping
iter().first() = nGlobalPoints_;
nGlobalPoints_++;
}
}
else
{
// Existing shared point. Add for current mesh
sharedPoints.insert(pI);
}
}
}
}
}
forAll (meshes_, meshI)
{
if (meshes_.set(meshI))
{
const labelList& curGlobalPointIndex = globalPointIndex[meshI];
labelList& curSharedPoints = sharedPointLabels_[meshI];
curSharedPoints = procSharedPoints[meshI].toc();
labelList& curSharedAddr = sharedPointAddr_[meshI];
curSharedAddr.setSize(curSharedPoints.size());
forAll(curSharedPoints, i)
{
const label gpi = curSharedPoints[i];
curSharedAddr[i] = marker.find(curGlobalPointIndex[gpi])().first();
}
}
}
// debug
{
pointField gp(nGlobalPoints_);
boolList gpSet(nGlobalPoints_, false);
forAll (meshes_, meshI)
{
if (meshes_.set(meshI))
{
// Get points
const pointField& P = meshes_[meshI].points();
// Get list of local point labels that are globally shared
const labelList& curShared = sharedPointLabels_[meshI];
// Get index in global point list
const labelList& curAddr = sharedPointAddr_[meshI];
// Loop through all local points
forAll (curShared, i)
{
if (!gpSet[curAddr[i]])
{
// Point not set: set it
gp[curAddr[i]] = P[curShared[i]];
gpSet[curAddr[i]] = true;
}
else
{
// Point already set: check location
if (mag(gp[curAddr[i]] - P[curShared[i]]) > SMALL)
{
Info<< "MERGE MISMATCH: mesh" << meshI
<< " point: " << curShared[i]
<< " dist: " << gp[curAddr[i]] << " "
<< P[curShared[i]]
<< endl;
}
}
}
}
}
/*
// Grab marked points
OFstream ppp("points.vtk");
ppp << "# vtk DataFile Version 2.0" << nl
<< "points.vtk" << nl
<< "ASCII" << nl
<< "DATASET POLYDATA" << nl
<< "POINTS " << nGlobalPoints_ << " float" << nl;
Pout << "Global marking " << nGlobalPoints_ << endl;
forAll (gp, i)
{
ppp << float(gp[i].x()) << ' '
<< float(gp[i].y()) << ' '
<< float(gp[i].z())
<< nl;
Pout << gp[i] << endl;
}
*/
}
}
// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
Foam::sharedPoints::sharedPoints(const PtrList<fvMesh>& meshes) Foam::sharedPoints::sharedPoints
(
const PtrList<fvMesh>& meshes
)
: :
meshes_(meshes), meshes_(meshes),
sharedPointAddr_(meshes_.size()), sharedPointAddr_(meshes_.size()),
@ -463,11 +614,19 @@ Foam::sharedPoints::sharedPoints(const PtrList<fvMesh>& meshes)
calcSharedPoints(); calcSharedPoints();
} }
Foam::sharedPoints::sharedPoints
// * * * * * * * * * * * * * * * * Destructor * * * * * * * * * * * * * * * // (
const PtrList<fvMesh>& meshes,
// Foam::sharedPoints::~sharedPoints() const labelListList& globalPointIndex
// {} )
:
meshes_(meshes),
sharedPointAddr_(meshes_.size()),
sharedPointLabels_(meshes_.size()),
nGlobalPoints_(0)
{
calcSharedPoints(globalPointIndex);
}
// ************************************************************************* // // ************************************************************************* //

View file

@ -117,13 +117,26 @@ class sharedPoints
//- Calculate shared points //- Calculate shared points
void calcSharedPoints(); void calcSharedPoints();
//- Calculate shared points
void calcSharedPoints(const labelListList& globalPointIndex);
public: public:
// Constructors // Constructors
//- Construct from the list of meshes //- Construct from the list of meshes
sharedPoints(const PtrList<fvMesh>& meshes); sharedPoints
(
const PtrList<fvMesh>& meshes
);
//- Construct from the list of meshes and global point addressing
sharedPoints
(
const PtrList<fvMesh>& meshes,
const labelListList& globalPointIndex
);
//- Destructor //- Destructor

View file

@ -44,6 +44,12 @@ SourceFiles
namespace Foam namespace Foam
{ {
// Forward declaration of friend functions and operators
class boundaryPatch;
Ostream& operator<<(Ostream&, const boundaryPatch&);
/*---------------------------------------------------------------------------*\ /*---------------------------------------------------------------------------*\
Class boundaryPatch Declaration Class boundaryPatch Declaration
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/

View file

@ -62,6 +62,8 @@ SourceFiles
namespace Foam namespace Foam
{ {
// Forward declaration of classes
class polyPatch; class polyPatch;
class polyMesh; class polyMesh;
class primitiveMesh; class primitiveMesh;
@ -69,6 +71,13 @@ class edge;
class face; class face;
class polyMesh; class polyMesh;
// Forward declaration of friend functions and operators
class directionInfo;
Ostream& operator<<(Ostream&, const directionInfo&);
Istream& operator>>(Istream&, directionInfo&);
/*---------------------------------------------------------------------------*\ /*---------------------------------------------------------------------------*\
Class directionInfo Declaration Class directionInfo Declaration
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/

View file

@ -43,9 +43,16 @@ SourceFiles
namespace Foam namespace Foam
{ {
// Forward declaration of classes
class Istream; class Istream;
class Ostream; class Ostream;
// Forward declaration of friend functions and operators
class refineCell;
Ostream& operator<<(Ostream&, const refineCell&);
/*---------------------------------------------------------------------------*\ /*---------------------------------------------------------------------------*\
Class refineCell Declaration Class refineCell Declaration
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/

View file

@ -51,6 +51,13 @@ namespace Foam
class polyPatch; class polyPatch;
class polyMesh; class polyMesh;
// Forward declaration of friend functions and operators
class wallNormalInfo;
Ostream& operator<<(Ostream&, const wallNormalInfo&);
Istream& operator>>(Istream&, wallNormalInfo&);
/*---------------------------------------------------------------------------*\ /*---------------------------------------------------------------------------*\
Class wallNormalInfo Declaration Class wallNormalInfo Declaration
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/

View file

@ -55,6 +55,12 @@ class polyTopoChanger;
class polyTopoChange; class polyTopoChange;
class mapPolyMesh; class mapPolyMesh;
// Forward declaration of friend functions and operators
class polyMeshModifier;
Ostream& operator<<(Ostream&, const polyMeshModifier&);
/*---------------------------------------------------------------------------*\ /*---------------------------------------------------------------------------*\
Class polyMeshModifier Declaration Class polyMeshModifier Declaration
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/

View file

@ -31,6 +31,7 @@ Author
#include "faceSet.H" #include "faceSet.H"
#include "pointSet.H" #include "pointSet.H"
#include "addToRunTimeSelectionTable.H" #include "addToRunTimeSelectionTable.H"
#include "meshTools.H"
// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * // // * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
@ -2042,7 +2043,16 @@ void Foam::polyhedralRefinement::setCellsToRefine
// layers // layers
for (label i = 0; i < nRefinementBufferLayers_; ++i) for (label i = 0; i < nRefinementBufferLayers_; ++i)
{ {
extendMarkedCellsAcrossFaces(refineCell); meshTools::extendMarkedCellsAcrossFaces(mesh_, refineCell);
}
// Remove all cells that would exceed the maximum refinement level
forAll (refineCell, cellI)
{
if (refineCell[cellI] && (cellLevel_[cellI] + 1 > maxRefinementLevel_))
{
refineCell[cellI] = false;
}
} }
// Remove all cells that would exceed the maximum refinement level // Remove all cells that would exceed the maximum refinement level
@ -2086,6 +2096,12 @@ void Foam::polyhedralRefinement::setCellsToRefine
++nIters; ++nIters;
nTotalAddCells += nAddCells; nTotalAddCells += nAddCells;
if (debug)
{
Info<< "Added " << nAddCells << " cells in iteration "
<< nIters << nl;
}
} while (nAddCells > 0); } while (nAddCells > 0);
Info<< "Added " << nTotalAddCells // nTotalAddCells already reduced Info<< "Added " << nTotalAddCells // nTotalAddCells already reduced
@ -2205,7 +2221,7 @@ void Foam::polyhedralRefinement::setSplitPointsToUnrefine
// Note: if there is no dynamic load balancing, points at the boundary // Note: if there is no dynamic load balancing, points at the boundary
// cannot be split points by definition. However, in dynamic load balancing // cannot be split points by definition. However, in dynamic load balancing
// runs, it is possible that a split point end on processor boundary, in // runs, it is possible that a split point ends on processor boundary, in
// which case we will simply avoid (actually delay) unrefining until this // which case we will simply avoid (actually delay) unrefining until this
// becomes internal point again. VV, 4/Jul/2018. // becomes internal point again. VV, 4/Jul/2018.
const label nInternalFaces = mesh_.nInternalFaces(); const label nInternalFaces = mesh_.nInternalFaces();
@ -2213,7 +2229,7 @@ void Foam::polyhedralRefinement::setSplitPointsToUnrefine
for (label faceI = nInternalFaces; faceI < nFaces; ++faceI) for (label faceI = nInternalFaces; faceI < nFaces; ++faceI)
{ {
// Get the face and make sure that the points are unarked // Get the face and make sure that the points are unmarked
const face& f = meshFaces[faceI]; const face& f = meshFaces[faceI];
forAll (f, fpI) forAll (f, fpI)
@ -2260,7 +2276,7 @@ void Foam::polyhedralRefinement::setSplitPointsToUnrefine
// unrefinement buffer layers // unrefinement buffer layers
for (label i = 0; i < nUnrefinementBufferLayers_; ++i) for (label i = 0; i < nUnrefinementBufferLayers_; ++i)
{ {
extendMarkedCellsAcrossPoints(protectedCell); meshTools::extendMarkedCellsAcrossPoints(mesh_, protectedCell);
} }
// Loop through all cells and if the cell should be protected, protect all // Loop through all cells and if the cell should be protected, protect all
@ -2368,6 +2384,12 @@ void Foam::polyhedralRefinement::setSplitPointsToUnrefine
++nIters; ++nIters;
nTotalRemCells += nRemCells; nTotalRemCells += nRemCells;
if (debug)
{
Info<< "Removed " << nRemCells << " cells in iteration "
<< nIters << nl;
}
} while (nRemCells > 0); } while (nRemCells > 0);
Info<< "Removed " << nTotalRemCells // nTotalRemCells already reduced Info<< "Removed " << nTotalRemCells // nTotalRemCells already reduced

View file

@ -33,6 +33,7 @@ Author
#include "emptyPolyPatch.H" #include "emptyPolyPatch.H"
#include "wedgePolyPatch.H" #include "wedgePolyPatch.H"
#include "addToRunTimeSelectionTable.H" #include "addToRunTimeSelectionTable.H"
#include "meshTools.H"
// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * // // * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
@ -2601,7 +2602,16 @@ void Foam::prismatic2DRefinement::setCellsToRefine
// layers // layers
for (label i = 0; i < nRefinementBufferLayers_; ++i) for (label i = 0; i < nRefinementBufferLayers_; ++i)
{ {
extendMarkedCellsAcrossFaces(refineCell); meshTools::extendMarkedCellsAcrossFaces(mesh_, refineCell);
}
// Remove all cells that exceed the maximum refinement level
forAll (refineCell, cellI)
{
if (refineCell[cellI] && (cellLevel_[cellI] + 1 > maxRefinementLevel_))
{
refineCell[cellI] = false;
}
} }
// Remove all cells that exceed the maximum refinement level // Remove all cells that exceed the maximum refinement level
@ -2695,7 +2705,7 @@ void Foam::prismatic2DRefinement::setSplitPointsToUnrefine
// 1. Has pointLevel_ > 0 (obviously), // 1. Has pointLevel_ > 0 (obviously),
// 2. A point that has the same pointLevel_ as ALL of the points of its // 2. A point that has the same pointLevel_ as ALL of the points of its
// edges. In other words, for each point, we will look through all the // edges. In other words, for each point, we will look through all the
// edges of the point. For each edges, we will visit both points and // edges of the point. For each edge, we will visit both points and
// check point levels. All point levels must be the same for this point // check point levels. All point levels must be the same for this point
// candidate to be a split point. This is quite useful since there is no // candidate to be a split point. This is quite useful since there is no
// need to store the refinement history // need to store the refinement history
@ -2779,11 +2789,14 @@ void Foam::prismatic2DRefinement::setSplitPointsToUnrefine
if (isA<processorPolyPatch>(patch)) if (isA<processorPolyPatch>(patch))
{ {
// Get patch start
const label startIndex = patch.start();
// Loop through all the faces // Loop through all the faces
forAll (patch, i) forAll (patch, i)
{ {
// Get global face index and face // Get global face index and face
const label faceI = patch.size() + i; const label faceI = startIndex + i;
const face& f = meshFaces[faceI]; const face& f = meshFaces[faceI];
// Make sure that we don't split around point at all points of // Make sure that we don't split around point at all points of
@ -2835,7 +2848,7 @@ void Foam::prismatic2DRefinement::setSplitPointsToUnrefine
// unrefinement buffer layers // unrefinement buffer layers
for (label i = 0; i < nUnrefinementBufferLayers_; ++i) for (label i = 0; i < nUnrefinementBufferLayers_; ++i)
{ {
extendMarkedCellsAcrossPoints(protectedCell); meshTools::extendMarkedCellsAcrossPoints(mesh_, protectedCell);
} }
// Loop through all cells and if the cell should be protected, protect all // Loop through all cells and if the cell should be protected, protect all

View file

@ -66,130 +66,6 @@ void Foam::refinement::setInstance(const fileName& inst) const
} }
void Foam::refinement::extendMarkedCellsAcrossFaces
(
boolList& markedCell
) const
{
// Mark all faces for all marked cells
const label nFaces = mesh_.nFaces();
boolList markedFace(nFaces, false);
// Get mesh cells
const cellList& meshCells = mesh_.cells();
// Loop through all cells
forAll (markedCell, cellI)
{
if (markedCell[cellI])
{
// This cell is marked, get its faces
const cell& cFaces = meshCells[cellI];
forAll (cFaces, i)
{
markedFace[cFaces[i]] = true;
}
}
}
// Snyc the face list across processor boundaries
syncTools::syncFaceList(mesh_, markedFace, orEqOp<bool>(), false);
// Get necessary mesh data
const label nInternalFaces = mesh_.nInternalFaces();
const labelList& owner = mesh_.faceOwner();
const labelList& neighbour = mesh_.faceNeighbour();
// Internal faces
for (label faceI = 0; faceI < nInternalFaces; ++faceI)
{
if (markedFace[faceI])
{
// Face is marked, mark both owner and neighbour if the maximum
// refinement level is not exceeded
const label& own = owner[faceI];
const label& nei = neighbour[faceI];
// Mark owner and neighbour cells
markedCell[own] = true;
markedCell[nei] = true;
}
}
// Boundary faces
for (label faceI = nInternalFaces; faceI < nFaces; ++faceI)
{
if (markedFace[faceI])
{
// Face is marked, mark owner if the maximum refinement level is not
// exceeded
const label& own = owner[faceI];
// Mark owner
markedCell[own] = true;
}
}
}
void Foam::refinement::extendMarkedCellsAcrossPoints
(
boolList& markedCell
) const
{
// Mark all points for all marked cells
const label nPoints = mesh_.nPoints();
boolList markedPoint(nPoints, false);
// Get cell points
const labelListList& meshCellPoints = mesh_.cellPoints();
// Loop through all cells
forAll (markedCell, cellI)
{
if (markedCell[cellI])
{
// This cell is marked, get its points
const labelList& cPoints = meshCellPoints[cellI];
forAll (cPoints, i)
{
markedPoint[cPoints[i]] = true;
}
}
}
// Snyc point list across processor boundaries
syncTools::syncPointList
(
mesh_,
markedPoint,
orEqOp<bool>(),
true, // Default value
true // Apply separation for parallel cyclics
);
// Get point cells
const labelListList& meshPointCells = mesh_.pointCells();
// Loop through all points
forAll (markedPoint, pointI)
{
if (markedPoint[pointI])
{
// This point is marked, mark all of its cells
const labelList& pCells = meshPointCells[pointI];
forAll (pCells, i)
{
markedCell[pCells[i]] = true;
}
}
}
}
Foam::label Foam::refinement::addFace Foam::label Foam::refinement::addFace
( (
polyTopoChange& ref, polyTopoChange& ref,
@ -797,7 +673,14 @@ Foam::label Foam::refinement::faceConsistentRefinement
// Note: we are using more stringent 1:1 consistency across coupled // Note: we are using more stringent 1:1 consistency across coupled
// boundaries in order to simplify handling of edge based consistency // boundaries in order to simplify handling of edge based consistency
// checks for parallel runs // checks for parallel runs
if (neiLevel[i] > curOwnLevel) // Bugfix related to PLB: Check whether owner is already marked for
// refinement. Will allow 2:1 consistency across certain processor faces
// where we have a new processor boundary. VV, 23/Jan/2019.
if
(
(neiLevel[i] > curOwnLevel)
&& !cellsToRefine[own]
)
{ {
// Neighbour level is higher than owner level, owner must be // Neighbour level is higher than owner level, owner must be
// marked for refinement // marked for refinement
@ -949,9 +832,11 @@ Foam::label Foam::refinement::faceConsistentUnrefinement
<< "Try increasing nUnrefinementBufferLayers. " << "Try increasing nUnrefinementBufferLayers. "
<< abort(FatalError); << abort(FatalError);
} }
else
cellsToUnrefine[own] = false; {
++nRemCells; cellsToUnrefine[own] = false;
++nRemCells;
}
} }
else if (neiLevel < (ownLevel - 1)) else if (neiLevel < (ownLevel - 1))
{ {
@ -977,9 +862,11 @@ Foam::label Foam::refinement::faceConsistentUnrefinement
<< "Try increasing nUnrefinementBufferLayers. " << "Try increasing nUnrefinementBufferLayers. "
<< abort(FatalError); << abort(FatalError);
} }
else
cellsToUnrefine[nei] = false; {
++nRemCells; cellsToUnrefine[nei] = false;
++nRemCells;
}
} }
} }
@ -1011,7 +898,7 @@ Foam::label Foam::refinement::faceConsistentUnrefinement
// Note: we are using more stringent 1:1 consistency across coupled // Note: we are using more stringent 1:1 consistency across coupled
// boundaries in order to simplify handling of edge based consistency // boundaries in order to simplify handling of edge based consistency
// checkes for parallel runs // checks for parallel runs
if (curOwnLevel < neiLevel[i]) if (curOwnLevel < neiLevel[i])
{ {
// Owner level is smaller than neighbour level, we must not // Owner level is smaller than neighbour level, we must not
@ -1046,7 +933,11 @@ Foam::label Foam::refinement::faceConsistentUnrefinement
<< "This is probably because the refinement and " << "This is probably because the refinement and "
<< "unrefinement regions are very close." << nl << "unrefinement regions are very close." << nl
<< "Try increasing nUnrefinementBufferLayers. " << "Try increasing nUnrefinementBufferLayers. "
<< abort(FatalError); << nl
<< "Another possibility is that you are running "
<< "with Dynamic Load Balancing, in which case "
<< "this should be fine."
<< endl;
} }
} }
else else
@ -1123,26 +1014,31 @@ Foam::label Foam::refinement::edgeConsistentUnrefinement
// unrefinement // unrefinement
if (!cellsToUnrefine[cellI]) if (!cellsToUnrefine[cellI])
{ {
FatalErrorIn if (debug)
( {
"label refinement::" WarningIn
"edgeConsistentUnrefinement" (
"(boolList& cellsToUnrefine)" "label refinement::"
) << "Cell not marked for unrefinement, indicating a" "edgeConsistentUnrefinement"
<< " previous unnoticed problem with unrefinement." "(boolList& cellsToUnrefine)"
<< nl ) << "Cell not marked for unrefinement, indicating a"
<< "cellI: " << cellI << ", cellJ: " << cellJ << " previous unnoticed problem with unrefinement."
<< nl << nl
<< "Level of cellI: " << cellILevel << "cellI: " << cellI << ", cellJ: " << cellJ
<< ", level of cellJ: " << cellJLevel << nl << nl
<< "This is probably because the refinement and " << "Level of cellI: " << cellILevel
<< "unrefinement regions are very close." << nl << ", level of cellJ: " << cellJLevel << nl
<< "Try increasing nUnrefinementBufferLayers. " << "This is probably because the refinement and "
<< abort(FatalError); << "unrefinement regions are very close." << nl
<< "Try increasing nUnrefinementBufferLayers. "
<< endl;
}
}
else
{
cellsToUnrefine[cellI] = false;
++nRemCells;
} }
cellsToUnrefine[cellI] = false;
++nRemCells;
} }
else if (cellJLevel < cellILevel - 1) else if (cellJLevel < cellILevel - 1)
{ {
@ -1153,26 +1049,31 @@ Foam::label Foam::refinement::edgeConsistentUnrefinement
// unrefinement // unrefinement
if (!cellsToUnrefine[cellJ]) if (!cellsToUnrefine[cellJ])
{ {
FatalErrorIn if (debug)
( {
"label refinement::" WarningIn
"edgeConsistentUnrefinement" (
"(boolList& cellsToUnrefine)" "label refinement::"
) << "Cell not marked for unrefinement, indicating a" "edgeConsistentUnrefinement"
<< " previous unnoticed problem with unrefinement." "(boolList& cellsToUnrefine)"
<< nl ) << "Cell not marked for unrefinement, indicating a"
<< "cellI: " << cellI << ", cellJ: " << cellJ << " previous unnoticed problem with unrefinement."
<< nl << nl
<< "Level of cellI: " << cellILevel << "cellI: " << cellI << ", cellJ: " << cellJ
<< ", level of cellJ: " << cellJLevel << nl << nl
<< "This is probably because the refinement and " << "Level of cellI: " << cellILevel
<< "unrefinement regions are very close." << nl << ", level of cellJ: " << cellJLevel << nl
<< "Try increasing nUnrefinementBufferLayers. " << "This is probably because the refinement and "
<< abort(FatalError); << "unrefinement regions are very close." << nl
<< "Try increasing nUnrefinementBufferLayers. "
<< endl;
}
}
else
{
cellsToUnrefine[cellJ] = false;
++nRemCells;
} }
cellsToUnrefine[cellJ] = false;
++nRemCells;
} }
} }
} }
@ -1442,7 +1343,7 @@ void Foam::refinement::setRefinement(polyTopoChange& ref) const
mesh_, mesh_,
pointLevel_, pointLevel_,
maxEqOp<label>(), maxEqOp<label>(),
label(0), // Null value 0, // Null value
true // Apply separation for parallel cyclics true // Apply separation for parallel cyclics
); );
@ -1599,10 +1500,21 @@ void Foam::refinement::updateMesh(const mapPolyMesh& map)
} }
} }
// Note: new point level is going to be synced at processor boundaries just // Sync the new point level. Note: here, we assume that the call to
// before the next step in setRefinement. Need to investigate why the sync // updateMesh happened after polyBoundaryMesh::updateMesh where the
// is not done properly if I put it here. Something is not updated yet. // processor data is fully rebuilt. If this is not the case, the point
// VV, 31/Jan/2018. // level will remain unsynced and will cause all kinds of trouble that
// are extremely difficult to spot. See the change in
// polyTopoChanger::changeMesh order of calling polyMesh::updateMesh and
// polyTopoChanger::update. VV, 19/Feb/2019.
syncTools::syncPointList
(
mesh_,
newPointLevel,
maxEqOp<label>(),
0, // Null value
true // Apply separation for parallel cyclics
);
// Transfer the new point level into the data member // Transfer the new point level into the data member
pointLevel_.transfer(newPointLevel); pointLevel_.transfer(newPointLevel);

View file

@ -159,12 +159,6 @@ protected:
//- Set file instance for cellLevel_ and pointLevel_ //- Set file instance for cellLevel_ and pointLevel_
void setInstance(const fileName& inst) const; void setInstance(const fileName& inst) const;
//- Extend marked cells across faces
void extendMarkedCellsAcrossFaces(boolList& markedCell) const;
//- Extend marked cells across points
void extendMarkedCellsAcrossPoints(boolList& markedCell) const;
// Local topology modification functions (operate on cells/faces) // Local topology modification functions (operate on cells/faces)
@ -189,8 +183,8 @@ protected:
const label nei const label nei
) const; ) const;
//- Modifies existing faceI for either new owner/neighbour or new face //- Modifies existing faceI for either new owner/neighbour or new
// points. Reverses if nessecary // face points. Reverses if nessecary
void modifyFace void modifyFace
( (
polyTopoChange& ref, polyTopoChange& ref,

View file

@ -44,12 +44,17 @@ SourceFiles
namespace Foam namespace Foam
{ {
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // Forward declaration of classes
class polyMesh; class polyMesh;
class mapPolyMesh; class mapPolyMesh;
class polyBoundaryMesh; class polyBoundaryMesh;
// Forward declaration of friend functions and operators
class polyTopoChanger;
Ostream& operator<<(Ostream&, const polyTopoChanger&);
/*---------------------------------------------------------------------------*\ /*---------------------------------------------------------------------------*\
Class polyTopoChanger Declaration Class polyTopoChanger Declaration
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/

View file

@ -2490,10 +2490,17 @@ Foam::autoPtr<Foam::mapPolyMesh> Foam::polyTopoChanger::changeMesh()
topoChangeRequest()() topoChangeRequest()()
); );
update(topoChangeMap()); // Mesh data needs to be updated before the update of polyMeshModifiers
// because polyMeshModifiers might need all the new polyMesh data (see
// below for further comments). VV, 19/Feb/2019
mesh_.updateMesh(topoChangeMap()); mesh_.updateMesh(topoChangeMap());
// Bugfix: call to polyTopoChanger::update must happen after
// polyMesh::updateMesh where all the relevant mesh bits for parallel
// comms are updated. First noticed when the syncying of pointLevel in
// refinement::updateMesh was not syncying properly. VV, 19/Feb/2019
update(topoChangeMap());
// Increment the morph index // Increment the morph index
morphIndex_++; morphIndex_++;

View file

@ -45,9 +45,17 @@ SourceFiles
namespace Foam namespace Foam
{ {
// Forward declaration of classes
class polyPatch; class polyPatch;
class polyMesh; class polyMesh;
// Forward declaration of friend functions and operators
class refinementData;
Ostream& operator<<(Ostream&, const refinementData&);
Istream& operator>>(Istream&, refinementData&);
/*---------------------------------------------------------------------------*\ /*---------------------------------------------------------------------------*\
Class refinementData Declaration Class refinementData Declaration
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/

View file

@ -45,9 +45,17 @@ SourceFiles
namespace Foam namespace Foam
{ {
// Forward declaration of classes
class polyPatch; class polyPatch;
class polyMesh; class polyMesh;
// Forward declaration of friend functions and operators
class refinementDistanceData;
Ostream& operator<<(Ostream&, const refinementDistanceData&);
Istream& operator>>(Istream&, refinementDistanceData&);
/*---------------------------------------------------------------------------*\ /*---------------------------------------------------------------------------*\
Class refinementDistanceData Declaration Class refinementDistanceData Declaration
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/

View file

@ -87,6 +87,14 @@ namespace Foam
// Forward declaration of classes // Forward declaration of classes
class mapPolyMesh; class mapPolyMesh;
class mapDistributePolyMesh; class mapDistributePolyMesh;
class polyMesh;
// Forward declaration of friend functions and operators
class refinementHistory;
Ostream& operator<<(Ostream&, const refinementHistory&);
Istream& operator>>(Istream&, refinementHistory&);
/*---------------------------------------------------------------------------*\ /*---------------------------------------------------------------------------*\
Class refinementHistory Declaration Class refinementHistory Declaration
@ -360,6 +368,10 @@ public:
}; };
Istream& operator>>(Istream&, refinementHistory::splitCell8&);
Ostream& operator<<(Ostream&, const refinementHistory::splitCell8&);
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
} // End namespace Foam } // End namespace Foam

View file

@ -271,15 +271,11 @@ bool Foam::dynamicPolyRefinementFvMesh::update()
( (
refinementSelectionPtr_->refinementCellCandidates()() refinementSelectionPtr_->refinementCellCandidates()()
); );
Pout<< "Selected " << refCandidates.size()
if (debug) << " refinement candidates."
{ << endl;
Pout<< "Selected " << refCandidates.size()
<< " refinement candidates."
<< endl;
}
} }
else if (debug) else
{ {
Pout<< "Skipping refinement for this time-step..." << endl; Pout<< "Skipping refinement for this time-step..." << endl;
} }
@ -301,15 +297,11 @@ bool Foam::dynamicPolyRefinementFvMesh::update()
( (
refinementSelectionPtr_->unrefinementPointCandidates()() refinementSelectionPtr_->unrefinementPointCandidates()()
); );
Pout<< "Selected " << unrefCandidates.size()
if (debug) << " unrefinement candidates."
{ << endl;
Pout<< "Selected " << unrefCandidates.size()
<< " unrefinement candidates."
<< endl;
}
} }
else if (debug) else
{ {
Pout<< "Skipping unrefinement for this time-step..." << endl; Pout<< "Skipping unrefinement for this time-step..." << endl;
} }
@ -352,13 +344,13 @@ bool Foam::dynamicPolyRefinementFvMesh::update()
// some topo changes // some topo changes
if (sizeCellMap) if (sizeCellMap)
{ {
Info<< "Successfully performed polyhedral refinement. " Pout<< "Successfully performed polyhedral refinement. "
<< "Changed from " << nOldCells << " to " << sizeCellMap << "Changed from " << nOldCells << " to " << sizeCellMap
<< " cells." << endl; << " cells." << endl;
} }
else else
{ {
Info<< "Refinement/unrefinement not performed in this time step " Pout<< "Refinement/unrefinement not performed in this time step "
<< "since no cells were selected." << endl; << "since no cells were selected." << endl;
} }
@ -370,9 +362,7 @@ bool Foam::dynamicPolyRefinementFvMesh::update()
// per time step // per time step
curTimeIndex_ = time().timeIndex(); curTimeIndex_ = time().timeIndex();
} }
Pout<< "No refinement/unrefinement" << endl;
Info<< "No refinement/unrefinement" << endl;
// No refinement/unrefinement at this time step. Return false // No refinement/unrefinement at this time step. Return false
return false; return false;
} }

View file

@ -33,6 +33,7 @@ License
#include "addToRunTimeSelectionTable.H" #include "addToRunTimeSelectionTable.H"
#include "cloud.H" #include "cloud.H"
#include "cloudDistribute.H" #include "cloudDistribute.H"
#include "meshObjectBase.H"
#include "IFstream.H" #include "IFstream.H"
#include "OFstream.H" #include "OFstream.H"
@ -107,7 +108,11 @@ bool Foam::topoChangerFvMesh::loadBalance(const dictionary& decompDict)
// Now that each processor has filled in its own part, combine the data // Now that each processor has filled in its own part, combine the data
Pstream::gatherList(migratedCells); Pstream::gatherList(migratedCells);
Pstream::scatterList(migratedCells); Pstream::scatterList(migratedCells);
Info<< "Migrated cells per processor: " << migratedCells << endl;
if (debug)
{
Info<< "Migrated cells per processor: " << migratedCells << endl;
}
// Reading through second index now tells how many cells will arrive // Reading through second index now tells how many cells will arrive
// from which processor // from which processor
@ -141,10 +146,14 @@ bool Foam::topoChangerFvMesh::loadBalance(const dictionary& decompDict)
// Prepare receiving side // Prepare receiving side
// Create the reconstructor // Create the reconstructor
processorMeshesReconstructor meshRecon("reconstructed");
// HR 21.12.18 : Use empty domainname to avoid auto-created of
// fvSchemes/fvSolution
processorMeshesReconstructor meshRecon("");
PtrList<fvMesh>& procMeshes = meshRecon.meshes(); PtrList<fvMesh>& procMeshes = meshRecon.meshes();
procMeshes.setSize(meshDecomp.nProcs()); procMeshes.setSize(meshDecomp.nProcs());
meshRecon.globalPointIndex().setSize(meshDecomp.nProcs());
// Collect local fields for decomposition // Collect local fields for decomposition
clearOut(); clearOut();
@ -245,6 +254,29 @@ bool Foam::topoChangerFvMesh::loadBalance(const dictionary& decompDict)
} }
} }
// HR 14.12.18: Create dummy database pointing into the non-parallel case
// directory and disable the runTimeModifiable switch. dummyTime is used
// for decomposed, received and reconstructed fvMeshes (ie. before its data
// is moved into *this).
//
// The pointing into the non-parallel case directory is somewhat a hack to
// prevent auto-creation of fvSchemes and fvSolution (they exist in the root
// case). This is potentially dangerous if we write anything, but fvMeshes
// derived from this database are NO_WRITE so we should be fine. Making if
// non-runTimeModifiable prevents registration of fvSolution with the
// fileMonitor (addWatch). Not all processors will necessarily receive a
// mesh and watches will then cause dead-locks!
Time dummyTime
(
time().rootPath(),
time().globalCaseName(),
"system",
"constant",
false
);
const_cast<Switch&>(dummyTime.runTimeModifiable()) = false;
for (label procI = 0; procI < meshDecomp.nProcs(); procI++) for (label procI = 0; procI < meshDecomp.nProcs(); procI++)
{ {
// Check if there is a mesh to send // Check if there is a mesh to send
@ -256,8 +288,9 @@ bool Foam::topoChangerFvMesh::loadBalance(const dictionary& decompDict)
autoPtr<fvMesh> procMeshPtr = meshDecomp.processorMesh autoPtr<fvMesh> procMeshPtr = meshDecomp.processorMesh
( (
procI, procI,
time(), dummyTime,
"processorPart" + Foam::name(procI), "", // HR 21.12.18 : Use empty domainname to avoid
// auto-created offvSchemes/fvSolution
true // Create passive processor patches true // Create passive processor patches
); );
fvMesh& procMesh = procMeshPtr(); fvMesh& procMesh = procMeshPtr();
@ -289,6 +322,7 @@ bool Foam::topoChangerFvMesh::loadBalance(const dictionary& decompDict)
// Send the mesh and fields to target processor // Send the mesh and fields to target processor
toProc << procMesh << nl; toProc << procMesh << nl;
toProc << meshDecomp.globalPointIndex(procI) << nl;
// Send fields // Send fields
sendFields(volScalarFields, fieldDecomposer, toProc); sendFields(volScalarFields, fieldDecomposer, toProc);
@ -345,6 +379,9 @@ bool Foam::topoChangerFvMesh::loadBalance(const dictionary& decompDict)
procMeshPtr procMeshPtr
); );
meshRecon.globalPointIndex()[procI] =
meshDecomp.globalPointIndex(procI);
// Set local fields // Set local fields
// Note: first index is field index and second index is procI // Note: first index is field index and second index is procI
insertFields insertFields
@ -413,7 +450,9 @@ bool Foam::topoChangerFvMesh::loadBalance(const dictionary& decompDict)
); );
} }
//HJ Insert clouds missing. HJ, 12/Oct/2018 // HR, 18.11.2018. Distribution of clouds is trivial and is
// treated in Cloud<ParticleType>::split, which is called in
// the constructor of CloudDistribute.
} }
} }
} }
@ -450,9 +489,9 @@ bool Foam::topoChangerFvMesh::loadBalance(const dictionary& decompDict)
( (
IOobject IOobject
( (
"processorPart" + Foam::name(procI), "", // "processorPart" + Foam::name(procI),
time().timeName(), dummyTime.timeName(),
time(), dummyTime,
IOobject::NO_READ, IOobject::NO_READ,
IOobject::NO_WRITE IOobject::NO_WRITE
), ),
@ -461,6 +500,10 @@ bool Foam::topoChangerFvMesh::loadBalance(const dictionary& decompDict)
) )
); );
// Receive the global points addr
labelList gppi(fromProc);
meshRecon.globalPointIndex()[procI] = gppi;
// Receive fields // Receive fields
// Note: first index is field index and second index is procI // Note: first index is field index and second index is procI
receiveFields receiveFields
@ -524,34 +567,40 @@ bool Foam::topoChangerFvMesh::loadBalance(const dictionary& decompDict)
} }
} }
forAll (procMeshes, procI) if (debug)
{ {
if (procMeshes.set(procI)) forAll (procMeshes, procI)
{ {
Pout<< "procMesh " << procI if (procMeshes.set(procI))
<< " points " << procMeshes[procI].nPoints() {
<< " faces: " << procMeshes[procI].nFaces() Pout<< "procMesh " << procI
<< " internal: " << procMeshes[procI].nInternalFaces() << " points " << procMeshes[procI].nPoints()
<< " cells: " << procMeshes[procI].nCells() << " faces: " << procMeshes[procI].nFaces()
<< " patches: " << procMeshes[procI].boundary().size() << " internal: " << procMeshes[procI].nInternalFaces()
<< endl; << " cells: " << procMeshes[procI].nCells()
<< " patches: " << procMeshes[procI].boundary().size()
<< endl;
}
} }
} }
// Create the reconstructed mesh // Create the reconstructed mesh
autoPtr<fvMesh> reconstructedMeshPtr = autoPtr<fvMesh> reconstructedMeshPtr =
meshRecon.reconstructMesh(time()); meshRecon.reconstructMesh(dummyTime);
fvMesh& reconMesh = reconstructedMeshPtr(); fvMesh& reconMesh = reconstructedMeshPtr();
Pout<< "Reconstructed mesh stats: " if (debug)
<< " nCells: " << reconMesh.nCells() {
<< " nFaces: " << reconMesh.nFaces() Pout<< "Reconstructed mesh stats: "
<< " nIntFaces: " << reconMesh.nInternalFaces() << " nCells: " << reconMesh.nCells()
<< " polyPatches: " << " nFaces: " << reconMesh.nFaces()
<< reconMesh.boundaryMesh().size() << " nIntFaces: " << reconMesh.nInternalFaces()
<< " patches: " << " polyPatches: "
<< reconMesh.boundary().size() << reconMesh.boundaryMesh().size()
<< endl; << " patches: "
<< reconMesh.boundary().size()
<< endl;
}
// Apply changes to the local mesh: // Apply changes to the local mesh:
// - refactor the boundary to match new patches. Note: processor // - refactor the boundary to match new patches. Note: processor
@ -920,8 +969,14 @@ bool Foam::topoChangerFvMesh::loadBalance(const dictionary& decompDict)
); );
} }
// Debug: remove? HJ, 22/Oct/2018 // HR 13.12.18: Update the mesh objects
// checkMesh(true); meshObjectBase::allUpdateTopology<polyMesh>(*this, meshMap);
if (debug)
{
Info<< "Checking reconstructed mesh after load balancing..." << endl;
checkMesh(true);
}
return true; return true;
} }

View file

@ -89,7 +89,6 @@ void Foam::topoChangerFvMesh::insertFields
iter iter
) )
{ {
localFields[fI].set localFields[fI].set
( (
Pstream::myProcNo(), Pstream::myProcNo(),
@ -126,7 +125,7 @@ void Foam::topoChangerFvMesh::receiveFields
receivedFields.setSize(nScalarFields); receivedFields.setSize(nScalarFields);
fromProc.readBegin("topoChangerFvMeshReceiveFields"); fromProc.readBegin("topoChangerFvMeshReceiveFields");
forAll (receivedFields, fI) forAll (receivedFields, fI)
{ {
word fieldName(fromProc); word fieldName(fromProc);
@ -181,7 +180,10 @@ void Foam::topoChangerFvMesh::rebuildFields
const PtrList<GeoField>& partFields = receivedFields[fieldI]; const PtrList<GeoField>& partFields = receivedFields[fieldI];
Pout<< "Rebuilding field " << masterField.name() << endl; if (debug)
{
Pout<< "Rebuilding field " << masterField.name() << endl;
}
// Check name match. Note: there may be holes // Check name match. Note: there may be holes
word partName; word partName;
@ -263,15 +265,19 @@ void Foam::topoChangerFvMesh::rebuildFields
// Resize internal field // Resize internal field
if if
( (
masterField.internalField().size() masterField.size()
!= GeoField::GeoMeshType::size(masterField.mesh()) != GeoField::GeoMeshType::size(masterField.mesh())
) )
{ {
Pout<< "Resizing internal field: old size = " if (debug)
<< masterField.internalField().size() {
<< " new size = " Pout<< "Resizing internal field: old size = "
<< GeoField::GeoMeshType::size(masterField.mesh()) << masterField.size()
<< endl; << " new size = "
<< GeoField::GeoMeshType::size(masterField.mesh())
<< endl;
}
masterField.setSize masterField.setSize
( (
GeoField::GeoMeshType::size(masterField.mesh()) GeoField::GeoMeshType::size(masterField.mesh())
@ -280,13 +286,16 @@ void Foam::topoChangerFvMesh::rebuildFields
// Resize boundary (number of patches) // Resize boundary (number of patches)
typename GeoField::GeometricBoundaryField& patchFields = typename GeoField::GeometricBoundaryField& patchFields =
masterField.boundaryField(); masterField.boundaryFieldNoStoreOldTimes();
if (patchFields.size() != masterField.mesh().boundary().size()) if (patchFields.size() != masterField.mesh().boundary().size())
{ {
Pout<< "Resizing boundary field: " if (debug)
{
Pout<< "Resizing boundary field: "
<< masterField.mesh().boundary().size() << masterField.mesh().boundary().size()
<< endl; << endl;
}
patchFields.setSize(masterField.mesh().boundary().size()); patchFields.setSize(masterField.mesh().boundary().size());
} }
@ -297,9 +306,12 @@ void Foam::topoChangerFvMesh::rebuildFields
if (meshMap.resetPatchFlag()[patchI]) if (meshMap.resetPatchFlag()[patchI])
{ {
// Create a new constrained patch field // Create a new constrained patch field
Pout<< "Inserting constrained patch field for patch " if (debug)
<< masterField.mesh().boundary()[patchI].name() {
<< endl; Pout<< "Inserting constrained patch field for patch "
<< masterField.mesh().boundary()[patchI].name()
<< endl;
}
patchFields.set patchFields.set
( (
@ -326,12 +338,15 @@ void Foam::topoChangerFvMesh::rebuildFields
) )
{ {
// Resize patch field // Resize patch field
Pout<< "Resizing patch field for patch " if (debug)
<< masterField.mesh().boundary()[patchI].name() {
<< " old size: " << patchFields[patchI].size() Pout<< "Resizing patch field for patch "
<< " new size: " << masterField.mesh().boundary()[patchI].name()
<< masterField.mesh().boundary()[patchI].size() << " old size: " << patchFields[patchI].size()
<< endl; << " new size: "
<< masterField.mesh().boundary()[patchI].size()
<< endl;
}
// Reset patch field size // Reset patch field size
patchFields[patchI].autoMap patchFields[patchI].autoMap
@ -350,7 +365,27 @@ void Foam::topoChangerFvMesh::rebuildFields
// Increment field counter // Increment field counter
fieldI++; fieldI++;
Pout<< "... done" << endl;
if (debug)
{
Pout<< "... done" << endl;
}
}
// HR 14.12.18: We create new processor boundary faces from internal
// faces. The values on these faces could be initialised by interpolation.
// Instead we choose to fix the values by evaluating the boundaries.
// I tried to execute evaluateCoupled() at the end of
// fvFieldReconstructor::reconstructField, but this fails in a strange way.
forAllConstIter
(
typename HashTable<const GeoField*>,
geoFields,
iter
)
{
GeoField& masterField = const_cast<GeoField&>(*iter());
masterField.boundaryField().evaluateCoupled();
} }
} }

View file

@ -45,6 +45,13 @@ SourceFiles
namespace Foam namespace Foam
{ {
// Forward declaration of friend functions and operators
class edgeMesh;
Ostream& operator<<(Ostream&, const edgeMesh&);
Istream& operator>>(Istream&, edgeMesh&);
/*---------------------------------------------------------------------------*\ /*---------------------------------------------------------------------------*\
Class edgeMesh Declaration Class edgeMesh Declaration
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/

View file

@ -107,16 +107,18 @@ Author
namespace Foam namespace Foam
{ {
// Forward declaration of friend functions and operators // Forward declaration of classes
class equation; class equation;
class equationOperation; class equationOperation;
// Forward declaration of friend functions and operators
// *** Located in equationReaderIO.C *** // *** Located in equationReaderIO.C ***
class equationReader; class equationReader;
Istream& operator>>(Istream&, equationReader&); Istream& operator>>(Istream&, equationReader&);
Ostream& operator<<(Ostream&, const equationReader&); Ostream& operator<<(Ostream&, const equationReader&);
/*---------------------------------------------------------------------------*\ /*---------------------------------------------------------------------------*\
Class equationReader Declaration Class equationReader Declaration
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/

View file

@ -50,7 +50,12 @@ SourceFiles
namespace Foam namespace Foam
{ {
// Forward declaration of friend functions and operators
class faBoundaryMesh; class faBoundaryMesh;
class faPatch;
Ostream& operator<<(Ostream&, const faPatch&);
/*---------------------------------------------------------------------------*\ /*---------------------------------------------------------------------------*\
Class faPatch Declaration Class faPatch Declaration

View file

@ -33,7 +33,12 @@ scalar CoNum = 0.0;
scalar meanCoNum = 0.0; scalar meanCoNum = 0.0;
scalar velMag = 0.0; scalar velMag = 0.0;
if (mesh.nInternalFaces()) // HR 26.06.18: A parallel run has at least two cells and therefore at least
// one internal face in the global mesh. It may be a processor boundary, but
// this is captured by max(mag(phi)).
// Old formulation hangs on parallel cases where one partition is degenerated
// to a single cell.
if (mesh.nInternalFaces() || Pstream::parRun())
{ {
surfaceScalarField phiOverRho = mag(phi)/fvc::interpolate(rho); surfaceScalarField phiOverRho = mag(phi)/fvc::interpolate(rho);
@ -47,6 +52,20 @@ if (mesh.nInternalFaces())
velMag = max(phiOverRho/mesh.magSf()).value(); velMag = max(phiOverRho/mesh.magSf()).value();
} }
else
{
// Single cell mesh: Co is still defined; use cell formulation
const scalar deltaT = runTime.deltaT().value();
const scalar deltaX = Foam::cbrt(mesh.V()[0]);
velMag = mag(U[0]);
CoNum = velMag*deltaT/deltaX;
meanCoNum = CoNum;
}
Info<< "Courant Number mean: " << meanCoNum Info<< "Courant Number mean: " << meanCoNum
<< " max: " << CoNum << " max: " << CoNum

View file

@ -127,7 +127,7 @@ Foam::scalar Foam::getRefCellValue
) )
{ {
scalar refCellValue = (refCelli >= 0 ? field[refCelli] : 0.0); scalar refCellValue = (refCelli >= 0 ? field[refCelli] : 0.0);
return returnReduce<label>(refCellValue, sumOp<scalar>()); return returnReduce<scalar>(refCellValue, sumOp<scalar>());
} }

View file

@ -80,8 +80,15 @@ SourceFiles
namespace Foam namespace Foam
{ {
// Forward declaration of classes
class fvMesh; class fvMesh;
// Forward declaration of friend functions and operators
class porousZone;
Ostream& operator<<(Ostream&, const porousZone&);
/*---------------------------------------------------------------------------*\ /*---------------------------------------------------------------------------*\
Class porousZone Declaration Class porousZone Declaration
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/

View file

@ -662,8 +662,7 @@ void Foam::solutionControl::calcSteadyConsistentFlux
"void solutionControl::calcSteadyConsistentFlux" "void solutionControl::calcSteadyConsistentFlux"
"\n(" "\n("
"\n surfaceScalarField& phi," "\n surfaceScalarField& phi,"
"\n const volVectorField& U," "\n const volVectorField& U"
"\n const volScalarField& rAU"
"\n)" "\n)"
) << "Either aCoeff or faceU is allocated for field " << UName ) << "Either aCoeff or faceU is allocated for field " << UName
<< " while the other is not." << " while the other is not."
@ -684,8 +683,7 @@ void Foam::solutionControl::calcSteadyConsistentFlux
"void solutionControl::calcSteadyConsistentFlux" "void solutionControl::calcSteadyConsistentFlux"
"\n(" "\n("
"\n surfaceScalarField& phi," "\n surfaceScalarField& phi,"
"\n const volVectorField& U," "\n const volVectorField& U"
"\n const volScalarField& rAU"
"\n)" "\n)"
) << "Index is set, but the aCoeff field is not allocated for " ) << "Index is set, but the aCoeff field is not allocated for "
<< UName << "." << nl << UName << "." << nl
@ -701,8 +699,7 @@ void Foam::solutionControl::calcSteadyConsistentFlux
"void solutionControl::calcSteadyConsistentFlux" "void solutionControl::calcSteadyConsistentFlux"
"\n(" "\n("
"\n surfaceScalarField& phi," "\n surfaceScalarField& phi,"
"\n const volVectorField& U," "\n const volVectorField& U"
"\n const volScalarField& rAU"
"\n)" "\n)"
) << "Index is set, but the faceU field is allocated for " ) << "Index is set, but the faceU field is allocated for "
<< UName << "." << nl << UName << "." << nl
@ -794,8 +791,7 @@ void Foam::solutionControl::calcSteadyConsistentFlux
"void solutionControl::calcSteadyConsistentFlux" "void solutionControl::calcSteadyConsistentFlux"
"\n(" "\n("
"\n surfaceScalarField& phi," "\n surfaceScalarField& phi,"
"\n const volVectorField& U," "\n const volVectorField& U"
"\n const volScalarField& rAU"
"\n)" "\n)"
) << "Either aCoeff or faceU is allocated for field " << UName ) << "Either aCoeff or faceU is allocated for field " << UName
<< " while the other is not." << " while the other is not."
@ -816,8 +812,7 @@ void Foam::solutionControl::calcSteadyConsistentFlux
"void solutionControl::calcSteadyConsistentFlux" "void solutionControl::calcSteadyConsistentFlux"
"\n(" "\n("
"\n surfaceScalarField& phi," "\n surfaceScalarField& phi,"
"\n const volVectorField& U," "\n const volVectorField& U"
"\n const volScalarField& rAU"
"\n)" "\n)"
) << "Index is set, but the aCoeff field is not allocated for " ) << "Index is set, but the aCoeff field is not allocated for "
<< UName << "." << nl << UName << "." << nl
@ -833,8 +828,7 @@ void Foam::solutionControl::calcSteadyConsistentFlux
"void solutionControl::calcSteadyConsistentFlux" "void solutionControl::calcSteadyConsistentFlux"
"\n(" "\n("
"\n surfaceScalarField& phi," "\n surfaceScalarField& phi,"
"\n const volVectorField& U," "\n const volVectorField& U"
"\n const volScalarField& rAU"
"\n)" "\n)"
) << "Index is set, but the faceU field is allocated for " ) << "Index is set, but the faceU field is allocated for "
<< UName << "." << nl << UName << "." << nl
@ -928,11 +922,11 @@ void Foam::solutionControl::calcSteadyMRFConsistentFlux
{ {
FatalErrorIn FatalErrorIn
( (
"void solutionControl::calcSteadyConsistentFlux" "void solutionControl::calcSteadyMRFConsistentFlux"
"\n(" "\n("
"\n surfaceScalarField& phi," "\n surfaceScalarField& phi,"
"\n const volVectorField& U," "\n const volVectorField& U,"
"\n const volScalarField& rAU" "\n const MRFZones& mrfZones"
"\n)" "\n)"
) << "Either aCoeff or faceU is allocated for field " << UName ) << "Either aCoeff or faceU is allocated for field " << UName
<< " while the other is not." << " while the other is not."
@ -954,7 +948,7 @@ void Foam::solutionControl::calcSteadyMRFConsistentFlux
"\n(" "\n("
"\n surfaceScalarField& phi," "\n surfaceScalarField& phi,"
"\n const volVectorField& U," "\n const volVectorField& U,"
"\n const volScalarField& rAU" "\n const MRFZones& mrfZones"
"\n)" "\n)"
) << "Index is set, but the aCoeff field is not allocated for " ) << "Index is set, but the aCoeff field is not allocated for "
<< UName << "." << nl << UName << "." << nl
@ -971,7 +965,7 @@ void Foam::solutionControl::calcSteadyMRFConsistentFlux
"\n(" "\n("
"\n surfaceScalarField& phi," "\n surfaceScalarField& phi,"
"\n const volVectorField& U," "\n const volVectorField& U,"
"\n const volScalarField& rAU" "\n const MRFZones& mrfZones"
"\n)" "\n)"
) << "Index is set, but the faceU field is allocated for " ) << "Index is set, but the faceU field is allocated for "
<< UName << "." << nl << UName << "." << nl
@ -1044,10 +1038,10 @@ void Foam::solutionControl::reconstructTransientVelocity
"void solutionControl::reconstructTransientVelocity" "void solutionControl::reconstructTransientVelocity"
"\n(" "\n("
"\n volVectorField& U," "\n volVectorField& U,"
"\n const surfaceScalarField& phi,"
"\n const volVectorField& ddtUEqn," "\n const volVectorField& ddtUEqn,"
"\n const volScalarField& rAU," "\n const volScalarField& rAU,"
"\n const volScalarField& p" "\n const volScalarField& p"
"\n const surfaceScalarField& phi"
"\n) const" "\n) const"
) << "faceU not calculated for field " << UName ) << "faceU not calculated for field " << UName
<< ". Make sure you have called" << ". Make sure you have called"
@ -1110,7 +1104,8 @@ const Foam::surfaceScalarField& Foam::solutionControl::aCoeff
{ {
FatalErrorIn FatalErrorIn
( (
"const surfaceScalarField& solutionControl::aCoeff() const" "const surfaceScalarField& solutionControl::aCoeff"
"(const word& UName) const"
) << "aCoeff not calculated for field " << UName ) << "aCoeff not calculated for field " << UName
<< ". Make sure you have called" << ". Make sure you have called"
<< " calcTransientConsistentFlux(...) or " << " calcTransientConsistentFlux(...) or "

View file

@ -104,6 +104,20 @@ protected:
label corrNonOrtho_; label corrNonOrtho_;
// Fields necessary for time and under-relaxation consistency
//- A coeff (A^~) arising from consistency formulation. Note: we can
// have multiple pressure/velocity systems, hence the PtrList
mutable PtrList<surfaceScalarField> aCoeffPtrs_;
//- Face velocity needed for consistent formulation. Note: we can
// have multiple pressure/velocity systems, hence the PtrList
mutable PtrList<surfaceVectorField> faceUPtrs_;
//- Hash Table containing indices of PtrLists for given names
mutable HashTable<label> indices_;
// Protected Member Functions // Protected Member Functions
//- Read controls from fvSolution dictionary //- Read controls from fvSolution dictionary
@ -194,22 +208,6 @@ protected:
private: private:
// Private data
// Fields necessary for time and under-relaxation consistency
//- A coeff (A^~) arising from consistency formulation. Note: we can
// have multiple pressure/velocity systems, hence the PtrList
mutable PtrList<surfaceScalarField> aCoeffPtrs_;
//- Face velocity needed for consistent formulation. Note: we can
// have multiple pressure/velocity systems, hence the PtrList
mutable PtrList<surfaceVectorField> faceUPtrs_;
//- Hash Table containing indices of PtrLists for given names
mutable HashTable<label> indices_;
// Private member functions // Private member functions
//- Disallow default bitwise copy construct //- Disallow default bitwise copy construct

View file

@ -33,7 +33,7 @@ scalar CoNum = 0.0;
scalar meanCoNum = 0.0; scalar meanCoNum = 0.0;
scalar velMag = 0.0; scalar velMag = 0.0;
// HR 26.06.28: A parallel run has at least two cells and therefore at least // HR 26.06.18: A parallel run has at least two cells and therefore at least
// one internal face in the global mesh. It may be a processor boundary, but // one internal face in the global mesh. It may be a processor boundary, but
// this is captured by max(mag(phi)). // this is captured by max(mag(phi)).
// Old formulation hangs on parallel cases where one partition is degenerated // Old formulation hangs on parallel cases where one partition is degenerated
@ -61,7 +61,11 @@ else
const scalar deltaX = Foam::cbrt(mesh.V()[0]); const scalar deltaX = Foam::cbrt(mesh.V()[0]);
velMag = mag(U[0]); // recover velocity field in a more general way
const volVectorField& URef
= mesh.db().lookupObject<const volVectorField>("U");
velMag = mag(URef[0]);
CoNum = velMag*deltaT/deltaX; CoNum = velMag*deltaT/deltaX;

View file

@ -67,11 +67,11 @@ fixedGradientFvPatchField<Type>::fixedGradientFvPatchField
const dictionary& dict const dictionary& dict
) )
: :
fvPatchField<Type>(p, iF, dict), // HR 15.12.18: Must not call evaluate during construction. Read value
// instead. This is needed for PLB.
fvPatchField<Type>(p, iF, dict, true),
gradient_("gradient", dict, p.size()) gradient_("gradient", dict, p.size())
{ {}
evaluate();
}
template<class Type> template<class Type>

View file

@ -54,13 +54,13 @@ mixedFvPatchField<Type>::mixedFvPatchField
const dictionary& dict const dictionary& dict
) )
: :
fvPatchField<Type>(p, iF, dict), // HR 15.12.18: Must not call evaluate during construction. Read value
// instead. This is needed for PLB.
fvPatchField<Type>(p, iF, dict, true),
refValue_("refValue", dict, p.size()), refValue_("refValue", dict, p.size()),
refGrad_("refGradient", dict, p.size()), refGrad_("refGradient", dict, p.size()),
valueFraction_("valueFraction", dict, p.size()) valueFraction_("valueFraction", dict, p.size())
{ {}
evaluate();
}
template<class Type> template<class Type>

View file

@ -62,7 +62,7 @@ inletOutletFvPatchField<Type>::inletOutletFvPatchField
{ {
// Read patch type // Read patch type
this->readPatchType(dict); this->readPatchType(dict);
this->refValue() = Field<Type>("inletValue", dict, p.size()); this->refValue() = Field<Type>("inletValue", dict, p.size());
if (dict.found("value")) if (dict.found("value"))

View file

@ -70,7 +70,12 @@ Foam::fvSchemes::fvSchemes(const objectRegistry& obr)
"fvSchemes", "fvSchemes",
obr.time().system(), obr.time().system(),
obr, obr,
IOobject::READ_IF_PRESENT_IF_MODIFIED, // Allow default dictionary creation (
obr.readOpt() == IOobject::MUST_READ
|| obr.readOpt() == IOobject::READ_IF_PRESENT
? IOobject::MUST_READ_IF_MODIFIED
: obr.readOpt()
),
IOobject::NO_WRITE IOobject::NO_WRITE
) )
), ),
@ -168,21 +173,17 @@ Foam::fvSchemes::fvSchemes(const objectRegistry& obr)
fluxRequired_(), // Do not read flux required option fluxRequired_(), // Do not read flux required option
defaultFluxRequired_(false) defaultFluxRequired_(false)
{ {
if (!headerOk()) // HR 21.12.18 : Writing a default fvSchemes is not useful in PLB. Please
// specify MUST_READ on obr if you need this.
if
(
readOpt() == IOobject::MUST_READ
|| readOpt() == IOobject::MUST_READ_IF_MODIFIED
|| (readOpt() == IOobject::READ_IF_PRESENT && headerOk())
)
{ {
if (debug) read();
{
InfoIn
(
"fvSchemes::fvSchemes(const objectRegistry& obr)"
) << "fvSchemes dictionary not found. Creating default."
<< endl;
}
regIOobject::write();
} }
read();
} }

View file

@ -424,6 +424,9 @@ void Foam::fvMesh::resetFvPrimitives
// Reset fvPatches HJ, 16/Apr/2018 // Reset fvPatches HJ, 16/Apr/2018
boundary_.resetFvPatches(resetFvPatchFlag); boundary_.resetFvPatches(resetFvPatchFlag);
// HR 14.12.18: Indicate that the mesh is changing to e.g. nearWallDist
polyMesh::changing(true);
// Clear all mesh data // Clear all mesh data
clearOut(); clearOut();
} }

View file

@ -84,7 +84,7 @@ void Foam::nearWallDist::correct()
{ {
setSize(mesh_.boundary().size()); setSize(mesh_.boundary().size());
} }
// Update size of GeometricBoundaryField // Update size of GeometricBoundaryField
forAll (mesh_.boundary(), patchI) forAll (mesh_.boundary(), patchI)
{ {

View file

@ -447,6 +447,7 @@ $(globalMeshData)/globalMeshData.C
$(globalMeshData)/globalPoints.C $(globalMeshData)/globalPoints.C
$(globalMeshData)/globalIndex.C $(globalMeshData)/globalIndex.C
$(globalMeshData)/globalProcFaceIndex.C $(globalMeshData)/globalProcFaceIndex.C
$(globalMeshData)/globalProcPointIndex.C
$(polyMesh)/syncTools/syncTools.C $(polyMesh)/syncTools/syncTools.C

View file

@ -51,8 +51,15 @@ SourceFiles
namespace Foam namespace Foam
{ {
// Forward declaration of friend functions and operators
template<class Type> class octree; template<class Type> class octree;
// Forward declaration of friend functions and operators
class octreeDataPoint;
Ostream& operator<<(Ostream&, const octreeDataPoint&);
/*---------------------------------------------------------------------------*\ /*---------------------------------------------------------------------------*\
Class octreeDataPoint Declaration Class octreeDataPoint Declaration
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/

View file

@ -66,8 +66,19 @@ SourceFiles
namespace Foam namespace Foam
{ {
// Forward declaration of classes
class Random; class Random;
// Forward declaration of friend functions and operators
class treeBoundBox;
bool operator==(const treeBoundBox&, const treeBoundBox&);
bool operator!=(const treeBoundBox&, const treeBoundBox&);
Istream& operator>>(Istream& is, treeBoundBox&);
Ostream& operator<<(Ostream& os, const treeBoundBox&);
/*---------------------------------------------------------------------------*\ /*---------------------------------------------------------------------------*\
Class treeBoundBox Declaration Class treeBoundBox Declaration
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/

View file

@ -50,13 +50,14 @@ SourceFiles
namespace Foam namespace Foam
{ {
// Forward declaration of classes
class treeBoundBox; class treeBoundBox;
class Ostream; class Ostream;
template<class Type> class octree; template<class Type> class octree;
template<class Type> class treeLeaf;
// Forward declaration of friend functions and operators // Forward declaration of friend functions and operators
template<class Type> class treeLeaf;
template<class Type> Istream& operator>>(Istream&, treeLeaf<Type>&); template<class Type> Istream& operator>>(Istream&, treeLeaf<Type>&);
template<class Type> Ostream& operator<<(Ostream&, const treeLeaf<Type>&); template<class Type> Ostream& operator<<(Ostream&, const treeLeaf<Type>&);

View file

@ -58,12 +58,12 @@ namespace Foam
{ {
// class intersection; // class intersection;
template<class Type> class octree; template<class Type> class octree;
template<class Type> class treeLeaf; template<class Type> class treeLeaf;
template<class Type> class treeNode;
// Forward declaration of friend functions and operators // Forward declaration of friend functions and operators
template<class Type> class treeNode;
template<class Type> Istream& operator>>(Istream&, treeNode<Type>&); template<class Type> Istream& operator>>(Istream&, treeNode<Type>&);
template<class Type> Ostream& operator<<(Ostream&, const treeNode<Type>&); template<class Type> Ostream& operator<<(Ostream&, const treeNode<Type>&);

View file

@ -43,6 +43,7 @@ SourceFiles
namespace Foam namespace Foam
{ {
// Forward declaration of classes
class Istream; class Istream;
class Ostream; class Ostream;

View file

@ -55,10 +55,11 @@ SourceFiles
namespace Foam namespace Foam
{ {
// Forward declaration of friend functions and operators // Forward declaration of classes
template<class T> class List; template<class T> class List;
template<class T> class UList; template<class T> class UList;
// Forward declaration of friend functions and operators
template<class T, class Key, class Hash> class HashTable; template<class T, class Key, class Hash> class HashTable;
template<class T, class Key, class Hash> class HashPtrTable; template<class T, class Key, class Hash> class HashPtrTable;

View file

@ -53,9 +53,10 @@ SourceFiles
namespace Foam namespace Foam
{ {
// Forward declaration of friend functions and operators // Forward declaration of classes
template<class T> class List; template<class T> class List;
// Forward declaration of friend functions and operators
template<class T, class Key, class Hash> class StaticHashTable; template<class T, class Key, class Hash> class StaticHashTable;
template<class T, class Key, class Hash> Istream& operator>> template<class T, class Key, class Hash> Istream& operator>>

View file

@ -43,6 +43,7 @@ SourceFiles
namespace Foam namespace Foam
{ {
// Forward declaration of classes
class Istream; class Istream;
class Ostream; class Ostream;

View file

@ -44,6 +44,7 @@ SourceFiles
namespace Foam namespace Foam
{ {
// Forward declaration of classes
class Istream; class Istream;
class Ostream; class Ostream;

View file

@ -44,6 +44,7 @@ SourceFiles
namespace Foam namespace Foam
{ {
// Forward declaration of classes
class Ostream; class Ostream;
// Forward declaration of friend functions and operators // Forward declaration of friend functions and operators

View file

@ -49,8 +49,12 @@ SourceFiles
namespace Foam namespace Foam
{ {
// Forward declaration of friend functions and operators // Forward declaration of classes
template<class T> class UList;
template<class T> class SLList;
// Forward declaration of friend functions and operators
template<class T, unsigned Size> class FixedList; template<class T, unsigned Size> class FixedList;
template<class T, unsigned Size> template<class T, unsigned Size>
@ -59,9 +63,6 @@ Istream& operator>>(Istream&, FixedList<T, Size>&);
template<class T, unsigned Size> template<class T, unsigned Size>
Ostream& operator<<(Ostream&, const FixedList<T, Size>&); Ostream& operator<<(Ostream&, const FixedList<T, Size>&);
template<class T> class UList;
template<class T> class SLList;
/*---------------------------------------------------------------------------*\ /*---------------------------------------------------------------------------*\
Class FixedList Declaration Class FixedList Declaration

View file

@ -143,9 +143,16 @@ SourceFiles
namespace Foam namespace Foam
{ {
// Forward declaration of friend functions and operators // Forward declaration of classes
class boundBox; class boundBox;
// Forward declaration of friend functions and operators
class coordinateSystem;
bool operator!=(const coordinateSystem&, const coordinateSystem&);
Ostream& operator<<(Ostream&, const coordinateSystem&);
/*---------------------------------------------------------------------------*\ /*---------------------------------------------------------------------------*\
Class coordinateSystem Declaration Class coordinateSystem Declaration
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/

View file

@ -47,6 +47,7 @@ SourceFiles
namespace Foam namespace Foam
{ {
// Forward declaration of classes
class Istream; class Istream;
class Ostream; class Ostream;
@ -64,6 +65,7 @@ template<class T, class BaseType> Ostream& operator<<
const CompactIOList<T, BaseType>& const CompactIOList<T, BaseType>&
); );
/*---------------------------------------------------------------------------*\ /*---------------------------------------------------------------------------*\
Class CompactIOList Declaration Class CompactIOList Declaration
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/

View file

@ -65,14 +65,17 @@ SourceFiles
namespace Foam namespace Foam
{ {
// Forward declaration of friend functions and operators // Forward declaration of classes
class regExp; class regExp;
class dictionary;
class SHA1Digest; class SHA1Digest;
// Forward declaration of friend functions and operators
class dictionary;
Istream& operator>>(Istream&, dictionary&); Istream& operator>>(Istream&, dictionary&);
Ostream& operator<<(Ostream&, const dictionary&); Ostream& operator<<(Ostream&, const dictionary&);
/*---------------------------------------------------------------------------*\ /*---------------------------------------------------------------------------*\
Class dictionaryName Declaration Class dictionaryName Declaration
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/

View file

@ -51,6 +51,12 @@ SourceFiles
namespace Foam namespace Foam
{ {
// Forward declaration of friend functions and operators
class dictionaryEntry;
Ostream& operator<<(Ostream&, const dictionaryEntry&);
/*---------------------------------------------------------------------------*\ /*---------------------------------------------------------------------------*\
Class dictionaryEntry Declaration Class dictionaryEntry Declaration
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/

View file

@ -45,8 +45,10 @@ SourceFiles
namespace Foam namespace Foam
{ {
// Forward declaration of friend functions and operators // Forward declaration of classes
class dictionary;
// Forward declaration of friend functions and operators
template<class Type> class dimensioned; template<class Type> class dimensioned;
template<class Type> template<class Type>
@ -55,7 +57,6 @@ Istream& operator>>(Istream&, dimensioned<Type>&);
template<class Type> template<class Type>
Ostream& operator<<(Ostream&, const dimensioned<Type>&); Ostream& operator<<(Ostream&, const dimensioned<Type>&);
class dictionary;
/*---------------------------------------------------------------------------*\ /*---------------------------------------------------------------------------*\
Class dimensioned Declaration Class dimensioned Declaration

View file

@ -47,6 +47,16 @@ SourceFiles
namespace Foam namespace Foam
{ {
// Forward declaration of friend functions and operators
Ostream& operator<<(Ostream&, const CoeffField<diagTensor>&);
Ostream& operator<<(Ostream&, const tmp<CoeffField<diagTensor> >&);
/*---------------------------------------------------------------------------*\
Class symmTensor4thOrderCoeffField Declaration
\*---------------------------------------------------------------------------*/
template<> template<>
class CoeffField<diagTensor> class CoeffField<diagTensor>
: :

View file

@ -45,6 +45,16 @@ SourceFiles
namespace Foam namespace Foam
{ {
// Forward declaration of friend functions and operators
Ostream& operator<<(Ostream&, const CoeffField<scalar>&);
Ostream& operator<<(Ostream&, const tmp<CoeffField<scalar> >&);
/*---------------------------------------------------------------------------*\
Class scalarCoeffField Declaration
\*---------------------------------------------------------------------------*/
template<> template<>
class CoeffField<scalar> class CoeffField<scalar>
: :

View file

@ -47,6 +47,16 @@ SourceFiles
namespace Foam namespace Foam
{ {
// Forward declaration of friend functions and operators
Ostream& operator<<(Ostream&, const CoeffField<sphericalTensor>&);
Ostream& operator<<(Ostream&, const tmp<CoeffField<sphericalTensor> >&);
/*---------------------------------------------------------------------------*\
Class sphericalTensorCoeffField Declaration
\*---------------------------------------------------------------------------*/
template<> template<>
class CoeffField<sphericalTensor> class CoeffField<sphericalTensor>
: :

View file

@ -47,6 +47,16 @@ SourceFiles
namespace Foam namespace Foam
{ {
// Forward declaration of friend functions and operators
Ostream& operator<<(Ostream&, const CoeffField<symmTensor4thOrder>&);
Ostream& operator<<(Ostream&, const tmp<CoeffField<symmTensor4thOrder> >&);
/*---------------------------------------------------------------------------*\
Class symmTensor4thOrderCoeffField Declaration
\*---------------------------------------------------------------------------*/
template<> template<>
class CoeffField<symmTensor4thOrder> class CoeffField<symmTensor4thOrder>
: :

View file

@ -47,6 +47,16 @@ SourceFiles
namespace Foam namespace Foam
{ {
// Forward declaration of friend functions and operators
Ostream& operator<<(Ostream&, const CoeffField<symmTensor>&);
Ostream& operator<<(Ostream&, const tmp<CoeffField<symmTensor> >&);
/*---------------------------------------------------------------------------*\
Class symmTensorCoeffField Declaration
\*---------------------------------------------------------------------------*/
template<> template<>
class CoeffField<symmTensor> class CoeffField<symmTensor>
: :

View file

@ -47,6 +47,16 @@ SourceFiles
namespace Foam namespace Foam
{ {
// Forward declaration of friend functions and operators
Ostream& operator<<(Ostream&, const CoeffField<tensor>&);
Ostream& operator<<(Ostream&, const tmp<CoeffField<tensor> >&);
/*---------------------------------------------------------------------------*\
Class tensorCoeffField Declaration
\*---------------------------------------------------------------------------*/
template<> template<>
class CoeffField<tensor> class CoeffField<tensor>
: :

View file

@ -728,6 +728,16 @@ Foam::GeometricField<Type, PatchField, GeoMesh>::boundaryField()
} }
// Return reference to GeometricBoundaryField
template<class Type, template<class> class PatchField, class GeoMesh>
typename
Foam::GeometricField<Type, PatchField, GeoMesh>::GeometricBoundaryField&
Foam::GeometricField<Type, PatchField, GeoMesh>::boundaryFieldNoStoreOldTimes()
{
return boundaryField_;
}
// Store old-time field // Store old-time field
template<class Type, template<class> class PatchField, class GeoMesh> template<class Type, template<class> class PatchField, class GeoMesh>
void Foam::GeometricField<Type, PatchField, GeoMesh>::storeOldTimes() const void Foam::GeometricField<Type, PatchField, GeoMesh>::storeOldTimes() const

View file

@ -51,6 +51,7 @@ SourceFiles
namespace Foam namespace Foam
{ {
// Forward declaration of classes
class dictionary; class dictionary;
// Forward declaration of friend functions and operators // Forward declaration of friend functions and operators
@ -447,6 +448,10 @@ public:
//- Return reference to GeometricBoundaryField for const field //- Return reference to GeometricBoundaryField for const field
inline const GeometricBoundaryField& boundaryField() const; inline const GeometricBoundaryField& boundaryField() const;
//- Return reference to GeometricBoundaryField without storing old
//- times
GeometricBoundaryField& boundaryFieldNoStoreOldTimes();
//- Return the time index of the field //- Return the time index of the field
inline label timeIndex() const; inline label timeIndex() const;

View file

@ -64,6 +64,13 @@ Foam::autoPtr<Foam::cloudDistribute> Foam::cloud::cloudDist
} }
Foam::labelList Foam::cloud::nParticlesPerCell() const
{
NotImplemented;
return labelList(0);
}
// * * * * * * * * * * * * * * * * Destructor * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * Destructor * * * * * * * * * * * * * * * //
Foam::cloud::~cloud() Foam::cloud::~cloud()

View file

@ -101,7 +101,9 @@ public:
//- Return size of the cloud //- Return size of the cloud
virtual label size() const; virtual label size() const;
//- Count and return number of particles per cell
virtual labelList nParticlesPerCell() const;
// Edit // Edit
//- Remap the cells of particles corresponding to the //- Remap the cells of particles corresponding to the

View file

@ -43,8 +43,15 @@ SourceFiles
namespace Foam namespace Foam
{ {
// Forward declaration of classes
class lduInterfaceField; class lduInterfaceField;
// Forward declaration of friend functions and operators
class procLduInterface;
Ostream& operator<<(Ostream&, const procLduInterface&);
/*---------------------------------------------------------------------------*\ /*---------------------------------------------------------------------------*\
Class procLduInterface Declaration Class procLduInterface Declaration
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/

View file

@ -45,6 +45,7 @@ SourceFiles
namespace Foam namespace Foam
{ {
// Forward declaration of classes
class procLduInterface; class procLduInterface;
class lduMatrix; class lduMatrix;

View file

@ -46,6 +46,12 @@ SourceFiles
namespace Foam namespace Foam
{ {
// Forward declaration of friend functions and operators
class crAddressing;
Ostream& operator<<(Ostream&, const crAddressing&);
/*---------------------------------------------------------------------------*\ /*---------------------------------------------------------------------------*\
Class crAddressing Declaration Class crAddressing Declaration
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/

View file

@ -46,6 +46,12 @@ SourceFiles
namespace Foam namespace Foam
{ {
// Forward declaration of friend functions and operators
class crMatrix;
Ostream& operator<<(Ostream&, const crMatrix&);
/*---------------------------------------------------------------------------*\ /*---------------------------------------------------------------------------*\
Class crMatrix Declaration Class crMatrix Declaration
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/

View file

@ -59,7 +59,7 @@ Foam::autoPtr<Foam::crMatrix> Foam::lduInterface::prolongationTransfer
); );
// Dummy return to make the compiler happy // Dummy return to make the compiler happy
return autoPtr<crMatrix>(NULL); return autoPtr<crMatrix>(nullptr);
} }

View file

@ -40,11 +40,11 @@ namespace Foam
{ {
// Forward declaration of friend functions and operators // Forward declaration of friend functions and operators
class boundBox; class boundBox;
template<class T> class tmp; template<class T> class tmp;
Ostream& operator<<(Ostream& os, const boundBox& b); Istream& operator>>(Istream& is, boundBox&);
Ostream& operator<<(Ostream& os, const boundBox&);
/*---------------------------------------------------------------------------*\ /*---------------------------------------------------------------------------*\

View file

@ -57,18 +57,20 @@ SourceFiles
namespace Foam namespace Foam
{ {
// Forward declaration of friend functions and operators // Forward declaration of classes
class face;
class triFace; class triFace;
template<class T, unsigned SizeInc, unsigned SizeMult, unsigned SizeDiv> template<class T, unsigned SizeInc, unsigned SizeMult, unsigned SizeDiv>
class DynamicList; class DynamicList;
// Forward declaration of friend functions and operators
class face;
inline bool operator==(const face& a, const face& b); inline bool operator==(const face& a, const face& b);
inline bool operator!=(const face& a, const face& b); inline bool operator!=(const face& a, const face& b);
inline Istream& operator>>(Istream&, face&); inline Istream& operator>>(Istream&, face&);
/*---------------------------------------------------------------------------*\ /*---------------------------------------------------------------------------*\
Class face Declaration Class face Declaration
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/

View file

@ -53,11 +53,12 @@ SourceFiles
namespace Foam namespace Foam
{ {
// Forward declaration of classes
class face; class face;
// Forward declaration of friend functions and operators // Forward declaration of friend functions and operators
class triFace; class triFace;
inline bool operator==(const triFace&, const triFace&); inline bool operator==(const triFace&, const triFace&);
inline bool operator!=(const triFace&, const triFace&); inline bool operator!=(const triFace&, const triFace&);

View file

@ -27,6 +27,7 @@ License
#include "polyMesh.H" #include "polyMesh.H"
#include "hexMatcher.H" #include "hexMatcher.H"
#include "faceZone.H" #include "faceZone.H"
#include "syncTools.H"
// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * //
@ -927,4 +928,128 @@ void Foam::meshTools::setFaceInfo
} }
void Foam::meshTools::extendMarkedCellsAcrossFaces
(
const polyMesh& mesh,
boolList& markedCell
)
{
// Mark all faces for all marked cells
const label nFaces = mesh.nFaces();
boolList markedFace(nFaces, false);
// Get mesh cells
const cellList& meshCells = mesh.cells();
// Loop through all cells
forAll (markedCell, cellI)
{
if (markedCell[cellI])
{
// This cell is marked, get its faces
const cell& cFaces = meshCells[cellI];
forAll (cFaces, i)
{
markedFace[cFaces[i]] = true;
}
}
}
// Snyc the face list across processor boundaries
syncTools::syncFaceList(mesh, markedFace, orEqOp<bool>(), false);
// Get necessary mesh data
const label nInternalFaces = mesh.nInternalFaces();
const labelList& owner = mesh.faceOwner();
const labelList& neighbour = mesh.faceNeighbour();
// Internal faces
for (label faceI = 0; faceI < nInternalFaces; ++faceI)
{
if (markedFace[faceI])
{
// Face is marked, mark both owner and neighbour
const label& own = owner[faceI];
const label& nei = neighbour[faceI];
// Mark owner and neighbour cells
markedCell[own] = true;
markedCell[nei] = true;
}
}
// Boundary faces
for (label faceI = nInternalFaces; faceI < nFaces; ++faceI)
{
if (markedFace[faceI])
{
// Face is marked, mark owner
const label& own = owner[faceI];
// Mark owner
markedCell[own] = true;
}
}
}
void Foam::meshTools::extendMarkedCellsAcrossPoints
(
const polyMesh& mesh,
boolList& markedCell
)
{
// Mark all points for all marked cells
const label nPoints = mesh.nPoints();
boolList markedPoint(nPoints, false);
// Get cell points
const labelListList& meshCellPoints = mesh.cellPoints();
// Loop through all cells
forAll (markedCell, cellI)
{
if (markedCell[cellI])
{
// This cell is marked, get its points
const labelList& cPoints = meshCellPoints[cellI];
forAll (cPoints, i)
{
markedPoint[cPoints[i]] = true;
}
}
}
// Snyc point list across processor boundaries
syncTools::syncPointList
(
mesh,
markedPoint,
orEqOp<bool>(),
true, // Default value
true // Apply separation for parallel cyclics
);
// Get point cells
const labelListList& meshPointCells = mesh.pointCells();
// Loop through all points
forAll (markedPoint, pointI)
{
if (markedPoint[pointI])
{
// This point is marked, mark all of its cells
const labelList& pCells = meshPointCells[pointI];
forAll (pCells, i)
{
markedCell[pCells[i]] = true;
}
}
}
}
// ************************************************************************* // // ************************************************************************* //

View file

@ -318,6 +318,25 @@ namespace meshTools
label& zoneFlip label& zoneFlip
); );
// Mark-up of mesh bits. Relocated from refinement polyMeshModifier
//- Extend marked cells across faces given a bool list of already marked
// cells
void extendMarkedCellsAcrossFaces
(
const polyMesh& mesh,
boolList& markedCell
);
//- Extend marked cells across points given a bool list of already
// marked cells
void extendMarkedCellsAcrossPoints
(
const polyMesh& mesh,
boolList& markedCell
);
} // End namespace meshTools } // End namespace meshTools

View file

@ -43,11 +43,12 @@ SourceFiles
namespace Foam namespace Foam
{ {
// Forward declaration of classes
class dictionary; class dictionary;
// Forward declaration of friend functions and operators // Forward declaration of friend functions and operators
class patchIdentifier; class patchIdentifier;
Ostream& operator<<(Ostream&, const patchIdentifier&); Ostream& operator<<(Ostream&, const patchIdentifier&);

View file

@ -24,6 +24,7 @@ License
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
#include "pointBoundaryMesh.H" #include "pointBoundaryMesh.H"
#include "polyMesh.H"
#include "polyBoundaryMesh.H" #include "polyBoundaryMesh.H"
#include "facePointPatch.H" #include "facePointPatch.H"
#include "globalPointPatch.H" #include "globalPointPatch.H"
@ -105,10 +106,39 @@ void Foam::pointBoundaryMesh::movePoints()
} }
void Foam::pointBoundaryMesh::updateMesh() void Foam::pointBoundaryMesh::updateMesh
(
const polyMesh& pMesh
)
{ {
const polyBoundaryMesh& pBoundary = pMesh.boundaryMesh();
pointPatchList& patches = *this; pointPatchList& patches = *this;
// 21.1.19 HR : Patches need to be recreated in PLB
patches.clear();
patches.setSize(pBoundary.size());
forAll(patches, patchI)
{
patches.set
(
patchI,
facePointPatch::New(pBoundary[patchI], *this).ptr()
);
}
// Add the globalPointPatch
if(pMesh.globalData().nGlobalPoints())
{
patches.setSize(pBoundary.size() + 1);
patches.set
(
patches.size() - 1,
new globalPointPatch(*this, patches.size() - 1)
);
}
forAll(patches, patchi) forAll(patches, patchi)
{ {
patches[patchi].initUpdateMesh(); patches[patchi].initUpdateMesh();

View file

@ -46,6 +46,7 @@ namespace Foam
class pointMesh; class pointMesh;
class polyBoundaryMesh; class polyBoundaryMesh;
class globalPointPatch; class globalPointPatch;
class polyMesh;
/*---------------------------------------------------------------------------*\ /*---------------------------------------------------------------------------*\
Class pointBoundaryMesh Declaration Class pointBoundaryMesh Declaration
@ -105,7 +106,10 @@ public:
void movePoints(); void movePoints();
//- Correct polyBoundaryMesh after topology update //- Correct polyBoundaryMesh after topology update
void updateMesh(); void updateMesh
(
const polyMesh& pMesh
);
}; };

View file

@ -122,7 +122,10 @@ bool Foam::pointMesh::updateMesh(const mapPolyMesh& mpm) const
{ {
// Casting const-ness to answer the interface of meshObject // Casting const-ness to answer the interface of meshObject
// HJ, 30/Aug/2010 // HJ, 30/Aug/2010
const_cast<pointBoundaryMesh&>(boundary_).updateMesh(); const_cast<pointBoundaryMesh&>(boundary_).updateMesh
(
GeoMesh<polyMesh>::mesh_
);
// Map all registered point fields // Map all registered point fields
mapFields(mpm); mapFields(mpm);

View file

@ -35,7 +35,7 @@ void Foam::globalProcFaceIndex::calcFaceIndex()
const polyBoundaryMesh& patches = mesh_.boundaryMesh(); const polyBoundaryMesh& patches = mesh_.boundaryMesh();
// Assing unique face label to all master processor faces // Assign unique face label to all master processor faces
// Count faces and processor faces per processor // Count faces and processor faces per processor
forAll (patches, patchI) forAll (patches, patchI)
@ -118,7 +118,8 @@ void Foam::globalProcFaceIndex::calcFaceIndex()
OPstream toProc OPstream toProc
( (
Pstream::nonBlocking, // HR 12.12.18: nonBlocking fails on PLB of Aachen bomb
Pstream::blocking,
procPatch.neighbProcNo() procPatch.neighbProcNo()
); );
toProc<< curFaceLabels; toProc<< curFaceLabels;
@ -154,7 +155,8 @@ void Foam::globalProcFaceIndex::calcFaceIndex()
// Receive the data from master and insert into the list // Receive the data from master and insert into the list
IPstream fromProc IPstream fromProc
( (
Pstream::nonBlocking, // HR 12.12.18: nonBlocking fails on PLB of Aachen bomb
Pstream::blocking,
procPatch.neighbProcNo() procPatch.neighbProcNo()
); );

View file

@ -33,7 +33,7 @@ Description
Face offsets counts a number of unique faces on each processor, Face offsets counts a number of unique faces on each processor,
excluding slave processor patch faces, which are given master face index. excluding slave processor patch faces, which are given master face index.
If needed, global face indes from all faces can be derived from this data If needed, global face index from all faces can be derived from this data
Currently, faces are ordered with internal faces first, followed by patch Currently, faces are ordered with internal faces first, followed by patch
faces in patch order, excluding slave processor patches. faces in patch order, excluding slave processor patches.
@ -120,9 +120,9 @@ public:
return procFaceOffset_; return procFaceOffset_;
} }
//- Return lobal face label for all faces of current mesh //- Return global face label for all faces of current mesh
// Sized to number of live faces in the mesh // Sized to number of live faces in the mesh
const labelList globalLabel() const const labelList& globalLabel() const
{ {
return globalLabel_; return globalLabel_;
} }

View file

@ -0,0 +1,319 @@
/*---------------------------------------------------------------------------*\
========= |
\\ / F ield | foam-extend: Open Source CFD
\\ / O peration | Version: 4.1
\\ / A nd | Web: http://www.foam-extend.org
\\/ M anipulation | For copyright notice see file Copyright
-------------------------------------------------------------------------------
License
This file is part of foam-extend.
foam-extend is free software: you can redistribute it and/or modify it
under the terms of the GNU General Public License as published by the
Free Software Foundation, either version 3 of the License, or (at your
option) any later version.
foam-extend is distributed in the hope that it will be useful, but
WITHOUT ANY WARRANTY; without even the implied warranty of
MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU
General Public License for more details.
You should have received a copy of the GNU General Public License
along with foam-extend. If not, see <http://www.gnu.org/licenses/>.
\*---------------------------------------------------------------------------*/
#include "globalProcPointIndex.H"
#include "processorPolyPatch.H"
#include "globalMeshData.H"
// * * * * * * * * * * * * * Private Member Functions * * * * * * * * * * * //
void Foam::globalProcPointIndex::calcPointIndex()
{
// Count and mark points in the following order
// 1. global points
// 2. processor patches
// 3. regular patches
// 4. anything else ("internal points")
//
// The marking is a follows
// -4 : Not visited yet
// -3 : Found in a regular patch
// -2 : Found in slave processor patch
// -1 : Found in a master processor patch
// 0 - nGlobalPoints-1 : Global point ID
// 1. Mark the global points
const labelList& spl = mesh_.globalData().sharedPointLabels();
const labelList& spa = mesh_.globalData().sharedPointAddr();
forAll(spl, spI)
{
globalLabel_[spl[spI]] = spa[spI];
}
const polyBoundaryMesh& patches = mesh_.boundaryMesh();
labelList procPointCounter(Pstream::nProcs(), 0);
labelList patchPointCounter(patches.size(), 0);
label& nProcPoints = procPointCounter[Pstream::myProcNo()];
// Master processor patches - first pass
forAll (patches, patchI)
{
const polyPatch& pp = patches[patchI];
const labelList& patchMeshPoints = pp.meshPoints();
if (isA<processorPolyPatch>(pp))
{
const processorPolyPatch& procPatch =
refCast<const processorPolyPatch>(pp);
label& nPatchPoints = patchPointCounter[patchI];
if (procPatch.master())
{
forAll (patchMeshPoints, mpI)
{
label& pl = globalLabel_[patchMeshPoints[mpI]];
if (pl < 0)
{
nProcPoints++;
nPatchPoints++;
pl = -1;
}
}
}
}
}
// Slave processor patches - first pass
forAll (patches, patchI)
{
const polyPatch& pp = patches[patchI];
const labelList& patchMeshPoints = pp.meshPoints();
if (isA<processorPolyPatch>(pp))
{
const processorPolyPatch& procPatch =
refCast<const processorPolyPatch>(pp);
if (!procPatch.master())
{
forAll (patchMeshPoints, mpI)
{
label& pl = globalLabel_[patchMeshPoints[mpI]];
if (pl == -4)
{
pl = -2;
}
}
}
}
}
// Regular patches - first pass
forAll (patches, patchI)
{
const polyPatch& pp = patches[patchI];
const labelList& patchMeshPoints = pp.meshPoints();
if (!isA<processorPolyPatch>(pp))
{
label& nPatchPoints = patchPointCounter[patchI];
forAll (patchMeshPoints, mpI)
{
label& pl = globalLabel_[patchMeshPoints[mpI]];
if (pl == -4)
{
nProcPoints++;
nPatchPoints++;
pl = -3;
}
}
}
}
// "Internal" points - first pass
label nInternalPoints = 0;
forAll (globalLabel_, pI)
{
if (globalLabel_[pI] == -4)
{
nInternalPoints++;
nProcPoints++;
}
}
// Gather-Scatter counter data
Pstream::gatherList(procPointCounter);
Pstream::scatterList(procPointCounter);
// Convert counters to offsets
procPointOffset_[0] = mesh_.globalData().nGlobalPoints();
for (label procI = 1; procI < procPointOffset_.size(); procI++)
{
procPointOffset_[procI] =
procPointCounter[procI-1] + procPointOffset_[procI-1];
}
patchPointOffset_[0] =
procPointOffset_[Pstream::myProcNo()] + nInternalPoints;
for (label patchI = 1; patchI < patchPointOffset_.size(); patchI++)
{
patchPointOffset_[patchI] =
patchPointCounter[patchI-1] + patchPointOffset_[patchI-1];
}
const pointField& points = mesh_.points();
// Master processor patches - second pass
// Send patch offset to slave and assign global labels to points on
// master processor patches and regular patches
forAll (patches, patchI)
{
const polyPatch& pp = patches[patchI];
const labelList& patchMeshPoints = pp.meshPoints();
const label patchPO = patchPointOffset_[patchI];
if (isA<processorPolyPatch>(pp))
{
const processorPolyPatch& procPatch =
refCast<const processorPolyPatch>(pp);
if (procPatch.master())
{
// Master processor patch
// Send the offset to the slave and mark the points through a
// face loop to establish an order that can be untangled on
// slave side
OPstream toProc
(
Pstream::nonBlocking,
procPatch.neighbProcNo()
);
toProc<< patchPO;
pointField pointLocs(patchMeshPoints.size());
label glPointLabelsI = 0;
forAll (pp, faceI)
{
const face& curFace = pp[faceI];
forAll (curFace, fpI)
{
const label pointI = curFace[fpI];
label& pl = globalLabel_[pointI];
if (pl == -1)
{
pl = patchPO + glPointLabelsI;
pointLocs[glPointLabelsI] = points[pointI];
glPointLabelsI++;
}
}
}
}
}
}
// Slave processor and regular patches - second pass
// Receive data on slave and assign global labels to points on
// master processor patches and regular patches
forAll (patches, patchI)
{
const polyPatch& pp = patches[patchI];
if (isA<processorPolyPatch>(pp))
{
const processorPolyPatch& procPatch =
refCast<const processorPolyPatch>(pp);
if (!procPatch.master())
{
// Slave processor patch - second pass
// Receive the offset from master and mark the points by taking
// into account that the points in the faces are in reverse
// order
IPstream fromProc
(
Pstream::nonBlocking,
procPatch.neighbProcNo()
);
label masterPatchPO(readLabel(fromProc));
label glPointLabelsI = 0;
forAll (pp, faceI)
{
const face curFace = pp[faceI].reverseFace();
forAll (curFace, fpI)
{
const label pointI = curFace[fpI];
label& pl = globalLabel_[pointI];
if (pl == -2)
{
pl = masterPatchPO + glPointLabelsI;
glPointLabelsI++;
}
}
}
}
}
else
{
// Regular patch - second pass
const labelList& patchMeshPoints = pp.meshPoints();
const label patchPO = patchPointOffset_[patchI];
label glPointLabelsI = 0;
forAll (patchMeshPoints, mpI)
{
label& pl = globalLabel_[patchMeshPoints[mpI]];
if (pl == -3)
{
pl = patchPO + glPointLabelsI;
glPointLabelsI++;
}
}
}
}
// "Internal" points - second pass
nInternalPoints = 0;
forAll (globalLabel_, pI)
{
label& pl = globalLabel_[pI];
if (pl == -4)
{
pl = procPointOffset_[Pstream::myProcNo()] + nInternalPoints;
nInternalPoints++;
}
}
}
// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
Foam::globalProcPointIndex::globalProcPointIndex(const polyMesh& mesh)
:
mesh_(mesh),
procPointOffset_(Pstream::nProcs()+1),
patchPointOffset_(mesh_.boundaryMesh().size()+1),
globalLabel_(mesh_.nPoints(), -4)
{
calcPointIndex();
}
// ************************************************************************* //

View file

@ -0,0 +1,135 @@
/*---------------------------------------------------------------------------*\
========= |
\\ / F ield | foam-extend: Open Source CFD
\\ / O peration | Version: 4.1
\\ / A nd | Web: http://www.foam-extend.org
\\/ M anipulation | For copyright notice see file Copyright
-------------------------------------------------------------------------------
License
This file is part of foam-extend.
foam-extend is free software: you can redistribute it and/or modify it
under the terms of the GNU General Public License as published by the
Free Software Foundation, either version 3 of the License, or (at your
option) any later version.
foam-extend is distributed in the hope that it will be useful, but
WITHOUT ANY WARRANTY; without even the implied warranty of
MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU
General Public License for more details.
You should have received a copy of the GNU General Public License
along with foam-extend. If not, see <http://www.gnu.org/licenses/>.
Class
Foam::globalProcPointIndex
Description
The class creates a unique global point index for each processor points
(pair) in the mesh. Master and slave processor points carry the same index.
Point offsets counts a number of unique points on each processor,
excluding slave processor patch points and global points.
Currently, faces are ordered with internal faces first, followed by patch
faces in patch order, excluding slave processor patches.
If needed, this can be changed to group processor faces with internal faces
to facilitate parallel I/O. HJ, 4/May/2018
Author
Henrik Rusche, Wikki GmbH
SourceFiles
globalProcPointIndex.C
\*---------------------------------------------------------------------------*/
#ifndef globalProcPointIndex_H
#define globalProcPointIndex_H
#include "polyMesh.H"
#include "labelList.H"
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
namespace Foam
{
// Forward declaration of classes
/*---------------------------------------------------------------------------*\
Class globalProcPointIndex Declaration
\*---------------------------------------------------------------------------*/
class globalProcPointIndex
{
// Private data
//- Mesh reference
const polyMesh& mesh_;
//- Processor point index offset
labelList procPointOffset_;
//- point index offset for patches in local mesh
labelList patchPointOffset_;
//- Global poins label for all points of current mesh
// Sized to number of live points in the mesh
labelList globalLabel_;
// Private Member Functions
//- Disallow default bitwise copy construct
globalProcPointIndex(const globalProcPointIndex&);
//- Disallow default bitwise assignment
void operator=(const globalProcPointIndex&);
//- Calculate point index
void calcPointIndex();
public:
// Constructors
//- Construct from mesh
globalProcPointIndex(const polyMesh&);
//- Destructor - default
// Member Functions
//- Return point index offset per processor
inline const labelList& procPointOffset() const
{
return procPointOffset_;
}
inline const labelList& patchPointOffset() const
{
return patchPointOffset_;
}
//- Return global point label for all points of current mesh
// Sized to number of live points in the mesh
const labelList globalLabel() const
{
return globalLabel_;
}
};
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
} // End namespace Foam
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
#endif
// ************************************************************************* //

View file

@ -44,6 +44,7 @@ Description
namespace Foam namespace Foam
{ {
// Forward declaration of classes
template<class ZoneType, class MeshType> class ZoneMesh; template<class ZoneType, class MeshType> class ZoneMesh;
// Forward declaration of friend functions and operators // Forward declaration of friend functions and operators

View file

@ -53,11 +53,12 @@ SourceFiles
namespace Foam namespace Foam
{ {
// Forward declaration of classes
class mapPolyMesh; class mapPolyMesh;
// Forward declaration of friend functions and operators // Forward declaration of friend functions and operators
class faceZone; class faceZone;
Ostream& operator<<(Ostream&, const faceZone&); Ostream& operator<<(Ostream&, const faceZone&);

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