From dc2951ca2f4b051fcf1782e024e2e76f9db33110 Mon Sep 17 00:00:00 2001 From: Henry Weller <http://cfd.direct> Date: Tue, 26 Apr 2016 16:29:43 +0100 Subject: [PATCH] GeometricField::dimensionedInternalField() -> GeometricField::dimensionedInternalFieldRef() See also commit 22f4ad32b174e219b57105cbe8b4c4c711a24c3d --- .../combustion/reactingFoam/setRDeltaT.H | 4 ++-- .../rhoCentralDyMFoam/rhoCentralDyMFoam.C | 4 ++-- .../rhoCentralFoam/rhoCentralFoam.C | 4 ++-- .../compressible/rhoCentralFoam/setRDeltaT.H | 2 +- .../compressible/rhoPimpleFoam/setRDeltaT.H | 4 ++-- .../lagrangian/coalChemistryFoam/setRDeltaT.H | 4 ++-- .../reactingParcelFoam/setRDeltaT.H | 4 ++-- .../solvers/multiphase/interFoam/setRDeltaT.H | 4 ++-- .../reactingMultiphaseEulerFoam/setRDeltaT.H | 2 +- .../reactingTwoPhaseEulerFoam/setRDeltaT.H | 2 +- .../writeCellCentres/writeCellCentres.C | 2 +- .../postProcessing/velocityField/Co/Co.C | 4 ++-- .../GeometricField/GeometricField.C | 22 +++++++++---------- .../GeometricField/GeometricField.H | 2 +- .../LESfilters/laplaceFilter/laplaceFilter.C | 6 ++--- .../SpalartAllmarasDES/SpalartAllmarasDES.C | 2 +- .../singleStepCombustion.C | 2 +- .../CrankNicolsonDdtScheme.C | 4 ++-- .../functionObjects/field/Make/files | 3 +++ .../utilities/CourantNo/CourantNo.C | 2 +- .../chemistryModel/chemistryModel.C | 2 +- .../solidChemistryModel/solidChemistryModel.C | 2 +- 22 files changed, 45 insertions(+), 42 deletions(-) diff --git a/applications/solvers/combustion/reactingFoam/setRDeltaT.H b/applications/solvers/combustion/reactingFoam/setRDeltaT.H index 12bdceb7e52..7612886aac9 100644 --- a/applications/solvers/combustion/reactingFoam/setRDeltaT.H +++ b/applications/solvers/combustion/reactingFoam/setRDeltaT.H @@ -58,7 +58,7 @@ License // Flow time scale { - rDeltaT.dimensionedInternalField() = + rDeltaT.dimensionedInternalFieldRef() = ( fvc::surfaceSum(mag(phi))().dimensionedInternalField() /((2*maxCo)*mesh.V()*rho.dimensionedInternalField()) @@ -84,7 +84,7 @@ License << gMin(1/(rDeltaTT.field() + VSMALL)) << ", " << gMax(1/(rDeltaTT.field() + VSMALL)) << endl; - rDeltaT.dimensionedInternalField() = max + rDeltaT.dimensionedInternalFieldRef() = max ( rDeltaT.dimensionedInternalField(), rDeltaTT diff --git a/applications/solvers/compressible/rhoCentralFoam/rhoCentralDyMFoam/rhoCentralDyMFoam.C b/applications/solvers/compressible/rhoCentralFoam/rhoCentralDyMFoam/rhoCentralDyMFoam.C index fb0fbc70795..683dc165a58 100644 --- a/applications/solvers/compressible/rhoCentralFoam/rhoCentralDyMFoam/rhoCentralDyMFoam.C +++ b/applications/solvers/compressible/rhoCentralFoam/rhoCentralDyMFoam/rhoCentralDyMFoam.C @@ -185,7 +185,7 @@ int main(int argc, char *argv[]) // --- Solve momentum solve(fvm::ddt(rhoU) + fvc::div(phiUp)); - U.dimensionedInternalField() = + U.dimensionedInternalFieldRef() = rhoU.dimensionedInternalField() /rho.dimensionedInternalField(); U.correctBoundaryConditions(); @@ -240,7 +240,7 @@ int main(int argc, char *argv[]) rhoE = rho*(e + 0.5*magSqr(U)); } - p.dimensionedInternalField() = + p.dimensionedInternalFieldRef() = rho.dimensionedInternalField() /psi.dimensionedInternalField(); p.correctBoundaryConditions(); diff --git a/applications/solvers/compressible/rhoCentralFoam/rhoCentralFoam.C b/applications/solvers/compressible/rhoCentralFoam/rhoCentralFoam.C index 083a1b1b5c1..af304aeb24e 100644 --- a/applications/solvers/compressible/rhoCentralFoam/rhoCentralFoam.C +++ b/applications/solvers/compressible/rhoCentralFoam/rhoCentralFoam.C @@ -178,7 +178,7 @@ int main(int argc, char *argv[]) // --- Solve momentum solve(fvm::ddt(rhoU) + fvc::div(phiUp)); - U.dimensionedInternalField() = + U.dimensionedInternalFieldRef() = rhoU.dimensionedInternalField() /rho.dimensionedInternalField(); U.correctBoundaryConditions(); @@ -233,7 +233,7 @@ int main(int argc, char *argv[]) rhoE = rho*(e + 0.5*magSqr(U)); } - p.dimensionedInternalField() = + p.dimensionedInternalFieldRef() = rho.dimensionedInternalField() /psi.dimensionedInternalField(); p.correctBoundaryConditions(); diff --git a/applications/solvers/compressible/rhoCentralFoam/setRDeltaT.H b/applications/solvers/compressible/rhoCentralFoam/setRDeltaT.H index 806ddd38324..f5dd49e7a3c 100644 --- a/applications/solvers/compressible/rhoCentralFoam/setRDeltaT.H +++ b/applications/solvers/compressible/rhoCentralFoam/setRDeltaT.H @@ -11,7 +11,7 @@ ); // Set the reciprocal time-step from the local Courant number - rDeltaT.dimensionedInternalField() = max + rDeltaT.dimensionedInternalFieldRef() = max ( 1/dimensionedScalar("maxDeltaT", dimTime, maxDeltaT), fvc::surfaceSum(amaxSf)().dimensionedInternalField() diff --git a/applications/solvers/compressible/rhoPimpleFoam/setRDeltaT.H b/applications/solvers/compressible/rhoPimpleFoam/setRDeltaT.H index 0a38e05ee9f..7c9dc6b870f 100644 --- a/applications/solvers/compressible/rhoPimpleFoam/setRDeltaT.H +++ b/applications/solvers/compressible/rhoPimpleFoam/setRDeltaT.H @@ -26,7 +26,7 @@ volScalarField rDeltaT0("rDeltaT0", rDeltaT); // Set the reciprocal time-step from the local Courant number - rDeltaT.dimensionedInternalField() = max + rDeltaT.dimensionedInternalFieldRef() = max ( 1/dimensionedScalar("maxDeltaT", dimTime, maxDeltaT), fvc::surfaceSum(mag(phi))().dimensionedInternalField() @@ -41,7 +41,7 @@ fvc::interpolate(psi)*fvc::flux(U) ); - rDeltaT.dimensionedInternalField() = max + rDeltaT.dimensionedInternalFieldRef() = max ( rDeltaT.dimensionedInternalField(), fvc::surfaceSum(mag(phid))().dimensionedInternalField() diff --git a/applications/solvers/lagrangian/coalChemistryFoam/setRDeltaT.H b/applications/solvers/lagrangian/coalChemistryFoam/setRDeltaT.H index 65b0388e12d..56c67ca2f21 100644 --- a/applications/solvers/lagrangian/coalChemistryFoam/setRDeltaT.H +++ b/applications/solvers/lagrangian/coalChemistryFoam/setRDeltaT.H @@ -58,7 +58,7 @@ License // Flow time scale { - rDeltaT.dimensionedInternalField() = + rDeltaT.dimensionedInternalFieldRef() = ( fvc::surfaceSum(mag(phi))().dimensionedInternalField() /((2*maxCo)*mesh.V()*rho.dimensionedInternalField()) @@ -94,7 +94,7 @@ License << gMin(1/(rDeltaTT.field() + VSMALL)) << ", " << gMax(1/(rDeltaTT.field() + VSMALL)) << endl; - rDeltaT.dimensionedInternalField() = max + rDeltaT.dimensionedInternalFieldRef() = max ( rDeltaT.dimensionedInternalField(), rDeltaTT diff --git a/applications/solvers/lagrangian/reactingParcelFoam/setRDeltaT.H b/applications/solvers/lagrangian/reactingParcelFoam/setRDeltaT.H index f51eeb49bf3..5ee1dc4630d 100644 --- a/applications/solvers/lagrangian/reactingParcelFoam/setRDeltaT.H +++ b/applications/solvers/lagrangian/reactingParcelFoam/setRDeltaT.H @@ -58,7 +58,7 @@ License // Flow time scale { - rDeltaT.dimensionedInternalField() = + rDeltaT.dimensionedInternalFieldRef() = ( fvc::surfaceSum(mag(phi))().dimensionedInternalField() /((2*maxCo)*mesh.V()*rho.dimensionedInternalField()) @@ -93,7 +93,7 @@ License << gMin(1/(rDeltaTT.field() + VSMALL)) << ", " << gMax(1/(rDeltaTT.field() + VSMALL)) << endl; - rDeltaT.dimensionedInternalField() = max + rDeltaT.dimensionedInternalFieldRef() = max ( rDeltaT.dimensionedInternalField(), rDeltaTT diff --git a/applications/solvers/multiphase/interFoam/setRDeltaT.H b/applications/solvers/multiphase/interFoam/setRDeltaT.H index dd0e6a4da45..afeee4cf434 100644 --- a/applications/solvers/multiphase/interFoam/setRDeltaT.H +++ b/applications/solvers/multiphase/interFoam/setRDeltaT.H @@ -56,7 +56,7 @@ volScalarField rDeltaT0("rDeltaT0", rDeltaT); // Set the reciprocal time-step from the local Courant number - rDeltaT.dimensionedInternalField() = max + rDeltaT.dimensionedInternalFieldRef() = max ( 1/dimensionedScalar("maxDeltaT", dimTime, maxDeltaT), fvc::surfaceSum(mag(rhoPhi))().dimensionedInternalField() @@ -70,7 +70,7 @@ volScalarField alpha1Bar(fvc::average(alpha1)); - rDeltaT.dimensionedInternalField() = max + rDeltaT.dimensionedInternalFieldRef() = max ( rDeltaT.dimensionedInternalField(), pos(alpha1Bar.dimensionedInternalField() - alphaSpreadMin) diff --git a/applications/solvers/multiphase/reactingEulerFoam/reactingMultiphaseEulerFoam/setRDeltaT.H b/applications/solvers/multiphase/reactingEulerFoam/reactingMultiphaseEulerFoam/setRDeltaT.H index fec017ea304..686d4506840 100644 --- a/applications/solvers/multiphase/reactingEulerFoam/reactingMultiphaseEulerFoam/setRDeltaT.H +++ b/applications/solvers/multiphase/reactingEulerFoam/reactingMultiphaseEulerFoam/setRDeltaT.H @@ -26,7 +26,7 @@ } // Set the reciprocal time-step from the local Courant number - rDeltaT.dimensionedInternalField() = max + rDeltaT.dimensionedInternalFieldRef() = max ( 1/dimensionedScalar("maxDeltaT", dimTime, maxDeltaT), fvc::surfaceSum(maxPhi)().dimensionedInternalField() diff --git a/applications/solvers/multiphase/reactingEulerFoam/reactingTwoPhaseEulerFoam/setRDeltaT.H b/applications/solvers/multiphase/reactingEulerFoam/reactingTwoPhaseEulerFoam/setRDeltaT.H index 4bef17a6bb4..3c68f2a95f4 100644 --- a/applications/solvers/multiphase/reactingEulerFoam/reactingTwoPhaseEulerFoam/setRDeltaT.H +++ b/applications/solvers/multiphase/reactingEulerFoam/reactingTwoPhaseEulerFoam/setRDeltaT.H @@ -19,7 +19,7 @@ ); // Set the reciprocal time-step from the local Courant number - rDeltaT.dimensionedInternalField() = max + rDeltaT.dimensionedInternalFieldRef() = max ( 1/dimensionedScalar("maxDeltaT", dimTime, maxDeltaT), fvc::surfaceSum(max(mag(phi1), mag(phi2)))().dimensionedInternalField() diff --git a/applications/utilities/postProcessing/miscellaneous/writeCellCentres/writeCellCentres.C b/applications/utilities/postProcessing/miscellaneous/writeCellCentres/writeCellCentres.C index c6b26e6d3ea..6a78ebad1e8 100644 --- a/applications/utilities/postProcessing/miscellaneous/writeCellCentres/writeCellCentres.C +++ b/applications/utilities/postProcessing/miscellaneous/writeCellCentres/writeCellCentres.C @@ -115,7 +115,7 @@ int main(int argc, char *argv[]) calculatedFvPatchField<scalar>::typeName ); - V.dimensionedInternalField() = mesh.V(); + V.dimensionedInternalFieldRef() = mesh.V(); volScalarField::GeometricBoundaryField& Vbf = V.boundaryFieldRef(); diff --git a/applications/utilities/postProcessing/velocityField/Co/Co.C b/applications/utilities/postProcessing/velocityField/Co/Co.C index 110c39b4158..ef5953c86f5 100644 --- a/applications/utilities/postProcessing/velocityField/Co/Co.C +++ b/applications/utilities/postProcessing/velocityField/Co/Co.C @@ -87,7 +87,7 @@ void Foam::calc(const argList& args, const Time& runTime, const fvMesh& mesh) mesh ); - Co.dimensionedInternalField() = + Co.dimensionedInternalFieldRef() = (0.5*runTime.deltaT()) *fvc::surfaceSum(mag(phi))().dimensionedInternalField() /(rho*mesh.V()); @@ -97,7 +97,7 @@ void Foam::calc(const argList& args, const Time& runTime, const fvMesh& mesh) { Info<< " Calculating incompressible Co" << endl; - Co.dimensionedInternalField() = + Co.dimensionedInternalFieldRef() = (0.5*runTime.deltaT()) *fvc::surfaceSum(mag(phi))().dimensionedInternalField() /mesh.V(); diff --git a/src/OpenFOAM/fields/GeometricFields/GeometricField/GeometricField.C b/src/OpenFOAM/fields/GeometricFields/GeometricField/GeometricField.C index b30ca6e5a7b..5228c5a630c 100644 --- a/src/OpenFOAM/fields/GeometricFields/GeometricField/GeometricField.C +++ b/src/OpenFOAM/fields/GeometricFields/GeometricField/GeometricField.C @@ -690,7 +690,7 @@ Foam::GeometricField<Type, PatchField, GeoMesh>::~GeometricField() template<class Type, template<class> class PatchField, class GeoMesh> typename Foam::GeometricField<Type, PatchField, GeoMesh>::DimensionedInternalField& -Foam::GeometricField<Type, PatchField, GeoMesh>::dimensionedInternalField() +Foam::GeometricField<Type, PatchField, GeoMesh>::dimensionedInternalFieldRef() { this->setUpToDate(); storeOldTimes(); @@ -1112,9 +1112,9 @@ void Foam::GeometricField<Type, PatchField, GeoMesh>::operator= checkField(*this, gf, "="); - // only equate field contents not ID + // Only assign field contents not ID - dimensionedInternalField() = gf.dimensionedInternalField(); + dimensionedInternalFieldRef() = gf.dimensionedInternalField(); boundaryFieldRef() = gf.boundaryField(); } @@ -1136,11 +1136,11 @@ void Foam::GeometricField<Type, PatchField, GeoMesh>::operator= checkField(*this, gf, "="); - // only equate field contents not ID + // Only assign field contents not ID this->dimensions() = gf.dimensions(); - // This is dodgy stuff, don't try it at home. + // Transfer the storage from the tmp internalField().transfer ( const_cast<Field<Type>&>(gf.internalField()) @@ -1158,7 +1158,7 @@ void Foam::GeometricField<Type, PatchField, GeoMesh>::operator= const dimensioned<Type>& dt ) { - dimensionedInternalField() = dt; + dimensionedInternalFieldRef() = dt; boundaryFieldRef() = dt.value(); } @@ -1173,9 +1173,9 @@ void Foam::GeometricField<Type, PatchField, GeoMesh>::operator== checkField(*this, gf, "=="); - // only equate field contents not ID + // Only assign field contents not ID - dimensionedInternalField() = gf.dimensionedInternalField(); + dimensionedInternalFieldRef() = gf.dimensionedInternalField(); boundaryFieldRef() == gf.boundaryField(); tgf.clear(); @@ -1188,7 +1188,7 @@ void Foam::GeometricField<Type, PatchField, GeoMesh>::operator== const dimensioned<Type>& dt ) { - dimensionedInternalField() = dt; + dimensionedInternalFieldRef() = dt; boundaryFieldRef() == dt.value(); } @@ -1203,7 +1203,7 @@ void Foam::GeometricField<Type, PatchField, GeoMesh>::operator op \ { \ checkField(*this, gf, #op); \ \ - dimensionedInternalField() op gf.dimensionedInternalField(); \ + dimensionedInternalFieldRef() op gf.dimensionedInternalField(); \ boundaryFieldRef() op gf.boundaryField(); \ } \ \ @@ -1223,7 +1223,7 @@ void Foam::GeometricField<Type, PatchField, GeoMesh>::operator op \ const dimensioned<TYPE>& dt \ ) \ { \ - dimensionedInternalField() op dt; \ + dimensionedInternalFieldRef() op dt; \ boundaryFieldRef() op dt.value(); \ } diff --git a/src/OpenFOAM/fields/GeometricFields/GeometricField/GeometricField.H b/src/OpenFOAM/fields/GeometricFields/GeometricField/GeometricField.H index 1d2c3e825a1..fe30dc91813 100644 --- a/src/OpenFOAM/fields/GeometricFields/GeometricField/GeometricField.H +++ b/src/OpenFOAM/fields/GeometricFields/GeometricField/GeometricField.H @@ -432,7 +432,7 @@ public: //- Return a reference to the dimensioned internal field // Note: this increments the event counter and checks the // old-time fields; avoid in loops. - DimensionedInternalField& dimensionedInternalField(); + DimensionedInternalField& dimensionedInternalFieldRef(); //- Return a const-reference to the dimensioned internal field inline const DimensionedInternalField& dimensionedInternalField() const; diff --git a/src/TurbulenceModels/turbulenceModels/LES/LESfilters/laplaceFilter/laplaceFilter.C b/src/TurbulenceModels/turbulenceModels/LES/LESfilters/laplaceFilter/laplaceFilter.C index 24db120ffa9..5d8fcb737b0 100644 --- a/src/TurbulenceModels/turbulenceModels/LES/LESfilters/laplaceFilter/laplaceFilter.C +++ b/src/TurbulenceModels/turbulenceModels/LES/LESfilters/laplaceFilter/laplaceFilter.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | - \\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -57,7 +57,7 @@ Foam::laplaceFilter::laplaceFilter(const fvMesh& mesh, scalar widthCoeff) 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 ) { - coeff_.dimensionedInternalField() = pow(mesh.V(), 2.0/3.0)/widthCoeff_; + coeff_.dimensionedInternalFieldRef() = pow(mesh.V(), 2.0/3.0)/widthCoeff_; } diff --git a/src/TurbulenceModels/turbulenceModels/LES/SpalartAllmarasDES/SpalartAllmarasDES.C b/src/TurbulenceModels/turbulenceModels/LES/SpalartAllmarasDES/SpalartAllmarasDES.C index 54db6c6d78e..73ec7ee3391 100644 --- a/src/TurbulenceModels/turbulenceModels/LES/SpalartAllmarasDES/SpalartAllmarasDES.C +++ b/src/TurbulenceModels/turbulenceModels/LES/SpalartAllmarasDES/SpalartAllmarasDES.C @@ -158,7 +158,7 @@ tmp<volScalarField> SpalartAllmarasDES<BasicTurbulenceModel>::dTilda ) const { tmp<volScalarField> tdTilda(CDES_*this->delta()); - min(tdTilda.ref().dimensionedInternalField(), tdTilda(), y_); + min(tdTilda.ref().dimensionedInternalFieldRef(), tdTilda(), y_); return tdTilda; } diff --git a/src/combustionModels/singleStepCombustion/singleStepCombustion.C b/src/combustionModels/singleStepCombustion/singleStepCombustion.C index d8bc1cfac30..566d92dee80 100644 --- a/src/combustionModels/singleStepCombustion/singleStepCombustion.C +++ b/src/combustionModels/singleStepCombustion/singleStepCombustion.C @@ -161,7 +161,7 @@ singleStepCombustion<CombThermoType, ThermoType>::dQ() const if (this->active()) { volScalarField& dQ = tdQ.ref(); - dQ.dimensionedInternalField() = this->mesh().V()*Sh()(); + dQ.dimensionedInternalFieldRef() = this->mesh().V()*Sh()(); } return tdQ; } diff --git a/src/finiteVolume/finiteVolume/ddtSchemes/CrankNicolsonDdtScheme/CrankNicolsonDdtScheme.C b/src/finiteVolume/finiteVolume/ddtSchemes/CrankNicolsonDdtScheme/CrankNicolsonDdtScheme.C index b424943e34d..c4419ec26e7 100644 --- a/src/finiteVolume/finiteVolume/ddtSchemes/CrankNicolsonDdtScheme/CrankNicolsonDdtScheme.C +++ b/src/finiteVolume/finiteVolume/ddtSchemes/CrankNicolsonDdtScheme/CrankNicolsonDdtScheme.C @@ -323,14 +323,14 @@ CrankNicolsonDdtScheme<Type>::fvcDdt { dimensionedScalar rDtCoef0 = rDtCoef0_(ddt0); - ddt0.dimensionedInternalField() = + ddt0.dimensionedInternalFieldRef() = ( (rDtCoef0*dt)*(mesh().V0() - mesh().V00()) - mesh().V00()*offCentre_(ddt0.dimensionedInternalField()) )/mesh().V0(); } - tdtdt.ref().dimensionedInternalField() = + tdtdt.ref().dimensionedInternalFieldRef() = ( (rDtCoef*dt)*(mesh().V() - mesh().V0()) - mesh().V0()*offCentre_(ddt0.dimensionedInternalField()) diff --git a/src/postProcessing/functionObjects/field/Make/files b/src/postProcessing/functionObjects/field/Make/files index 75464c40139..24a3e5b5996 100644 --- a/src/postProcessing/functionObjects/field/Make/files +++ b/src/postProcessing/functionObjects/field/Make/files @@ -46,4 +46,7 @@ surfaceInterpolateFields/surfaceInterpolateFieldsFunctionObject.C regionSizeDistribution/regionSizeDistribution.C regionSizeDistribution/regionSizeDistributionFunctionObject.C +histogram/histogram.C +histogram/histogramFunctionObject.C + LIB = $(FOAM_LIBBIN)/libfieldFunctionObjects diff --git a/src/postProcessing/functionObjects/utilities/CourantNo/CourantNo.C b/src/postProcessing/functionObjects/utilities/CourantNo/CourantNo.C index ec56dcc94ba..c35709cf6d1 100644 --- a/src/postProcessing/functionObjects/utilities/CourantNo/CourantNo.C +++ b/src/postProcessing/functionObjects/utilities/CourantNo/CourantNo.C @@ -142,7 +142,7 @@ void Foam::CourantNo::execute() mesh.lookupObject<volScalarField>(type()) ); - Co.dimensionedInternalField() = byRho + Co.dimensionedInternalFieldRef() = byRho ( (0.5*mesh.time().deltaT()) *fvc::surfaceSum(mag(phi))().dimensionedInternalField() diff --git a/src/thermophysicalModels/chemistryModel/chemistryModel/chemistryModel/chemistryModel.C b/src/thermophysicalModels/chemistryModel/chemistryModel/chemistryModel/chemistryModel.C index bf9682d9584..4522edcd18b 100644 --- a/src/thermophysicalModels/chemistryModel/chemistryModel/chemistryModel/chemistryModel.C +++ b/src/thermophysicalModels/chemistryModel/chemistryModel/chemistryModel/chemistryModel.C @@ -611,7 +611,7 @@ Foam::chemistryModel<CompType, ThermoType>::dQ() const if (this->chemistry_) { volScalarField& dQ = tdQ.ref(); - dQ.dimensionedInternalField() = this->mesh_.V()*Sh()(); + dQ.dimensionedInternalFieldRef() = this->mesh_.V()*Sh()(); } return tdQ; diff --git a/src/thermophysicalModels/solidChemistryModel/solidChemistryModel/solidChemistryModel.C b/src/thermophysicalModels/solidChemistryModel/solidChemistryModel/solidChemistryModel.C index e723ff90ed3..72f6c52e716 100644 --- a/src/thermophysicalModels/solidChemistryModel/solidChemistryModel/solidChemistryModel.C +++ b/src/thermophysicalModels/solidChemistryModel/solidChemistryModel/solidChemistryModel.C @@ -177,7 +177,7 @@ Foam::solidChemistryModel<CompType, SolidThermo>::dQ() const if (this->chemistry_) { volScalarField& dQ = tdQ.ref(); - dQ.dimensionedInternalField() = this->mesh_.V()*Sh()(); + dQ.dimensionedInternalFieldRef() = this->mesh_.V()*Sh()(); } return tdQ; -- GitLab