GeometricField: Temporary fields are no longer registered on the database by default

Registration occurs when the temporary field is transferred to a non-temporary
field via a constructor or if explicitly transferred to the database via the
regIOobject "store" methods.
This commit is contained in:
Henry Weller
2018-12-20 11:00:37 +00:00
parent 6faadcb45c
commit 146a59e46c
307 changed files with 707 additions and 1042 deletions

View File

@ -98,7 +98,7 @@ volScalarField Phi
IOobject::NO_WRITE IOobject::NO_WRITE
), ),
mesh, mesh,
dimensionedScalar("Phi", dimLength*dimVelocity, 0), dimensionedScalar(dimLength*dimVelocity, 0),
PhiBCTypes PhiBCTypes
); );

View File

@ -96,7 +96,7 @@ int main(int argc, char *argv[])
{ {
fvScalarMatrix PhiEqn fvScalarMatrix PhiEqn
( (
fvm::laplacian(dimensionedScalar("1", dimless, 1), Phi) fvm::laplacian(dimensionedScalar(dimless, 1), Phi)
== ==
fvc::div(phi) fvc::div(phi)
); );

View File

@ -87,7 +87,7 @@ Foam::tmp<Foam::volScalarField> Foam::XiEqModels::basicSubGrid::XiEq() const
volScalarField magU(mag(U)); volScalarField magU(mag(U));
volVectorField Uhat volVectorField Uhat
( (
U/(mag(U) + dimensionedScalar("Usmall", U.dimensions(), 1e-4)) U/(mag(U) + dimensionedScalar(U.dimensions(), 1e-4))
); );
const scalarField Cw = pow(mesh.V(), 2.0/3.0); const scalarField Cw = pow(mesh.V(), 2.0/3.0);
@ -103,7 +103,7 @@ Foam::tmp<Foam::volScalarField> Foam::XiEqModels::basicSubGrid::XiEq() const
IOobject::NO_WRITE IOobject::NO_WRITE
), ),
mesh, mesh,
dimensionedScalar("zero", Nv.dimensions(), 0) dimensionedScalar(Nv.dimensions(), 0)
); );
N.primitiveFieldRef() = Nv.primitiveField()*Cw; N.primitiveFieldRef() = Nv.primitiveField()*Cw;

View File

@ -143,7 +143,7 @@ Foam::tmp<Foam::volScalarField> Foam::PDRDragModels::basic::Gk() const
IOobject::NO_WRITE IOobject::NO_WRITE
), ),
U_.mesh(), U_.mesh(),
dimensionedScalar("zero", dimMass/dimLength/pow(dimTime, 3), 0) dimensionedScalar(dimMass/dimLength/pow(dimTime, 3), 0)
) )
); );

View File

@ -146,7 +146,7 @@ void PDRkEpsilon::correct()
volScalarField GR(drag.Gk()); volScalarField GR(drag.Gk());
volScalarField LI volScalarField LI
(C4_*(Lobs + dimensionedScalar("minLength", dimLength, rootVSmall))); (C4_*(Lobs + dimensionedScalar(dimLength, rootVSmall)));
// Dissipation equation // Dissipation equation
tmp<fvScalarMatrix> epsEqn tmp<fvScalarMatrix> epsEqn

View File

@ -84,7 +84,7 @@ Foam::tmp<Foam::volScalarField> Foam::XiEqModels::Gulder::XiEq() const
up up
/ ( / (
sqrt(epsilon*tauEta) sqrt(epsilon*tauEta)
+ dimensionedScalar("1e-8", up.dimensions(), 1e-8) + dimensionedScalar(up.dimensions(), 1e-8)
) )
); );

View File

@ -105,7 +105,7 @@ Foam::tmp<Foam::volScalarField> Foam::XiEqModels::SCOPEXiEq::XiEq() const
IOobject::NO_WRITE IOobject::NO_WRITE
), ),
epsilon.mesh(), epsilon.mesh(),
dimensionedScalar("XiEq", dimless, 0) dimensionedScalar(dimless, 0)
) )
); );
volScalarField& xieq = tXiEq.ref(); volScalarField& xieq = tXiEq.ref();

View File

@ -110,7 +110,7 @@ Foam::XiEqModel::calculateSchelkinEffect(const scalar uPrimeCoef) const
false false
), ),
mesh, mesh,
dimensionedScalar("zero", Nv.dimensions(), 0) dimensionedScalar(Nv.dimensions(), 0)
) )
); );
volScalarField& N = tN.ref(); volScalarField& N = tN.ref();
@ -138,7 +138,7 @@ Foam::XiEqModel::calculateSchelkinEffect(const scalar uPrimeCoef) const
const volVectorField Uhat const volVectorField Uhat
( (
U/(mag(U) + dimensionedScalar("Usmall", U.dimensions(), 1e-4)) U/(mag(U) + dimensionedScalar(U.dimensions(), 1e-4))
); );
const volScalarField nr(sqrt(max(N - (Uhat & ns & Uhat), scalar(1e-4)))); const volScalarField nr(sqrt(max(N - (Uhat & ns & Uhat), scalar(1e-4))));

View File

@ -68,7 +68,7 @@ volScalarField dpdt
mesh mesh
), ),
mesh, mesh,
dimensionedScalar("dpdt", p.dimensions()/dimTime, 0) dimensionedScalar(p.dimensions()/dimTime, 0)
); );
Info<< "Creating field kinetic energy K\n" << endl; Info<< "Creating field kinetic energy K\n" << endl;

View File

@ -255,7 +255,7 @@ Foam::tmp<Foam::volScalarField> Foam::laminarFlameSpeedModels::SCOPE::Su0pTphi
IOobject::NO_WRITE IOobject::NO_WRITE
), ),
p.mesh(), p.mesh(),
dimensionedScalar("Su0", dimVelocity, 0) dimensionedScalar(dimVelocity, 0)
) )
); );
@ -304,7 +304,7 @@ Foam::tmp<Foam::volScalarField> Foam::laminarFlameSpeedModels::SCOPE::Su0pTphi
IOobject::NO_WRITE IOobject::NO_WRITE
), ),
p.mesh(), p.mesh(),
dimensionedScalar("Su0", dimVelocity, 0) dimensionedScalar(dimVelocity, 0)
) )
); );
@ -358,7 +358,7 @@ Foam::tmp<Foam::volScalarField> Foam::laminarFlameSpeedModels::SCOPE::Ma
IOobject::NO_WRITE IOobject::NO_WRITE
), ),
phi.mesh(), phi.mesh(),
dimensionedScalar("Ma", dimless, 0) dimensionedScalar(dimless, 0)
) )
); );
@ -418,7 +418,7 @@ Foam::laminarFlameSpeedModels::SCOPE::Ma() const
IOobject::NO_WRITE IOobject::NO_WRITE
), ),
mesh, mesh,
dimensionedScalar("Ma", dimless, Ma(equivalenceRatio_)) dimensionedScalar(dimless, Ma(equivalenceRatio_))
) )
); );
} }

View File

@ -18,7 +18,7 @@ if (ign.ignited())
dimensionedScalar dMgb = 1.0e-3* dimensionedScalar dMgb = 1.0e-3*
(b*c*mgb)().weightedAverage(mesh.V()) (b*c*mgb)().weightedAverage(mesh.V())
/((b*c)().weightedAverage(mesh.V()) + small) /((b*c)().weightedAverage(mesh.V()) + small)
+ dimensionedScalar("ddMgb", mgb.dimensions(), small); + dimensionedScalar(mgb.dimensions(), small);
mgb += dMgb; mgb += dMgb;
@ -91,12 +91,12 @@ if (ign.ignited())
up up
/ ( / (
sqrt(epsilon*tauEta) sqrt(epsilon*tauEta)
+ dimensionedScalar("1e-8", up.dimensions(), 1e-8) + dimensionedScalar(up.dimensions(), 1e-8)
) )
); );
// volScalarField l = 0.337*k*sqrt(k)/epsilon; // volScalarField l = 0.337*k*sqrt(k)/epsilon;
// Reta *= max((l - dimensionedScalar("dl", dimLength, 1.5e-3))/l, 0); // Reta *= max((l - dimensionedScalar(dimLength, 1.5e-3))/l, 0);
// Calculate Xi flux // Calculate Xi flux
// ~~~~~~~~~~~~~~~~~ // ~~~~~~~~~~~~~~~~~
@ -243,7 +243,7 @@ if (ign.ignited())
rho*max rho*max
( (
sigmat - sigmas, sigmat - sigmas,
dimensionedScalar("0", sigmat.dimensions(), 0) dimensionedScalar(sigmat.dimensions(), 0)
), ),
Xi Xi
) )

View File

@ -68,7 +68,7 @@ volScalarField dpdt
mesh mesh
), ),
mesh, mesh,
dimensionedScalar("dpdt", p.dimensions()/dimTime, 0) dimensionedScalar(p.dimensions()/dimTime, 0)
); );
Info<< "Creating field kinetic energy K\n" << endl; Info<< "Creating field kinetic energy K\n" << endl;

View File

@ -15,7 +15,7 @@ Info<< "Creating base fields for time " << runTime.timeName() << endl;
false false
), ),
mesh, mesh,
dimensionedScalar("Ydefault", dimless, 1) dimensionedScalar(dimless, 1)
); );
Ydefault.write(); Ydefault.write();
@ -32,7 +32,7 @@ Info<< "Creating base fields for time " << runTime.timeName() << endl;
false false
), ),
mesh, mesh,
dimensionedScalar("p", dimPressure, p0) dimensionedScalar(dimPressure, p0)
); );
p.write(); p.write();
@ -49,7 +49,7 @@ Info<< "Creating base fields for time " << runTime.timeName() << endl;
false false
), ),
mesh, mesh,
dimensionedScalar("T", dimTemperature, T0) dimensionedScalar(dimTemperature, T0)
); );
T.write(); T.write();

View File

@ -59,9 +59,8 @@
mesh, mesh,
dimensionedScalar dimensionedScalar
( (
"zero",
dimensionSet(dimEnergy/dimMass/dimTemperature), dimensionSet(dimEnergy/dimMass/dimTemperature),
0.0 0
) )
); );

View File

@ -85,7 +85,7 @@
Y[i] = Y0[i]; Y[i] = Y0[i];
} }
thermo.he() = dimensionedScalar("h", dimEnergy/dimMass, h0); thermo.he() = dimensionedScalar(dimEnergy/dimMass, h0);
thermo.correct(); thermo.correct();
rho = thermo.rho(); rho = thermo.rho();

View File

@ -61,7 +61,7 @@ volScalarField dpdt
mesh mesh
), ),
mesh, mesh,
dimensionedScalar("dpdt", p.dimensions()/dimTime, 0) dimensionedScalar(p.dimensions()/dimTime, 0)
); );
Info<< "Creating field kinetic energy K\n" << endl; Info<< "Creating field kinetic energy K\n" << endl;

View File

@ -135,7 +135,7 @@ volScalarField Qdot
IOobject::AUTO_WRITE IOobject::AUTO_WRITE
), ),
mesh, mesh,
dimensionedScalar("Qdot", dimEnergy/dimVolume/dimTime, 0) dimensionedScalar(dimEnergy/dimVolume/dimTime, 0)
); );
@ -149,7 +149,7 @@ volScalarField dpdt
mesh mesh
), ),
mesh, mesh,
dimensionedScalar("dpdt", p.dimensions()/dimTime, 0) dimensionedScalar(p.dimensions()/dimTime, 0)
); );
Info<< "Creating field kinetic energy K\n" << endl; Info<< "Creating field kinetic energy K\n" << endl;

View File

@ -77,7 +77,7 @@ volScalarField dpdt
mesh mesh
), ),
mesh, mesh,
dimensionedScalar("dpdt", p.dimensions()/dimTime, 0) dimensionedScalar(p.dimensions()/dimTime, 0)
); );
Info<< "Creating field kinetic energy K\n" << endl; Info<< "Creating field kinetic energy K\n" << endl;
@ -103,7 +103,7 @@ volScalarField Qdot
IOobject::AUTO_WRITE IOobject::AUTO_WRITE
), ),
mesh, mesh,
dimensionedScalar("Qdot", dimEnergy/dimVolume/dimTime, 0) dimensionedScalar(dimEnergy/dimVolume/dimTime, 0)
); );
#include "createMRF.H" #include "createMRF.H"

View File

@ -99,7 +99,7 @@ volScalarField dpdt
mesh mesh
), ),
mesh, mesh,
dimensionedScalar("dpdt", p.dimensions()/dimTime, 0) dimensionedScalar(p.dimensions()/dimTime, 0)
); );
Info<< "Creating field kinetic energy K\n" << endl; Info<< "Creating field kinetic energy K\n" << endl;
@ -125,7 +125,7 @@ volScalarField Qdot
IOobject::AUTO_WRITE IOobject::AUTO_WRITE
), ),
mesh, mesh,
dimensionedScalar("Qdot", dimEnergy/dimVolume/dimTime, 0) dimensionedScalar(dimEnergy/dimVolume/dimTime, 0)
); );
#include "createMRF.H" #include "createMRF.H"

View File

@ -81,7 +81,7 @@ volScalarField dpdt
mesh mesh
), ),
mesh, mesh,
dimensionedScalar("dpdt", p.dimensions()/dimTime, 0) dimensionedScalar(p.dimensions()/dimTime, 0)
); );
Info<< "Creating field kinetic energy K\n" << endl; Info<< "Creating field kinetic energy K\n" << endl;
@ -107,7 +107,7 @@ volScalarField Qdot
IOobject::AUTO_WRITE IOobject::AUTO_WRITE
), ),
mesh, mesh,
dimensionedScalar("Qdot", dimEnergy/dimVolume/dimTime, 0) dimensionedScalar(dimEnergy/dimVolume/dimTime, 0)
); );
#include "createMRF.H" #include "createMRF.H"

View File

@ -104,7 +104,7 @@ License
mesh mesh
), ),
mesh, mesh,
dimensionedScalar("rDeltaTY", rDeltaT.dimensions(), 0) dimensionedScalar(rDeltaT.dimensions(), 0)
); );
bool foundY = false; bool foundY = false;

View File

@ -72,7 +72,7 @@ surfaceScalarField pos
mesh mesh
), ),
mesh, mesh,
dimensionedScalar("pos", dimless, 1.0) dimensionedScalar(dimless, 1.0)
); );
surfaceScalarField neg surfaceScalarField neg
@ -84,7 +84,7 @@ surfaceScalarField neg
mesh mesh
), ),
mesh, mesh,
dimensionedScalar("neg", dimless, -1.0) dimensionedScalar(dimless, -1.0)
); );
surfaceScalarField phi("phi", fvc::flux(rhoU)); surfaceScalarField phi("phi", fvc::flux(rhoU));

View File

@ -13,7 +13,7 @@
// Set the reciprocal time-step from the local Courant number // Set the reciprocal time-step from the local Courant number
rDeltaT.ref() = max rDeltaT.ref() = max
( (
1/dimensionedScalar("maxDeltaT", dimTime, maxDeltaT), 1/dimensionedScalar(dimTime, maxDeltaT),
fvc::surfaceSum(amaxSf)()() fvc::surfaceSum(amaxSf)()()
/((2*maxCo)*mesh.V()) /((2*maxCo)*mesh.V())
); );

View File

@ -66,7 +66,7 @@ volScalarField dpdt
mesh mesh
), ),
mesh, mesh,
dimensionedScalar("dpdt", p.dimensions()/dimTime, 0) dimensionedScalar(p.dimensions()/dimTime, 0)
); );
Info<< "Creating field kinetic energy K\n" << endl; Info<< "Creating field kinetic energy K\n" << endl;

View File

@ -28,7 +28,7 @@
// Set the reciprocal time-step from the local Courant number // Set the reciprocal time-step from the local Courant number
rDeltaT.ref() = max rDeltaT.ref() = max
( (
1/dimensionedScalar("maxDeltaT", dimTime, maxDeltaT), 1/dimensionedScalar(dimTime, maxDeltaT),
fvc::surfaceSum(mag(phi))()() fvc::surfaceSum(mag(phi))()()
/((2*maxCo)*mesh.V()*rho()) /((2*maxCo)*mesh.V()*rho())
); );

View File

@ -49,7 +49,7 @@
mesh mesh
), ),
mesh, mesh,
dimensionedScalar("Mr", dimensionSet(0, 1, 0, 0, 0, 1, 0), 0) dimensionedScalar(dimensionSet(0, 1, 0, 0, 0, 1, 0), 0)
); );
forAll(magnets, i) forAll(magnets, i)

View File

@ -82,7 +82,7 @@ volVectorField P
V == max V == max
( (
P.component(Foam::vector::X) - strike, P.component(Foam::vector::X) - strike,
dimensionedScalar("0", V.dimensions(), 0) dimensionedScalar(V.dimensions(), 0)
); );
volScalarField delta volScalarField delta

View File

@ -98,7 +98,7 @@ volScalarField dpdt
mesh mesh
), ),
mesh, mesh,
dimensionedScalar("dpdt", p.dimensions()/dimTime, 0) dimensionedScalar(p.dimensions()/dimTime, 0)
); );
Info<< "Creating field kinetic energy K\n" << endl; Info<< "Creating field kinetic energy K\n" << endl;

View File

@ -27,7 +27,7 @@ if (Y.size())
( (
IOobject("Yt", runTime.timeName(), mesh), IOobject("Yt", runTime.timeName(), mesh),
mesh, mesh,
dimensionedScalar("Yt", dimless, 0) dimensionedScalar(dimless, 0)
) )
); );
} }

View File

@ -116,7 +116,7 @@ forAll(fluidRegions, i)
IOobject::READ_IF_PRESENT, IOobject::READ_IF_PRESENT,
IOobject::NO_WRITE IOobject::NO_WRITE
), ),
dimensionedScalar("hRef", dimLength, 0) dimensionedScalar(dimLength, 0)
) )
); );
@ -225,7 +225,6 @@ forAll(fluidRegions, i)
fluidRegions[i], fluidRegions[i],
dimensionedScalar dimensionedScalar
( (
"dpdt",
thermoFluid[i].p().dimensions()/dimTime, thermoFluid[i].p().dimensions()/dimTime,
0 0
) )

View File

@ -100,7 +100,7 @@ forAll(solidRegions, i)
IOobject::NO_WRITE IOobject::NO_WRITE
), ),
solidRegions[i], solidRegions[i],
dimensionedScalar("1", dimless, scalar(1)) dimensionedScalar(dimless, scalar(1))
) )
); );
} }

View File

@ -47,7 +47,7 @@ volScalarField dpdt
mesh mesh
), ),
mesh, mesh,
dimensionedScalar("dpdt", p.dimensions()/dimTime, 0) dimensionedScalar(p.dimensions()/dimTime, 0)
); );
Info<< "Creating field kinetic energy K\n" << endl; Info<< "Creating field kinetic energy K\n" << endl;

View File

@ -41,7 +41,7 @@ else
IOobject::NO_WRITE IOobject::NO_WRITE
), ),
mesh, mesh,
dimensionedScalar("0", dimMass/dimLength/dimTime, 0) dimensionedScalar(dimMass/dimLength/dimTime, 0)
) )
); );
} }

View File

@ -25,7 +25,7 @@ surfaceScalarField phi
IOobject::NO_WRITE IOobject::NO_WRITE
), ),
mesh, mesh,
dimensionedScalar("zero", mesh.Sf().dimensions()*U.dimensions(), 0) dimensionedScalar(mesh.Sf().dimensions()*U.dimensions(), 0)
); );

View File

@ -25,7 +25,7 @@ const volScalarField h0
IOobject::READ_IF_PRESENT IOobject::READ_IF_PRESENT
), ),
mesh, mesh,
dimensionedScalar("h0", dimLength, 0) dimensionedScalar(dimLength, 0)
); );
Info<< "Creating field hU\n" << endl; Info<< "Creating field hU\n" << endl;

View File

@ -119,7 +119,7 @@ volScalarField alphac
IOobject::AUTO_WRITE IOobject::AUTO_WRITE
), ),
mesh, mesh,
dimensionedScalar("0", dimless, 0) dimensionedScalar(dimless, 0)
); );
word kinematicCloudName("kinematicCloud"); word kinematicCloudName("kinematicCloud");

View File

@ -58,7 +58,7 @@ volScalarField rhoEffLagrangian
IOobject::AUTO_WRITE IOobject::AUTO_WRITE
), ),
mesh, mesh,
dimensionedScalar("zero", dimDensity, 0) dimensionedScalar(dimDensity, 0)
); );
// dynamic pressure field - used externally (optional) // dynamic pressure field - used externally (optional)
@ -73,7 +73,7 @@ volScalarField pDyn
IOobject::AUTO_WRITE IOobject::AUTO_WRITE
), ),
mesh, mesh,
dimensionedScalar("zero", dimPressure, 0) dimensionedScalar(dimPressure, 0)
); );
@ -123,7 +123,7 @@ volScalarField dpdt
mesh mesh
), ),
mesh, mesh,
dimensionedScalar("dpdt", p.dimensions()/dimTime, 0) dimensionedScalar(p.dimensions()/dimTime, 0)
); );
Info<< "Creating field kinetic energy K\n" << endl; Info<< "Creating field kinetic energy K\n" << endl;
@ -140,7 +140,7 @@ volScalarField Qdot
IOobject::AUTO_WRITE IOobject::AUTO_WRITE
), ),
mesh, mesh,
dimensionedScalar("Qdot", dimEnergy/dimVolume/dimTime, 0) dimensionedScalar(dimEnergy/dimVolume/dimTime, 0)
); );
#include "createMRF.H" #include "createMRF.H"

View File

@ -77,7 +77,7 @@ volScalarField dpdt
mesh mesh
), ),
mesh, mesh,
dimensionedScalar("dpdt", p.dimensions()/dimTime, 0) dimensionedScalar(p.dimensions()/dimTime, 0)
); );
Info<< "Creating field kinetic energy K\n" << endl; Info<< "Creating field kinetic energy K\n" << endl;
@ -128,7 +128,7 @@ volScalarField Qdot
IOobject::AUTO_WRITE IOobject::AUTO_WRITE
), ),
mesh, mesh,
dimensionedScalar("Qdot", dimEnergy/dimVolume/dimTime, 0) dimensionedScalar(dimEnergy/dimVolume/dimTime, 0)
); );
#include "createMRF.H" #include "createMRF.H"

View File

@ -110,7 +110,7 @@ volScalarField Qdot
IOobject::AUTO_WRITE IOobject::AUTO_WRITE
), ),
mesh, mesh,
dimensionedScalar("Qdot", dimEnergy/dimVolume/dimTime, 0) dimensionedScalar(dimEnergy/dimVolume/dimTime, 0)
); );
#include "createMRF.H" #include "createMRF.H"

View File

@ -102,7 +102,7 @@ volScalarField dpdt
mesh mesh
), ),
mesh, mesh,
dimensionedScalar("dpdt", p.dimensions()/dimTime, 0) dimensionedScalar(p.dimensions()/dimTime, 0)
); );
Info<< "Creating field kinetic energy K\n" << endl; Info<< "Creating field kinetic energy K\n" << endl;
@ -126,7 +126,7 @@ volScalarField Qdot
IOobject::AUTO_WRITE IOobject::AUTO_WRITE
), ),
mesh, mesh,
dimensionedScalar("Qdot", dimEnergy/dimVolume/dimTime, 0) dimensionedScalar(dimEnergy/dimVolume/dimTime, 0)
); );
#include "createMRF.H" #include "createMRF.H"

View File

@ -113,7 +113,7 @@
phiCN, phiCN,
upwind<scalar>(mesh, phiCN) upwind<scalar>(mesh, phiCN)
).fvmDiv(phiCN, alpha1) ).fvmDiv(phiCN, alpha1)
// - fvm::Sp(fvc::ddt(dimensionedScalar("1", dimless, 1), mesh) // - fvm::Sp(fvc::ddt(dimensionedScalar(dimless, 1), mesh)
// + fvc::div(phiCN), alpha1) // + fvc::div(phiCN), alpha1)
== ==
Su + fvm::Sp(Sp + divU, alpha1) Su + fvm::Sp(Sp + divU, alpha1)

View File

@ -10,7 +10,7 @@ if (nAlphaSubCycles > 1)
mesh mesh
), ),
mesh, mesh,
dimensionedScalar("0", rhoPhi.dimensions(), 0) dimensionedScalar(rhoPhi.dimensions(), 0)
); );
tmp<volScalarField> trSubDeltaT; tmp<volScalarField> trSubDeltaT;

View File

@ -58,7 +58,7 @@
// Set the reciprocal time-step from the local Courant number // Set the reciprocal time-step from the local Courant number
rDeltaT.ref() = max rDeltaT.ref() = max
( (
1/dimensionedScalar("maxDeltaT", dimTime, maxDeltaT), 1/dimensionedScalar(dimTime, maxDeltaT),
fvc::surfaceSum(mag(rhoPhi))()() fvc::surfaceSum(mag(rhoPhi))()()
/((2*maxCo)*mesh.V()*rho()) /((2*maxCo)*mesh.V()*rho())
); );

View File

@ -12,7 +12,7 @@ correctUphiBCs(U, phi);
IOobject::NO_WRITE IOobject::NO_WRITE
), ),
mesh, mesh,
dimensionedScalar("pcorr", p.dimensions(), 0), dimensionedScalar(p.dimensions(), 0),
pcorrTypes pcorrTypes
); );

View File

@ -7,7 +7,7 @@ volScalarField::Internal Sp
mesh mesh
), ),
mesh, mesh,
dimensionedScalar("Sp", dgdt.dimensions(), 0) dimensionedScalar(dgdt.dimensions(), 0)
); );
volScalarField::Internal Su volScalarField::Internal Su
@ -19,7 +19,7 @@ volScalarField::Internal Su
mesh mesh
), ),
mesh, mesh,
dimensionedScalar("Su", dgdt.dimensions(), 0) dimensionedScalar(dgdt.dimensions(), 0)
); );
forAll(dgdt, celli) forAll(dgdt, celli)

View File

@ -13,7 +13,7 @@ if (nAlphaSubCycles > 1)
mesh mesh
), ),
mesh, mesh,
dimensionedScalar("0", alphaPhi10.dimensions(), 0) dimensionedScalar(alphaPhi10.dimensions(), 0)
); );
surfaceScalarField rhoPhiSum surfaceScalarField rhoPhiSum
@ -25,7 +25,7 @@ if (nAlphaSubCycles > 1)
mesh mesh
), ),
mesh, mesh,
dimensionedScalar("0", rhoPhi.dimensions(), 0) dimensionedScalar(rhoPhi.dimensions(), 0)
); );
tmp<volScalarField> trSubDeltaT; tmp<volScalarField> trSubDeltaT;

View File

@ -136,7 +136,7 @@ Foam::fv::VoFSolidificationMeltingSource::VoFSolidificationMeltingSource
IOobject::AUTO_WRITE IOobject::AUTO_WRITE
), ),
mesh, mesh,
dimensionedScalar("alpha1", dimless, 0), dimensionedScalar(dimless, 0),
zeroGradientFvPatchScalarField::typeName zeroGradientFvPatchScalarField::typeName
), ),
curTimeIndex_(-1) curTimeIndex_(-1)

View File

@ -88,7 +88,7 @@ Foam::multiphaseMixtureThermo::multiphaseMixtureThermo
IOobject::NO_WRITE IOobject::NO_WRITE
), ),
mesh_, mesh_,
dimensionedScalar("rhoPhi", dimMass/dimTime, 0) dimensionedScalar(dimMass/dimTime, 0)
), ),
alphas_ alphas_
@ -102,7 +102,7 @@ Foam::multiphaseMixtureThermo::multiphaseMixtureThermo
IOobject::AUTO_WRITE IOobject::AUTO_WRITE
), ),
mesh_, mesh_,
dimensionedScalar("alphas", dimless, 0) dimensionedScalar(dimless, 0)
), ),
sigmas_(lookup("sigmas")), sigmas_(lookup("sigmas")),
@ -779,12 +779,7 @@ Foam::multiphaseMixtureThermo::surfaceTensionForce() const
mesh_ mesh_
), ),
mesh_, mesh_,
dimensionedScalar dimensionedScalar(dimensionSet(1, -2, -2, 0, 0), 0)
(
"surfaceTensionForce",
dimensionSet(1, -2, -2, 0, 0),
0.0
)
) )
); );
@ -812,7 +807,7 @@ Foam::multiphaseMixtureThermo::surfaceTensionForce() const
<< exit(FatalError); << exit(FatalError);
} }
stf += dimensionedScalar("sigma", dimSigma_, sigma()) stf += dimensionedScalar(dimSigma_, sigma())
*fvc::interpolate(K(alpha1, alpha2))* *fvc::interpolate(K(alpha1, alpha2))*
( (
fvc::interpolate(alpha2)*fvc::snGrad(alpha1) fvc::interpolate(alpha2)*fvc::snGrad(alpha1)
@ -1035,7 +1030,7 @@ Foam::multiphaseMixtureThermo::nearInterface() const
mesh_ mesh_
), ),
mesh_, mesh_,
dimensionedScalar("nearInterface", dimless, 0) dimensionedScalar(dimless, 0)
) )
); );
@ -1122,7 +1117,7 @@ void Foam::multiphaseMixtureThermo::solveAlphas
MULES::limitSum(alphaPhiCorrs); MULES::limitSum(alphaPhiCorrs);
rhoPhi_ = dimensionedScalar("0", dimensionSet(1, 0, -1, 0, 0), 0); rhoPhi_ = dimensionedScalar(dimensionSet(1, 0, -1, 0, 0), 0);
volScalarField sumAlpha volScalarField sumAlpha
( (
@ -1133,7 +1128,7 @@ void Foam::multiphaseMixtureThermo::solveAlphas
mesh_ mesh_
), ),
mesh_, mesh_,
dimensionedScalar("sumAlpha", dimless, 0) dimensionedScalar(dimless, 0)
); );
@ -1158,7 +1153,7 @@ void Foam::multiphaseMixtureThermo::solveAlphas
mesh_ mesh_
), ),
mesh_, mesh_,
dimensionedScalar("Sp", alpha.dgdt().dimensions(), 0) dimensionedScalar(alpha.dgdt().dimensions(), 0)
); );
volScalarField::Internal Su volScalarField::Internal Su

View File

@ -61,7 +61,7 @@ Foam::phaseModel::phaseModel
IOobject::AUTO_WRITE IOobject::AUTO_WRITE
), ),
p.mesh(), p.mesh(),
dimensionedScalar("0", dimless/dimTime, 0) dimensionedScalar(dimless/dimTime, 0)
) )
{ {
{ {

View File

@ -8,7 +8,7 @@
mesh mesh
), ),
mesh, mesh,
dimensionedScalar("0", phi.dimensions(), 0) dimensionedScalar(phi.dimensions(), 0)
); );
surfaceScalarField phir(fvc::flux(UdmModel.Udm())); surfaceScalarField phir(fvc::flux(UdmModel.Udm()));
@ -25,7 +25,7 @@
mesh mesh
), ),
mesh, mesh,
dimensionedScalar("0", phi.dimensions(), 0) dimensionedScalar(phi.dimensions(), 0)
); );
for for

View File

@ -102,7 +102,7 @@ incompressibleTwoPhaseInteractingMixture
U_.db() U_.db()
), ),
U_.mesh(), U_.mesh(),
dimensionedScalar("mu", dimensionSet(1, -1, -1, 0, 0), 0), dimensionedScalar(dimensionSet(1, -1, -1, 0, 0), 0),
calculatedFvPatchScalarField::typeName calculatedFvPatchScalarField::typeName
) )
{ {

View File

@ -13,7 +13,7 @@ if (correctPhi)
IOobject::AUTO_WRITE IOobject::AUTO_WRITE
), ),
mesh, mesh,
dimensionedScalar("rAU", dimTime/dimDensity, 1) dimensionedScalar(dimTime/dimDensity, 1)
); );
#include "correctPhi.H" #include "correctPhi.H"
@ -27,7 +27,7 @@ else
U, U,
phi, phi,
p_rgh, p_rgh,
dimensionedScalar("rAUf", dimTime/rho.dimensions(), 1), dimensionedScalar(dimTime/rho.dimensions(), 1),
geometricZeroField(), geometricZeroField(),
pcorrControl pcorrControl
); );

View File

@ -10,7 +10,7 @@ if (nAlphaSubCycles > 1)
mesh mesh
), ),
mesh, mesh,
dimensionedScalar("0", rhoPhi.dimensions(), 0) dimensionedScalar(rhoPhi.dimensions(), 0)
); );
for for

View File

@ -116,7 +116,7 @@ Foam::incompressibleThreePhaseMixture::incompressibleThreePhaseMixture
U.db() U.db()
), ),
U.mesh(), U.mesh(),
dimensionedScalar("nu", dimensionSet(0, 2, -1, 0, 0), 0), dimensionedScalar(dimensionSet(0, 2, -1, 0, 0), 0),
calculatedFvPatchScalarField::typeName calculatedFvPatchScalarField::typeName
), ),

View File

@ -186,7 +186,7 @@ Foam::threePhaseInterfaceProperties::threePhaseInterfaceProperties
mixture.alpha1().mesh() mixture.alpha1().mesh()
), ),
mixture.alpha1().mesh(), mixture.alpha1().mesh(),
dimensionedScalar("nHatf", dimArea, 0) dimensionedScalar(dimArea, 0)
), ),
K_ K_
@ -198,7 +198,7 @@ Foam::threePhaseInterfaceProperties::threePhaseInterfaceProperties
mixture.alpha1().mesh() mixture.alpha1().mesh()
), ),
mixture.alpha1().mesh(), mixture.alpha1().mesh(),
dimensionedScalar("K", dimless/dimLength, 0) dimensionedScalar(dimless/dimLength, 0)
) )
{ {
calculateK(); calculateK();

View File

@ -137,7 +137,7 @@ int main(int argc, char *argv[])
mesh mesh
), ),
mesh, mesh,
dimensionedScalar("0", dimMass/dimTime, 0) dimensionedScalar(dimMass/dimTime, 0)
); );
#include "alphaControls.H" #include "alphaControls.H"

View File

@ -44,7 +44,7 @@ forAllIter(PtrDictionary<phaseModel>, fluid.phases(), iter)
*max *max
( (
mag(U()) - maxSlamVelocity, mag(U()) - maxSlamVelocity,
dimensionedScalar("U0", dimVelocity, 0) dimensionedScalar(dimVelocity, 0)
) )
/pow(mesh.V(), 1.0/3.0), /pow(mesh.V(), 1.0/3.0),
U U

View File

@ -37,7 +37,7 @@ surfaceScalarField phi
IOobject::AUTO_WRITE IOobject::AUTO_WRITE
), ),
mesh, mesh,
dimensionedScalar("phi", dimArea*dimVelocity, 0) dimensionedScalar(dimArea*dimVelocity, 0)
); );
multiphaseSystem fluid(U, phi); multiphaseSystem fluid(U, phi);

View File

@ -84,7 +84,7 @@ Foam::tmp<Foam::volScalarField> Foam::dragModels::interface::K
false false
), ),
Ur.mesh(), Ur.mesh(),
dimensionedScalar("K", dimDensity/dimTime, 0) dimensionedScalar(dimDensity/dimTime, 0)
) )
); );
} }

View File

@ -151,7 +151,7 @@ void Foam::multiphaseSystem::solveAlphas()
mesh_ mesh_
), ),
mesh_, mesh_,
dimensionedScalar("sumAlpha", dimless, 0) dimensionedScalar(dimless, 0)
); );
phasei = 0; phasei = 0;
@ -401,7 +401,7 @@ Foam::multiphaseSystem::multiphaseSystem
IOobject::AUTO_WRITE IOobject::AUTO_WRITE
), ),
mesh_, mesh_,
dimensionedScalar("alphas", dimless, 0) dimensionedScalar(dimless, 0)
), ),
sigmas_(lookup("sigmas")), sigmas_(lookup("sigmas")),
@ -560,12 +560,7 @@ Foam::tmp<Foam::volScalarField> Foam::multiphaseSystem::Cvm
mesh_ mesh_
), ),
mesh_, mesh_,
dimensionedScalar dimensionedScalar(dimensionSet(1, -3, 0, 0, 0), 0)
(
"Cvm",
dimensionSet(1, -3, 0, 0, 0),
0
)
) )
); );
@ -743,12 +738,7 @@ Foam::tmp<Foam::volScalarField> Foam::multiphaseSystem::dragCoeff
mesh_ mesh_
), ),
mesh_, mesh_,
dimensionedScalar dimensionedScalar(dimensionSet(1, -3, -1, 0, 0), 0)
(
"dragCoeff",
dimensionSet(1, -3, -1, 0, 0),
0
)
) )
); );
@ -791,12 +781,7 @@ Foam::tmp<Foam::surfaceScalarField> Foam::multiphaseSystem::surfaceTension
mesh_ mesh_
), ),
mesh_, mesh_,
dimensionedScalar dimensionedScalar(dimensionSet(1, -2, -2, 0, 0), 0)
(
"surfaceTension",
dimensionSet(1, -2, -2, 0, 0),
0
)
) )
); );
@ -814,7 +799,7 @@ Foam::tmp<Foam::surfaceScalarField> Foam::multiphaseSystem::surfaceTension
if (sigma != sigmas_.end()) if (sigma != sigmas_.end())
{ {
tSurfaceTension.ref() += tSurfaceTension.ref() +=
dimensionedScalar("sigma", dimSigma_, sigma()) dimensionedScalar(dimSigma_, sigma())
*fvc::interpolate(K(phase1, phase2))* *fvc::interpolate(K(phase1, phase2))*
( (
fvc::interpolate(phase2)*fvc::snGrad(phase1) fvc::interpolate(phase2)*fvc::snGrad(phase1)
@ -842,7 +827,7 @@ Foam::multiphaseSystem::nearInterface() const
mesh_ mesh_
), ),
mesh_, mesh_,
dimensionedScalar("nearInterface", dimless, 0) dimensionedScalar(dimless, 0)
) )
); );
@ -899,7 +884,7 @@ void Foam::multiphaseSystem::solve()
mesh_ mesh_
), ),
mesh_, mesh_,
dimensionedScalar("0", dimensionSet(0, 3, -1, 0, 0), 0) dimensionedScalar(dimensionSet(0, 3, -1, 0, 0), 0)
) )
); );

View File

@ -110,7 +110,7 @@ Foam::phaseModel::phaseModel
mesh mesh
), ),
mesh, mesh,
dimensionedScalar("0", dimensionSet(0, 3, -1, 0, 0), 0) dimensionedScalar(dimensionSet(0, 3, -1, 0, 0), 0)
) )
{ {
const word phiName = IOobject::groupName("phi", name_); const word phiName = IOobject::groupName("phi", name_);

View File

@ -55,7 +55,7 @@
IOobject::AUTO_WRITE IOobject::AUTO_WRITE
), ),
mesh, mesh,
dimensionedScalar("phiHbyA", dimArea*dimVelocity, 0) dimensionedScalar(dimArea*dimVelocity, 0)
); );
volScalarField rho("rho", fluid.rho()); volScalarField rho("rho", fluid.rho());
@ -176,7 +176,7 @@
mesh mesh
), ),
mesh, mesh,
dimensionedScalar("rAUf", dimensionSet(-1, 3, 1, 0, 0), 0) dimensionedScalar(dimensionSet(-1, 3, 1, 0, 0), 0)
); );
phasei = 0; phasei = 0;
@ -237,7 +237,7 @@
surfaceScalarField mSfGradp("mSfGradp", pEqnIncomp.flux()/rAUf); surfaceScalarField mSfGradp("mSfGradp", pEqnIncomp.flux()/rAUf);
phasei = 0; phasei = 0;
phi = dimensionedScalar("phi", phi.dimensions(), 0); phi = dimensionedScalar(phi.dimensions(), 0);
forAllIter(PtrDictionary<phaseModel>, fluid.phases(), iter) forAllIter(PtrDictionary<phaseModel>, fluid.phases(), iter)
{ {
phaseModel& phase = iter(); phaseModel& phase = iter();

View File

@ -92,7 +92,7 @@ Foam::multiphaseMixture::multiphaseMixture
IOobject::NO_WRITE IOobject::NO_WRITE
), ),
mesh_, mesh_,
dimensionedScalar("rhoPhi", dimMass/dimTime, 0) dimensionedScalar(dimMass/dimTime, 0)
), ),
alphas_ alphas_
@ -106,7 +106,7 @@ Foam::multiphaseMixture::multiphaseMixture
IOobject::AUTO_WRITE IOobject::AUTO_WRITE
), ),
mesh_, mesh_,
dimensionedScalar("alphas", dimless, 0) dimensionedScalar(dimless, 0)
), ),
nu_ nu_
@ -263,12 +263,7 @@ Foam::multiphaseMixture::surfaceTensionForce() const
mesh_ mesh_
), ),
mesh_, mesh_,
dimensionedScalar dimensionedScalar(dimensionSet(1, -2, -2, 0, 0), 0)
(
"surfaceTensionForce",
dimensionSet(1, -2, -2, 0, 0),
0.0
)
) )
); );
@ -296,7 +291,7 @@ Foam::multiphaseMixture::surfaceTensionForce() const
<< exit(FatalError); << exit(FatalError);
} }
stf += dimensionedScalar("sigma", dimSigma_, sigma()) stf += dimensionedScalar(dimSigma_, sigma())
*fvc::interpolate(K(alpha1, alpha2))* *fvc::interpolate(K(alpha1, alpha2))*
( (
fvc::interpolate(alpha2)*fvc::snGrad(alpha1) fvc::interpolate(alpha2)*fvc::snGrad(alpha1)
@ -332,7 +327,7 @@ void Foam::multiphaseMixture::solve()
mesh_ mesh_
), ),
mesh_, mesh_,
dimensionedScalar("0", rhoPhi_.dimensions(), 0) dimensionedScalar(rhoPhi_.dimensions(), 0)
); );
dimensionedScalar totalDeltaT = runTime.deltaT(); dimensionedScalar totalDeltaT = runTime.deltaT();
@ -544,7 +539,7 @@ Foam::multiphaseMixture::nearInterface() const
mesh_ mesh_
), ),
mesh_, mesh_,
dimensionedScalar("nearInterface", dimless, 0) dimensionedScalar(dimless, 0)
) )
); );
@ -631,7 +626,7 @@ void Foam::multiphaseMixture::solveAlphas
MULES::limitSum(alphaPhiCorrs); MULES::limitSum(alphaPhiCorrs);
rhoPhi_ = dimensionedScalar("0", dimensionSet(1, 0, -1, 0, 0), 0); rhoPhi_ = dimensionedScalar(dimensionSet(1, 0, -1, 0, 0), 0);
volScalarField sumAlpha volScalarField sumAlpha
( (
@ -642,7 +637,7 @@ void Foam::multiphaseMixture::solveAlphas
mesh_ mesh_
), ),
mesh_, mesh_,
dimensionedScalar("sumAlpha", dimless, 0) dimensionedScalar(dimless, 0)
); );
phasei = 0; phasei = 0;

View File

@ -70,7 +70,7 @@ int main(int argc, char *argv[])
IOobject::AUTO_WRITE IOobject::AUTO_WRITE
), ),
mesh, mesh,
dimensionedScalar("rAUf", dimTime, 1.0) dimensionedScalar(dimTime, 1.0)
); );
if (correctPhi) if (correctPhi)

View File

@ -45,7 +45,7 @@ Foam::interfaceCompositionModels::Henry<Thermo, OtherThermo>::Henry
pair.phase1().mesh() pair.phase1().mesh()
), ),
pair.phase1().mesh(), pair.phase1().mesh(),
dimensionedScalar("one", dimless, 1) dimensionedScalar(dimless, 1)
) )
{ {
if (k_.size() != this->speciesNames_.size()) if (k_.size() != this->speciesNames_.size())
@ -127,7 +127,7 @@ Foam::interfaceCompositionModels::Henry<Thermo, OtherThermo>::YfPrime
this->pair_.phase1().mesh() this->pair_.phase1().mesh()
), ),
this->pair_.phase1().mesh(), this->pair_.phase1().mesh(),
dimensionedScalar("zero", dimless/dimTemperature, 0) dimensionedScalar(dimless/dimTemperature, 0)
) )
); );
} }

View File

@ -149,7 +149,7 @@ Foam::InterfaceCompositionModel<Thermo, OtherThermo>::D
p.mesh() p.mesh()
), ),
p.mesh(), p.mesh(),
dimensionedScalar("zero", dimArea/dimTime, 0) dimensionedScalar(dimArea/dimTime, 0)
) )
); );
@ -203,7 +203,7 @@ Foam::InterfaceCompositionModel<Thermo, OtherThermo>::L
p.mesh() p.mesh()
), ),
p.mesh(), p.mesh(),
dimensionedScalar("zero", dimEnergy/dimMass, 0) dimensionedScalar(dimEnergy/dimMass, 0)
) )
); );

View File

@ -45,7 +45,7 @@ NonRandomTwoLiquid
pair.phase1().mesh() pair.phase1().mesh()
), ),
pair.phase1().mesh(), pair.phase1().mesh(),
dimensionedScalar("one", dimless, 1) dimensionedScalar(dimless, 1)
), ),
gamma2_ gamma2_
( (
@ -56,7 +56,7 @@ NonRandomTwoLiquid
pair.phase1().mesh() pair.phase1().mesh()
), ),
pair.phase1().mesh(), pair.phase1().mesh(),
dimensionedScalar("one", dimless, 1) dimensionedScalar(dimless, 1)
), ),
beta12_("", dimless/dimTemperature, 0), beta12_("", dimless/dimTemperature, 0),
beta21_("", dimless/dimTemperature, 0) beta21_("", dimless/dimTemperature, 0)

View File

@ -44,7 +44,7 @@ Foam::interfaceCompositionModels::Raoult<Thermo, OtherThermo>::Raoult
pair.phase1().mesh() pair.phase1().mesh()
), ),
pair.phase1().mesh(), pair.phase1().mesh(),
dimensionedScalar("one", dimless, 1) dimensionedScalar(dimless, 1)
), ),
YNonVapourPrime_ YNonVapourPrime_
( (
@ -55,7 +55,7 @@ Foam::interfaceCompositionModels::Raoult<Thermo, OtherThermo>::Raoult
pair.phase1().mesh() pair.phase1().mesh()
), ),
pair.phase1().mesh(), pair.phase1().mesh(),
dimensionedScalar("zero", dimless/dimTemperature, 0) dimensionedScalar(dimless/dimTemperature, 0)
) )
{ {
forAllConstIter(hashedWordList, this->speciesNames_, iter) forAllConstIter(hashedWordList, this->speciesNames_, iter)

View File

@ -68,7 +68,7 @@ Foam::saturationModels::Antoine::pSat
) const ) const
{ {
return return
dimensionedScalar("one", dimPressure, 1) dimensionedScalar(dimPressure, 1)
*exp(A_ + B_/(C_ + T)); *exp(A_ + B_/(C_ + T));
} }
@ -100,7 +100,7 @@ Foam::saturationModels::Antoine::Tsat
) const ) const
{ {
return return
B_/(log(p*dimensionedScalar("one", dimless/dimPressure, 1)) - A_) B_/(log(p*dimensionedScalar(dimless/dimPressure, 1)) - A_)
- C_; - C_;
} }

View File

@ -73,7 +73,7 @@ Foam::saturationModels::AntoineExtended::pSat
) const ) const
{ {
return return
dimensionedScalar("one", dimPressure/pow(dimTemperature, D_), 1) dimensionedScalar(dimPressure/pow(dimTemperature, D_), 1)
*exp(A_ + B_/(C_ + T) + E_*pow(T, F_)) *exp(A_ + B_/(C_ + T) + E_*pow(T, F_))
*pow(T, D_); *pow(T, D_);
} }
@ -98,7 +98,7 @@ Foam::saturationModels::AntoineExtended::lnPSat
return return
A_ A_
+ B_/(C_ + T) + B_/(C_ + T)
+ D_*log(T*dimensionedScalar("one", dimless/dimTemperature, 1)) + D_*log(T*dimensionedScalar(dimless/dimTemperature, 1))
+ E_*pow(T, F_); + E_*pow(T, F_);
} }

View File

@ -113,7 +113,7 @@ Foam::saturationModels::constantSaturationConditions::pSatPrime
false false
), ),
T.mesh(), T.mesh(),
dimensionedScalar("zero", dimPressure/dimTemperature, 0) dimensionedScalar(dimPressure/dimTemperature, 0)
) )
); );
} }
@ -139,7 +139,7 @@ Foam::saturationModels::constantSaturationConditions::lnPSat
false false
), ),
T.mesh(), T.mesh(),
dimensionedScalar("lnPSat", dimless, log(pSat_.value())) dimensionedScalar(dimless, log(pSat_.value()))
) )
); );
} }

View File

@ -114,7 +114,7 @@ Foam::saturationModels::function1::Tsat
IOobject::NO_WRITE IOobject::NO_WRITE
), ),
p.mesh(), p.mesh(),
dimensionedScalar("zero", dimTemperature, 0) dimensionedScalar(dimTemperature, 0)
) )
); );

View File

@ -111,7 +111,7 @@ Foam::saturationModels::polynomial::Tsat
IOobject::NO_WRITE IOobject::NO_WRITE
), ),
p.mesh(), p.mesh(),
dimensionedScalar("zero", dimTemperature, 0) dimensionedScalar(dimTemperature, 0)
) )
); );

View File

@ -101,7 +101,7 @@ Foam::tmp<Foam::volScalarField> Foam::dragModels::segregated::K() const
mesh mesh
), ),
mesh, mesh,
dimensionedScalar("L", dimLength, 0), dimensionedScalar(dimLength, 0),
zeroGradientFvPatchField<scalar>::typeName zeroGradientFvPatchField<scalar>::typeName
); );
L.primitiveFieldRef() = cbrt(mesh.V()); L.primitiveFieldRef() = cbrt(mesh.V());

View File

@ -77,7 +77,7 @@ Foam::tmp<Foam::volScalarField> Foam::liftModels::noLift::Cl() const
false false
), ),
mesh, mesh,
dimensionedScalar("Cl", dimless, 0) dimensionedScalar(dimless, 0)
) )
); );
} }
@ -125,7 +125,7 @@ Foam::tmp<Foam::surfaceScalarField> Foam::liftModels::noLift::Ff() const
false false
), ),
mesh, mesh,
dimensionedScalar("zero", dimF*dimArea, 0) dimensionedScalar(dimF*dimArea, 0)
) )
); );
} }

View File

@ -75,7 +75,7 @@ Foam::tmp<Foam::volScalarField> Foam::swarmCorrections::noSwarm::Cs() const
mesh mesh
), ),
mesh, mesh,
dimensionedScalar("one", dimless, 1) dimensionedScalar(dimless, 1)
) )
); );
} }

View File

@ -84,7 +84,7 @@ Foam::turbulentDispersionModels::noTurbulentDispersion::D() const
false false
), ),
mesh, mesh,
dimensionedScalar("zero", dimD, 0) dimensionedScalar(dimD, 0)
) )
); );
} }

View File

@ -77,7 +77,7 @@ Foam::virtualMassModels::noVirtualMass::Cvm() const
mesh mesh
), ),
mesh, mesh,
dimensionedScalar("zero", dimless, 0) dimensionedScalar(dimless, 0)
) )
); );
} }
@ -86,7 +86,7 @@ Foam::virtualMassModels::noVirtualMass::Cvm() const
Foam::tmp<Foam::volScalarField> Foam::tmp<Foam::volScalarField>
Foam::virtualMassModels::noVirtualMass::K() const Foam::virtualMassModels::noVirtualMass::K() const
{ {
return Cvm()*dimensionedScalar("zero", dimDensity, 0); return Cvm()*dimensionedScalar(dimDensity, 0);
} }

View File

@ -76,7 +76,7 @@ Foam::tmp<Foam::volVectorField> Foam::wallLubricationModels::Antal::Fi() const
( (
max max
( (
dimensionedScalar("zero", dimless/dimLength, 0), dimensionedScalar(dimless/dimLength, 0),
Cw1_/pair_.dispersed().d() + Cw2_/yWall() Cw1_/pair_.dispersed().d() + Cw2_/yWall()
) )
*pair_.continuous().rho() *pair_.continuous().rho()

View File

@ -86,7 +86,7 @@ Foam::tmp<Foam::volVectorField> Foam::wallLubricationModels::Frank::Fi() const
) )
*max *max
( (
dimensionedScalar("zero", dimless/dimLength, 0), dimensionedScalar(dimless/dimLength, 0),
(1 - yTilde)/(Cwd_*y*pow(yTilde, p_ - 1)) (1 - yTilde)/(Cwd_*y*pow(yTilde, p_ - 1))
) )
*pair_.continuous().rho() *pair_.continuous().rho()

View File

@ -215,7 +215,7 @@ InterfaceCompositionPhaseChangePhaseSystem
this->mesh() this->mesh()
), ),
this->mesh(), this->mesh(),
dimensionedScalar("zero", dimDensity/dimTime, 0) dimensionedScalar(dimDensity/dimTime, 0)
) )
); );
@ -231,7 +231,7 @@ InterfaceCompositionPhaseChangePhaseSystem
this->mesh() this->mesh()
), ),
this->mesh(), this->mesh(),
dimensionedScalar("zero", dimDensity/dimTime, 0) dimensionedScalar(dimDensity/dimTime, 0)
) )
); );
} }
@ -431,7 +431,7 @@ correctInterfaceThermo()
this->mesh() this->mesh()
), ),
this->mesh(), this->mesh(),
dimensionedScalar("zero", dimEnergy/dimVolume/dimTime, 0) dimensionedScalar(dimEnergy/dimVolume/dimTime, 0)
); );
volScalarField mDotLPrime volScalarField mDotLPrime
( (
@ -442,7 +442,7 @@ correctInterfaceThermo()
this->mesh() this->mesh()
), ),
this->mesh(), this->mesh(),
dimensionedScalar("zero", mDotL.dimensions()/dimTemperature, 0) dimensionedScalar(mDotL.dimensions()/dimTemperature, 0)
); );
// Add latent heats from forward and backward models // Add latent heats from forward and backward models

View File

@ -74,7 +74,7 @@ Foam::MomentumTransferPhaseSystem<BasePhaseSystem>::Kd
false false
), ),
this->mesh_, this->mesh_,
dimensionedScalar("zero", dragModel::dimK, 0) dimensionedScalar(dragModel::dimK, 0)
) )
); );
} }
@ -108,7 +108,7 @@ Foam::MomentumTransferPhaseSystem<BasePhaseSystem>::Kdf
false false
), ),
this->mesh_, this->mesh_,
dimensionedScalar("zero", dragModel::dimK, 0) dimensionedScalar(dragModel::dimK, 0)
) )
); );
} }
@ -142,7 +142,7 @@ Foam::MomentumTransferPhaseSystem<BasePhaseSystem>::Vm
false false
), ),
this->mesh_, this->mesh_,
dimensionedScalar("zero", virtualMassModel::dimK, 0) dimensionedScalar(virtualMassModel::dimK, 0)
) )
); );
} }

View File

@ -210,7 +210,7 @@ void Foam::PhaseTransferPhaseSystem<BasePhaseSystem>::correct()
) )
{ {
*rDmdt_[phaseTransferModelIter.key()] = *rDmdt_[phaseTransferModelIter.key()] =
dimensionedScalar("zero", dimDensity/dimTime, 0); dimensionedScalar(dimDensity/dimTime, 0);
} }
forAllConstIter forAllConstIter

View File

@ -119,7 +119,7 @@ PopulationBalancePhaseSystem
IOobject::AUTO_WRITE IOobject::AUTO_WRITE
), ),
this->mesh(), this->mesh(),
dimensionedScalar("zero", dimDensity/dimTime, 0) dimensionedScalar(dimDensity/dimTime, 0)
) )
); );
} }

View File

@ -113,7 +113,7 @@ ThermalPhaseChangePhaseSystem
IOobject::AUTO_WRITE IOobject::AUTO_WRITE
), ),
this->mesh(), this->mesh(),
dimensionedScalar("zero", dimDensity/dimTime, 0) dimensionedScalar(dimDensity/dimTime, 0)
) )
); );
@ -132,7 +132,7 @@ ThermalPhaseChangePhaseSystem
IOobject::AUTO_WRITE IOobject::AUTO_WRITE
), ),
this->mesh(), this->mesh(),
dimensionedScalar("zero", dimDensity/dimTime, 0) dimensionedScalar(dimDensity/dimTime, 0)
) )
); );
@ -151,7 +151,7 @@ ThermalPhaseChangePhaseSystem
IOobject::AUTO_WRITE IOobject::AUTO_WRITE
), ),
this->mesh(), this->mesh(),
dimensionedScalar("zero", dimEnergy/dimTime/dimVolume, 0) dimensionedScalar(dimEnergy/dimTime/dimVolume, 0)
) )
); );
} }
@ -415,7 +415,7 @@ Foam::ThermalPhaseChangePhaseSystem<BasePhaseSystem>::correctInterfaceThermo()
} }
else else
{ {
iDmdtNew == dimensionedScalar("0", iDmdt.dimensions(), 0); iDmdtNew == dimensionedScalar(iDmdt.dimensions(), 0);
} }
volScalarField H1(heatTransferModelIter().first()->K()); volScalarField H1(heatTransferModelIter().first()->K());

View File

@ -179,7 +179,7 @@ heatTransfer() const
/max /max
( (
Ks.first()() + Ks.second()(), Ks.first()() + Ks.second()(),
dimensionedScalar("small", heatTransferModel::dimK, small) dimensionedScalar(heatTransferModel::dimK, small)
) )
); );

View File

@ -62,7 +62,7 @@ Foam::tmp<Foam::volScalarField> Foam::diameterModels::velocityGroup::dsm() const
phase_.mesh() phase_.mesh()
), ),
phase_.mesh(), phase_.mesh(),
dimensionedScalar("invDsm", inv(dimLength), Zero) dimensionedScalar(inv(dimLength), Zero)
) )
); );
@ -93,7 +93,7 @@ Foam::diameterModels::velocityGroup::fSum() const
phase_.mesh() phase_.mesh()
), ),
phase_.mesh(), phase_.mesh(),
dimensionedScalar("sumSizeGroups", dimless, 0) dimensionedScalar(dimless, 0)
) )
); );
@ -213,7 +213,7 @@ Foam::diameterModels::velocityGroup::velocityGroup
IOobject::AUTO_WRITE IOobject::AUTO_WRITE
), ),
phase.mesh(), phase.mesh(),
dimensionedScalar("d", dimLength, Zero) dimensionedScalar(dimLength, Zero)
), ),
dmdt_ dmdt_
( (
@ -224,7 +224,7 @@ Foam::diameterModels::velocityGroup::velocityGroup
phase.mesh() phase.mesh()
), ),
phase.mesh(), phase.mesh(),
dimensionedScalar("dmdt", dimDensity/dimTime, Zero) dimensionedScalar(dimDensity/dimTime, Zero)
) )
{ {
if if

View File

@ -78,7 +78,7 @@ Foam::InertPhaseModel<BasePhaseModel>::Qdot() const
this->mesh() this->mesh()
), ),
this->mesh(), this->mesh(),
dimensionedScalar("zero", dimEnergy/dimTime/dimVolume, 0) dimensionedScalar(dimEnergy/dimTime/dimVolume, 0)
) )
); );
} }

View File

@ -151,7 +151,7 @@ Foam::MovingPhaseModel<BasePhaseModel>::MovingPhaseModel
fluid.mesh() fluid.mesh()
), ),
fluid.mesh(), fluid.mesh(),
dimensionedScalar("0", dimensionSet(0, 3, -1, 0, 0), 0) dimensionedScalar(dimensionSet(0, 3, -1, 0, 0), 0)
), ),
alphaRhoPhi_ alphaRhoPhi_
( (
@ -162,7 +162,7 @@ Foam::MovingPhaseModel<BasePhaseModel>::MovingPhaseModel
fluid.mesh() fluid.mesh()
), ),
fluid.mesh(), fluid.mesh(),
dimensionedScalar("0", dimensionSet(1, 0, -1, 0, 0), 0) dimensionedScalar(dimensionSet(1, 0, -1, 0, 0), 0)
), ),
DUDt_(nullptr), DUDt_(nullptr),
DUDtf_(nullptr), DUDtf_(nullptr),
@ -188,7 +188,7 @@ Foam::MovingPhaseModel<BasePhaseModel>::MovingPhaseModel
fluid.mesh() fluid.mesh()
), ),
fluid.mesh(), fluid.mesh(),
dimensionedScalar("0", dimDensity/dimTime, 0) dimensionedScalar(dimDensity/dimTime, 0)
), ),
continuityErrorSources_ continuityErrorSources_
( (
@ -199,7 +199,7 @@ Foam::MovingPhaseModel<BasePhaseModel>::MovingPhaseModel
fluid.mesh() fluid.mesh()
), ),
fluid.mesh(), fluid.mesh(),
dimensionedScalar("0", dimDensity/dimTime, 0) dimensionedScalar(dimDensity/dimTime, 0)
), ),
K_(nullptr) K_(nullptr)
{ {

View File

@ -105,7 +105,7 @@ void Foam::MultiComponentPhaseModel<BasePhaseModel>::correctThermo()
this->fluid().mesh() this->fluid().mesh()
), ),
this->fluid().mesh(), this->fluid().mesh(),
dimensionedScalar("zero", dimless, 0) dimensionedScalar(dimless, 0)
); );
PtrList<volScalarField>& Yi = YRef(); PtrList<volScalarField>& Yi = YRef();

View File

@ -56,7 +56,7 @@ Foam::phaseModel::phaseModel
IOobject::AUTO_WRITE IOobject::AUTO_WRITE
), ),
fluid.mesh(), fluid.mesh(),
dimensionedScalar("alpha", dimless, 0) dimensionedScalar(dimless, 0)
), ),
fluid_(fluid), fluid_(fluid),

View File

@ -153,7 +153,7 @@ Foam::phaseSystem::phaseSystem
mesh mesh
), ),
mesh, mesh,
dimensionedScalar("dpdt", dimPressure/dimTime, 0) dimensionedScalar(dimPressure/dimTime, 0)
), ),
MRF_(mesh_) MRF_(mesh_)
@ -313,7 +313,7 @@ Foam::phaseSystem::E(const phasePairKey& key) const
false false
), ),
this->mesh_, this->mesh_,
dimensionedScalar("zero", dimless, 1) dimensionedScalar(dimless, 1)
) )
); );
} }
@ -343,7 +343,7 @@ Foam::phaseSystem::sigma(const phasePairKey& key) const
false false
), ),
this->mesh_, this->mesh_,
dimensionedScalar("zero", surfaceTensionModel::dimSigma, 0) dimensionedScalar(surfaceTensionModel::dimSigma, 0)
) )
); );
} }
@ -366,7 +366,7 @@ Foam::tmp<Foam::volScalarField> Foam::phaseSystem::dmdt
this->mesh_ this->mesh_
), ),
this->mesh_, this->mesh_,
dimensionedScalar("zero", dimDensity/dimTime, 0) dimensionedScalar(dimDensity/dimTime, 0)
) )
); );
} }

View File

@ -60,7 +60,7 @@ Foam::diameterModels::driftModels::constantDrift::constantDrift
popBal.mesh() popBal.mesh()
), ),
popBal.mesh(), popBal.mesh(),
dimensionedScalar("Sui", inv(dimVolume), Zero) dimensionedScalar(inv(dimVolume), Zero)
) )
{} {}

View File

@ -62,7 +62,7 @@ Foam::diameterModels::driftModels::phaseChange::phaseChange
popBal.mesh() popBal.mesh()
), ),
popBal.mesh(), popBal.mesh(),
dimensionedScalar("Sui", dimDensity/dimTime, Zero) dimensionedScalar(dimDensity/dimTime, Zero)
), ),
N_ N_
( (
@ -73,7 +73,7 @@ Foam::diameterModels::driftModels::phaseChange::phaseChange
popBal.mesh() popBal.mesh()
), ),
popBal.mesh(), popBal.mesh(),
dimensionedScalar("Sui", inv(dimVolume), Zero) dimensionedScalar(inv(dimVolume), Zero)
) )
{} {}

View File

@ -152,7 +152,7 @@ Foam::diameterModels::populationBalanceModel::add(sizeGroup& group)
mesh_ mesh_
), ),
mesh_, mesh_,
dimensionedScalar("Su", inv(dimTime), 0) dimensionedScalar(inv(dimTime), 0)
) )
); );
@ -167,7 +167,7 @@ Foam::diameterModels::populationBalanceModel::add(sizeGroup& group)
mesh_ mesh_
), ),
mesh_, mesh_,
dimensionedScalar("SuSp", inv(dimTime), 0) dimensionedScalar(inv(dimTime), 0)
) )
); );
} }
@ -812,7 +812,7 @@ Foam::diameterModels::populationBalanceModel::calcDsm()
mesh_ mesh_
), ),
mesh_, mesh_,
dimensionedScalar("invDsm", inv(dimLength), Zero) dimensionedScalar(inv(dimLength), Zero)
) )
); );
@ -900,7 +900,7 @@ Foam::diameterModels::populationBalanceModel::populationBalanceModel
mesh_ mesh_
), ),
mesh_, mesh_,
dimensionedScalar("Sui", inv(dimTime), Zero) dimensionedScalar(inv(dimTime), Zero)
), ),
coalescence_ coalescence_
( (
@ -968,7 +968,7 @@ Foam::diameterModels::populationBalanceModel::populationBalanceModel
mesh_ mesh_
), ),
mesh_, mesh_,
dimensionedScalar("coalescenceRate", dimVolume/dimTime, Zero) dimensionedScalar(dimVolume/dimTime, Zero)
) )
); );
} }
@ -986,7 +986,7 @@ Foam::diameterModels::populationBalanceModel::populationBalanceModel
mesh_ mesh_
), ),
mesh_, mesh_,
dimensionedScalar("breakupRate", inv(dimTime), Zero) dimensionedScalar(inv(dimTime), Zero)
) )
); );
} }
@ -1027,7 +1027,7 @@ Foam::diameterModels::populationBalanceModel::populationBalanceModel
mesh_ mesh_
), ),
mesh_, mesh_,
dimensionedScalar("driftRate", dimVolume/dimTime, Zero) dimensionedScalar(dimVolume/dimTime, Zero)
) )
); );
@ -1042,7 +1042,7 @@ Foam::diameterModels::populationBalanceModel::populationBalanceModel
mesh_ mesh_
), ),
mesh_, mesh_,
dimensionedScalar("r", dimless, Zero) dimensionedScalar(dimless, Zero)
) )
); );
@ -1057,7 +1057,7 @@ Foam::diameterModels::populationBalanceModel::populationBalanceModel
mesh_ mesh_
), ),
mesh_, mesh_,
dimensionedScalar("r", dimless, Zero) dimensionedScalar(dimless, Zero)
) )
); );
} }
@ -1100,7 +1100,7 @@ Foam::diameterModels::populationBalanceModel::populationBalanceModel
IOobject::AUTO_WRITE IOobject::AUTO_WRITE
), ),
mesh_, mesh_,
dimensionedScalar("alpha", dimless, Zero) dimensionedScalar(dimless, Zero)
) )
); );
@ -1117,7 +1117,7 @@ Foam::diameterModels::populationBalanceModel::populationBalanceModel
IOobject::AUTO_WRITE IOobject::AUTO_WRITE
), ),
mesh_, mesh_,
dimensionedScalar("d", dimLength, Zero) dimensionedScalar(dimLength, Zero)
) )
); );

View File

@ -85,7 +85,7 @@ void Foam::multiphaseSystem::solveAlphas()
mesh_ mesh_
), ),
mesh_, mesh_,
dimensionedScalar("alphaVoid", dimless, 1) dimensionedScalar(dimless, 1)
); );
forAll(stationaryPhases(), stationaryPhasei) forAll(stationaryPhases(), stationaryPhasei)
{ {
@ -221,7 +221,7 @@ void Foam::multiphaseSystem::solveAlphas()
mesh_ mesh_
), ),
mesh_, mesh_,
dimensionedScalar("Sp", dimless/dimTime, 0) dimensionedScalar(dimless/dimTime, 0)
); );
volScalarField::Internal Su volScalarField::Internal Su
@ -314,7 +314,7 @@ void Foam::multiphaseSystem::solveAlphas()
mesh_ mesh_
), ),
mesh_, mesh_,
dimensionedScalar("sumAlphaMoving", dimless, 0) dimensionedScalar(dimless, 0)
); );
forAll(movingPhases(), movingPhasei) forAll(movingPhases(), movingPhasei)
{ {
@ -519,7 +519,7 @@ Foam::multiphaseSystem::multiphaseSystem
IOobject::AUTO_WRITE IOobject::AUTO_WRITE
), ),
mesh, mesh,
dimensionedScalar("alphas", dimless, 0) dimensionedScalar(dimless, 0)
), ),
cAlphas_(lookup("interfaceCompression")), cAlphas_(lookup("interfaceCompression")),
@ -562,12 +562,7 @@ Foam::tmp<Foam::surfaceScalarField> Foam::multiphaseSystem::surfaceTension
mesh_ mesh_
), ),
mesh_, mesh_,
dimensionedScalar dimensionedScalar(dimensionSet(1, -2, -2, 0, 0), 0)
(
"surfaceTension",
dimensionSet(1, -2, -2, 0, 0),
0
)
) )
); );
@ -611,7 +606,7 @@ Foam::multiphaseSystem::nearInterface() const
mesh_ mesh_
), ),
mesh_, mesh_,
dimensionedScalar("nearInterface", dimless, 0) dimensionedScalar(dimless, 0)
) )
); );
@ -673,7 +668,7 @@ void Foam::multiphaseSystem::solve()
mesh_ mesh_
), ),
mesh_, mesh_,
dimensionedScalar("0", dimensionSet(0, 3, -1, 0, 0), 0) dimensionedScalar(dimensionSet(0, 3, -1, 0, 0), 0)
) )
); );
} }

View File

@ -180,7 +180,7 @@ while (pimple.correct())
IOobject::AUTO_WRITE IOobject::AUTO_WRITE
), ),
mesh, mesh,
dimensionedScalar("phiHbyA", dimArea*dimVelocity, 0) dimensionedScalar(dimArea*dimVelocity, 0)
); );
forAll(phases, phasei) forAll(phases, phasei)
@ -214,7 +214,7 @@ while (pimple.correct())
mesh mesh
), ),
mesh, mesh,
dimensionedScalar("rAUf", dimensionSet(-1, 3, 1, 0, 0), 0) dimensionedScalar(dimensionSet(-1, 3, 1, 0, 0), 0)
); );
forAll(phases, phasei) forAll(phases, phasei)

View File

@ -165,7 +165,7 @@ while (pimple.correct())
IOobject::AUTO_WRITE IOobject::AUTO_WRITE
), ),
mesh, mesh,
dimensionedScalar("phiHbyA", dimArea*dimVelocity, 0) dimensionedScalar(dimArea*dimVelocity, 0)
); );
forAll(phases, phasei) forAll(phases, phasei)
@ -199,7 +199,7 @@ while (pimple.correct())
mesh mesh
), ),
mesh, mesh,
dimensionedScalar("rAUf", dimensionSet(-1, 3, 1, 0, 0), 0) dimensionedScalar(dimensionSet(-1, 3, 1, 0, 0), 0)
); );
forAll(phases, phasei) forAll(phases, phasei)

View File

@ -28,7 +28,7 @@
// Set the reciprocal time-step from the local Courant number // Set the reciprocal time-step from the local Courant number
rDeltaT.ref() = max rDeltaT.ref() = max
( (
1/dimensionedScalar("maxDeltaT", dimTime, maxDeltaT), 1/dimensionedScalar(dimTime, maxDeltaT),
fvc::surfaceSum(maxPhi)()() fvc::surfaceSum(maxPhi)()()
/((2*maxCo)*mesh.V()) /((2*maxCo)*mesh.V())
); );

View File

@ -15,7 +15,7 @@ if (LTS && faceMomentum)
IOobject::AUTO_WRITE IOobject::AUTO_WRITE
), ),
mesh, mesh,
dimensionedScalar("one", dimless/dimTime, 1) dimensionedScalar(dimless/dimTime, 1)
) )
); );
} }

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