GeometricField::dimensionedInternalField() -> GeometricField::dimensionedInternalFieldRef()

See also commit 22f4ad32b1
This commit is contained in:
Henry Weller
2016-04-26 16:29:43 +01:00
parent 6962fd3ba4
commit dc2951ca2f
22 changed files with 45 additions and 42 deletions

View File

@ -58,7 +58,7 @@ License
// Flow time scale // Flow time scale
{ {
rDeltaT.dimensionedInternalField() = rDeltaT.dimensionedInternalFieldRef() =
( (
fvc::surfaceSum(mag(phi))().dimensionedInternalField() fvc::surfaceSum(mag(phi))().dimensionedInternalField()
/((2*maxCo)*mesh.V()*rho.dimensionedInternalField()) /((2*maxCo)*mesh.V()*rho.dimensionedInternalField())
@ -84,7 +84,7 @@ License
<< gMin(1/(rDeltaTT.field() + VSMALL)) << ", " << gMin(1/(rDeltaTT.field() + VSMALL)) << ", "
<< gMax(1/(rDeltaTT.field() + VSMALL)) << endl; << gMax(1/(rDeltaTT.field() + VSMALL)) << endl;
rDeltaT.dimensionedInternalField() = max rDeltaT.dimensionedInternalFieldRef() = max
( (
rDeltaT.dimensionedInternalField(), rDeltaT.dimensionedInternalField(),
rDeltaTT rDeltaTT

View File

@ -185,7 +185,7 @@ int main(int argc, char *argv[])
// --- Solve momentum // --- Solve momentum
solve(fvm::ddt(rhoU) + fvc::div(phiUp)); solve(fvm::ddt(rhoU) + fvc::div(phiUp));
U.dimensionedInternalField() = U.dimensionedInternalFieldRef() =
rhoU.dimensionedInternalField() rhoU.dimensionedInternalField()
/rho.dimensionedInternalField(); /rho.dimensionedInternalField();
U.correctBoundaryConditions(); U.correctBoundaryConditions();
@ -240,7 +240,7 @@ int main(int argc, char *argv[])
rhoE = rho*(e + 0.5*magSqr(U)); rhoE = rho*(e + 0.5*magSqr(U));
} }
p.dimensionedInternalField() = p.dimensionedInternalFieldRef() =
rho.dimensionedInternalField() rho.dimensionedInternalField()
/psi.dimensionedInternalField(); /psi.dimensionedInternalField();
p.correctBoundaryConditions(); p.correctBoundaryConditions();

View File

@ -178,7 +178,7 @@ int main(int argc, char *argv[])
// --- Solve momentum // --- Solve momentum
solve(fvm::ddt(rhoU) + fvc::div(phiUp)); solve(fvm::ddt(rhoU) + fvc::div(phiUp));
U.dimensionedInternalField() = U.dimensionedInternalFieldRef() =
rhoU.dimensionedInternalField() rhoU.dimensionedInternalField()
/rho.dimensionedInternalField(); /rho.dimensionedInternalField();
U.correctBoundaryConditions(); U.correctBoundaryConditions();
@ -233,7 +233,7 @@ int main(int argc, char *argv[])
rhoE = rho*(e + 0.5*magSqr(U)); rhoE = rho*(e + 0.5*magSqr(U));
} }
p.dimensionedInternalField() = p.dimensionedInternalFieldRef() =
rho.dimensionedInternalField() rho.dimensionedInternalField()
/psi.dimensionedInternalField(); /psi.dimensionedInternalField();
p.correctBoundaryConditions(); p.correctBoundaryConditions();

View File

@ -11,7 +11,7 @@
); );
// Set the reciprocal time-step from the local Courant number // Set the reciprocal time-step from the local Courant number
rDeltaT.dimensionedInternalField() = max rDeltaT.dimensionedInternalFieldRef() = max
( (
1/dimensionedScalar("maxDeltaT", dimTime, maxDeltaT), 1/dimensionedScalar("maxDeltaT", dimTime, maxDeltaT),
fvc::surfaceSum(amaxSf)().dimensionedInternalField() fvc::surfaceSum(amaxSf)().dimensionedInternalField()

View File

@ -26,7 +26,7 @@
volScalarField rDeltaT0("rDeltaT0", rDeltaT); volScalarField rDeltaT0("rDeltaT0", rDeltaT);
// Set the reciprocal time-step from the local Courant number // Set the reciprocal time-step from the local Courant number
rDeltaT.dimensionedInternalField() = max rDeltaT.dimensionedInternalFieldRef() = max
( (
1/dimensionedScalar("maxDeltaT", dimTime, maxDeltaT), 1/dimensionedScalar("maxDeltaT", dimTime, maxDeltaT),
fvc::surfaceSum(mag(phi))().dimensionedInternalField() fvc::surfaceSum(mag(phi))().dimensionedInternalField()
@ -41,7 +41,7 @@
fvc::interpolate(psi)*fvc::flux(U) fvc::interpolate(psi)*fvc::flux(U)
); );
rDeltaT.dimensionedInternalField() = max rDeltaT.dimensionedInternalFieldRef() = max
( (
rDeltaT.dimensionedInternalField(), rDeltaT.dimensionedInternalField(),
fvc::surfaceSum(mag(phid))().dimensionedInternalField() fvc::surfaceSum(mag(phid))().dimensionedInternalField()

View File

@ -58,7 +58,7 @@ License
// Flow time scale // Flow time scale
{ {
rDeltaT.dimensionedInternalField() = rDeltaT.dimensionedInternalFieldRef() =
( (
fvc::surfaceSum(mag(phi))().dimensionedInternalField() fvc::surfaceSum(mag(phi))().dimensionedInternalField()
/((2*maxCo)*mesh.V()*rho.dimensionedInternalField()) /((2*maxCo)*mesh.V()*rho.dimensionedInternalField())
@ -94,7 +94,7 @@ License
<< gMin(1/(rDeltaTT.field() + VSMALL)) << ", " << gMin(1/(rDeltaTT.field() + VSMALL)) << ", "
<< gMax(1/(rDeltaTT.field() + VSMALL)) << endl; << gMax(1/(rDeltaTT.field() + VSMALL)) << endl;
rDeltaT.dimensionedInternalField() = max rDeltaT.dimensionedInternalFieldRef() = max
( (
rDeltaT.dimensionedInternalField(), rDeltaT.dimensionedInternalField(),
rDeltaTT rDeltaTT

View File

@ -58,7 +58,7 @@ License
// Flow time scale // Flow time scale
{ {
rDeltaT.dimensionedInternalField() = rDeltaT.dimensionedInternalFieldRef() =
( (
fvc::surfaceSum(mag(phi))().dimensionedInternalField() fvc::surfaceSum(mag(phi))().dimensionedInternalField()
/((2*maxCo)*mesh.V()*rho.dimensionedInternalField()) /((2*maxCo)*mesh.V()*rho.dimensionedInternalField())
@ -93,7 +93,7 @@ License
<< gMin(1/(rDeltaTT.field() + VSMALL)) << ", " << gMin(1/(rDeltaTT.field() + VSMALL)) << ", "
<< gMax(1/(rDeltaTT.field() + VSMALL)) << endl; << gMax(1/(rDeltaTT.field() + VSMALL)) << endl;
rDeltaT.dimensionedInternalField() = max rDeltaT.dimensionedInternalFieldRef() = max
( (
rDeltaT.dimensionedInternalField(), rDeltaT.dimensionedInternalField(),
rDeltaTT rDeltaTT

View File

@ -56,7 +56,7 @@
volScalarField rDeltaT0("rDeltaT0", rDeltaT); volScalarField rDeltaT0("rDeltaT0", rDeltaT);
// Set the reciprocal time-step from the local Courant number // Set the reciprocal time-step from the local Courant number
rDeltaT.dimensionedInternalField() = max rDeltaT.dimensionedInternalFieldRef() = max
( (
1/dimensionedScalar("maxDeltaT", dimTime, maxDeltaT), 1/dimensionedScalar("maxDeltaT", dimTime, maxDeltaT),
fvc::surfaceSum(mag(rhoPhi))().dimensionedInternalField() fvc::surfaceSum(mag(rhoPhi))().dimensionedInternalField()
@ -70,7 +70,7 @@
volScalarField alpha1Bar(fvc::average(alpha1)); volScalarField alpha1Bar(fvc::average(alpha1));
rDeltaT.dimensionedInternalField() = max rDeltaT.dimensionedInternalFieldRef() = max
( (
rDeltaT.dimensionedInternalField(), rDeltaT.dimensionedInternalField(),
pos(alpha1Bar.dimensionedInternalField() - alphaSpreadMin) pos(alpha1Bar.dimensionedInternalField() - alphaSpreadMin)

View File

@ -26,7 +26,7 @@
} }
// Set the reciprocal time-step from the local Courant number // Set the reciprocal time-step from the local Courant number
rDeltaT.dimensionedInternalField() = max rDeltaT.dimensionedInternalFieldRef() = max
( (
1/dimensionedScalar("maxDeltaT", dimTime, maxDeltaT), 1/dimensionedScalar("maxDeltaT", dimTime, maxDeltaT),
fvc::surfaceSum(maxPhi)().dimensionedInternalField() fvc::surfaceSum(maxPhi)().dimensionedInternalField()

View File

@ -19,7 +19,7 @@
); );
// Set the reciprocal time-step from the local Courant number // Set the reciprocal time-step from the local Courant number
rDeltaT.dimensionedInternalField() = max rDeltaT.dimensionedInternalFieldRef() = max
( (
1/dimensionedScalar("maxDeltaT", dimTime, maxDeltaT), 1/dimensionedScalar("maxDeltaT", dimTime, maxDeltaT),
fvc::surfaceSum(max(mag(phi1), mag(phi2)))().dimensionedInternalField() fvc::surfaceSum(max(mag(phi1), mag(phi2)))().dimensionedInternalField()

View File

@ -115,7 +115,7 @@ int main(int argc, char *argv[])
calculatedFvPatchField<scalar>::typeName calculatedFvPatchField<scalar>::typeName
); );
V.dimensionedInternalField() = mesh.V(); V.dimensionedInternalFieldRef() = mesh.V();
volScalarField::GeometricBoundaryField& Vbf = V.boundaryFieldRef(); volScalarField::GeometricBoundaryField& Vbf = V.boundaryFieldRef();

View File

@ -87,7 +87,7 @@ void Foam::calc(const argList& args, const Time& runTime, const fvMesh& mesh)
mesh mesh
); );
Co.dimensionedInternalField() = Co.dimensionedInternalFieldRef() =
(0.5*runTime.deltaT()) (0.5*runTime.deltaT())
*fvc::surfaceSum(mag(phi))().dimensionedInternalField() *fvc::surfaceSum(mag(phi))().dimensionedInternalField()
/(rho*mesh.V()); /(rho*mesh.V());
@ -97,7 +97,7 @@ void Foam::calc(const argList& args, const Time& runTime, const fvMesh& mesh)
{ {
Info<< " Calculating incompressible Co" << endl; Info<< " Calculating incompressible Co" << endl;
Co.dimensionedInternalField() = Co.dimensionedInternalFieldRef() =
(0.5*runTime.deltaT()) (0.5*runTime.deltaT())
*fvc::surfaceSum(mag(phi))().dimensionedInternalField() *fvc::surfaceSum(mag(phi))().dimensionedInternalField()
/mesh.V(); /mesh.V();

View File

@ -690,7 +690,7 @@ Foam::GeometricField<Type, PatchField, GeoMesh>::~GeometricField()
template<class Type, template<class> class PatchField, class GeoMesh> template<class Type, template<class> class PatchField, class GeoMesh>
typename typename
Foam::GeometricField<Type, PatchField, GeoMesh>::DimensionedInternalField& Foam::GeometricField<Type, PatchField, GeoMesh>::DimensionedInternalField&
Foam::GeometricField<Type, PatchField, GeoMesh>::dimensionedInternalField() Foam::GeometricField<Type, PatchField, GeoMesh>::dimensionedInternalFieldRef()
{ {
this->setUpToDate(); this->setUpToDate();
storeOldTimes(); storeOldTimes();
@ -1112,9 +1112,9 @@ void Foam::GeometricField<Type, PatchField, GeoMesh>::operator=
checkField(*this, gf, "="); checkField(*this, gf, "=");
// only equate field contents not ID // Only assign field contents not ID
dimensionedInternalField() = gf.dimensionedInternalField(); dimensionedInternalFieldRef() = gf.dimensionedInternalField();
boundaryFieldRef() = gf.boundaryField(); boundaryFieldRef() = gf.boundaryField();
} }
@ -1136,11 +1136,11 @@ void Foam::GeometricField<Type, PatchField, GeoMesh>::operator=
checkField(*this, gf, "="); checkField(*this, gf, "=");
// only equate field contents not ID // Only assign field contents not ID
this->dimensions() = gf.dimensions(); this->dimensions() = gf.dimensions();
// This is dodgy stuff, don't try it at home. // Transfer the storage from the tmp
internalField().transfer internalField().transfer
( (
const_cast<Field<Type>&>(gf.internalField()) const_cast<Field<Type>&>(gf.internalField())
@ -1158,7 +1158,7 @@ void Foam::GeometricField<Type, PatchField, GeoMesh>::operator=
const dimensioned<Type>& dt const dimensioned<Type>& dt
) )
{ {
dimensionedInternalField() = dt; dimensionedInternalFieldRef() = dt;
boundaryFieldRef() = dt.value(); boundaryFieldRef() = dt.value();
} }
@ -1173,9 +1173,9 @@ void Foam::GeometricField<Type, PatchField, GeoMesh>::operator==
checkField(*this, gf, "=="); checkField(*this, gf, "==");
// only equate field contents not ID // Only assign field contents not ID
dimensionedInternalField() = gf.dimensionedInternalField(); dimensionedInternalFieldRef() = gf.dimensionedInternalField();
boundaryFieldRef() == gf.boundaryField(); boundaryFieldRef() == gf.boundaryField();
tgf.clear(); tgf.clear();
@ -1188,7 +1188,7 @@ void Foam::GeometricField<Type, PatchField, GeoMesh>::operator==
const dimensioned<Type>& dt const dimensioned<Type>& dt
) )
{ {
dimensionedInternalField() = dt; dimensionedInternalFieldRef() = dt;
boundaryFieldRef() == dt.value(); boundaryFieldRef() == dt.value();
} }
@ -1203,7 +1203,7 @@ void Foam::GeometricField<Type, PatchField, GeoMesh>::operator op \
{ \ { \
checkField(*this, gf, #op); \ checkField(*this, gf, #op); \
\ \
dimensionedInternalField() op gf.dimensionedInternalField(); \ dimensionedInternalFieldRef() op gf.dimensionedInternalField(); \
boundaryFieldRef() op gf.boundaryField(); \ boundaryFieldRef() op gf.boundaryField(); \
} \ } \
\ \
@ -1223,7 +1223,7 @@ void Foam::GeometricField<Type, PatchField, GeoMesh>::operator op \
const dimensioned<TYPE>& dt \ const dimensioned<TYPE>& dt \
) \ ) \
{ \ { \
dimensionedInternalField() op dt; \ dimensionedInternalFieldRef() op dt; \
boundaryFieldRef() op dt.value(); \ boundaryFieldRef() op dt.value(); \
} }

View File

@ -432,7 +432,7 @@ public:
//- Return a reference to the dimensioned internal field //- Return a reference to the dimensioned internal field
// Note: this increments the event counter and checks the // Note: this increments the event counter and checks the
// old-time fields; avoid in loops. // old-time fields; avoid in loops.
DimensionedInternalField& dimensionedInternalField(); DimensionedInternalField& dimensionedInternalFieldRef();
//- Return a const-reference to the dimensioned internal field //- Return a const-reference to the dimensioned internal field
inline const DimensionedInternalField& dimensionedInternalField() const; inline const DimensionedInternalField& dimensionedInternalField() const;

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License
@ -57,7 +57,7 @@ Foam::laplaceFilter::laplaceFilter(const fvMesh& mesh, scalar widthCoeff)
calculatedFvPatchScalarField::typeName calculatedFvPatchScalarField::typeName
) )
{ {
coeff_.dimensionedInternalField() = pow(mesh.V(), 2.0/3.0)/widthCoeff_; coeff_.dimensionedInternalFieldRef() = pow(mesh.V(), 2.0/3.0)/widthCoeff_;
} }
@ -78,7 +78,7 @@ Foam::laplaceFilter::laplaceFilter(const fvMesh& mesh, const dictionary& bd)
calculatedFvPatchScalarField::typeName calculatedFvPatchScalarField::typeName
) )
{ {
coeff_.dimensionedInternalField() = pow(mesh.V(), 2.0/3.0)/widthCoeff_; coeff_.dimensionedInternalFieldRef() = pow(mesh.V(), 2.0/3.0)/widthCoeff_;
} }

View File

@ -158,7 +158,7 @@ tmp<volScalarField> SpalartAllmarasDES<BasicTurbulenceModel>::dTilda
) const ) const
{ {
tmp<volScalarField> tdTilda(CDES_*this->delta()); tmp<volScalarField> tdTilda(CDES_*this->delta());
min(tdTilda.ref().dimensionedInternalField(), tdTilda(), y_); min(tdTilda.ref().dimensionedInternalFieldRef(), tdTilda(), y_);
return tdTilda; return tdTilda;
} }

View File

@ -161,7 +161,7 @@ singleStepCombustion<CombThermoType, ThermoType>::dQ() const
if (this->active()) if (this->active())
{ {
volScalarField& dQ = tdQ.ref(); volScalarField& dQ = tdQ.ref();
dQ.dimensionedInternalField() = this->mesh().V()*Sh()(); dQ.dimensionedInternalFieldRef() = this->mesh().V()*Sh()();
} }
return tdQ; return tdQ;
} }

View File

@ -323,14 +323,14 @@ CrankNicolsonDdtScheme<Type>::fvcDdt
{ {
dimensionedScalar rDtCoef0 = rDtCoef0_(ddt0); dimensionedScalar rDtCoef0 = rDtCoef0_(ddt0);
ddt0.dimensionedInternalField() = ddt0.dimensionedInternalFieldRef() =
( (
(rDtCoef0*dt)*(mesh().V0() - mesh().V00()) (rDtCoef0*dt)*(mesh().V0() - mesh().V00())
- mesh().V00()*offCentre_(ddt0.dimensionedInternalField()) - mesh().V00()*offCentre_(ddt0.dimensionedInternalField())
)/mesh().V0(); )/mesh().V0();
} }
tdtdt.ref().dimensionedInternalField() = tdtdt.ref().dimensionedInternalFieldRef() =
( (
(rDtCoef*dt)*(mesh().V() - mesh().V0()) (rDtCoef*dt)*(mesh().V() - mesh().V0())
- mesh().V0()*offCentre_(ddt0.dimensionedInternalField()) - mesh().V0()*offCentre_(ddt0.dimensionedInternalField())

View File

@ -46,4 +46,7 @@ surfaceInterpolateFields/surfaceInterpolateFieldsFunctionObject.C
regionSizeDistribution/regionSizeDistribution.C regionSizeDistribution/regionSizeDistribution.C
regionSizeDistribution/regionSizeDistributionFunctionObject.C regionSizeDistribution/regionSizeDistributionFunctionObject.C
histogram/histogram.C
histogram/histogramFunctionObject.C
LIB = $(FOAM_LIBBIN)/libfieldFunctionObjects LIB = $(FOAM_LIBBIN)/libfieldFunctionObjects

View File

@ -142,7 +142,7 @@ void Foam::CourantNo::execute()
mesh.lookupObject<volScalarField>(type()) mesh.lookupObject<volScalarField>(type())
); );
Co.dimensionedInternalField() = byRho Co.dimensionedInternalFieldRef() = byRho
( (
(0.5*mesh.time().deltaT()) (0.5*mesh.time().deltaT())
*fvc::surfaceSum(mag(phi))().dimensionedInternalField() *fvc::surfaceSum(mag(phi))().dimensionedInternalField()

View File

@ -611,7 +611,7 @@ Foam::chemistryModel<CompType, ThermoType>::dQ() const
if (this->chemistry_) if (this->chemistry_)
{ {
volScalarField& dQ = tdQ.ref(); volScalarField& dQ = tdQ.ref();
dQ.dimensionedInternalField() = this->mesh_.V()*Sh()(); dQ.dimensionedInternalFieldRef() = this->mesh_.V()*Sh()();
} }
return tdQ; return tdQ;

View File

@ -177,7 +177,7 @@ Foam::solidChemistryModel<CompType, SolidThermo>::dQ() const
if (this->chemistry_) if (this->chemistry_)
{ {
volScalarField& dQ = tdQ.ref(); volScalarField& dQ = tdQ.ref();
dQ.dimensionedInternalField() = this->mesh_.V()*Sh()(); dQ.dimensionedInternalFieldRef() = this->mesh_.V()*Sh()();
} }
return tdQ; return tdQ;