STYLE: Consistency updates

This commit is contained in:
Andrew Heather
2016-09-23 16:52:46 +01:00
parent b9940cbbb1
commit 1fbcb686ff
109 changed files with 245 additions and 236 deletions

View File

@ -0,0 +1,9 @@
const dictionary& potentialFlow
(
mesh.solutionDict().subDict("potentialFlow")
);
const int nNonOrthCorr
(
potentialFlow.lookupOrDefault<int>("nNonOrthogonalCorrectors", 0)
);

View File

@ -119,3 +119,5 @@ setRefCell
PhiRefValue PhiRefValue
); );
mesh.setFluxRequired(Phi.name()); mesh.setFluxRequired(Phi.name());
#include "createMRF.H"

View File

@ -132,7 +132,6 @@ int main(int argc, char *argv[])
pisoControl potentialFlow(mesh, "potentialFlow"); pisoControl potentialFlow(mesh, "potentialFlow");
#include "createFields.H" #include "createFields.H"
#include "createMRF.H"
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //

View File

@ -1,32 +1,32 @@
scalar CoNum = -GREAT; scalar CoNum = -GREAT;
forAll(fluidRegions, regionI) forAll(fluidRegions, regioni)
{ {
CoNum = max CoNum = max
( (
compressibleCourantNo compressibleCourantNo
( (
fluidRegions[regionI], fluidRegions[regioni],
runTime, runTime,
rhoFluid[regionI], rhoFluid[regioni],
phiFluid[regionI] phiFluid[regioni]
), ),
CoNum CoNum
); );
} }
/* /*
forAll(porousFluidRegions, porousI) forAll(porousFluidRegions, porousi)
{ {
CoNum = max CoNum = max
( (
compressibleCourantNo compressibleCourantNo
( (
porousFluidRegions[porousI], porousFluidRegions[porousi],
runTime, runTime,
rhoPorous[porousI], rhoPorous[porousi],
phiPorous[porousI] phiPorous[porousi]
), ),
CoNum CoNum
); );
} }
*/ */

View File

@ -204,13 +204,13 @@ Foam::tmp<Foam::scalarField> Foam::twoPhaseMixtureEThermo::he
( (
const scalarField& p, const scalarField& p,
const scalarField& T, const scalarField& T,
const label patchI const label patchi
) const ) const
{ {
const scalarField& alpha1p = alpha1().boundaryField()[patchI]; const scalarField& alpha1p = alpha1().boundaryField()[patchi];
const scalarField& alpha2p = alpha2().boundaryField()[patchI]; const scalarField& alpha2p = alpha2().boundaryField()[patchi];
const scalarField& Tp = T_.boundaryField()[patchI]; const scalarField& Tp = T_.boundaryField()[patchi];
return return
( (
@ -429,11 +429,11 @@ Foam::tmp<Foam::scalarField> Foam::twoPhaseMixtureEThermo::Cpv
( (
const scalarField& p, const scalarField& p,
const scalarField& T, const scalarField& T,
const label patchI const label patchi
) const ) const
{ {
// This is a e thermo (Cpv = Cv) // This is a e thermo (Cpv = Cv)
return Cv(p, T, patchI); return Cv(p, T, patchi);
} }

View File

@ -127,9 +127,9 @@ scalar getEdgeStats(const primitiveMesh& mesh, const direction excludeCmpt)
const edgeList& edges = mesh.edges(); const edgeList& edges = mesh.edges();
forAll(edges, edgeI) forAll(edges, edgei)
{ {
const edge& e = edges[edgeI]; const edge& e = edges[edgei];
vector eVec(e.vec(mesh.points())); vector eVec(e.vec(mesh.points()));
@ -196,24 +196,24 @@ scalar getEdgeStats(const primitiveMesh& mesh, const direction excludeCmpt)
// Adds empty patch if not yet there. Returns patchID. // Adds empty patch if not yet there. Returns patchID.
label addPatch(polyMesh& mesh, const word& patchName) label addPatch(polyMesh& mesh, const word& patchName)
{ {
label patchI = mesh.boundaryMesh().findPatchID(patchName); label patchi = mesh.boundaryMesh().findPatchID(patchName);
if (patchI == -1) if (patchi == -1)
{ {
const polyBoundaryMesh& patches = mesh.boundaryMesh(); const polyBoundaryMesh& patches = mesh.boundaryMesh();
List<polyPatch*> newPatches(patches.size() + 1); List<polyPatch*> newPatches(patches.size() + 1);
// Add empty patch as 0th entry (Note: only since subsetMesh wants this) // Add empty patch as 0th entry (Note: only since subsetMesh wants this)
patchI = 0; patchi = 0;
newPatches[patchI] = newPatches[patchi] =
new emptyPolyPatch new emptyPolyPatch
( (
Foam::word(patchName), Foam::word(patchName),
0, 0,
mesh.nInternalFaces(), mesh.nInternalFaces(),
patchI, patchi,
patches, patches,
emptyPolyPatch::typeName emptyPolyPatch::typeName
); );
@ -235,15 +235,15 @@ label addPatch(polyMesh& mesh, const word& patchName)
mesh.removeBoundary(); mesh.removeBoundary();
mesh.addPatches(newPatches); mesh.addPatches(newPatches);
Info<< "Created patch oldInternalFaces at " << patchI << endl; Info<< "Created patch oldInternalFaces at " << patchi << endl;
} }
else else
{ {
Info<< "Reusing patch oldInternalFaces at " << patchI << endl; Info<< "Reusing patch oldInternalFaces at " << patchi << endl;
} }
return patchI; return patchi;
} }
@ -302,20 +302,20 @@ void addCutNeighbours
forAllConstIter(labelHashSet, cutCells, iter) forAllConstIter(labelHashSet, cutCells, iter)
{ {
const label cellI = iter.key(); const label celli = iter.key();
const labelList& cFaces = mesh.cells()[cellI]; const labelList& cFaces = mesh.cells()[celli];
forAll(cFaces, i) forAll(cFaces, i)
{ {
const label faceI = cFaces[i]; const label facei = cFaces[i];
if (mesh.isInternalFace(faceI)) if (mesh.isInternalFace(facei))
{ {
label nbr = mesh.faceOwner()[faceI]; label nbr = mesh.faceOwner()[facei];
if (nbr == cellI) if (nbr == celli)
{ {
nbr = mesh.faceNeighbour()[faceI]; nbr = mesh.faceNeighbour()[facei];
} }
if (selectInside && inside.found(nbr)) if (selectInside && inside.found(nbr))
@ -354,11 +354,11 @@ bool limitRefinementLevel
) )
{ {
// Do simple check on validity of refinement level. // Do simple check on validity of refinement level.
forAll(refLevel, cellI) forAll(refLevel, celli)
{ {
if (!excludeCells.found(cellI)) if (!excludeCells.found(celli))
{ {
const labelList& cCells = mesh.cellCells()[cellI]; const labelList& cCells = mesh.cellCells()[celli];
forAll(cCells, i) forAll(cCells, i)
{ {
@ -366,13 +366,13 @@ bool limitRefinementLevel
if (!excludeCells.found(nbr)) if (!excludeCells.found(nbr))
{ {
if (refLevel[cellI] - refLevel[nbr] >= limitDiff) if (refLevel[celli] - refLevel[nbr] >= limitDiff)
{ {
FatalErrorInFunction FatalErrorInFunction
<< "Level difference between neighbouring cells " << "Level difference between neighbouring cells "
<< cellI << " and " << nbr << celli << " and " << nbr
<< " greater than or equal to " << limitDiff << endl << " greater than or equal to " << limitDiff << endl
<< "refLevels:" << refLevel[cellI] << ' ' << "refLevels:" << refLevel[celli] << ' '
<< refLevel[nbr] << abort(FatalError); << refLevel[nbr] << abort(FatalError);
} }
} }
@ -386,8 +386,8 @@ bool limitRefinementLevel
forAllConstIter(labelHashSet, cutCells, iter) forAllConstIter(labelHashSet, cutCells, iter)
{ {
// cellI will be refined. // cellI will be refined.
const label cellI = iter.key(); const label celli = iter.key();
const labelList& cCells = mesh.cellCells()[cellI]; const labelList& cCells = mesh.cellCells()[celli];
forAll(cCells, i) forAll(cCells, i)
{ {
@ -395,7 +395,7 @@ bool limitRefinementLevel
if (!excludeCells.found(nbr) && !cutCells.found(nbr)) if (!excludeCells.found(nbr) && !cutCells.found(nbr))
{ {
if (refLevel[cellI] + 1 - refLevel[nbr] >= limitDiff) if (refLevel[celli] + 1 - refLevel[nbr] >= limitDiff)
{ {
addCutCells.insert(nbr); addCutCells.insert(nbr);
} }
@ -454,22 +454,22 @@ void doRefinement
refLevel.setSize(mesh.nCells()); refLevel.setSize(mesh.nCells());
for (label cellI = oldCells; cellI < mesh.nCells(); cellI++) for (label celli = oldCells; celli < mesh.nCells(); celli++)
{ {
refLevel[cellI] = 0; refLevel[celli] = 0;
} }
const labelListList& addedCells = multiRef.addedCells(); const labelListList& addedCells = multiRef.addedCells();
forAll(addedCells, oldCellI) forAll(addedCells, oldCelli)
{ {
const labelList& added = addedCells[oldCellI]; const labelList& added = addedCells[oldCelli];
if (added.size()) if (added.size())
{ {
// Give all cells resulting from split the refinement level // Give all cells resulting from split the refinement level
// of the master. // of the master.
label masterLevel = ++refLevel[oldCellI]; label masterLevel = ++refLevel[oldCelli];
forAll(added, i) forAll(added, i)
{ {
@ -485,7 +485,7 @@ void subsetMesh
( (
polyMesh& mesh, polyMesh& mesh,
const label writeMesh, const label writeMesh,
const label patchI, // patchID for exposed faces const label patchi, // patchID for exposed faces
const labelHashSet& cellsToRemove, const labelHashSet& cellsToRemove,
cellSet& cutCells, cellSet& cutCells,
labelIOList& refLevel labelIOList& refLevel
@ -506,7 +506,7 @@ void subsetMesh
( (
cellLabels, cellLabels,
exposedFaces, exposedFaces,
labelList(exposedFaces.size(), patchI), labelList(exposedFaces.size(), patchi),
meshMod meshMod
); );
@ -632,7 +632,7 @@ int main(int argc, char *argv[])
#include "createPolyMesh.H" #include "createPolyMesh.H"
// If nessecary add oldInternalFaces patch // If nessecary add oldInternalFaces patch
label newPatchI = addPatch(mesh, "oldInternalFaces"); label newPatchi = addPatch(mesh, "oldInternalFaces");
// //
@ -725,9 +725,9 @@ int main(int argc, char *argv[])
meshSearch queryMesh(mesh, polyMesh::FACE_PLANES); meshSearch queryMesh(mesh, polyMesh::FACE_PLANES);
// Check all 'outside' points // Check all 'outside' points
forAll(outsidePts, outsideI) forAll(outsidePts, outsidei)
{ {
const point& outsidePoint = outsidePts[outsideI]; const point& outsidePoint = outsidePts[outsidei];
if (queryMesh.findCell(outsidePoint, -1, false) == -1) if (queryMesh.findCell(outsidePoint, -1, false) == -1)
{ {
@ -857,7 +857,7 @@ int main(int argc, char *argv[])
{ {
// Subset mesh to remove inside cells altogether. Updates cutCells, // Subset mesh to remove inside cells altogether. Updates cutCells,
// refLevel. // refLevel.
subsetMesh(mesh, writeMesh, newPatchI, inside, cutCells, refLevel); subsetMesh(mesh, writeMesh, newPatchi, inside, cutCells, refLevel);
} }

View File

@ -91,39 +91,39 @@ autoPtr<refinementSurfaces> createRefinementSurfaces
autoPtr<refinementSurfaces> surfacePtr; autoPtr<refinementSurfaces> surfacePtr;
// Count number of surfaces. // Count number of surfaces.
label surfI = 0; label surfi = 0;
forAll(allGeometry.names(), geomI) forAll(allGeometry.names(), geomi)
{ {
const word& geomName = allGeometry.names()[geomI]; const word& geomName = allGeometry.names()[geomi];
if (surfacesDict.found(geomName)) if (surfacesDict.found(geomName))
{ {
surfI++; surfi++;
} }
} }
labelList surfaces(surfI); labelList surfaces(surfi);
wordList names(surfI); wordList names(surfi);
PtrList<surfaceZonesInfo> surfZones(surfI); PtrList<surfaceZonesInfo> surfZones(surfi);
labelList regionOffset(surfI); labelList regionOffset(surfi);
labelList globalMinLevel(surfI, 0); labelList globalMinLevel(surfi, 0);
labelList globalMaxLevel(surfI, 0); labelList globalMaxLevel(surfi, 0);
labelList globalLevelIncr(surfI, 0); labelList globalLevelIncr(surfi, 0);
PtrList<dictionary> globalPatchInfo(surfI); PtrList<dictionary> globalPatchInfo(surfi);
List<Map<label>> regionMinLevel(surfI); List<Map<label>> regionMinLevel(surfi);
List<Map<label>> regionMaxLevel(surfI); List<Map<label>> regionMaxLevel(surfi);
List<Map<label>> regionLevelIncr(surfI); List<Map<label>> regionLevelIncr(surfi);
List<Map<scalar>> regionAngle(surfI); List<Map<scalar>> regionAngle(surfi);
List<Map<autoPtr<dictionary>>> regionPatchInfo(surfI); List<Map<autoPtr<dictionary>>> regionPatchInfo(surfi);
HashSet<word> unmatchedKeys(surfacesDict.toc()); HashSet<word> unmatchedKeys(surfacesDict.toc());
surfI = 0; surfi = 0;
forAll(allGeometry.names(), geomI) forAll(allGeometry.names(), geomi)
{ {
const word& geomName = allGeometry.names()[geomI]; const word& geomName = allGeometry.names()[geomi];
const entry* ePtr = surfacesDict.lookupEntryPtr(geomName, false, true); const entry* ePtr = surfacesDict.lookupEntryPtr(geomName, false, true);
@ -132,10 +132,10 @@ autoPtr<refinementSurfaces> createRefinementSurfaces
const dictionary& shapeDict = ePtr->dict(); const dictionary& shapeDict = ePtr->dict();
unmatchedKeys.erase(ePtr->keyword()); unmatchedKeys.erase(ePtr->keyword());
names[surfI] = geomName; names[surfi] = geomName;
surfaces[surfI] = geomI; surfaces[surfi] = geomi;
const searchableSurface& surface = allGeometry[geomI]; const searchableSurface& surface = allGeometry[geomi];
// Find the index in shapeControlDict // Find the index in shapeControlDict
// Invert surfaceCellSize to get the refinementLevel // Invert surfaceCellSize to get the refinementLevel
@ -154,12 +154,12 @@ autoPtr<refinementSurfaces> createRefinementSurfaces
surfaceCellSize surfaceCellSize
); );
globalMinLevel[surfI] = refLevel; globalMinLevel[surfi] = refLevel;
globalMaxLevel[surfI] = refLevel; globalMaxLevel[surfi] = refLevel;
globalLevelIncr[surfI] = gapLevelIncrement; globalLevelIncr[surfi] = gapLevelIncrement;
// Surface zones // Surface zones
surfZones.set(surfI, new surfaceZonesInfo(surface, shapeDict)); surfZones.set(surfi, new surfaceZonesInfo(surface, shapeDict));
// Global perpendicular angle // Global perpendicular angle
@ -167,7 +167,7 @@ autoPtr<refinementSurfaces> createRefinementSurfaces
{ {
globalPatchInfo.set globalPatchInfo.set
( (
surfI, surfi,
shapeDict.subDict("patchInfo").clone() shapeDict.subDict("patchInfo").clone()
); );
} }
@ -179,23 +179,23 @@ autoPtr<refinementSurfaces> createRefinementSurfaces
{ {
const dictionary& regionsDict = shapeDict.subDict("regions"); const dictionary& regionsDict = shapeDict.subDict("regions");
const wordList& regionNames = const wordList& regionNames =
allGeometry[surfaces[surfI]].regions(); allGeometry[surfaces[surfi]].regions();
forAll(regionNames, regionI) forAll(regionNames, regioni)
{ {
if (regionsDict.found(regionNames[regionI])) if (regionsDict.found(regionNames[regioni]))
{ {
// Get the dictionary for region // Get the dictionary for region
const dictionary& regionDict = regionsDict.subDict const dictionary& regionDict = regionsDict.subDict
( (
regionNames[regionI] regionNames[regioni]
); );
if (regionDict.found("patchInfo")) if (regionDict.found("patchInfo"))
{ {
regionPatchInfo[surfI].insert regionPatchInfo[surfi].insert
( (
regionI, regioni,
regionDict.subDict("patchInfo").clone() regionDict.subDict("patchInfo").clone()
); );
} }
@ -209,16 +209,16 @@ autoPtr<refinementSurfaces> createRefinementSurfaces
const dictionary& shapeControlRegionsDict = const dictionary& shapeControlRegionsDict =
shapeDict.subDict("regions"); shapeDict.subDict("regions");
const wordList& regionNames = const wordList& regionNames =
allGeometry[surfaces[surfI]].regions(); allGeometry[surfaces[surfi]].regions();
forAll(regionNames, regionI) forAll(regionNames, regioni)
{ {
if (shapeControlRegionsDict.found(regionNames[regionI])) if (shapeControlRegionsDict.found(regionNames[regioni]))
{ {
const dictionary& shapeControlRegionDict = const dictionary& shapeControlRegionDict =
shapeControlRegionsDict.subDict shapeControlRegionsDict.subDict
( (
regionNames[regionI] regionNames[regioni]
); );
const word scsFuncName = const word scsFuncName =
@ -244,24 +244,24 @@ autoPtr<refinementSurfaces> createRefinementSurfaces
surfaceCellSize surfaceCellSize
); );
regionMinLevel[surfI].insert(regionI, refLevel); regionMinLevel[surfi].insert(regioni, refLevel);
regionMaxLevel[surfI].insert(regionI, refLevel); regionMaxLevel[surfi].insert(regioni, refLevel);
regionLevelIncr[surfI].insert(regionI, 0); regionLevelIncr[surfi].insert(regioni, 0);
} }
} }
} }
surfI++; surfi++;
} }
} }
// Calculate local to global region offset // Calculate local to global region offset
label nRegions = 0; label nRegions = 0;
forAll(surfaces, surfI) forAll(surfaces, surfi)
{ {
regionOffset[surfI] = nRegions; regionOffset[surfi] = nRegions;
nRegions += allGeometry[surfaces[surfI]].regions().size(); nRegions += allGeometry[surfaces[surfi]].regions().size();
} }
// Rework surface specific information into information per global region // Rework surface specific information into information per global region
@ -270,47 +270,47 @@ autoPtr<refinementSurfaces> createRefinementSurfaces
labelList gapLevel(nRegions, -1); labelList gapLevel(nRegions, -1);
PtrList<dictionary> patchInfo(nRegions); PtrList<dictionary> patchInfo(nRegions);
forAll(globalMinLevel, surfI) forAll(globalMinLevel, surfi)
{ {
label nRegions = allGeometry[surfaces[surfI]].regions().size(); label nRegions = allGeometry[surfaces[surfi]].regions().size();
// Initialise to global (i.e. per surface) // Initialise to global (i.e. per surface)
for (label i = 0; i < nRegions; i++) for (label i = 0; i < nRegions; i++)
{ {
label globalRegionI = regionOffset[surfI] + i; label globalRegioni = regionOffset[surfi] + i;
minLevel[globalRegionI] = globalMinLevel[surfI]; minLevel[globalRegioni] = globalMinLevel[surfi];
maxLevel[globalRegionI] = globalMaxLevel[surfI]; maxLevel[globalRegioni] = globalMaxLevel[surfi];
gapLevel[globalRegionI] = gapLevel[globalRegioni] =
maxLevel[globalRegionI] maxLevel[globalRegioni]
+ globalLevelIncr[surfI]; + globalLevelIncr[surfi];
if (globalPatchInfo.set(surfI)) if (globalPatchInfo.set(surfi))
{ {
patchInfo.set patchInfo.set
( (
globalRegionI, globalRegioni,
globalPatchInfo[surfI].clone() globalPatchInfo[surfi].clone()
); );
} }
} }
// Overwrite with region specific information // Overwrite with region specific information
forAllConstIter(Map<label>, regionMinLevel[surfI], iter) forAllConstIter(Map<label>, regionMinLevel[surfi], iter)
{ {
label globalRegionI = regionOffset[surfI] + iter.key(); label globalRegioni = regionOffset[surfi] + iter.key();
minLevel[globalRegionI] = iter(); minLevel[globalRegioni] = iter();
maxLevel[globalRegionI] = regionMaxLevel[surfI][iter.key()]; maxLevel[globalRegioni] = regionMaxLevel[surfi][iter.key()];
gapLevel[globalRegionI] = gapLevel[globalRegioni] =
maxLevel[globalRegionI] maxLevel[globalRegioni]
+ regionLevelIncr[surfI][iter.key()]; + regionLevelIncr[surfi][iter.key()];
} }
const Map<autoPtr<dictionary>>& localInfo = regionPatchInfo[surfI]; const Map<autoPtr<dictionary>>& localInfo = regionPatchInfo[surfi];
forAllConstIter(Map<autoPtr<dictionary>>, localInfo, iter) forAllConstIter(Map<autoPtr<dictionary>>, localInfo, iter)
{ {
label globalRegionI = regionOffset[surfI] + iter.key(); label globalRegioni = regionOffset[surfi] + iter.key();
patchInfo.set(globalRegionI, iter()().clone()); patchInfo.set(globalRegioni, iter()().clone());
} }
} }
@ -336,13 +336,13 @@ autoPtr<refinementSurfaces> createRefinementSurfaces
// Determine maximum region name length // Determine maximum region name length
label maxLen = 0; label maxLen = 0;
forAll(rf.surfaces(), surfI) forAll(rf.surfaces(), surfi)
{ {
label geomI = rf.surfaces()[surfI]; label geomi = rf.surfaces()[surfi];
const wordList& regionNames = allGeometry.regionNames()[geomI]; const wordList& regionNames = allGeometry.regionNames()[geomi];
forAll(regionNames, regionI) forAll(regionNames, regioni)
{ {
maxLen = Foam::max(maxLen, label(regionNames[regionI].size())); maxLen = Foam::max(maxLen, label(regionNames[regioni].size()));
} }
} }
@ -356,22 +356,22 @@ autoPtr<refinementSurfaces> createRefinementSurfaces
<< setw(10) << "---------" << setw(10) << "---------"
<< setw(10) << "---------" << endl; << setw(10) << "---------" << endl;
forAll(rf.surfaces(), surfI) forAll(rf.surfaces(), surfi)
{ {
label geomI = rf.surfaces()[surfI]; label geomi = rf.surfaces()[surfi];
Info<< rf.names()[surfI] << ':' << nl; Info<< rf.names()[surfi] << ':' << nl;
const wordList& regionNames = allGeometry.regionNames()[geomI]; const wordList& regionNames = allGeometry.regionNames()[geomi];
forAll(regionNames, regionI) forAll(regionNames, regioni)
{ {
label globalI = rf.globalRegion(surfI, regionI); label globali = rf.globalRegion(surfi, regioni);
Info<< setw(maxLen) << regionNames[regionI] Info<< setw(maxLen) << regionNames[regioni]
<< setw(10) << rf.minLevel()[globalI] << setw(10) << rf.minLevel()[globali]
<< setw(10) << rf.maxLevel()[globalI] << setw(10) << rf.maxLevel()[globali]
<< setw(10) << rf.gapLevel()[globalI] << endl; << setw(10) << rf.gapLevel()[globali] << endl;
} }
} }
@ -796,7 +796,7 @@ int main(int argc, char *argv[])
// { // {
// hexRef8 meshCutter(meshPtr(), false); // hexRef8 meshCutter(meshPtr(), false);
// //
// for (label refineI = 0; refineI < initialRefLevels; ++refineI) // for (label refinei = 0; refinei < initialRefLevels; ++refinei)
// { // {
// // Mesh changing engine. // // Mesh changing engine.
// polyTopoChange meshMod(meshPtr(), true); // polyTopoChange meshMod(meshPtr(), true);
@ -818,7 +818,7 @@ int main(int argc, char *argv[])
// // Delete mesh volumes. // // Delete mesh volumes.
// meshPtr().clearOut(); // meshPtr().clearOut();
// //
// Info<< "Refinement Iteration " << refineI + 1 // Info<< "Refinement Iteration " << refinei + 1
// << ", Mesh size = " << meshPtr().nCells() << endl; // << ", Mesh size = " << meshPtr().nCells() << endl;
// } // }
// } // }
@ -1117,24 +1117,24 @@ int main(int argc, char *argv[])
const PtrList<dictionary>& patchInfo = surfaces.patchInfo(); const PtrList<dictionary>& patchInfo = surfaces.patchInfo();
const labelList& surfaceGeometry = surfaces.surfaces(); const labelList& surfaceGeometry = surfaces.surfaces();
forAll(surfaceGeometry, surfI) forAll(surfaceGeometry, surfi)
{ {
label geomI = surfaceGeometry[surfI]; label geomi = surfaceGeometry[surfi];
const wordList& regNames = allGeometry.regionNames()[geomI]; const wordList& regNames = allGeometry.regionNames()[geomi];
patchTypes[geomI].setSize(regNames.size()); patchTypes[geomi].setSize(regNames.size());
forAll(regNames, regionI) forAll(regNames, regioni)
{ {
label globalRegionI = surfaces.globalRegion(surfI, regionI); label globalRegioni = surfaces.globalRegion(surfi, regioni);
if (patchInfo.set(globalRegionI)) if (patchInfo.set(globalRegioni))
{ {
patchTypes[geomI][regionI] = patchTypes[geomi][regioni] =
word(patchInfo[globalRegionI].lookup("type")); word(patchInfo[globalRegioni].lookup("type"));
} }
else else
{ {
patchTypes[geomI][regionI] = wallPolyPatch::typeName; patchTypes[geomi][regioni] = wallPolyPatch::typeName;
} }
} }
} }

View File

@ -3,7 +3,7 @@
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2014 OpenFOAM Foundation \\ / A nd | Copyright (C) 2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation | Copyright (C) 2016 OpenCFD Ltd.
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License
This file is part of OpenFOAM. This file is part of OpenFOAM.
@ -46,7 +46,7 @@ namespace searchableSurfaceModifiers
{ {
/*---------------------------------------------------------------------------*\ /*---------------------------------------------------------------------------*\
Class autoPatch Declaration Class autoPatch Declaration
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
class autoPatch class autoPatch
@ -76,7 +76,7 @@ public:
autoPtr<searchableSurfaceModifier> clone() const autoPtr<searchableSurfaceModifier> clone() const
{ {
NotImplemented; NotImplemented;
return autoPtr<searchableSurfaceModifier>(NULL); return autoPtr<searchableSurfaceModifier>(nullptr);
} }

View File

@ -3,7 +3,7 @@
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2014 OpenFOAM Foundation \\ / A nd | Copyright (C) 2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation | Copyright (C) 2016 OpenCFD Ltd.
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License
This file is part of OpenFOAM. This file is part of OpenFOAM.
@ -53,7 +53,7 @@ namespace searchableSurfaceModifiers
{ {
/*---------------------------------------------------------------------------*\ /*---------------------------------------------------------------------------*\
Class cut Declaration Class cut Declaration
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
class cut class cut
@ -100,7 +100,7 @@ public:
autoPtr<searchableSurfaceModifier> clone() const autoPtr<searchableSurfaceModifier> clone() const
{ {
NotImplemented; NotImplemented;
return autoPtr<searchableSurfaceModifier>(NULL); return autoPtr<searchableSurfaceModifier>(nullptr);
} }

View File

@ -3,7 +3,7 @@
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2014 OpenFOAM Foundation \\ / A nd | Copyright (C) 2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation | Copyright (C) 2016 OpenCFD Ltd.
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License
This file is part of OpenFOAM. This file is part of OpenFOAM.
@ -52,7 +52,7 @@ class searchableSurface;
class searchableSurfaces; class searchableSurfaces;
/*---------------------------------------------------------------------------*\ /*---------------------------------------------------------------------------*\
Class searchableSurfaceModifier Declaration Class searchableSurfaceModifier Declaration
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
class searchableSurfaceModifier class searchableSurfaceModifier
@ -96,7 +96,7 @@ public:
autoPtr<searchableSurfaceModifier> clone() const autoPtr<searchableSurfaceModifier> clone() const
{ {
NotImplemented; NotImplemented;
return autoPtr<searchableSurfaceModifier>(NULL); return autoPtr<searchableSurfaceModifier>(nullptr);
} }

View File

@ -125,7 +125,7 @@ cleanCase()
rm -rf constant/tetDualMesh > /dev/null 2>&1 rm -rf constant/tetDualMesh > /dev/null 2>&1
rm -rf VTK > /dev/null 2>&1 rm -rf VTK > /dev/null 2>&1
rm -f 0/cellDist constant/cellDecomposition rm -f 0/cellLevel 0/pointLevel 0/cellDist constant/cellDecomposition
if [ -e system/blockMeshDict.m4 ] if [ -e system/blockMeshDict.m4 ]
then then

View File

@ -176,28 +176,28 @@ cloneCase()
fi fi
} }
# Overwrite 0/ with the contents of 0.org/ if it exists. # Overwrite 0/ with the contents of 0.orig/ if it exists.
# The -processor option to do the processor directories instead # The -processor option to do the processor directories instead
# #
restore0Dir() restore0Dir()
{ {
if [ "$1" = "-processor" ] if [ "$1" = "-processor" ]
then then
echo "Restore 0/ from 0.org/ for processor directories" echo "Restore 0/ from 0.orig/ for processor directories"
[ -d 0.org ] || echo " Warning: no 0.org/ found" [ -d 0.orig ] || echo " Warning: no 0.orig/ found"
# do nonetheless # do nonetheless
\ls -d processor* | xargs -I {} \rm -rf ./{}/0 \ls -d processor* | xargs -I {} \rm -rf ./{}/0
\ls -d processor* | xargs -I {} \cp -r 0.org ./{}/0 > /dev/null 2>&1 \ls -d processor* | xargs -I {} \cp -r 0.orig ./{}/0 > /dev/null 2>&1
else else
echo "Restore 0/ from 0.org/" echo "Restore 0/ from 0.orig/"
if [ -d 0.org ] if [ -d 0.orig ]
then then
\rm -rf 0 \rm -rf 0
\cp -r 0.org 0 > /dev/null 2>&1 \cp -r 0.orig 0 > /dev/null 2>&1
else else
echo " Warning: no 0.org/ found" echo " Warning: no 0.orig/ found"
fi fi
fi fi
} }

View File

@ -58,7 +58,7 @@ void Foam::CStringList::reset
} }
argv_ = new char*[argc_+1]; argv_ = new char*[argc_+1];
argv_[argc_] = NULL; // extra terminator argv_[argc_] = nullptr; // extra terminator
if (argc_ > 0) if (argc_ > 0)
{ {

View File

@ -407,7 +407,7 @@ public:
<< "Unable to retrieve turbulence model from the mesh " << "Unable to retrieve turbulence model from the mesh "
<< "database" << exit(FatalError); << "database" << exit(FatalError);
return tmp<surfaceScalarField>(NULL); return tmp<surfaceScalarField>(nullptr);
} }
} }
@ -488,7 +488,7 @@ public:
{ {
return tmp<GeometricField<Type, fvsPatchField, surfaceMesh>> return tmp<GeometricField<Type, fvsPatchField, surfaceMesh>>
( (
NULL nullptr
); );
} }
} }

View File

@ -726,7 +726,7 @@ turbulentDFSEMInletFvPatchVectorField
perturb_(1e-5), perturb_(1e-5),
mapMethod_("planarInterpolation"), mapMethod_("planarInterpolation"),
mapperPtr_(NULL), mapperPtr_(nullptr),
interpolateR_(false), interpolateR_(false),
R_(), R_(),
interpolateL_(false), interpolateL_(false),
@ -772,7 +772,7 @@ turbulentDFSEMInletFvPatchVectorField
perturb_(ptf.perturb_), perturb_(ptf.perturb_),
mapMethod_(ptf.mapMethod_), mapMethod_(ptf.mapMethod_),
mapperPtr_(NULL), mapperPtr_(nullptr),
interpolateR_(ptf.interpolateR_), interpolateR_(ptf.interpolateR_),
R_(ptf.R_, mapper), R_(ptf.R_, mapper),
interpolateL_(ptf.interpolateL_), interpolateL_(ptf.interpolateL_),
@ -817,7 +817,7 @@ turbulentDFSEMInletFvPatchVectorField
perturb_(dict.lookupOrDefault<scalar>("perturb", 1e-5)), perturb_(dict.lookupOrDefault<scalar>("perturb", 1e-5)),
mapMethod_(dict.lookup("mapMethod")), mapMethod_(dict.lookup("mapMethod")),
mapperPtr_(NULL), mapperPtr_(nullptr),
interpolateR_(false), interpolateR_(false),
R_(interpolateOrRead<symmTensor>("R", dict, interpolateR_)), R_(interpolateOrRead<symmTensor>("R", dict, interpolateR_)),
interpolateL_(false), interpolateL_(false),
@ -865,7 +865,7 @@ turbulentDFSEMInletFvPatchVectorField
perturb_(ptf.perturb_), perturb_(ptf.perturb_),
mapMethod_(ptf.mapMethod_), mapMethod_(ptf.mapMethod_),
mapperPtr_(NULL), mapperPtr_(nullptr),
interpolateR_(ptf.interpolateR_), interpolateR_(ptf.interpolateR_),
R_(ptf.R_), R_(ptf.R_),
interpolateL_(ptf.interpolateL_), interpolateL_(ptf.interpolateL_),
@ -909,7 +909,7 @@ turbulentDFSEMInletFvPatchVectorField
perturb_(ptf.perturb_), perturb_(ptf.perturb_),
mapMethod_(ptf.mapMethod_), mapMethod_(ptf.mapMethod_),
mapperPtr_(NULL), mapperPtr_(nullptr),
interpolateR_(ptf.interpolateR_), interpolateR_(ptf.interpolateR_),
R_(ptf.R_), R_(ptf.R_),
interpolateL_(ptf.interpolateL_), interpolateL_(ptf.interpolateL_),

View File

@ -99,7 +99,7 @@ Foam::functionObjects::runTimePostPro::geometryBase::geometryBase
name_(dict.dictName()), name_(dict.dictName()),
visible_(readBool(dict.lookup("visible"))), visible_(readBool(dict.lookup("visible"))),
renderMode_(rmGouraud), renderMode_(rmGouraud),
opacity_(NULL), opacity_(nullptr),
colours_(colours) colours_(colours)
{ {
if (dict.found("renderMode")) if (dict.found("renderMode"))

View File

@ -141,7 +141,7 @@ Foam::functionObjects::runTimePostPro::pathline::pathline
representationTypeNames.read(dict.lookup("representation")) representationTypeNames.read(dict.lookup("representation"))
), ),
tubeRadius_(0.0), tubeRadius_(0.0),
lineColour_(NULL) lineColour_(nullptr)
{ {
if (dict.found("lineColour")) if (dict.found("lineColour"))
{ {

View File

@ -109,7 +109,7 @@ Foam::functionObjects::runTimePostPro::pointData::pointData
representationTypeNames.read(dict.lookup("representation")) representationTypeNames.read(dict.lookup("representation"))
), ),
maxGlyphLength_(readScalar(dict.lookup("maxGlyphLength"))), maxGlyphLength_(readScalar(dict.lookup("maxGlyphLength"))),
pointColour_(NULL) pointColour_(nullptr)
{ {
if (dict.found("pointColour")) if (dict.found("pointColour"))
{ {

View File

@ -324,10 +324,10 @@ Foam::functionObjects::runTimePostPro::scene::scene
name_(name), name_(name),
colours_(), colours_(),
mode_(mtStatic), mode_(mtStatic),
cameraPosition_(NULL), cameraPosition_(nullptr),
cameraFocalPoint_(NULL), cameraFocalPoint_(nullptr),
cameraUp_(NULL), cameraUp_(nullptr),
cameraViewAngle_(NULL), cameraViewAngle_(nullptr),
clipBox_(), clipBox_(),
parallelProjection_(true), parallelProjection_(true),
nFrameTotal_(1), nFrameTotal_(1),

View File

@ -160,8 +160,8 @@ Foam::functionObjects::runTimePostPro::surface::surface
representationTypeNames.read(dict.lookup("representation")) representationTypeNames.read(dict.lookup("representation"))
), ),
featureEdges_(false), featureEdges_(false),
surfaceColour_(NULL), surfaceColour_(nullptr),
edgeColour_(NULL), edgeColour_(nullptr),
surfaceActor_(), surfaceActor_(),
edgeActor_(), edgeActor_(),
maxGlyphLength_(0.0) maxGlyphLength_(0.0)

View File

@ -47,7 +47,7 @@ Foam::functionObjects::runTimePostPro::text::text
string_(dict.lookup("string")), string_(dict.lookup("string")),
position_(dict.lookup("position")), position_(dict.lookup("position")),
size_(readScalar(dict.lookup("size"))), size_(readScalar(dict.lookup("size"))),
colour_(NULL), colour_(nullptr),
bold_(readBool(dict.lookup("bold"))), bold_(readBool(dict.lookup("bold"))),
timeStamp_(dict.lookupOrDefault<bool>("timeStamp", false)) timeStamp_(dict.lookupOrDefault<bool>("timeStamp", false))
{ {

View File

@ -173,7 +173,7 @@ displacementLaplacianFvMotionSolver
), ),
cellMotionBoundaryTypes<vector>(pointDisplacement_.boundaryField()) cellMotionBoundaryTypes<vector>(pointDisplacement_.boundaryField())
), ),
pointLocation_(NULL), pointLocation_(nullptr),
interpolationPtr_ interpolationPtr_
( (
coeffDict().found("interpolation") coeffDict().found("interpolation")

View File

@ -183,7 +183,7 @@ directionalPressureGradientExplicitSource
dGradP_(cells_.size(), Zero), dGradP_(cells_.size(), Zero),
gradPporous_(cells_.size(), Zero), gradPporous_(cells_.size(), Zero),
flowDir_(coeffs_.lookup("flowDir")), flowDir_(coeffs_.lookup("flowDir")),
invAPtr_(NULL), invAPtr_(nullptr),
D_(0), D_(0),
I_(0), I_(0),
length_(0), length_(0),

View File

@ -45,7 +45,7 @@ Foam::InterfaceForce<CloudType>::InterfaceForce
( (
readScalar(this->coeffs().lookup("C")) readScalar(this->coeffs().lookup("C"))
), ),
gradInterForceInterpPtr_(NULL) gradInterForceInterpPtr_(nullptr)
{} {}

View File

@ -507,7 +507,7 @@ Foam::refinementSurfaces::refinementSurfaces
{ {
if (patchInfo.set(pI)) if (patchInfo.set(pI))
{ {
patchInfo_.set(pI, patchInfo.set(pI, NULL)); patchInfo_.set(pI, patchInfo.set(pI, nullptr));
} }
} }
} }

View File

@ -257,7 +257,7 @@ Foam::ensightSurfaceReader::ensightSurfaceReader(const fileName& fName)
timeStartIndex_(0), timeStartIndex_(0),
timeIncrement_(1), timeIncrement_(1),
timeValues_(), timeValues_(),
surfPtr_(NULL) surfPtr_(nullptr)
{ {
IFstream is(fName); IFstream is(fName);
readCase(is); readCase(is);

View File

@ -152,8 +152,8 @@ humidityTemperatureCoupledMixedFvPatchScalarField
QrNbrName_("none"), QrNbrName_("none"),
QrName_("none"), QrName_("none"),
specieName_("none"), specieName_("none"),
liquid_(NULL), liquid_(nullptr),
liquidDict_(NULL), liquidDict_(nullptr),
mass_(patch().size(), 0.0), mass_(patch().size(), 0.0),
Tvap_(0.0), Tvap_(0.0),
myKDelta_(patch().size(), 0.0), myKDelta_(patch().size(), 0.0),
@ -227,7 +227,7 @@ humidityTemperatureCoupledMixedFvPatchScalarField
QrNbrName_(dict.lookupOrDefault<word>("QrNbr", "none")), QrNbrName_(dict.lookupOrDefault<word>("QrNbr", "none")),
QrName_(dict.lookupOrDefault<word>("Qr", "none")), QrName_(dict.lookupOrDefault<word>("Qr", "none")),
specieName_(dict.lookupOrDefault<word>("specieName", "none")), specieName_(dict.lookupOrDefault<word>("specieName", "none")),
liquid_(NULL), liquid_(nullptr),
liquidDict_(), liquidDict_(),
mass_(patch().size(), 0.0), mass_(patch().size(), 0.0),
Tvap_(0.0), Tvap_(0.0),

View File

@ -142,7 +142,6 @@ Foam::radiation::wideBandAbsorptionEmission::wideBandAbsorptionEmission
} }
// * * * * * * * * * * * * * * * * Destructor * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * Destructor * * * * * * * * * * * * * * * //
Foam::radiation::wideBandAbsorptionEmission::~wideBandAbsorptionEmission() Foam::radiation::wideBandAbsorptionEmission::~wideBandAbsorptionEmission()
@ -152,7 +151,7 @@ Foam::radiation::wideBandAbsorptionEmission::~wideBandAbsorptionEmission()
// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * //
Foam::tmp<Foam::volScalarField> Foam::tmp<Foam::volScalarField>
Foam::radiation::wideBandAbsorptionEmission::aCont(const label bandI) const Foam::radiation::wideBandAbsorptionEmission::aCont(const label bandi) const
{ {
const volScalarField& T = thermo_.T(); const volScalarField& T = thermo_.T();
const volScalarField& p = thermo_.p(); const volScalarField& p = thermo_.p();
@ -202,9 +201,9 @@ Foam::radiation::wideBandAbsorptionEmission::aCont(const label bandI) const
scalar Ti = T[i]; scalar Ti = T[i];
const absorptionCoeffs::coeffArray& b = const absorptionCoeffs::coeffArray& b =
coeffs_[n][bandI].coeffs(T[i]); coeffs_[n][bandi].coeffs(T[i]);
if (coeffs_[n][bandI].invTemp()) if (coeffs_[n][bandi].invTemp())
{ {
Ti = 1.0/T[i]; Ti = 1.0/T[i];
} }
@ -223,14 +222,14 @@ Foam::radiation::wideBandAbsorptionEmission::aCont(const label bandI) const
Foam::tmp<Foam::volScalarField> Foam::tmp<Foam::volScalarField>
Foam::radiation::wideBandAbsorptionEmission::eCont(const label bandI) const Foam::radiation::wideBandAbsorptionEmission::eCont(const label bandi) const
{ {
return aCont(bandI); return aCont(bandi);
} }
Foam::tmp<Foam::volScalarField> Foam::tmp<Foam::volScalarField>
Foam::radiation::wideBandAbsorptionEmission::ECont(const label bandI) const Foam::radiation::wideBandAbsorptionEmission::ECont(const label bandi) const
{ {
tmp<volScalarField> E tmp<volScalarField> E
( (
@ -256,18 +255,18 @@ Foam::radiation::wideBandAbsorptionEmission::ECont(const label bandI) const
if (dQ.dimensions() == dimEnergy/dimTime) if (dQ.dimensions() == dimEnergy/dimTime)
{ {
E.ref().primitiveFieldRef() = E.ref().primitiveFieldRef() =
iEhrrCoeffs_[bandI] iEhrrCoeffs_[bandi]
*dQ.primitiveField() *dQ.primitiveField()
*(iBands_[bandI][1] - iBands_[bandI][0]) *(iBands_[bandi][1] - iBands_[bandi][0])
/totalWaveLength_ /totalWaveLength_
/mesh_.V(); /mesh_.V();
} }
else if (dQ.dimensions() == dimEnergy/dimTime/dimVolume) else if (dQ.dimensions() == dimEnergy/dimTime/dimVolume)
{ {
E.ref().primitiveFieldRef() = E.ref().primitiveFieldRef() =
iEhrrCoeffs_[bandI] iEhrrCoeffs_[bandi]
*dQ.primitiveField() *dQ.primitiveField()
*(iBands_[bandI][1] - iBands_[bandI][0]) *(iBands_[bandi][1] - iBands_[bandi][0])
/totalWaveLength_; /totalWaveLength_;
} }
else else

View File

@ -65,7 +65,7 @@ Foam::radiation::boundaryRadiationProperties::boundaryRadiationProperties
{ {
const IOdictionary radiationDict(boundaryIO); const IOdictionary radiationDict(boundaryIO);
forAll (mesh.boundary(), patchi) forAll(mesh.boundary(), patchi)
{ {
const polyPatch& pp = mesh.boundaryMesh()[patchi]; const polyPatch& pp = mesh.boundaryMesh()[patchi];
@ -88,18 +88,18 @@ Foam::radiation::boundaryRadiationProperties::boundaryRadiationProperties
Foam::tmp<Foam::scalarField> Foam::tmp<Foam::scalarField>
Foam::radiation::boundaryRadiationProperties::emissivity Foam::radiation::boundaryRadiationProperties::emissivity
( (
const label patchI, const label patchi,
const label bandI const label bandi
) const ) const
{ {
if (!radBoundaryPropertiesPtrList_[patchI].empty()) if (!radBoundaryPropertiesPtrList_[patchi].empty())
{ {
return radBoundaryPropertiesPtrList_[patchI]->emissivity(bandI); return radBoundaryPropertiesPtrList_[patchi]->emissivity(bandi);
} }
else else
{ {
FatalErrorInFunction FatalErrorInFunction
<< "Patch : " << mesh().boundaryMesh()[patchI].name() << "Patch : " << mesh().boundaryMesh()[patchi].name()
<< " is not found in the boundaryRadiationProperties. " << " is not found in the boundaryRadiationProperties. "
<< "Please add it" << "Please add it"
<< exit(FatalError); << exit(FatalError);
@ -112,18 +112,18 @@ Foam::radiation::boundaryRadiationProperties::emissivity
Foam::tmp<Foam::scalarField> Foam::tmp<Foam::scalarField>
Foam::radiation::boundaryRadiationProperties::absorptivity Foam::radiation::boundaryRadiationProperties::absorptivity
( (
const label patchI, const label patchi,
const label bandI const label bandi
) const ) const
{ {
if (!radBoundaryPropertiesPtrList_[patchI].empty()) if (!radBoundaryPropertiesPtrList_[patchi].empty())
{ {
return radBoundaryPropertiesPtrList_[patchI]->absorptivity(bandI); return radBoundaryPropertiesPtrList_[patchi]->absorptivity(bandi);
} }
else else
{ {
FatalErrorInFunction FatalErrorInFunction
<< "Patch : " << mesh().boundaryMesh()[patchI].name() << "Patch : " << mesh().boundaryMesh()[patchi].name()
<< " is not found in the boundaryRadiationProperties. " << " is not found in the boundaryRadiationProperties. "
<< "Please add it" << "Please add it"
<< exit(FatalError); << exit(FatalError);
@ -136,18 +136,18 @@ Foam::radiation::boundaryRadiationProperties::absorptivity
Foam::tmp<Foam::scalarField> Foam::tmp<Foam::scalarField>
Foam::radiation::boundaryRadiationProperties::transmissivity Foam::radiation::boundaryRadiationProperties::transmissivity
( (
const label patchI, const label patchi,
const label bandI const label bandi
) const ) const
{ {
if (!radBoundaryPropertiesPtrList_[patchI].empty()) if (!radBoundaryPropertiesPtrList_[patchi].empty())
{ {
return radBoundaryPropertiesPtrList_[patchI]->transmissivity(bandI); return radBoundaryPropertiesPtrList_[patchi]->transmissivity(bandi);
} }
else else
{ {
FatalErrorInFunction FatalErrorInFunction
<< "Patch : " << mesh().boundaryMesh()[patchI].name() << "Patch : " << mesh().boundaryMesh()[patchi].name()
<< " is not found in the boundaryRadiationProperties. " << " is not found in the boundaryRadiationProperties. "
<< "Please add it" << "Please add it"
<< exit(FatalError); << exit(FatalError);
@ -160,18 +160,18 @@ Foam::radiation::boundaryRadiationProperties::transmissivity
Foam::tmp<Foam::scalarField> Foam::tmp<Foam::scalarField>
Foam::radiation::boundaryRadiationProperties::reflectivity Foam::radiation::boundaryRadiationProperties::reflectivity
( (
const label patchI, const label patchi,
const label bandI const label bandi
) const ) const
{ {
if (!radBoundaryPropertiesPtrList_[patchI].empty()) if (!radBoundaryPropertiesPtrList_[patchi].empty())
{ {
return radBoundaryPropertiesPtrList_[patchI]->reflectivity(bandI); return radBoundaryPropertiesPtrList_[patchi]->reflectivity(bandi);
} }
else else
{ {
FatalErrorInFunction FatalErrorInFunction
<< "Patch : " << mesh().boundaryMesh()[patchI].name() << "Patch : " << mesh().boundaryMesh()[patchi].name()
<< " is not found in the boundaryRadiationProperties. " << " is not found in the boundaryRadiationProperties. "
<< "Please add it" << "Please add it"
<< exit(FatalError); << exit(FatalError);

View File

@ -86,8 +86,8 @@ boundaryRadiationPropertiesPatch
: :
method_(methodTypeNames_.read(dict.lookup("mode"))), method_(methodTypeNames_.read(dict.lookup("mode"))),
dict_(dict), dict_(dict),
absorptionEmission_(NULL), absorptionEmission_(nullptr),
transmissivity_(NULL), transmissivity_(nullptr),
patch_(p) patch_(p)
{ {
switch (method_) switch (method_)

View File

@ -6,7 +6,7 @@ cd ${0%/*} || exit 1 # Run from this directory
echo "Use common files for 0/, constant/ and blockMeshDict" echo "Use common files for 0/, constant/ and blockMeshDict"
\rm -rf 0 constant \rm -rf 0 constant
\cp -r ../common/0.org 0 \cp -r ../common/0.orig 0
\cp -r ../common/constant constant \cp -r ../common/constant constant
m4 system/blockMeshDict.m4 > system/blockMeshDict m4 system/blockMeshDict.m4 > system/blockMeshDict

View File

@ -6,7 +6,7 @@ cd ${0%/*} || exit 1 # Run from this directory
echo "Use common files for 0/, constant/ and blockMeshDict" echo "Use common files for 0/, constant/ and blockMeshDict"
\rm -rf 0 constant \rm -rf 0 constant
\cp -r ../common/0.org 0 \cp -r ../common/0.orig 0
\cp -r ../common/constant constant \cp -r ../common/constant constant
m4 system/blockMeshDict.m4 > system/blockMeshDict m4 system/blockMeshDict.m4 > system/blockMeshDict

View File

@ -17,19 +17,19 @@ FoamFile
application icoFoam; application icoFoam;
startFrom startTime; startFrom latestTime;
startTime 0; startTime 0;
stopAt endTime; stopAt nextWrite;
endTime 0.5; endTime 0.5;
deltaT 0.005; deltaT 0.005;
writeControl timeStep; writeControl timeStep;
writeInterval 20; writeInterval 1;
purgeWrite 0; purgeWrite 0;
@ -49,10 +49,10 @@ functions
{ {
meshInterp1 meshInterp1
{ {
type mapFieldsFO; type mapFields;
functionObjectLibs ("libutilityFunctionObjects.so"); libs ("libfieldFunctionObjects.so");
outputControl timeStep; writeControl timeStep;
outputInterval 1; writeInterval 1;
mapRegion coarseMesh; mapRegion coarseMesh;
mapMethod cellVolumeWeight; mapMethod cellVolumeWeight;

View File

@ -6,7 +6,7 @@ cd ${0%/*} || exit 1 # Run from this directory
echo "Use common files for 0/, constant/ and blockMeshDict" echo "Use common files for 0/, constant/ and blockMeshDict"
\rm -rf 0 constant \rm -rf 0 constant
\cp -r ../common/0.org 0 \cp -r ../common/0.orig 0
\cp -r ../common/constant constant \cp -r ../common/constant constant
m4 system/blockMeshDict.m4 > system/blockMeshDict m4 system/blockMeshDict.m4 > system/blockMeshDict

View File

@ -6,7 +6,7 @@ cd ${0%/*} || exit 1 # Run from this directory
echo "Use common files for 0/, constant/ and blockMeshDict" echo "Use common files for 0/, constant/ and blockMeshDict"
\rm -rf 0 constant \rm -rf 0 constant
\cp -r ../common/0.org 0 \cp -r ../common/0.orig 0
\cp -r ../common/constant constant \cp -r ../common/constant constant
m4 system/blockMeshDict.m4 > system/blockMeshDict m4 system/blockMeshDict.m4 > system/blockMeshDict

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