From 9c32ce1016a7fc438754f50505e580e8c212b38e Mon Sep 17 00:00:00 2001 From: Mark Olesen Date: Fri, 23 Apr 2010 18:35:55 +0200 Subject: [PATCH] STYLE: use forAll macro in more places, avoid LF-CR endings --- .../combustion/dieselEngineFoam/YEqn.H | 2 +- .../combustion/dieselEngineFoam/rhoEqn.H | 2 +- .../solvers/combustion/reactingFoam/YEqn.H | 2 +- .../solvers/combustion/rhoReactingFoam/YEqn.H | 2 +- .../incompressible/pimpleDyMFoam/correctPhi.H | 2 +- .../lagrangian/reactingParcelFilmFoam/YEqn.H | 2 +- .../multiphase/bubbleFoam/createPhia.H | 2 +- .../multiphase/bubbleFoam/createPhib.H | 2 +- .../compressibleInterDyMFoam/createFields.H | 2 +- .../multiphase/interDyMFoam/createFields.H | 2 +- .../solvers/multiphase/interFoam/correctPhi.H | 2 +- .../interPhaseChangeFoam/correctPhi.H | 2 +- .../solvers/multiphase/settlingFoam/pmhEqn.H | 2 +- .../phaseModel/phaseModel/phaseModel.C | 2 +- .../foamToEnsight/foamToEnsight.C | 4 +- .../dataConversion/foamToGMV/gmvOutput.H | 6 +- .../foamToGMV/gmvOutputHeader.H | 2 +- .../USERD_get_gold_variable_info.H | 2 +- .../USERD_get_part_element_ids_by_type.H | 2 +- .../USERD_get_part_elements_by_type.H | 2 +- .../ensightFoamReader/USERD_set_filenames.H | 6 +- .../ensightFoamReader/getLagrangianScalar.H | 2 +- .../ensightFoamReader/getLagrangianVector.H | 2 +- .../ensightFoamReader/getPatchFieldScalar.H | 8 +- .../ensightFoamReader/getPatchFieldTensor.H | 6 +- .../ensightFoamReader/getPatchFieldVector.H | 6 +- .../SpaldingsLaw/SpaldingsLaw.C | 2 +- .../primitiveEntry/primitiveEntryIO.C | 2 +- .../PrimitivePatchInterpolation.C | 2 +- .../matrices/scalarMatrices/SVD/SVD.C | 2 +- .../primitiveMesh/primitivePatch/walkPatch.C | 2 +- .../attachDetach/attachInterface.C | 2 +- src/dynamicMesh/polyMeshAdder/polyMeshAdder.C | 4 +- .../polyTopoChange/addPatchCellLayer.C | 4 +- .../repatchPolyTopoChanger.C | 2 +- .../enrichedPatch/enrichedPatchFaces.C | 4 +- .../quadraticFitSnGradData.C | 7 +- .../schemes/FitData/FitData.C | 2 +- .../dieselSpray/parcel/setRelaxationTimes.C | 2 +- .../autoHexMesh/shellSurfaces/shellSurfaces.C | 2 +- src/meshTools/octree/treeLeaf.C | 2 +- src/randomProcesses/fft/fftRenumber.C | 2 +- src/sampling/sampledSet/face/faceOnlySet.C | 2 +- src/sampling/sampledSet/uniform/uniformSet.C | 4 +- .../kinematicSingleLayer.C | 2124 ++++++++--------- .../kinematicSingleLayer.H | 964 ++++---- .../kinematicSingleLayerTemplates.C | 124 +- .../thermoSingleLayer/thermoSingleLayer.C | 2 +- .../ODEChemistryModel/ODEChemistryModel.C | 6 +- .../EulerImplicit/EulerImplicit.C | 6 +- .../chemistryModel/chemistrySolver/ode/ode.C | 2 +- .../chemistrySolver/sequential/sequential.C | 6 +- .../reaction/Reactions/Reaction/Reaction.C | 2 +- .../faceTriangulation/faceTriangulation.C | 2 +- src/triSurface/triSurface/triSurface.C | 6 +- .../mixer/constant/polyMesh/blockMeshDict | 204 +- 56 files changed, 1784 insertions(+), 1789 deletions(-) diff --git a/applications/solvers/combustion/dieselEngineFoam/YEqn.H b/applications/solvers/combustion/dieselEngineFoam/YEqn.H index 9d46c0d611..f6251d1c30 100644 --- a/applications/solvers/combustion/dieselEngineFoam/YEqn.H +++ b/applications/solvers/combustion/dieselEngineFoam/YEqn.H @@ -14,7 +14,7 @@ tmp > mvConvection label inertIndex = -1; volScalarField Yt = 0.0*Y[0]; - for (label i=0; i > mvConvection label inertIndex = -1; volScalarField Yt = 0.0*Y[0]; - for (label i=0; i > mvConvection label inertIndex = -1; volScalarField Yt = 0.0*Y[0]; - for (label i=0; i > mvConvection label inertIndex = -1; volScalarField Yt = 0.0*Y[0]; - for (label i=0; i(Ua.boundaryField()[i])) { diff --git a/applications/solvers/multiphase/bubbleFoam/createPhib.H b/applications/solvers/multiphase/bubbleFoam/createPhib.H index 77bb467063..bdf4c46bcc 100644 --- a/applications/solvers/multiphase/bubbleFoam/createPhib.H +++ b/applications/solvers/multiphase/bubbleFoam/createPhib.H @@ -36,7 +36,7 @@ calculatedFvPatchScalarField::typeName ); - for (label i=0; i(Ub.boundaryField()[i])) { diff --git a/applications/solvers/multiphase/compressibleInterDyMFoam/createFields.H b/applications/solvers/multiphase/compressibleInterDyMFoam/createFields.H index 3da1b5e9c1..9d3be93d0e 100644 --- a/applications/solvers/multiphase/compressibleInterDyMFoam/createFields.H +++ b/applications/solvers/multiphase/compressibleInterDyMFoam/createFields.H @@ -135,7 +135,7 @@ zeroGradientFvPatchScalarField::typeName ); - for (label i=0; i(U_.boundaryField()[i])) { diff --git a/applications/utilities/postProcessing/dataConversion/foamToEnsight/foamToEnsight.C b/applications/utilities/postProcessing/dataConversion/foamToEnsight/foamToEnsight.C index 29bb06782f..dff5d8b8c8 100644 --- a/applications/utilities/postProcessing/dataConversion/foamToEnsight/foamToEnsight.C +++ b/applications/utilities/postProcessing/dataConversion/foamToEnsight/foamToEnsight.C @@ -341,9 +341,9 @@ int main(int argc, char *argv[]) { wordList fieldNames = objects.names(volFieldTypes[i]); - for (label j=0; jsize(); n++) + forAll(*sprayPtr, n) { elemid_array[n] = n + 1; } diff --git a/applications/utilities/postProcessing/graphics/ensightFoamReader/USERD_get_part_elements_by_type.H b/applications/utilities/postProcessing/graphics/ensightFoamReader/USERD_get_part_elements_by_type.H index d90f3643fc..c9fd0d389f 100644 --- a/applications/utilities/postProcessing/graphics/ensightFoamReader/USERD_get_part_elements_by_type.H +++ b/applications/utilities/postProcessing/graphics/ensightFoamReader/USERD_get_part_elements_by_type.H @@ -234,7 +234,7 @@ int USERD_get_part_elements_by_type } else if (part_number == nPatches+2) { - for (label n=0; nsize(); n++) + forAll(*sprayPtr, n) { conn_array[n][0] = n + 1; } diff --git a/applications/utilities/postProcessing/graphics/ensightFoamReader/USERD_set_filenames.H b/applications/utilities/postProcessing/graphics/ensightFoamReader/USERD_set_filenames.H index ccaad12cb3..a85c942a08 100644 --- a/applications/utilities/postProcessing/graphics/ensightFoamReader/USERD_set_filenames.H +++ b/applications/utilities/postProcessing/graphics/ensightFoamReader/USERD_set_filenames.H @@ -99,7 +99,7 @@ int USERD_set_filenames label nVar = 0; wordList scalars = objects.names(scalarName); - for (label n=0; n= 0) if (s.size()) { - for (label n = 0; n < s.size(); n++) + forAll(s, n) { var_array[n+1] = s[n]; } diff --git a/applications/utilities/postProcessing/graphics/ensightFoamReader/getLagrangianVector.H b/applications/utilities/postProcessing/graphics/ensightFoamReader/getLagrangianVector.H index c6548c1408..31e4bc729c 100644 --- a/applications/utilities/postProcessing/graphics/ensightFoamReader/getLagrangianVector.H +++ b/applications/utilities/postProcessing/graphics/ensightFoamReader/getLagrangianVector.H @@ -22,7 +22,7 @@ if (nVar >= 0) if (v.size()) { - for (label n = 0; n < v.size(); n++) + forAll(v, n) { if (component == 0) { diff --git a/applications/utilities/postProcessing/graphics/ensightFoamReader/getPatchFieldScalar.H b/applications/utilities/postProcessing/graphics/ensightFoamReader/getPatchFieldScalar.H index 0c91c665e6..46f4f46d8d 100644 --- a/applications/utilities/postProcessing/graphics/ensightFoamReader/getPatchFieldScalar.H +++ b/applications/utilities/postProcessing/graphics/ensightFoamReader/getPatchFieldScalar.H @@ -39,7 +39,7 @@ const polyBoundaryMesh& bMesh = meshPtr->boundaryMesh(); if (which_type == Z_TRI03) { label counter = 1; - for (label facei=0; faceiboundaryMesh(); if (which_type == Z_TRI03) { label counter = 1; - for (label n=0; nboundaryMesh(); if (which_type == Z_TRI03) { label counter = 1; - for (label facei=0; facei::makeFaceToEdgeWeights() const faceToEdgeWeightsPtr_ = new scalarList(patch_.nInternalEdges()); scalarList& weights = *faceToEdgeWeightsPtr_; - for (label edgei = 0; edgei < weights.size(); edgei++) + forAll(weights, edgei) { vector P = faces[edgeFaces[edgei][0]].centre(points); vector N = faces[edgeFaces[edgei][1]].centre(points); diff --git a/src/OpenFOAM/matrices/scalarMatrices/SVD/SVD.C b/src/OpenFOAM/matrices/scalarMatrices/SVD/SVD.C index 841dbc7d0a..1d4716a222 100644 --- a/src/OpenFOAM/matrices/scalarMatrices/SVD/SVD.C +++ b/src/OpenFOAM/matrices/scalarMatrices/SVD/SVD.C @@ -363,7 +363,7 @@ Foam::SVD::SVD(const scalarRectangularMatrix& A, const scalar minCondition) // zero singular values that are less than minCondition*maxS const scalar minS = minCondition*S_[findMax(S_)]; - for (label i = 0; i < S_.size(); i++) + forAll(S_, i) { if (S_[i] <= minS) { diff --git a/src/OpenFOAM/meshes/primitiveMesh/primitivePatch/walkPatch.C b/src/OpenFOAM/meshes/primitiveMesh/primitivePatch/walkPatch.C index a94cf99ae4..956846fb94 100644 --- a/src/OpenFOAM/meshes/primitiveMesh/primitivePatch/walkPatch.C +++ b/src/OpenFOAM/meshes/primitiveMesh/primitivePatch/walkPatch.C @@ -153,7 +153,7 @@ void Foam::walkPatch::faceToFace indexInFace_.append(fp); // Visit neighbouring faces in order, starting at fp. - for (label i = 0; i < f.size(); i++) + forAll(f, i) { label fp1 = reverse_ ? f.rcIndex(fp) : f.fcIndex(fp); label nbr = getNeighbour(faceI, fp, f[fp], f[fp1]); diff --git a/src/dynamicMesh/attachDetach/attachInterface.C b/src/dynamicMesh/attachDetach/attachInterface.C index e195395e6a..8217d549be 100644 --- a/src/dynamicMesh/attachDetach/attachInterface.C +++ b/src/dynamicMesh/attachDetach/attachInterface.C @@ -88,7 +88,7 @@ void Foam::attachDetach::attachInterface // Pout << "Points to be mapped: " << removedPoints << endl; // Remove all faces from the slave patch - for (label i = 0; i < slavePatch.size(); i++) + forAll(slavePatch, i) { ref.setAction(polyRemoveFace(i + slavePatchStart)); // Pout << "Removing face " << i + slavePatchStart << endl; diff --git a/src/dynamicMesh/polyMeshAdder/polyMeshAdder.C b/src/dynamicMesh/polyMeshAdder/polyMeshAdder.C index 4eae7a7c69..76e0bd0f89 100644 --- a/src/dynamicMesh/polyMeshAdder/polyMeshAdder.C +++ b/src/dynamicMesh/polyMeshAdder/polyMeshAdder.C @@ -265,7 +265,7 @@ Foam::List Foam::polyMeshAdder::combinePatches // Copy patches0 with new sizes. First patches always come from // mesh0 and will always be present. - for (label patchI = 0; patchI < patches0.size(); patchI++) + forAll(patches0, patchI) { // Originates from mesh0. Clone with new size & filter out empty // patch. @@ -363,7 +363,7 @@ Foam::labelList Foam::polyMeshAdder::getFaceOrder labelList oldToNew(owner.size(), -1); // Leave boundary faces in order - for (label faceI = nInternalFaces; faceI < owner.size(); faceI++) + for (label faceI = nInternalFaces; faceI < owner.size(); ++faceI) { oldToNew[faceI] = faceI; } diff --git a/src/dynamicMesh/polyTopoChange/polyTopoChange/addPatchCellLayer.C b/src/dynamicMesh/polyTopoChange/polyTopoChange/addPatchCellLayer.C index 5d4ff5722f..9105db9023 100644 --- a/src/dynamicMesh/polyTopoChange/polyTopoChange/addPatchCellLayer.C +++ b/src/dynamicMesh/polyTopoChange/polyTopoChange/addPatchCellLayer.C @@ -915,7 +915,7 @@ void Foam::addPatchCellLayer::setRefinement vector disp = firstLayerDisp[patchPointI]; - for (label i = 0; i < addedPoints_[patchPointI].size(); i++) + forAll(addedPoints_[patchPointI], i) { pt += disp; @@ -1000,7 +1000,7 @@ void Foam::addPatchCellLayer::setRefinement face newFace(f.size()); - for (label i = 0; i < addedCells[patchFaceI].size(); i++) + forAll(addedCells[patchFaceI], i) { forAll(f, fp) { diff --git a/src/dynamicMesh/polyTopoChange/repatchPolyTopoChanger/repatchPolyTopoChanger.C b/src/dynamicMesh/polyTopoChange/repatchPolyTopoChanger/repatchPolyTopoChanger.C index 428f6e0e49..f5040a0d8e 100644 --- a/src/dynamicMesh/polyTopoChange/repatchPolyTopoChanger/repatchPolyTopoChanger.C +++ b/src/dynamicMesh/polyTopoChange/repatchPolyTopoChanger/repatchPolyTopoChanger.C @@ -262,7 +262,7 @@ void Foam::repatchPolyTopoChanger::changeAnchorPoint label fVert = fp; - for (label i = 0; i < f.size(); i++) + forAll(f, i) { newFace[i] = f[fVert++]; diff --git a/src/dynamicMesh/slidingInterface/enrichedPatch/enrichedPatchFaces.C b/src/dynamicMesh/slidingInterface/enrichedPatch/enrichedPatchFaces.C index f92963bb2c..1bc7f633dd 100644 --- a/src/dynamicMesh/slidingInterface/enrichedPatch/enrichedPatchFaces.C +++ b/src/dynamicMesh/slidingInterface/enrichedPatch/enrichedPatchFaces.C @@ -200,7 +200,7 @@ void Foam::enrichedPatch::calcEnrichedFaces // Go through the points and collect them based on // weights from lower to higher. This gives the // correct order of points along the edge. - for (label passI = 0; passI < edgePointWeights.size(); passI++) + forAll(edgePointWeights, passI) { // Max weight can only be one, so the sorting is // done by elimination. @@ -351,7 +351,7 @@ void Foam::enrichedPatch::calcEnrichedFaces // Go through the points and collect them based on // weights from lower to higher. This gives the // correct order of points along the edge. - for (label pass = 0; pass < edgePointWeights.size(); pass++) + forAll(edgePointWeights, passI) { // Max weight can only be one, so the sorting is // done by elimination. diff --git a/src/finiteVolume/finiteVolume/snGradSchemes/quadraticFitSnGrad/quadraticFitSnGradData.C b/src/finiteVolume/finiteVolume/snGradSchemes/quadraticFitSnGrad/quadraticFitSnGradData.C index 101acff876..dc93fbbfc1 100644 --- a/src/finiteVolume/finiteVolume/snGradSchemes/quadraticFitSnGrad/quadraticFitSnGradData.C +++ b/src/finiteVolume/finiteVolume/snGradSchemes/quadraticFitSnGrad/quadraticFitSnGradData.C @@ -31,10 +31,7 @@ License // * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * // -namespace Foam -{ - defineTypeNameAndDebug(quadraticFitSnGradData, 0); -} +defineTypeNameAndDebug(Foam::quadraticFitSnGradData, 0); // * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // @@ -205,7 +202,7 @@ Foam::label Foam::quadraticFitSnGradData::calcFit // calculate the matrix of the polynomial components scalarRectangularMatrix B(C.size(), minSize_, scalar(0)); - for (label ip = 0; ip < C.size(); ip++) + forAll(C, ip) { const point& p = C[ip]; diff --git a/src/finiteVolume/interpolation/surfaceInterpolation/schemes/FitData/FitData.C b/src/finiteVolume/interpolation/surfaceInterpolation/schemes/FitData/FitData.C index 69df844100..053c08b2f9 100644 --- a/src/finiteVolume/interpolation/surfaceInterpolation/schemes/FitData/FitData.C +++ b/src/finiteVolume/interpolation/surfaceInterpolation/schemes/FitData/FitData.C @@ -164,7 +164,7 @@ void Foam::FitData::calcFit // Matrix of the polynomial components scalarRectangularMatrix B(C.size(), minSize_, scalar(0)); - for (label ip = 0; ip < C.size(); ip++) + forAll(C, ip) { const point& p = C[ip]; diff --git a/src/lagrangian/dieselSpray/parcel/setRelaxationTimes.C b/src/lagrangian/dieselSpray/parcel/setRelaxationTimes.C index 7192e70ad1..698f347b03 100644 --- a/src/lagrangian/dieselSpray/parcel/setRelaxationTimes.C +++ b/src/lagrangian/dieselSpray/parcel/setRelaxationTimes.C @@ -258,7 +258,7 @@ void parcel::setRelaxationTimes scalar vapourSurfaceEnthalpy = 0.0; scalar vapourFarEnthalpy = 0.0; - for (label k = 0; k < sDB.gasProperties().size(); k++) + forAll(sDB.gasProperties(), k) { vapourSurfaceEnthalpy += sDB.composition().Y()[k][celli]*sDB.gasProperties()[k].H(tBoilingSurface); vapourFarEnthalpy += sDB.composition().Y()[k][celli]*sDB.gasProperties()[k].H(temperature); diff --git a/src/mesh/autoMesh/autoHexMesh/shellSurfaces/shellSurfaces.C b/src/mesh/autoMesh/autoHexMesh/shellSurfaces/shellSurfaces.C index bacbbd17b5..c957f32f64 100644 --- a/src/mesh/autoMesh/autoHexMesh/shellSurfaces/shellSurfaces.C +++ b/src/mesh/autoMesh/autoHexMesh/shellSurfaces/shellSurfaces.C @@ -177,7 +177,7 @@ void Foam::shellSurfaces::orient() boundBox shellBb(points[0], points[0]); // Assume surface is compact! - for (label i = 0; i < points.size(); i++) + forAll(points, i) { const point& pt = points[i]; shellBb.min() = min(shellBb.min(), pt); diff --git a/src/meshTools/octree/treeLeaf.C b/src/meshTools/octree/treeLeaf.C index 823594fb71..9f672f73fa 100644 --- a/src/meshTools/octree/treeLeaf.C +++ b/src/meshTools/octree/treeLeaf.C @@ -453,7 +453,7 @@ Foam::Ostream& Foam::operator<< (Ostream& os, const treeLeaf& leaf) { // Storage not trimmed os << token::SPACE << leaf.size() << token::SPACE << token::BEGIN_LIST; - for (label i = 0; i < leaf.size(); i++) + forAll(leaf, i) { os << token::SPACE << leaf.indices()[i]; } diff --git a/src/randomProcesses/fft/fftRenumber.C b/src/randomProcesses/fft/fftRenumber.C index c88dfb12c6..d18f19c6d6 100644 --- a/src/randomProcesses/fft/fftRenumber.C +++ b/src/randomProcesses/fft/fftRenumber.C @@ -115,7 +115,7 @@ void fftRenumber List renumData(data); label nnprod(1); - for (label i=0; i= startSegmentI; --i) + for (label i = samplingPts.size() - 1; i >= startSegmentI; --i) { samplingSegments.append(segmentI); } diff --git a/src/sampling/sampledSet/uniform/uniformSet.C b/src/sampling/sampledSet/uniform/uniformSet.C index 877ec14392..02e731e3e5 100644 --- a/src/sampling/sampledSet/uniform/uniformSet.C +++ b/src/sampling/sampledSet/uniform/uniformSet.C @@ -64,7 +64,7 @@ bool Foam::uniformSet::nextSample samplePt += offset; sampleI++; - for(; sampleI < nPoints_; sampleI++) + for (; sampleI < nPoints_; sampleI++) { scalar s = (samplePt - currentPt) & normOffset; @@ -328,7 +328,7 @@ void Foam::uniformSet::calcSamples ); // fill sampleSegments - for(label i = samplingPts.size() - 1; i >= startSegmentI; --i) + for (label i = samplingPts.size() - 1; i >= startSegmentI; --i) { samplingSegments.append(segmentI); } diff --git a/src/surfaceFilmModels/surfaceFilmModel/kinematicSingleLayer/kinematicSingleLayer.C b/src/surfaceFilmModels/surfaceFilmModel/kinematicSingleLayer/kinematicSingleLayer.C index 376d2cd199..090b1091ae 100644 --- a/src/surfaceFilmModels/surfaceFilmModel/kinematicSingleLayer/kinematicSingleLayer.C +++ b/src/surfaceFilmModels/surfaceFilmModel/kinematicSingleLayer/kinematicSingleLayer.C @@ -1,1062 +1,1062 @@ -/*---------------------------------------------------------------------------*\ - ========= | - \\ / F ield | OpenFOAM: The Open Source CFD Toolbox - \\ / O peration | - \\ / A nd | Copyright (C) 2009-2010 OpenCFD Ltd. - \\/ M anipulation | -------------------------------------------------------------------------------- -License - This file is part of OpenFOAM. - - OpenFOAM 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. - - OpenFOAM 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 OpenFOAM. If not, see . - -\*---------------------------------------------------------------------------*/ - -#include "kinematicSingleLayer.H" -#include "fvm.H" -#include "fvcDiv.H" -#include "fvcLaplacian.H" -#include "fvcSnGrad.H" -#include "fvcReconstruct.H" -#include "fvcVolumeIntegrate.H" -#include "addToRunTimeSelectionTable.H" -#include "directMappedWallPolyPatch.H" - -// Sub-models -#include "injectionModel.H" - -// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * // - -namespace Foam -{ - namespace surfaceFilmModels - { - defineTypeNameAndDebug(kinematicSingleLayer, 0); - addToRunTimeSelectionTable - ( - surfaceFilmModel, - kinematicSingleLayer, - mesh - ); - } -} - - -// * * * * * * * * * * * * Protected Member Functions * * * * * * * * * * * // - -bool Foam::surfaceFilmModels::kinematicSingleLayer::read() -{ - if (surfaceFilmModel::read()) - { - const dictionary& solution = filmRegion_.solutionDict().subDict("PISO"); - solution.lookup("momentumPredictor") >> momentumPredictor_; - solution.lookup("nOuterCorr") >> nOuterCorr_; - solution.lookup("nCorr") >> nCorr_; - solution.lookup("nNonOrthCorr") >> nNonOrthCorr_; - - coeffs_.lookup("Cf") >> Cf_; - coeffs_.lookup("deltaStable") >> deltaStable_; - - return true; - } - else - { - return false; - } -} - - -void Foam::surfaceFilmModels::kinematicSingleLayer::initialise() -{ - if (debug) - { - Pout<< "kinematicSingleLayer::initialise()" << endl; - } - - label nBoundaryFaces = 0; - DynamicList