Correct formatting: "forAll (" -> "forAll("

Resolves bug-report http://www.openfoam.org/mantisbt/view.php?id=1967
This commit is contained in:
Henry Weller
2016-01-09 23:10:16 +00:00
parent 1eca13aeb9
commit 75cf86b769
25 changed files with 63 additions and 65 deletions

View File

@ -15,7 +15,7 @@
); );
} }
/* /*
forAll (porousFluidRegions, porousI) forAll(porousFluidRegions, porousI)
{ {
CoNum = max CoNum = max
( (

View File

@ -2,7 +2,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) 2011-2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License
@ -446,7 +446,7 @@ Foam::label Foam::checkTopology
if (returnReduce(mp.size(), sumOp<label>()) > 0) if (returnReduce(mp.size(), sumOp<label>()) > 0)
{ {
boundBox bb(point::max, point::min); boundBox bb(point::max, point::min);
forAll (mp, i) forAll(mp, i)
{ {
bb.min() = min(bb.min(), pts[mp[i]]); bb.min() = min(bb.min(), pts[mp[i]]);
bb.max() = max(bb.max(), pts[mp[i]]); bb.max() = max(bb.max(), pts[mp[i]]);

View File

@ -2,7 +2,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) 2011-2015 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License
@ -381,7 +381,7 @@ int main(int argc, char *argv[])
DynamicList<label> localAgg(nCoarseFaces); DynamicList<label> localAgg(nCoarseFaces);
forAll (viewFactorsPatches, i) forAll(viewFactorsPatches, i)
{ {
const label patchID = viewFactorsPatches[i]; const label patchID = viewFactorsPatches[i];
@ -689,7 +689,7 @@ int main(int argc, char *argv[])
if (mesh.nSolutionD() == 3) if (mesh.nSolutionD() == 3)
{ {
forAll (localCoarseSf, coarseFaceI) forAll(localCoarseSf, coarseFaceI)
{ {
const List<point>& localFineSf = compactFineSf[coarseFaceI]; const List<point>& localFineSf = compactFineSf[coarseFaceI];
const vector Ai = sum(localFineSf); const vector Ai = sum(localFineSf);
@ -709,12 +709,12 @@ int main(int argc, char *argv[])
const label toPatchId = compactPatchId[compactJ]; const label toPatchId = compactPatchId[compactJ];
scalar Fij = 0; scalar Fij = 0;
forAll (localFineSf, i) forAll(localFineSf, i)
{ {
const vector& dAi = localFineSf[i]; const vector& dAi = localFineSf[i];
const vector& dCi = localFineCf[i]; const vector& dCi = localFineCf[i];
forAll (remoteFineSj, j) forAll(remoteFineSj, j)
{ {
const vector& dAj = remoteFineSj[j]; const vector& dAj = remoteFineSj[j];
const vector& dCj = remoteFineCj[j]; const vector& dCj = remoteFineCj[j];
@ -762,7 +762,7 @@ int main(int argc, char *argv[])
patchArea[fromPatchId] += mag(Ai); patchArea[fromPatchId] += mag(Ai);
const labelList& visCoarseFaces = visibleFaceFaces[coarseFaceI]; const labelList& visCoarseFaces = visibleFaceFaces[coarseFaceI];
forAll (visCoarseFaces, visCoarseFaceI) forAll(visCoarseFaces, visCoarseFaceI)
{ {
F[coarseFaceI].setSize(visCoarseFaces.size()); F[coarseFaceI].setSize(visCoarseFaces.size());
label compactJ = visCoarseFaces[visCoarseFaceI]; label compactJ = visCoarseFaces[visCoarseFaceI];
@ -847,7 +847,7 @@ int main(int argc, char *argv[])
const scalar Fij = sum(F[compactI]); const scalar Fij = sum(F[compactI]);
const label coarseFaceID = coarsePatchFace[coarseI]; const label coarseFaceID = coarsePatchFace[coarseI];
const labelList& fineFaces = coarseToFine[coarseFaceID]; const labelList& fineFaces = coarseToFine[coarseFaceID];
forAll (fineFaces, fineId) forAll(fineFaces, fineId)
{ {
const label faceID = fineFaces[fineId]; const label faceID = fineFaces[fineId];
viewFactorField.boundaryField()[patchID][faceID] = Fij; viewFactorField.boundaryField()[patchID][faceID] = Fij;

View File

@ -2,7 +2,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) 2011-2015 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License
@ -101,7 +101,7 @@ int main(int argc, char *argv[])
{ {
if (faceZone[f] == z) if (faceZone[f] == z)
{ {
forAll (faceEds[f], fe) forAll(faceEds[f], fe)
{ {
if (edFaces[faceEds[f][fe]].size() < 2) if (edFaces[faceEds[f][fe]].size() < 2)
{ {

View File

@ -2,7 +2,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) 2011-2015 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License
@ -42,7 +42,7 @@ void Foam::LduMatrix<Type, DType, LUType>::initMatrixInterfaces
|| Pstream::defaultCommsType == Pstream::nonBlocking || Pstream::defaultCommsType == Pstream::nonBlocking
) )
{ {
forAll (interfaces_, interfaceI) forAll(interfaces_, interfaceI)
{ {
if (interfaces_.set(interfaceI)) if (interfaces_.set(interfaceI))
{ {
@ -114,7 +114,7 @@ void Foam::LduMatrix<Type, DType, LUType>::updateMatrixInterfaces
OPstream::waitRequests(); OPstream::waitRequests();
} }
forAll (interfaces_, interfaceI) forAll(interfaces_, interfaceI)
{ {
if (interfaces_.set(interfaceI)) if (interfaces_.set(interfaceI))
{ {
@ -134,7 +134,7 @@ void Foam::LduMatrix<Type, DType, LUType>::updateMatrixInterfaces
const lduSchedule& patchSchedule = this->patchSchedule(); const lduSchedule& patchSchedule = this->patchSchedule();
// Loop over all the "normal" interfaces relating to standard patches // Loop over all the "normal" interfaces relating to standard patches
forAll (patchSchedule, i) forAll(patchSchedule, i)
{ {
label interfaceI = patchSchedule[i].patch; label interfaceI = patchSchedule[i].patch;

View File

@ -2,7 +2,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) 2011-2015 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License
@ -179,7 +179,7 @@ Foam::polyBoundaryMesh::polyBoundaryMesh
{ {
polyPatchList& patches = *this; polyPatchList& patches = *this;
patches.setSize(ppl.size()); patches.setSize(ppl.size());
forAll (patches, patchI) forAll(patches, patchI)
{ {
patches.set(patchI, ppl[patchI].clone(*this).ptr()); patches.set(patchI, ppl[patchI].clone(*this).ptr());
} }

View File

@ -2,7 +2,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) 2012-2015 OpenFOAM Foundation \\ / A nd | Copyright (C) 2012-2016 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License
@ -441,7 +441,7 @@ bool Foam::polyMesh::checkCellDeterminant
scalar minDet = min(cellDeterminant); scalar minDet = min(cellDeterminant);
scalar sumDet = sum(cellDeterminant); scalar sumDet = sum(cellDeterminant);
forAll (cellDeterminant, cellI) forAll(cellDeterminant, cellI)
{ {
if (cellDeterminant[cellI] < warnDet) if (cellDeterminant[cellI] < warnDet)
{ {
@ -529,7 +529,7 @@ bool Foam::polyMesh::checkFaceWeight
// Statistics only for internal and masters of coupled faces // Statistics only for internal and masters of coupled faces
PackedBoolList isMasterFace(syncTools::getInternalOrMasterFaces(*this)); PackedBoolList isMasterFace(syncTools::getInternalOrMasterFaces(*this));
forAll (faceWght, faceI) forAll(faceWght, faceI)
{ {
if (faceWght[faceI] < minWeight) if (faceWght[faceI] < minWeight)
{ {
@ -618,7 +618,7 @@ bool Foam::polyMesh::checkVolRatio
// Statistics only for internal and masters of coupled faces // Statistics only for internal and masters of coupled faces
PackedBoolList isMasterFace(syncTools::getInternalOrMasterFaces(*this)); PackedBoolList isMasterFace(syncTools::getInternalOrMasterFaces(*this));
forAll (volRatio, faceI) forAll(volRatio, faceI)
{ {
if (volRatio[faceI] < minRatio) if (volRatio[faceI] < minRatio)
{ {

View File

@ -2,7 +2,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) 2011-2015 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License
@ -186,7 +186,7 @@ Foam::ZoneMesh<ZoneType, MeshType>::ZoneMesh
// Nothing read. Use supplied zones // Nothing read. Use supplied zones
PtrList<ZoneType>& zones = *this; PtrList<ZoneType>& zones = *this;
zones.setSize(pzm.size()); zones.setSize(pzm.size());
forAll (zones, zoneI) forAll(zones, zoneI)
{ {
zones.set(zoneI, pzm[zoneI].clone(*this).ptr()); zones.set(zoneI, pzm[zoneI].clone(*this).ptr());
} }

View File

@ -2,7 +2,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) 2012-2015 OpenFOAM Foundation \\ / A nd | Copyright (C) 2012-2016 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License
@ -484,7 +484,7 @@ Foam::tmp<Foam::scalarField> Foam::primitiveMeshTools::cellDeterminant
} }
else else
{ {
forAll (c, cellI) forAll(c, cellI)
{ {
const labelList& curFaces = c[cellI]; const labelList& curFaces = c[cellI];

View File

@ -2,7 +2,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) 2011-2015 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License
@ -282,7 +282,7 @@ void Foam::externalWallHeatFluxTemperatureFvPatchScalarField::updateCoeffs()
scalar totalSolidRes = 0.0; scalar totalSolidRes = 0.0;
if (thicknessLayers_.size() > 0) if (thicknessLayers_.size() > 0)
{ {
forAll (thicknessLayers_, iLayer) forAll(thicknessLayers_, iLayer)
{ {
const scalar l = thicknessLayers_[iLayer]; const scalar l = thicknessLayers_[iLayer];
if (kappaLayers_[iLayer] > 0.0) if (kappaLayers_[iLayer] > 0.0)

View File

@ -2,7 +2,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) 2011-2015 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License
@ -109,7 +109,7 @@ turbulentTemperatureCoupledBaffleMixedFvPatchScalarField
if (thicknessLayers_.size() > 0) if (thicknessLayers_.size() > 0)
{ {
// Calculate effective thermal resistance by harmonic averaging // Calculate effective thermal resistance by harmonic averaging
forAll (thicknessLayers_, iLayer) forAll(thicknessLayers_, iLayer)
{ {
contactRes_ += thicknessLayers_[iLayer]/kappaLayers_[iLayer]; contactRes_ += thicknessLayers_[iLayer]/kappaLayers_[iLayer];
} }

View File

@ -2,7 +2,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) 2011-2015 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License
@ -115,7 +115,7 @@ turbulentTemperatureRadCoupledMixedFvPatchScalarField
if (thicknessLayers_.size() > 0) if (thicknessLayers_.size() > 0)
{ {
// Calculate effective thermal resistance by harmonic averaging // Calculate effective thermal resistance by harmonic averaging
forAll (thicknessLayers_, iLayer) forAll(thicknessLayers_, iLayer)
{ {
contactRes_ += thicknessLayers_[iLayer]/kappaLayers_[iLayer]; contactRes_ += thicknessLayers_[iLayer]/kappaLayers_[iLayer];
} }

View File

@ -2,7 +2,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) 2011-2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License
@ -110,7 +110,7 @@ extrudePatchMesh::extrudePatchMesh
List<word> patchTypes(regionPatches.size()); List<word> patchTypes(regionPatches.size());
PtrList<dictionary> dicts(regionPatches.size()); PtrList<dictionary> dicts(regionPatches.size());
forAll (dicts, patchI) forAll(dicts, patchI)
{ {
if (!dicts.set(patchI)) if (!dicts.set(patchI))
{ {
@ -122,13 +122,13 @@ extrudePatchMesh::extrudePatchMesh
dicts[sidePatchID] = dict_.subDict("sideCoeffs"); dicts[sidePatchID] = dict_.subDict("sideCoeffs");
dicts[topPatchID] = dict_.subDict("topCoeffs"); dicts[topPatchID] = dict_.subDict("topCoeffs");
forAll (dicts, patchI) forAll(dicts, patchI)
{ {
dicts[patchI].lookup("name") >> patchNames[patchI]; dicts[patchI].lookup("name") >> patchNames[patchI];
dicts[patchI].lookup("type") >> patchTypes[patchI]; dicts[patchI].lookup("type") >> patchTypes[patchI];
} }
forAll (regionPatches, patchI) forAll(regionPatches, patchI)
{ {
dictionary& patchDict = dicts[patchI]; dictionary& patchDict = dicts[patchI];
patchDict.set("nFaces", 0); patchDict.set("nFaces", 0);
@ -267,7 +267,7 @@ void extrudePatchMesh::extrudeMesh(const List<polyPatch*>& regionPatches)
List<word> patchTypes(regionPatches.size()); List<word> patchTypes(regionPatches.size());
PtrList<dictionary> dicts(regionPatches.size()); PtrList<dictionary> dicts(regionPatches.size());
forAll (dicts, patchI) forAll(dicts, patchI)
{ {
if (!dicts.set(patchI)) if (!dicts.set(patchI))
{ {
@ -279,13 +279,13 @@ void extrudePatchMesh::extrudeMesh(const List<polyPatch*>& regionPatches)
dicts[sidePatchID] = dict_.subDict("sideCoeffs"); dicts[sidePatchID] = dict_.subDict("sideCoeffs");
dicts[topPatchID] = dict_.subDict("topCoeffs"); dicts[topPatchID] = dict_.subDict("topCoeffs");
forAll (dicts, patchI) forAll(dicts, patchI)
{ {
dicts[patchI].lookup("name") >> patchNames[patchI]; dicts[patchI].lookup("name") >> patchNames[patchI];
dicts[patchI].lookup("type") >> patchTypes[patchI]; dicts[patchI].lookup("type") >> patchTypes[patchI];
} }
forAll (regionPatches, patchI) forAll(regionPatches, patchI)
{ {
dictionary& patchDict = dicts[patchI]; dictionary& patchDict = dicts[patchI];
patchDict.set("nFaces", 0); patchDict.set("nFaces", 0);

View File

@ -2,7 +2,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) 2012-2015 OpenFOAM Foundation \\ / A nd | Copyright (C) 2012-2016 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License
@ -79,7 +79,7 @@ void Foam::porosityModels::DarcyForchheimer::calcTransformModelData()
{ {
if (coordSys_.R().uniform()) if (coordSys_.R().uniform())
{ {
forAll (cellZoneIDs_, zoneI) forAll(cellZoneIDs_, zoneI)
{ {
D_[zoneI].setSize(1); D_[zoneI].setSize(1);
F_[zoneI].setSize(1); F_[zoneI].setSize(1);

View File

@ -2,7 +2,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) 2012-2015 OpenFOAM Foundation \\ / A nd | Copyright (C) 2012-2016 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License
@ -135,7 +135,7 @@ void Foam::porosityModels::fixedCoeff::calcTransformModelData()
{ {
if (coordSys_.R().uniform()) if (coordSys_.R().uniform())
{ {
forAll (cellZoneIDs_, zoneI) forAll(cellZoneIDs_, zoneI)
{ {
alpha_[zoneI].setSize(1); alpha_[zoneI].setSize(1);
beta_[zoneI].setSize(1); beta_[zoneI].setSize(1);

View File

@ -2,7 +2,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) 2011-2015 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License
@ -190,7 +190,7 @@ void Foam::activePressureForceBaffleVelocityFvPatchVectorField::autoMap
//- Note: we don't want to use Sf here since triggers rebuilding of //- Note: we don't want to use Sf here since triggers rebuilding of
// fvMesh::S() which will give problems when mapped (since already // fvMesh::S() which will give problems when mapped (since already
// on new mesh) // on new mesh)
forAll (patch().boundaryMesh().mesh().faceAreas(), i) forAll(patch().boundaryMesh().mesh().faceAreas(), i)
{ {
if (mag(patch().boundaryMesh().mesh().faceAreas()[i]) == 0) if (mag(patch().boundaryMesh().mesh().faceAreas()[i]) == 0)
{ {

View File

@ -2,7 +2,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) 2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2013-2016 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License
@ -68,7 +68,7 @@ void Foam::fv::LeastSquaresVectors<Stencil>::calcLeastSquaresVectors()
// including components for the "empty" directions // including components for the "empty" directions
symmTensor dd0(sqr((Vector<label>::one - mesh.geometricD())/2)); symmTensor dd0(sqr((Vector<label>::one - mesh.geometricD())/2));
forAll (vectors_, i) forAll(vectors_, i)
{ {
List<vector>& lsvi = vectors_[i]; List<vector>& lsvi = vectors_[i];
symmTensor dd(dd0); symmTensor dd(dd0);

View File

@ -2,7 +2,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) 2011-2015 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License
@ -254,7 +254,7 @@ void Foam::pairPatchAgglomeration::mapBaseToTopAgglom
) )
{ {
const labelList& fineToCoarse = restrictAddressing_[fineLevelIndex]; const labelList& fineToCoarse = restrictAddressing_[fineLevelIndex];
forAll (restrictTopBottomAddressing_, i) forAll(restrictTopBottomAddressing_, i)
{ {
restrictTopBottomAddressing_[i] = restrictTopBottomAddressing_[i] =
fineToCoarse[restrictTopBottomAddressing_[i]]; fineToCoarse[restrictTopBottomAddressing_[i]];

View File

@ -2,7 +2,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) 2011-2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License
@ -94,8 +94,6 @@ class mapPolyMesh;
class writeRegisteredObject class writeRegisteredObject
{ {
protected:
// Private data // Private data
//- Name of this set of writeRegisteredObject //- Name of this set of writeRegisteredObject

View File

@ -2,7 +2,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) 2011-2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License
@ -134,7 +134,7 @@ void Foam::regionModels::regionModel1D::initialise()
{ {
const vector& n = pNormals[localFaceI]; const vector& n = pNormals[localFaceI];
const labelList& faces = boundaryFaceFaces_[localPyrolysisFaceI++]; const labelList& faces = boundaryFaceFaces_[localPyrolysisFaceI++];
forAll (faces, faceI) forAll(faces, faceI)
{ {
const label faceID = faces[faceI]; const label faceID = faces[faceI];
nMagSf[faceID] = regionMesh().Sf()[faceID] & n; nMagSf[faceID] = regionMesh().Sf()[faceID] & n;

View File

@ -2,7 +2,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) 2011-2015 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License
@ -208,7 +208,7 @@ void thermalBaffleFvPatchScalarField::createPatchMesh()
dicts[topPatchID].add("sampleMode", mpp.sampleModeNames_[mpp.mode()]); dicts[topPatchID].add("sampleMode", mpp.sampleModeNames_[mpp.mode()]);
forAll (regionPatches, patchI) forAll(regionPatches, patchI)
{ {
dictionary& patchDict = dicts[patchI]; dictionary& patchDict = dicts[patchI];
patchDict.set("nFaces", 0); patchDict.set("nFaces", 0);

View File

@ -2,7 +2,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) 2011-2015 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License
@ -76,7 +76,7 @@ void thermalBaffleModel::init()
reduce(nTotalEdges, sumOp<label>()); reduce(nTotalEdges, sumOp<label>());
label nFaces = 0; label nFaces = 0;
forAll (rbm, patchi) forAll(rbm, patchi)
{ {
if ( if (
rbm[patchi].size() rbm[patchi].size()
@ -157,7 +157,7 @@ void thermalBaffleModel::init()
// Calculate thickness of the baffle on the first face only. // Calculate thickness of the baffle on the first face only.
if (delta_.value() == 0.0) if (delta_.value() == 0.0)
{ {
forAll (ppCoupled, localFaceI) forAll(ppCoupled, localFaceI)
{ {
label faceI = ppCoupled.start() + localFaceI; label faceI = ppCoupled.start() + localFaceI;

View File

@ -2,7 +2,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) 2011-2015 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License
@ -67,7 +67,7 @@ void Foam::probes::findElements(const fvMesh& mesh)
const vector& cellCentre = mesh.cellCentres()[cellI]; const vector& cellCentre = mesh.cellCentres()[cellI];
scalar minDistance = GREAT; scalar minDistance = GREAT;
label minFaceID = -1; label minFaceID = -1;
forAll (cellFaces, i) forAll(cellFaces, i)
{ {
label faceI = cellFaces[i]; label faceI = cellFaces[i];
vector dist = mesh.faceCentres()[faceI] - cellCentre; vector dist = mesh.faceCentres()[faceI] - cellCentre;

View File

@ -2,7 +2,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) 2011-2015 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License
@ -234,7 +234,7 @@ Foam::radiation::greyMeanAbsorptionEmission::aCont(const label bandI) const
else else
{ {
scalar invWt = 0.0; scalar invWt = 0.0;
forAll (mixture.Y(), s) forAll(mixture.Y(), s)
{ {
invWt += mixture.Y(s)[cellI]/mixture.W(s); invWt += mixture.Y(s)[cellI]/mixture.W(s);
} }

View File

@ -2,7 +2,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) 2011-2015 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License
@ -64,7 +64,7 @@ greyMeanSolidAbsorptionEmission::X(const word specie) const
{ {
const scalarField& Yi = mixture_.Y()[specieI]; const scalarField& Yi = mixture_.Y()[specieI];
forAll (rhoInv, iCell) forAll(rhoInv, iCell)
{ {
rhoInv[iCell] += rhoInv[iCell] +=
Yi[iCell]/mixture_.rho(specieI, p[iCell], T[iCell]); Yi[iCell]/mixture_.rho(specieI, p[iCell], T[iCell]);