dictionary label lookup: simplified syntax using the type templated lookup function

Replaced
    readLabel(dict.lookup("name"))
with
    dict.lookup<label>("name)
This commit is contained in:
Henry Weller
2019-11-27 11:38:59 +00:00
parent f2f9fae27b
commit d987648ef4
90 changed files with 196 additions and 196 deletions

View File

@ -69,7 +69,7 @@
// Remove the swirl component of velocity for "wedge" cases
if (pimple.dict().found("removeSwirl"))
{
label swirlCmpt(readLabel(pimple.dict().lookup("removeSwirl")));
label swirlCmpt(pimple.dict().lookup<label>("removeSwirl"));
Info<< "Removing swirl component-" << swirlCmpt << " of U" << endl;
U.field().replace(swirlCmpt, 0.0);

View File

@ -891,7 +891,7 @@ void Foam::multiphaseMixtureThermo::solve()
const Time& runTime = mesh_.time();
const dictionary& alphaControls = mesh_.solverDict("alpha");
label nAlphaSubCycles(readLabel(alphaControls.lookup("nAlphaSubCycles")));
label nAlphaSubCycles(alphaControls.lookup<label>("nAlphaSubCycles"));
scalar cAlpha(readScalar(alphaControls.lookup("cAlpha")));
volScalarField& alpha = phases_.first();

View File

@ -1,8 +1,8 @@
const dictionary& alphaControls = mesh.solverDict(alpha1.name());
label nAlphaCorr(readLabel(alphaControls.lookup("nAlphaCorr")));
label nAlphaCorr(alphaControls.lookup<label>("nAlphaCorr"));
label nAlphaSubCycles(readLabel(alphaControls.lookup("nAlphaSubCycles")));
label nAlphaSubCycles(alphaControls.lookup<label>("nAlphaSubCycles"));
bool MULESCorr(alphaControls.lookupOrDefault<Switch>("MULESCorr", false));

View File

@ -1,5 +1,5 @@
const dictionary& alphaControls = mesh.solverDict(alpha1.name());
label nAlphaCorr(readLabel(alphaControls.lookup("nAlphaCorr")));
label nAlphaCorr(alphaControls.lookup<label>("nAlphaCorr"));
label nAlphaSubCycles(readLabel(alphaControls.lookup("nAlphaSubCycles")));
label nAlphaSubCycles(alphaControls.lookup<label>("nAlphaSubCycles"));

View File

@ -1,8 +1,8 @@
const dictionary& alphaControls = mesh.solverDict(alpha1.name());
label nAlphaCorr(readLabel(alphaControls.lookup("nAlphaCorr")));
label nAlphaCorr(alphaControls.lookup<label>("nAlphaCorr"));
label nAlphaSubCycles(readLabel(alphaControls.lookup("nAlphaSubCycles")));
label nAlphaSubCycles(alphaControls.lookup<label>("nAlphaSubCycles"));
bool MULESCorr(alphaControls.lookupOrDefault<Switch>("MULESCorr", false));

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2019 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -821,7 +821,7 @@ void Foam::multiphaseSystem::solve()
const Time& runTime = mesh_.time();
const dictionary& alphaControls = mesh_.solverDict("alpha");
label nAlphaSubCycles(readLabel(alphaControls.lookup("nAlphaSubCycles")));
label nAlphaSubCycles(alphaControls.lookup<label>("nAlphaSubCycles"));
if (nAlphaSubCycles > 1)
{

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2019 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -308,7 +308,7 @@ void Foam::multiphaseMixture::solve()
volScalarField& alpha = phases_.first();
const dictionary& alphaControls = mesh_.solverDict("alpha");
label nAlphaSubCycles(readLabel(alphaControls.lookup("nAlphaSubCycles")));
label nAlphaSubCycles(alphaControls.lookup<label>("nAlphaSubCycles"));
scalar cAlpha(readScalar(alphaControls.lookup("cAlpha")));
if (nAlphaSubCycles > 1)

View File

@ -27,7 +27,7 @@ License
inline Foam::label Foam::diameterModels::populationBalanceModel::nCorr() const
{
return mesh_.solverDict(name_).lookupType<label>("nCorr");
return mesh_.solverDict(name_).lookup<label>("nCorr");
}

View File

@ -663,7 +663,7 @@ void Foam::multiphaseSystem::solve
const Time& runTime = mesh_.time();
const dictionary& alphaControls = mesh_.solverDict("alpha");
label nAlphaSubCycles(readLabel(alphaControls.lookup("nAlphaSubCycles")));
label nAlphaSubCycles(alphaControls.lookup<label>("nAlphaSubCycles"));
bool LTS = fv::localEulerDdt::enabled(mesh_);

View File

@ -129,8 +129,8 @@ void Foam::twoPhaseSystem::solve
const dictionary& alphaControls = mesh_.solverDict(alpha1.name());
label nAlphaSubCycles(readLabel(alphaControls.lookup("nAlphaSubCycles")));
label nAlphaCorr(readLabel(alphaControls.lookup("nAlphaCorr")));
label nAlphaSubCycles(alphaControls.lookup<label>("nAlphaSubCycles"));
label nAlphaCorr(alphaControls.lookup<label>("nAlphaCorr"));
bool LTS = fv::localEulerDdt::enabled(mesh_);

View File

@ -1,3 +1,3 @@
const dictionary& alphaControls = mesh.solverDict(alpha1.name());
label nAlphaSubCycles(readLabel(alphaControls.lookup("nAlphaSubCycles")));
label nAlphaSubCycles(alphaControls.lookup<label>("nAlphaSubCycles"));

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2013-2018 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2013-2019 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -361,8 +361,8 @@ void Foam::twoPhaseSystem::solve()
alpha1.name()
);
label nAlphaSubCycles(readLabel(alphaControls.lookup("nAlphaSubCycles")));
label nAlphaCorr(readLabel(alphaControls.lookup("nAlphaCorr")));
label nAlphaSubCycles(alphaControls.lookup<label>("nAlphaSubCycles"));
label nAlphaCorr(alphaControls.lookup<label>("nAlphaCorr"));
word alphaScheme("div(phi," + alpha1.name() + ')');
word alpharScheme("div(phir," + alpha1.name() + ')');

View File

@ -54,7 +54,7 @@ int main(int argc, char *argv[])
const scalar x0 = readScalar(dict.lookup("x0"));
const scalar x1 = readScalar(dict.lookup("x1"));
const label nX = readLabel(dict.lookup("nX"));
const label nX = dict.lookup<label>("nX");
const scalar dx = (x1 - x0)/(nX - 1);
const scalarField xs
(

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2019 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -681,8 +681,8 @@ int main(int argc, char *argv[])
fileName surfName(refineDict.lookup("surface"));
surfName.expand();
label nCutLayers(readLabel(refineDict.lookup("nCutLayers")));
label cellLimit(readLabel(refineDict.lookup("cellLimit")));
label nCutLayers(refineDict.lookup<label>("nCutLayers"));
label cellLimit(refineDict.lookup<label>("cellLimit"));
bool selectCut(readBool(refineDict.lookup("selectCut")));
bool selectInside(readBool(refineDict.lookup("selectInside")));
bool selectOutside(readBool(refineDict.lookup("selectOutside")));
@ -693,7 +693,7 @@ int main(int argc, char *argv[])
scalar curvature(readScalar(refineDict.lookup("curvature")));
scalar curvDist(readScalar(refineDict.lookup("curvatureDistance")));
pointField outsidePts(refineDict.lookup("outsidePoints"));
label refinementLimit(readLabel(refineDict.lookup("splitLevel")));
label refinementLimit(refineDict.lookup<label>("splitLevel"));
bool writeMesh(readBool(refineDict.lookup("writeMesh")));
Info<< "Cells to be used for meshing (0=false, 1=true):" << nl

View File

@ -73,7 +73,7 @@ Foam::cv2DControls::cv2DControls
maxBoundaryConformingIter_
(
readLabel(conformationControl_.lookup("maxBoundaryConformingIter"))
conformationControl_.lookup<label>("maxBoundaryConformingIter")
),
span_

View File

@ -819,8 +819,8 @@ Foam::backgroundMeshDecomposition::backgroundMeshDecomposition
(
coeffsDict.lookupOrDefault<scalar>("minCellSizeLimit", 0.0)
),
minLevels_(readLabel(coeffsDict.lookup("minLevels"))),
volRes_(readLabel(coeffsDict.lookup("sampleResolution"))),
minLevels_(coeffsDict.lookup<label>("minLevels")),
volRes_(coeffsDict.lookup<label>("sampleResolution")),
maxCellWeightCoeff_(readScalar(coeffsDict.lookup("maxCellWeightCoeff")))
{
if (!Pstream::parRun())

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2012-2018 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2012-2019 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -73,7 +73,7 @@ Foam::fileControl::fileControl
pointsFile_(controlFunctionDict.lookup("pointsFile")),
sizesFile_(controlFunctionDict.lookup("sizesFile")),
alignmentsFile_(controlFunctionDict.lookup("alignmentsFile")),
maxPriority_(readLabel(controlFunctionDict.lookup("priority")))
maxPriority_(controlFunctionDict.lookup<label>("priority"))
{
Info<< indent << "Loading " << name << " from file:" << nl
<< indent << " priority : " << maxPriority_ << nl

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2012-2018 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2012-2019 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -62,7 +62,7 @@ Foam::cellSizeFunction::cellSizeFunction
defaultCellSize_(defaultCellSize),
regionIndices_(regionIndices),
sideMode_(),
priority_(readLabel(cellSizeFunctionDict.lookup("priority", true)))
priority_(cellSizeFunctionDict.lookup<label>("priority", true))
{
word mode = cellSizeFunctionDict.lookup("mode", true);

View File

@ -754,7 +754,7 @@ Foam::conformalVoronoiMesh::createPolyMeshFromPoints
forAll(patches, p)
{
label totalPatchSize = readLabel(patchDicts[p].lookup("nFaces"));
label totalPatchSize = patchDicts[p].lookup<label>("nFaces");
if
(
@ -1741,7 +1741,7 @@ void Foam::conformalVoronoiMesh::createFacesOwnerNeighbourAndPatches
procNeighbours[patchi] =
(
patchDicts[patchi].found("neighbProcNo")
? readLabel(patchDicts[patchi].lookup("neighbProcNo"))
? patchDicts[patchi].lookup<label>("neighbProcNo")
: -1
);
}
@ -2368,7 +2368,7 @@ void Foam::conformalVoronoiMesh::createFacesOwnerNeighbourAndPatches
const label neighbour =
(
patchDicts[nbI].found("neighbProcNo")
? readLabel(patchDicts[nbI].lookup("neighbProcNo"))
? patchDicts[nbI].lookup<label>("neighbProcNo")
: -1
);

View File

@ -155,7 +155,7 @@ void Foam::conformalVoronoiMesh::writeMesh(const fileName& instance)
forAll(dualPatchStarts, patchi)
{
dualPatchStarts[patchi] =
readLabel(patchDicts[patchi].lookup("startFace"));
patchDicts[patchi].lookup<label>("startFace");
}
}
@ -436,8 +436,8 @@ Foam::autoPtr<Foam::fvMesh> Foam::conformalVoronoiMesh::createDummyMesh
0, // patchStarts[p],
patchi,
mesh.boundaryMesh(),
readLabel(patchDicts[patchi].lookup("myProcNo")),
readLabel(patchDicts[patchi].lookup("neighbProcNo")),
patchDicts[patchi].lookup<label>("myProcNo"),
patchDicts[patchi].lookup<label>("neighbProcNo"),
coupledPolyPatch::COINCIDENTFULLMATCH
);
}
@ -485,10 +485,10 @@ void Foam::conformalVoronoiMesh::checkProcessorPatchesMatch
)
{
const label procNeighb =
readLabel(patchDicts[patchi].lookup("neighbProcNo"));
patchDicts[patchi].lookup<label>("neighbProcNo");
procPatchSizes[Pstream::myProcNo()][procNeighb]
= readLabel(patchDicts[patchi].lookup("nFaces"));
= patchDicts[patchi].lookup<label>("nFaces");
}
}
@ -643,8 +643,8 @@ void Foam::conformalVoronoiMesh::reorderProcessorPatches
SubList<face>
(
faces,
readLabel(patchDicts[patchi].lookup("nFaces")),
readLabel(patchDicts[patchi].lookup("startFace"))
patchDicts[patchi].lookup<label>("nFaces"),
patchDicts[patchi].lookup<label>("startFace")
),
points
)
@ -666,9 +666,9 @@ void Foam::conformalVoronoiMesh::reorderProcessorPatches
if (isA<processorPolyPatch>(pp))
{
const label nPatchFaces =
readLabel(patchDicts[patchi].lookup("nFaces"));
patchDicts[patchi].lookup<label>("nFaces");
const label patchStartFace =
readLabel(patchDicts[patchi].lookup("startFace"));
patchDicts[patchi].lookup<label>("startFace");
labelList patchFaceMap(nPatchFaces, label(-1));
labelList patchFaceRotation(nPatchFaces, label(0));
@ -783,7 +783,7 @@ void Foam::conformalVoronoiMesh::writeMesh
);
}
const label nInternalFaces = readLabel(patchDicts[0].lookup("startFace"));
const label nInternalFaces = patchDicts[0].lookup<label>("startFace");
reorderPoints(points, boundaryPts, faces, nInternalFaces);
@ -831,7 +831,7 @@ void Foam::conformalVoronoiMesh::writeMesh
forAll(patches, p)
{
label totalPatchSize = readLabel(patchDicts[p].lookup("nFaces"));
label totalPatchSize = patchDicts[p].lookup<label>("nFaces");
if
(

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2012-2018 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2012-2019 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -78,7 +78,7 @@ Foam::cvControls::cvControls
surfaceConformationRebuildFrequency_ = max
(
1,
readLabel(surfDict.lookup("surfaceConformationRebuildFrequency"))
surfDict.lookup<label>("surfaceConformationRebuildFrequency")
);

View File

@ -884,9 +884,9 @@ autoDensity::autoDensity
(
detailsDict().lookupOrDefault<scalar>("minCellSizeLimit", 0.0)
),
minLevels_(readLabel(detailsDict().lookup("minLevels"))),
minLevels_(detailsDict().lookup<label>("minLevels")),
maxSizeRatio_(readScalar(detailsDict().lookup("maxSizeRatio"))),
volRes_(readLabel(detailsDict().lookup("sampleResolution"))),
volRes_(detailsDict().lookup<label>("sampleResolution")),
surfRes_
(
detailsDict().lookupOrDefault<label>("surfaceSampleResolution", volRes_)

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2019 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -432,7 +432,7 @@ int main(int argc, char *argv[])
// Get requested numberOfSubdomains. Note: have no mesh yet so
// cannot use decompositionModel::New
const label nDomains =
readLabel(IOdictionary(dictIO).lookup("numberOfSubdomains"));
IOdictionary(dictIO).lookup<label>("numberOfSubdomains");
// Give file handler a chance to determine the output directory
const_cast<fileOperation&>(fileHandler()).setNProcs(nDomains);

View File

@ -352,7 +352,7 @@ void Foam::vtkPVFoam::updateInfoPatches
{
const dictionary& patchDict = patchEntries[patchi].dict();
sizes[patchi] = readLabel(patchDict.lookup("nFaces"));
sizes[patchi] = patchDict.lookup<label>("nFaces");
names[patchi] = patchEntries[patchi].keyword();
}

View File

@ -11,8 +11,8 @@ IOdictionary propsDict
const word cloudName(propsDict.lookup("cloudName"));
label sampleFrequency(readLabel(propsDict.lookup("sampleFrequency")));
label sampleFrequency(propsDict.lookup<label>("sampleFrequency"));
label maxPositions(readLabel(propsDict.lookup("maxPositions")));
label maxPositions(propsDict.lookup<label>("maxPositions"));
word setFormat(propsDict.lookupOrDefault<word>("setFormat", "vtk"));

View File

@ -10,9 +10,9 @@
)
);
const label nIntervals(readLabel(pdfDictionary.lookup("nIntervals")));
const label nIntervals(pdfDictionary.lookup<label>("nIntervals"));
const label nSamples(readLabel(pdfDictionary.lookup("nSamples")));
const label nSamples(pdfDictionary.lookup<label>("nSamples"));
const bool writeData(readBool(pdfDictionary.lookup("writeData")));

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2019 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -210,16 +210,16 @@ void rewriteBoundary
Info<< "Replaced with patches" << nl
<< patches[patchi].keyword() << " with" << nl
<< " nFaces : "
<< readLabel(thisPatchDict.lookup("nFaces"))
<< thisPatchDict.lookup<label>("nFaces")
<< nl
<< " startFace : "
<< readLabel(thisPatchDict.lookup("startFace")) << nl
<< thisPatchDict.lookup<label>("startFace") << nl
<< patches[addedPatchi].keyword() << " with" << nl
<< " nFaces : "
<< readLabel(nbrPatchDict.lookup("nFaces"))
<< nbrPatchDict.lookup<label>("nFaces")
<< nl
<< " startFace : "
<< readLabel(nbrPatchDict.lookup("startFace"))
<< nbrPatchDict.lookup<label>("startFace")
<< nl << endl;
addedPatchi++;

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2019 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -332,7 +332,7 @@ int main(int argc, char *argv[])
)
);
int nProcs(readInt(decompositionDict.lookup("numberOfSubdomains")));
const int nProcs(decompositionDict.lookup<int>("numberOfSubdomains"));
Info<< "Create target mesh\n" << endl;
@ -411,7 +411,7 @@ int main(int argc, char *argv[])
)
);
int nProcs(readInt(decompositionDict.lookup("numberOfSubdomains")));
const int nProcs(decompositionDict.lookup<int>("numberOfSubdomains"));
Info<< "Create source mesh\n" << endl;
@ -490,9 +490,9 @@ int main(int argc, char *argv[])
)
);
int nProcsSource
const int nProcsSource
(
readInt(decompositionDictSource.lookup("numberOfSubdomains"))
decompositionDictSource.lookup<int>("numberOfSubdomains")
);
@ -508,9 +508,9 @@ int main(int argc, char *argv[])
)
);
int nProcsTarget
const int nProcsTarget
(
readInt(decompositionDictTarget.lookup("numberOfSubdomains"))
decompositionDictTarget.lookup<int>("numberOfSubdomains")
);
List<boundBox> bbsTarget(nProcsTarget);

View File

@ -52,7 +52,7 @@ Foam::functionObjects::FUNCTIONOBJECT::FUNCTIONOBJECT
fvMeshFunctionObject(name, runTime, dict),
wordData_(dict.lookupOrDefault<word>("wordData", "defaultWord")),
scalarData_(readScalar(dict.lookup("scalarData"))),
labelData_(readLabel(dict.lookup("labelData")))
labelData_(dict.lookup<label>("labelData"))
{
read(dict);
}

View File

@ -380,7 +380,7 @@ public:
// If recursive, search parent dictionaries.
// If patternMatch, use regular expressions.
template<class T>
T lookupType
T lookup
(
const word&,
bool recursive=false,

View File

@ -29,7 +29,7 @@ License
// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * //
template<class T>
T Foam::dictionary::lookupType
T Foam::dictionary::lookup
(
const word& keyword,
bool recursive,

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2019 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -45,8 +45,8 @@ Foam::IOerror::IOerror(const dictionary& errDict)
:
error(errDict),
ioFileName_(errDict.lookup("ioFileName")),
ioStartLineNumber_(readLabel(errDict.lookup("ioStartLineNumber"))),
ioEndLineNumber_(readLabel(errDict.lookup("ioEndLineNumber")))
ioStartLineNumber_(errDict.lookup<label>("ioStartLineNumber")),
ioEndLineNumber_(errDict.lookup<label>("ioEndLineNumber"))
{}

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2019 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -60,7 +60,7 @@ Foam::error::error(const dictionary& errDict)
messageStream(errDict),
functionName_(errDict.lookup("functionName")),
sourceFileName_(errDict.lookup("sourceFileName")),
sourceFileLineNumber_(readLabel(errDict.lookup("sourceFileLineNumber"))),
sourceFileLineNumber_(errDict.lookup<label>("sourceFileLineNumber")),
abort_(env("FOAM_ABORT")),
throwExceptions_(false),
messageStreamPtr_(new OStringStream())

View File

@ -158,7 +158,7 @@ void Foam::interpolationLookUpTable<Type>::dimensionTable()
forAll(entries_,i)
{
dim_[i] = readLabel(entries_[i].lookup("N"));
dim_[i] = entries_[i].template lookup<label>("N");
max_[i] = readScalar(entries_[i].lookup("max"));
min_[i] = readScalar(entries_[i].lookup("min"));
delta_[i] = (max_[i] - min_[i])/dim_[i];

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2013-2018 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2013-2019 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -50,7 +50,7 @@ Foam::dummyAgglomeration::dummyAgglomeration
)
:
GAMGAgglomeration(mesh, controlDict),
nLevels_(readLabel(controlDict.lookup("nLevels")))
nLevels_(controlDict.lookup<label>("nLevels"))
{
const label nCoarseCells = mesh.lduAddr().size();

View File

@ -223,7 +223,7 @@ Foam::procFacesGAMGProcAgglomeration::procFacesGAMGProcAgglomeration
)
:
GAMGProcAgglomeration(agglom, controlDict),
nAgglomeratingCells_(readLabel(controlDict.lookup("nAgglomeratingCells")))
nAgglomeratingCells_(controlDict.lookup<label>("nAgglomeratingCells"))
{}

View File

@ -109,8 +109,8 @@ Foam::processorPolyPatch::processorPolyPatch
)
:
coupledPolyPatch(name, dict, index, bm, patchType),
myProcNo_(readLabel(dict.lookup("myProcNo"))),
neighbProcNo_(readLabel(dict.lookup("neighbProcNo"))),
myProcNo_(dict.lookup<label>("myProcNo")),
neighbProcNo_(dict.lookup<label>("neighbProcNo")),
neighbFaceCentres_(),
neighbFaceAreas_(),
neighbFaceCellCentres_()

View File

@ -122,12 +122,12 @@ Foam::polyPatch::polyPatch
faceSubList
(
bm.mesh().faces(),
readLabel(dict.lookup("nFaces")),
readLabel(dict.lookup("startFace"))
dict.lookup<label>("nFaces"),
dict.lookup<label>("startFace")
),
bm.mesh().points()
),
start_(readLabel(dict.lookup("startFace"))),
start_(dict.lookup<label>("startFace")),
boundaryMesh_(bm),
faceCellsPtr_(nullptr),
mePtr_(nullptr)

View File

@ -31,7 +31,7 @@ template <class Function1Type>
void Foam::Function1s::Ramp<Function1Type>::read(const dictionary& coeffs)
{
start_ = coeffs.lookupOrDefault<scalar>("start", 0);
duration_ = coeffs.lookupType<scalar>("duration");
duration_ = coeffs.lookup<scalar>("duration");
}

View File

@ -215,8 +215,8 @@ template<class Type>
Foam::TableReaders::Csv<Type>::Csv(const dictionary& dict)
:
TableReader<Type>(dict),
nHeaderLine_(readLabel(dict.lookup("nHeaderLine"))),
refColumn_(readLabel(dict.lookup("refColumn"))),
nHeaderLine_(dict.lookup<label>("nHeaderLine")),
refColumn_(dict.lookup<label>("refColumn")),
componentColumns_(dict.lookup("componentColumns")),
separator_(dict.lookupOrDefault<string>("separator", string(","))[0]),
mergeSeparators_(readBool(dict.lookup("mergeSeparators")))

View File

@ -1183,7 +1183,7 @@ bool Foam::dynamicRefineFvMesh::update()
dynamicMeshDict().optionalSubDict(typeName + "Coeffs")
);
label refineInterval = readLabel(refineDict.lookup("refineInterval"));
label refineInterval = refineDict.lookup<label>("refineInterval");
bool hasChanged = false;
@ -1207,7 +1207,7 @@ bool Foam::dynamicRefineFvMesh::update()
if (time().timeIndex() > 0 && time().timeIndex() % refineInterval == 0)
{
label maxCells = readLabel(refineDict.lookup("maxCells"));
label maxCells = refineDict.lookup<label>("maxCells");
if (maxCells <= 0)
{
@ -1218,7 +1218,7 @@ bool Foam::dynamicRefineFvMesh::update()
<< exit(FatalError);
}
label maxRefinement = readLabel(refineDict.lookup("maxRefinement"));
label maxRefinement = refineDict.lookup<label>("maxRefinement");
if (maxRefinement <= 0)
{
@ -1243,7 +1243,7 @@ bool Foam::dynamicRefineFvMesh::update()
great
);
const label nBufferLayers =
readLabel(refineDict.lookup("nBufferLayers"));
refineDict.lookup<label>("nBufferLayers");
// Cells marked for refinement or otherwise protected from unrefinement.
PackedBoolList refineCell(nCells());

View File

@ -52,8 +52,8 @@ Foam::boundaryPatch::boundaryPatch
)
:
patchIdentifier(name, dict, index),
size_(readLabel(dict.lookup("nFaces"))),
start_(readLabel(dict.lookup("startFace")))
size_(dict.lookup<label>("nFaces")),
start_(dict.lookup<label>("startFace"))
{}

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2019 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -872,7 +872,7 @@ bool Foam::motionSmootherAlgo::scaleMesh
const scalar errorReduction =
readScalar(paramDict.lookup("errorReduction"));
const label nSmoothScale =
readLabel(paramDict.lookup("nSmoothScale"));
paramDict.lookup<label>("nSmoothScale");
// Note: displacement_ should already be synced already from setDisplacement

View File

@ -48,7 +48,7 @@ bool Foam::setRefCell
{
if (Pstream::master())
{
refCelli = readLabel(dict.lookup(refCellName));
refCelli = dict.lookup<label>(refCellName);
if (refCelli < 0 || refCelli >= field.mesh().nCells())
{

View File

@ -1,8 +1,8 @@
const dictionary& alphaControls = mesh.solverDict(alpha1.name());
label nAlphaCorr(readLabel(alphaControls.lookup("nAlphaCorr")));
label nAlphaCorr(alphaControls.lookup<label>("nAlphaCorr"));
label nAlphaSubCycles(readLabel(alphaControls.lookup("nAlphaSubCycles")));
label nAlphaSubCycles(alphaControls.lookup<label>("nAlphaSubCycles"));
bool MULESCorr(alphaControls.lookupOrDefault<Switch>("MULESCorr", false));

View File

@ -89,7 +89,7 @@ activeBaffleVelocityFvPatchVectorField
pName_(dict.lookupOrDefault<word>("p", "p")),
cyclicPatchName_(dict.lookup("cyclicPatch")),
cyclicPatchLabel_(p.patch().boundaryMesh().findPatchID(cyclicPatchName_)),
orientation_(readLabel(dict.lookup("orientation"))),
orientation_(dict.lookup<label>("orientation")),
initWallSf_(p.Sf()),
initCyclicSf_(p.boundaryMesh()[cyclicPatchLabel_].Sf()),
nbrCyclicSf_

View File

@ -95,7 +95,7 @@ activePressureForceBaffleVelocityFvPatchVectorField
pName_(dict.lookupOrDefault<word>("p", "p")),
cyclicPatchName_(dict.lookup("cyclicPatch")),
cyclicPatchLabel_(p.patch().boundaryMesh().findPatchID(cyclicPatchName_)),
orientation_(readLabel(dict.lookup("orientation"))),
orientation_(dict.lookup<label>("orientation")),
initWallSf_(0),
initCyclicSf_(0),
nbrCyclicSf_(0),

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2013-2018 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2013-2019 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -220,7 +220,7 @@ void Foam::MULES::limiterCorr
const label nLimiterIter
(
readLabel(MULEScontrols.lookup("nLimiterIter"))
MULEScontrols.lookup<label>("nLimiterIter")
);
const scalar smoothLimiter

View File

@ -265,7 +265,7 @@ void Foam::functionObjects::fieldAverage::readAveragingProperties()
{
dictionary fieldDict(propsDict.subDict(fieldName));
totalIter_[fieldi] = readLabel(fieldDict.lookup("totalIter"));
totalIter_[fieldi] = fieldDict.lookup<label>("totalIter");
totalTime_[fieldi] = readScalar(fieldDict.lookup("totalTime"));
Log << " " << fieldName

View File

@ -346,7 +346,7 @@ bool Foam::functionObjects::streamLine::read(const dictionary& dict)
if (!dict.found("direction") && dict.found("trackForward"))
{
trackDirection_ =
dict.lookupType<bool>("trackForward")
dict.lookup<bool>("trackForward")
? trackDirection::forward
: trackDirection::backward;
}

View File

@ -60,7 +60,7 @@ Foam::wordList Foam::functionObjects::forces::createFileNames
if (dict.found("binData"))
{
const dictionary& binDict(dict.subDict("binData"));
label nb = readLabel(binDict.lookup("nBin"));
label nb = binDict.lookup<label>("nBin");
if (nb > 0)
{
// Name for file(fileID::binsFile=1)

View File

@ -170,14 +170,14 @@ Foam::MGridGenGAMGAgglomeration::MGridGenGAMGAgglomeration
fvMesh_(refCast<const fvMesh>(mesh))
{
// Min, max size of agglomerated cells
label minSize(readLabel(controlDict.lookup("minSize")));
label maxSize(readLabel(controlDict.lookup("maxSize")));
label minSize(controlDict.lookup<label>("minSize"));
label maxSize(controlDict.lookup<label>("maxSize"));
// Number of iterations applied to improve agglomeration consistency across
// processor boundaries
label nProcConsistencyIter
(
readLabel(controlDict.lookup("nProcConsistencyIter"))
controlDict.lookup<label>("nProcConsistencyIter")
);
// Start geometric agglomeration from the cell volumes and areas of the mesh

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2019 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -200,7 +200,7 @@ Foam::pairPatchAgglomeration::pairPatchAgglomeration
maxLevels_(50),
nFacesInCoarsestLevel_
(
readLabel(controlDict.lookup("nFacesInCoarsestLevel"))
controlDict.lookup<label>("nFacesInCoarsestLevel")
),
featureAngle_
(

View File

@ -102,7 +102,7 @@ Foam::fv::solidEquilibriumEnergySource::solidEquilibriumEnergySource
)
:
option(name, modelType, dict, mesh),
phaseName_(dict.lookupType<word>("phase"))
phaseName_(dict.lookup<word>("phase"))
{
read(dict);
alpha();
@ -169,7 +169,7 @@ bool Foam::fv::solidEquilibriumEnergySource::read(const dictionary& dict)
{
if (option::read(dict))
{
fieldNames_ = wordList(1, coeffs_.lookupType<word>("field"));
fieldNames_ = wordList(1, coeffs_.lookup<word>("field"));
applied_.setSize(fieldNames_.size(), false);

View File

@ -199,7 +199,7 @@ Foam::fv::volumeFractionSource::volumeFractionSource
)
:
option(name, modelType, dict, mesh),
phaseName_(dict.lookupType<word>("phase")),
phaseName_(dict.lookup<word>("phase")),
phiName_("phi"),
rhoName_("rho"),
UName_("U")

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2019 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -45,7 +45,7 @@ inline Foam::DSMCParcel<ParcelType>::constantProperties::constantProperties
d_(readScalar(dict.lookup("diameter"))),
internalDegreesOfFreedom_
(
readInt(dict.lookup("internalDegreesOfFreedom"))
dict.template lookup<int>("internalDegreesOfFreedom")
),
omega_(readScalar(dict.lookup("omega")))
{}

View File

@ -158,7 +158,7 @@ void Foam::ParticleCollector<CloudType>::initConcentricCircles()
vector origin(this->coeffDict().lookup("origin"));
this->coeffDict().lookup("radius") >> radius_;
nSector_ = readLabel(this->coeffDict().lookup("nSector"));
nSector_ = this->coeffDict().template lookup<label>("nSector");
label nS = nSector_;

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2019 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -63,8 +63,8 @@ Foam::ParticleTracks<CloudType>::ParticleTracks
)
:
CloudFunctionObject<CloudType>(dict, owner, modelName, typeName),
trackInterval_(readLabel(this->coeffDict().lookup("trackInterval"))),
maxSamples_(readLabel(this->coeffDict().lookup("maxSamples"))),
trackInterval_(this->coeffDict().template lookup<label>("trackInterval")),
maxSamples_(this->coeffDict().template lookup<label>("maxSamples")),
resetOnWrite_(this->coeffDict().lookup("resetOnWrite")),
faceHitCounter_(),
cloudPtr_(nullptr)

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2019 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -72,7 +72,7 @@ Foam::FieldActivatedInjection<CloudType>::FieldActivatedInjection
injectorTetPts_(positions_.size()),
nParcelsPerInjector_
(
readLabel(this->coeffDict().lookup("parcelsPerInjector"))
this->coeffDict().template lookup<label>("parcelsPerInjector")
),
nParcelsInjected_(positions_.size(), 0),
U0_(this->coeffDict().lookup("U0")),

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2019 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -43,7 +43,7 @@ Foam::ParticleForce<CloudType>::New
if (cstrIter == dictionaryConstructorTablePtr_->end() && dict.found("type"))
{
forceType = dict.lookupType<word>("type");
forceType = dict.lookup<word>("type");
cstrIter = dictionaryConstructorTablePtr_->find(forceType);
}

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2018 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2018-2019 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -35,7 +35,7 @@ Foam::dictionary Foam::ScaledForce<CloudType>::modelDict
) const
{
dictionary modelDict(dict);
modelDict.add<word>("type", dict.lookupType<word>("forceType"), true);
modelDict.add<word>("type", dict.lookup<word>("forceType"), true);
return modelDict;
}
@ -58,7 +58,7 @@ Foam::ScaledForce<CloudType>::ScaledForce
owner,
mesh,
modelDict(dict),
dict.lookupType<word>("forceType")
dict.lookup<word>("forceType")
)
),
factor_(readScalar(this->coeffs().lookup("factor")))

View File

@ -2048,7 +2048,7 @@ bool Foam::medialAxisMeshMover::shrinkMesh
)
{
//- Number of attempts shrinking the mesh
const label nSnap = readLabel(meshQualityDict.lookup("nRelaxIter"));
const label nSnap = meshQualityDict.lookup<label>("nRelaxIter");

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2019 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -227,7 +227,7 @@ void Foam::refinementFeatures::read
else
{
// Look up 'level' for single level
levels_[featI] = labelList(1, readLabel(dict.lookup("level")));
levels_[featI] = labelList(1, dict.lookup<label>("level"));
distances_[featI] = scalarField(1, 0.0);
}

View File

@ -119,7 +119,7 @@ Foam::layerParameters::layerParameters
boundaryMesh.size(),
dict.found("mergeFaces")
? (
dict.lookupType<bool>("mergeFaces")
dict.lookup<bool>("mergeFaces")
? mergeFace::yes
: mergeFace::no
)
@ -130,16 +130,16 @@ Foam::layerParameters::layerParameters
(
dict.lookupOrDefault("concaveAngle", defaultConcaveAngle)
),
nGrow_(readLabel(dict.lookup("nGrow"))),
nGrow_(dict.lookup<label>("nGrow")),
maxFaceThicknessRatio_
(
readScalar(dict.lookup("maxFaceThicknessRatio"))
),
nBufferCellsNoExtrude_
(
readLabel(dict.lookup("nBufferCellsNoExtrude"))
dict.lookup<label>("nBufferCellsNoExtrude")
),
nLayerIter_(readLabel(dict.lookup("nLayerIter"))),
nLayerIter_(dict.lookup<label>("nLayerIter")),
nRelaxedIter_(labelMax),
additionalReporting_(dict.lookupOrDefault("additionalReporting", false)),
meshShrinker_
@ -290,7 +290,7 @@ Foam::layerParameters::layerParameters
const label patchi = patchiter.key();
numLayers_[patchi] =
readLabel(layerDict.lookup("nSurfaceLayers"));
layerDict.lookup<label>("nSurfaceLayers");
switch (layerSpec_)
{
@ -376,7 +376,7 @@ Foam::layerParameters::layerParameters
if (layerDict.found("mergeFaces"))
{
mergeFaces_[patchi] =
layerDict.lookupType<bool>("mergeFaces")
layerDict.lookup<bool>("mergeFaces")
? mergeFace::yes
: mergeFace::no;
}

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2019 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -32,9 +32,9 @@ License
Foam::refinementParameters::refinementParameters(const dictionary& dict)
:
maxGlobalCells_(readLabel(dict.lookup("maxGlobalCells"))),
maxLocalCells_(readLabel(dict.lookup("maxLocalCells"))),
minRefineCells_(readLabel(dict.lookup("minRefinementCells"))),
maxGlobalCells_(dict.lookup<label>("maxGlobalCells")),
maxLocalCells_(dict.lookup<label>("maxLocalCells")),
minRefineCells_(dict.lookup<label>("minRefinementCells")),
planarAngle_
(
dict.lookupOrDefault
@ -43,7 +43,7 @@ Foam::refinementParameters::refinementParameters(const dictionary& dict)
readScalar(dict.lookup("resolveFeatureAngle"))
)
),
nBufferLayers_(readLabel(dict.lookup("nCellsBetweenLevels"))),
nBufferLayers_(dict.lookup<label>("nCellsBetweenLevels")),
keepPoints_(pointField(1, dict.lookup("locationInMesh"))),
allowFreeStandingZoneFaces_(dict.lookup("allowFreeStandingZoneFaces")),
useTopologicalSnapDetection_

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2019 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -30,10 +30,10 @@ License
// Construct from dictionary
Foam::snapParameters::snapParameters(const dictionary& dict)
:
nSmoothPatch_(readLabel(dict.lookup("nSmoothPatch"))),
nSmoothPatch_(dict.lookup<label>("nSmoothPatch")),
snapTol_(readScalar(dict.lookup("tolerance"))),
nSmoothDispl_(readLabel(dict.lookup("nSolveIter"))),
nSnap_(readLabel(dict.lookup("nRelaxIter"))),
nSmoothDispl_(dict.lookup<label>("nSolveIter")),
nSnap_(dict.lookup<label>("nRelaxIter")),
nFeatureSnap_(dict.lookupOrDefault("nFeatureSnapIter", -1)),
explicitFeatureSnap_(dict.lookupOrDefault("explicitFeatureSnap", true)),
implicitFeatureSnap_(dict.lookupOrDefault("implicitFeatureSnap", false)),

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2019 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -117,7 +117,7 @@ Foam::nbrToCell::nbrToCell
)
:
topoSetSource(mesh),
minNbrs_(readLabel(dict.lookup("neighbours")))
minNbrs_(dict.lookup<label>("neighbours"))
{}

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2019 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -506,8 +506,8 @@ Foam::surfaceFeatures::surfaceFeatures
surf_(surf),
featurePoints_(featInfoDict.lookup("featurePoints")),
featureEdges_(featInfoDict.lookup("featureEdges")),
externalStart_(readLabel(featInfoDict.lookup("externalStart"))),
internalStart_(readLabel(featInfoDict.lookup("internalStart")))
externalStart_(featInfoDict.lookup<label>("externalStart")),
internalStart_(featInfoDict.lookup<label>("internalStart"))
{}
@ -529,8 +529,8 @@ Foam::surfaceFeatures::surfaceFeatures
featureEdges_ = labelList(featInfoDict.lookup("featureEdges"));
featurePoints_ = labelList(featInfoDict.lookup("featurePoints"));
externalStart_ = readLabel(featInfoDict.lookup("externalStart"));
internalStart_ = readLabel(featInfoDict.lookup("internalStart"));
externalStart_ = featInfoDict.lookup<label>("externalStart");
internalStart_ = featInfoDict.lookup<label>("internalStart");
}

View File

@ -59,7 +59,7 @@ Foam::decompositionMethod::decompositionMethod
decompositionDict_(decompositionDict),
nProcessors_
(
readLabel(decompositionDict.lookup("numberOfSubdomains"))
decompositionDict.lookup<label>("numberOfSubdomains")
)
{
// Read any constraints

View File

@ -266,8 +266,8 @@ Foam::radiationModels::fvDOM::fvDOM(const volScalarField& T)
mesh_,
dimensionedScalar(dimless/dimLength, 0)
),
nTheta_(readLabel(coeffs_.lookup("nTheta"))),
nPhi_(readLabel(coeffs_.lookup("nPhi"))),
nTheta_(coeffs_.lookup<label>("nTheta")),
nPhi_(coeffs_.lookup<label>("nPhi")),
nRay_(0),
nLambda_(absorptionEmission_->nBands()),
aLambda_(nLambda_),
@ -358,8 +358,8 @@ Foam::radiationModels::fvDOM::fvDOM
mesh_,
dimensionedScalar(dimless/dimLength, 0)
),
nTheta_(readLabel(coeffs_.lookup("nTheta"))),
nPhi_(readLabel(coeffs_.lookup("nPhi"))),
nTheta_(coeffs_.lookup<label>("nTheta")),
nPhi_(coeffs_.lookup<label>("nPhi")),
nRay_(0),
nLambda_(absorptionEmission_->nBands()),
aLambda_(nLambda_),

View File

@ -435,10 +435,10 @@ kinematicSingleLayer::kinematicSingleLayer
momentumPredictor_(solution().subDict("PISO").lookup("momentumPredictor")),
nOuterCorr_(solution().subDict("PISO").lookupOrDefault("nOuterCorr", 1)),
nCorr_(readLabel(solution().subDict("PISO").lookup("nCorr"))),
nCorr_(solution().subDict("PISO").lookup<label>("nCorr")),
nNonOrthCorr_
(
readLabel(solution().subDict("PISO").lookup("nNonOrthCorr"))
solution().subDict("PISO").lookup<label>("nNonOrthCorr")
),
cumulativeContErr_(0.0),

View File

@ -277,7 +277,7 @@ void thermalBaffleFvPatchScalarField::write(Ostream& os) const
<< token::END_STATEMENT << nl;
writeKeyword(os, "nLayers");
os << readLabel(dict_.lookup("nLayers"))
os << dict_.lookup<label>("nLayers")
<< token::END_STATEMENT << nl;
writeKeyword(os, "expansionRatio");

View File

@ -156,7 +156,7 @@ thermalBaffle::thermalBaffle
)
:
thermalBaffleModel(modelType, mesh, dict),
nNonOrthCorr_(readLabel(solution().lookup("nNonOrthCorr"))),
nNonOrthCorr_(solution().lookup<label>("nNonOrthCorr")),
thermo_(solidThermo::New(regionMesh(), dict)),
h_(thermo_->he()),
Qs_
@ -206,7 +206,7 @@ thermalBaffle::thermalBaffle
)
:
thermalBaffleModel(modelType, mesh),
nNonOrthCorr_(readLabel(solution().lookup("nNonOrthCorr"))),
nNonOrthCorr_(solution().lookup<label>("nNonOrthCorr")),
thermo_(solidThermo::New(regionMesh())),
h_(thermo_->he()),
Qs_

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2019 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -49,7 +49,7 @@ Foam::springRenumber::springRenumber(const dictionary& renumberDict)
renumberMethod(renumberDict),
dict_(renumberDict.optionalSubDict(typeName+"Coeffs")),
maxCo_(readScalar(dict_.lookup("maxCo"))),
maxIter_(readLabel(dict_.lookup("maxIter"))),
maxIter_(dict_.lookup<label>("maxIter")),
freezeFraction_(readScalar(dict_.lookup("freezeFraction")))
{}

View File

@ -254,7 +254,7 @@ void Foam::rigidBodyMeshMotion::solve()
if (test_)
{
label nIter(readLabel(coeffDict().lookup("nIter")));
label nIter(coeffDict().lookup<label>("nIter"));
for (label i=0; i<nIter; i++)
{

View File

@ -201,7 +201,7 @@ void Foam::rigidBodyMeshMotionSolver::solve()
if (test_)
{
label nIter(readLabel(coeffDict().lookup("nIter")));
label nIter(coeffDict().lookup<label>("nIter"));
for (label i=0; i<nIter; i++)
{

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2019 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -127,11 +127,11 @@ Foam::sampledSets::arcUniform::arcUniform
:
sampledSet(name, mesh, searchEngine, dict),
centre_(dict.lookup("centre")),
normal_(normalised(dict.lookupType<vector>("normal"))),
radial_(dict.lookupType<vector>("radial")),
normal_(normalised(dict.lookup<vector>("normal"))),
radial_(dict.lookup<vector>("radial")),
startAngle_(readScalar(dict.lookup("startAngle"))),
endAngle_(readScalar(dict.lookup("endAngle"))),
nPoints_(dict.lookupType<scalar>("nPoints"))
nPoints_(dict.lookup<scalar>("nPoints"))
{
genSamples();

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2019 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -231,7 +231,7 @@ Foam::sampledSets::boundaryRandom::boundaryRandom
wordReList(dict.lookup("patches"))
)
),
nPoints_(readLabel(dict.lookup("nPoints")))
nPoints_(dict.lookup<label>("nPoints"))
{
genSamples();

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2019 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -132,9 +132,9 @@ Foam::sampledSets::circleRandom::circleRandom
:
sampledSet(name, mesh, searchEngine, dict),
centre_(dict.lookup("centre")),
normal_(normalised(dict.lookupType<vector>("normal"))),
normal_(normalised(dict.lookup<vector>("normal"))),
radius_(readScalar(dict.lookup("radius"))),
nPoints_(readLabel(dict.lookup("nPoints")))
nPoints_(dict.lookup<label>("nPoints"))
{
genSamples();

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2019 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -141,7 +141,7 @@ Foam::sampledSets::lineUniform::lineUniform
sampledSet(name, mesh, searchEngine, dict),
start_(dict.lookup("start")),
end_(dict.lookup("end")),
nPoints_(readLabel(dict.lookup("nPoints")))
nPoints_(dict.lookup<label>("nPoints"))
{
genSamples();

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2019 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -132,7 +132,7 @@ Foam::sampledSets::sphereRandom::sphereRandom
sampledSet(name, mesh, searchEngine, dict),
centre_(dict.lookup("centre")),
radius_(readScalar(dict.lookup("radius"))),
nPoints_(readLabel(dict.lookup("nPoints")))
nPoints_(dict.lookup<label>("nPoints"))
{
genSamples();

View File

@ -81,8 +81,8 @@ Foam::surfZone::surfZone
)
:
surfZoneIdentifier(name, dict, index),
size_(readLabel(dict.lookup("nFaces"))),
start_(readLabel(dict.lookup("startFace")))
size_(dict.lookup<label>("nFaces")),
start_(dict.lookup<label>("startFace"))
{}

View File

@ -66,8 +66,8 @@ Foam::surfZoneIOList::surfZoneIOList
{
const dictionary& dict = dictEntries[zoneI].dict();
label zoneSize = readLabel(dict.lookup("nFaces"));
label startFacei = readLabel(dict.lookup("startFace"));
label zoneSize = dict.lookup<label>("nFaces");
label startFacei = dict.lookup<label>("startFace");
zones[zoneI] = surfZone
(

View File

@ -218,7 +218,7 @@ Foam::chemistryReductionMethods::DAC<CompType, ThermoType>::DAC
if (this->coeffsDict_.found("nbCLarge"))
{
nbCLarge_ = readLabel(fuelDict.lookup("nbCLarge"));
nbCLarge_ = fuelDict.lookup<label>("nbCLarge");
}
fuelSpeciesID_.setSize(fuelSpecies_.size());

View File

@ -63,7 +63,7 @@ Foam::chemistryReductionMethods::DRGEP<CompType, ThermoType>::DRGEP
if (this->coeffsDict_.found("NGroupBased"))
{
NGroupBased_ = readLabel(this->coeffsDict_.lookup("NGroupBased"));
NGroupBased_ = this->coeffsDict_.template lookup<label>("NGroupBased");
}
const List<List<specieElement>>& specieComposition =

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2016-2018 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2016-2019 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -349,7 +349,7 @@ Foam::binaryTree<CompType, ThermoType>::binaryTree
:
chemistry_(chemistry),
root_(nullptr),
maxNLeafs_(readLabel(coeffsDict.lookup("maxNLeafs"))),
maxNLeafs_(coeffsDict.lookup<label>("maxNLeafs")),
size_(0),
n2ndSearch_(0),
max2ndSearch_(coeffsDict.lookupOrDefault("max2ndSearch",0)),

View File

@ -42,7 +42,7 @@ namespace thermophysicalFunctions
Foam::thermophysicalFunctions::constant::constant(const dictionary& dict)
:
value_(dict.lookupType<scalar>("value"))
value_(dict.lookup<scalar>("value"))
{}

View File

@ -43,8 +43,8 @@ namespace thermophysicalFunctions
Foam::thermophysicalFunctions::table::table(const dictionary& dict)
:
dictName_(dict.name()),
Tlow_(dict.lookupType<scalar>("Tlow")),
Thigh_(dict.lookupType<scalar>("Thigh")),
Tlow_(dict.lookup<scalar>("Tlow")),
Thigh_(dict.lookup<scalar>("Thigh")),
values_(dict.lookup("values"))
{
if (values_.size() < 2)

View File

@ -78,8 +78,8 @@ Foam::surfacePatch::surfacePatch
)
:
geometricSurfacePatch(name, dict, index),
size_(readLabel(dict.lookup("nFaces"))),
start_(readLabel(dict.lookup("startFace")))
size_(dict.lookup<label>("nFaces")),
start_(dict.lookup<label>("startFace"))
{}

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2019 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -78,8 +78,8 @@ Foam::surfacePatchIOList::surfacePatchIOList
{
const dictionary& dict = patchEntries[patchi].dict();
label patchSize = readLabel(dict.lookup("nFaces"));
label startFacei = readLabel(dict.lookup("startFace"));
label patchSize = dict.lookup<label>("nFaces");
label startFacei = dict.lookup<label>("startFace");
patches[patchi] =
surfacePatch