From ccd958a8f1df60a9fc76c9e0fe980c993ebcf83c Mon Sep 17 00:00:00 2001
From: Henry Weller <http://cfd.direct>
Date: Sat, 30 Apr 2016 18:43:51 +0100
Subject: [PATCH] GeometricField::dimensionedInteralFieldRef() ->
 GeometricField::ref()

In order to simplify expressions involving dimensioned internal field it
is preferable to use a simpler access convention.  Given that
GeometricField is derived from DimensionedField it is simply a matter of
de-referencing this underlying type unlike the boundary field which is
peripheral information.  For consistency with the new convention in
"tmp"  "dimensionedInteralFieldRef()" has been renamed "ref()".
---
 .../combustion/reactingFoam/setRDeltaT.H      | 10 ++++----
 .../rhoCentralDyMFoam/rhoCentralDyMFoam.C     | 12 +++++-----
 .../rhoCentralFoam/rhoCentralFoam.C           | 12 +++++-----
 .../compressible/rhoCentralFoam/setRDeltaT.H  |  4 ++--
 .../compressible/rhoPimpleFoam/setRDeltaT.H   | 14 +++++------
 .../lagrangian/coalChemistryFoam/UEqn.H       |  2 +-
 .../lagrangian/coalChemistryFoam/setRDeltaT.H | 16 ++++++-------
 .../lagrangian/reactingParcelFoam/UEqn.H      |  2 +-
 .../reactingParcelFoam/setRDeltaT.H           | 16 ++++++-------
 .../simpleReactingParcelFoam/UEqn.H           |  2 +-
 .../solvers/lagrangian/sprayFoam/UEqn.H       |  2 +-
 .../solvers/multiphase/interFoam/setRDeltaT.H | 16 ++++++-------
 .../multiphase/multiphaseEulerFoam/UEqns.H    |  2 +-
 .../reactingMultiphaseEulerFoam/setRDeltaT.H  |  4 ++--
 .../reactingTwoPhaseEulerFoam/setRDeltaT.H    |  4 ++--
 .../twoPhaseSystem/twoPhaseSystem.C           | 16 ++++++-------
 .../writeCellCentres/writeCellCentres.C       |  2 +-
 .../postProcessing/velocityField/Co/Co.C      |  8 +++----
 .../GeometricField/GeometricField.C           | 16 ++++++-------
 .../GeometricField/GeometricField.H           |  2 +-
 .../GeometricField/GeometricFieldI.H          | 24 ++++++++++---------
 .../RAS/kkLOmega/kkLOmega.C                   |  2 +-
 .../LESfilters/laplaceFilter/laplaceFilter.C  |  4 ++--
 .../SpalartAllmarasDES/SpalartAllmarasDES.C   |  2 +-
 .../singleStepCombustion.C                    |  2 +-
 .../fvMeshAdder/fvMeshAdderTemplates.C        |  8 +++----
 .../fvMeshTools/fvMeshToolsTemplates.C        |  6 ++---
 .../CrankNicolsonDdtScheme.C                  |  4 ++--
 .../fvMeshSubset/fvMeshSubsetInterpolate.C    |  6 ++---
 .../singleCellFvMeshInterpolate.C             |  4 ++--
 .../volPointInterpolate.C                     |  2 +-
 ...polatedDisplacementPointPatchVectorField.C |  4 ++--
 .../meshRefinement/meshRefinementTemplates.C  |  2 +-
 .../fvFieldDecomposerDecomposeFields.C        | 14 +++++------
 .../utilities/CourantNo/CourantNo.C           |  4 ++--
 src/sampling/meshToMesh/meshToMeshTemplates.C |  4 ++--
 .../chemistryModel/chemistryModel.C           |  2 +-
 .../radiation/radiationModels/P1/P1.C         |  6 ++---
 .../radiationModels/fvDOM/fvDOM/fvDOM.C       |  6 ++---
 .../solidChemistryModel/solidChemistryModel.C |  2 +-
 40 files changed, 136 insertions(+), 134 deletions(-)

diff --git a/applications/solvers/combustion/reactingFoam/setRDeltaT.H b/applications/solvers/combustion/reactingFoam/setRDeltaT.H
index 1267aefdcce..d83e129717b 100644
--- a/applications/solvers/combustion/reactingFoam/setRDeltaT.H
+++ b/applications/solvers/combustion/reactingFoam/setRDeltaT.H
@@ -58,10 +58,10 @@ License
 
     // Flow time scale
     {
-        rDeltaT.dimensionedInternalFieldRef() =
+        rDeltaT.ref() =
         (
-            fvc::surfaceSum(mag(phi))().dimensionedInternalField()
-           /((2*maxCo)*mesh.V()*rho.dimensionedInternalField())
+            fvc::surfaceSum(mag(phi))()()
+           /((2*maxCo)*mesh.V()*rho())
         );
 
         // Limit the largest time scale
@@ -84,9 +84,9 @@ License
             << gMin(1/(rDeltaTT.field() + VSMALL)) << ", "
             << gMax(1/(rDeltaTT.field() + VSMALL)) << endl;
 
-        rDeltaT.dimensionedInternalFieldRef() = max
+        rDeltaT.ref() = max
         (
-            rDeltaT.dimensionedInternalField(),
+            rDeltaT(),
             rDeltaTT
         );
     }
diff --git a/applications/solvers/compressible/rhoCentralFoam/rhoCentralDyMFoam/rhoCentralDyMFoam.C b/applications/solvers/compressible/rhoCentralFoam/rhoCentralDyMFoam/rhoCentralDyMFoam.C
index 683dc165a58..a64bfc9a046 100644
--- a/applications/solvers/compressible/rhoCentralFoam/rhoCentralDyMFoam/rhoCentralDyMFoam.C
+++ b/applications/solvers/compressible/rhoCentralFoam/rhoCentralDyMFoam/rhoCentralDyMFoam.C
@@ -185,9 +185,9 @@ int main(int argc, char *argv[])
         // --- Solve momentum
         solve(fvm::ddt(rhoU) + fvc::div(phiUp));
 
-        U.dimensionedInternalFieldRef() =
-            rhoU.dimensionedInternalField()
-           /rho.dimensionedInternalField();
+        U.ref() =
+            rhoU()
+           /rho();
         U.correctBoundaryConditions();
         rhoU.boundaryFieldRef() == rho.boundaryField()*U.boundaryField();
 
@@ -240,9 +240,9 @@ int main(int argc, char *argv[])
             rhoE = rho*(e + 0.5*magSqr(U));
         }
 
-        p.dimensionedInternalFieldRef() =
-            rho.dimensionedInternalField()
-           /psi.dimensionedInternalField();
+        p.ref() =
+            rho()
+           /psi();
         p.correctBoundaryConditions();
         rho.boundaryFieldRef() == psi.boundaryField()*p.boundaryField();
 
diff --git a/applications/solvers/compressible/rhoCentralFoam/rhoCentralFoam.C b/applications/solvers/compressible/rhoCentralFoam/rhoCentralFoam.C
index af304aeb24e..ea16c6ba614 100644
--- a/applications/solvers/compressible/rhoCentralFoam/rhoCentralFoam.C
+++ b/applications/solvers/compressible/rhoCentralFoam/rhoCentralFoam.C
@@ -178,9 +178,9 @@ int main(int argc, char *argv[])
         // --- Solve momentum
         solve(fvm::ddt(rhoU) + fvc::div(phiUp));
 
-        U.dimensionedInternalFieldRef() =
-            rhoU.dimensionedInternalField()
-           /rho.dimensionedInternalField();
+        U.ref() =
+            rhoU()
+           /rho();
         U.correctBoundaryConditions();
         rhoU.boundaryFieldRef() == rho.boundaryField()*U.boundaryField();
 
@@ -233,9 +233,9 @@ int main(int argc, char *argv[])
             rhoE = rho*(e + 0.5*magSqr(U));
         }
 
-        p.dimensionedInternalFieldRef() =
-            rho.dimensionedInternalField()
-           /psi.dimensionedInternalField();
+        p.ref() =
+            rho()
+           /psi();
         p.correctBoundaryConditions();
         rho.boundaryFieldRef() == psi.boundaryField()*p.boundaryField();
 
diff --git a/applications/solvers/compressible/rhoCentralFoam/setRDeltaT.H b/applications/solvers/compressible/rhoCentralFoam/setRDeltaT.H
index f5dd49e7a3c..4ebe06a6f51 100644
--- a/applications/solvers/compressible/rhoCentralFoam/setRDeltaT.H
+++ b/applications/solvers/compressible/rhoCentralFoam/setRDeltaT.H
@@ -11,10 +11,10 @@
     );
 
     // Set the reciprocal time-step from the local Courant number
-    rDeltaT.dimensionedInternalFieldRef() = max
+    rDeltaT.ref() = max
     (
         1/dimensionedScalar("maxDeltaT", dimTime, maxDeltaT),
-        fvc::surfaceSum(amaxSf)().dimensionedInternalField()
+        fvc::surfaceSum(amaxSf)()()
        /((2*maxCo)*mesh.V())
     );
 
diff --git a/applications/solvers/compressible/rhoPimpleFoam/setRDeltaT.H b/applications/solvers/compressible/rhoPimpleFoam/setRDeltaT.H
index 7c9dc6b870f..8591a74b9a7 100644
--- a/applications/solvers/compressible/rhoPimpleFoam/setRDeltaT.H
+++ b/applications/solvers/compressible/rhoPimpleFoam/setRDeltaT.H
@@ -26,11 +26,11 @@
     volScalarField rDeltaT0("rDeltaT0", rDeltaT);
 
     // Set the reciprocal time-step from the local Courant number
-    rDeltaT.dimensionedInternalFieldRef() = max
+    rDeltaT.ref() = max
     (
         1/dimensionedScalar("maxDeltaT", dimTime, maxDeltaT),
-        fvc::surfaceSum(mag(phi))().dimensionedInternalField()
-       /((2*maxCo)*mesh.V()*rho.dimensionedInternalField())
+        fvc::surfaceSum(mag(phi))()()
+       /((2*maxCo)*mesh.V()*rho())
     );
 
     if (pimple.transonic())
@@ -41,11 +41,11 @@
             fvc::interpolate(psi)*fvc::flux(U)
         );
 
-        rDeltaT.dimensionedInternalFieldRef() = max
+        rDeltaT.ref() = max
         (
-            rDeltaT.dimensionedInternalField(),
-            fvc::surfaceSum(mag(phid))().dimensionedInternalField()
-            /((2*maxCo)*mesh.V()*psi.dimensionedInternalField())
+            rDeltaT(),
+            fvc::surfaceSum(mag(phid))()()
+            /((2*maxCo)*mesh.V()*psi())
         );
     }
 
diff --git a/applications/solvers/lagrangian/coalChemistryFoam/UEqn.H b/applications/solvers/lagrangian/coalChemistryFoam/UEqn.H
index 2062c123fc8..937f0ecc5ec 100644
--- a/applications/solvers/lagrangian/coalChemistryFoam/UEqn.H
+++ b/applications/solvers/lagrangian/coalChemistryFoam/UEqn.H
@@ -6,7 +6,7 @@
       + MRF.DDt(rho, U)
       + turbulence->divDevRhoReff(U)
      ==
-        rho.dimensionedInternalField()*g
+        rho()*g
       + coalParcels.SU(U)
       + limestoneParcels.SU(U)
       + fvOptions(rho, U)
diff --git a/applications/solvers/lagrangian/coalChemistryFoam/setRDeltaT.H b/applications/solvers/lagrangian/coalChemistryFoam/setRDeltaT.H
index c123dc4c755..403ed28bac2 100644
--- a/applications/solvers/lagrangian/coalChemistryFoam/setRDeltaT.H
+++ b/applications/solvers/lagrangian/coalChemistryFoam/setRDeltaT.H
@@ -58,10 +58,10 @@ License
 
     // Flow time scale
     {
-        rDeltaT.dimensionedInternalFieldRef() =
+        rDeltaT.ref() =
         (
-            fvc::surfaceSum(mag(phi))().dimensionedInternalField()
-           /((2*maxCo)*mesh.V()*rho.dimensionedInternalField())
+            fvc::surfaceSum(mag(phi))()()
+           /((2*maxCo)*mesh.V()*rho())
         );
 
         // Limit the largest time scale
@@ -84,9 +84,9 @@ License
             )
            /(
                alphaTemp
-              *rho.dimensionedInternalField()
-              *thermo.Cp()().dimensionedInternalField()
-              *T.dimensionedInternalField()
+              *rho()
+              *thermo.Cp()()()
+              *T()
            )
         );
 
@@ -94,9 +94,9 @@ License
             << gMin(1/(rDeltaTT.field() + VSMALL)) << ", "
             << gMax(1/(rDeltaTT.field() + VSMALL)) << endl;
 
-        rDeltaT.dimensionedInternalFieldRef() = max
+        rDeltaT.ref() = max
         (
-            rDeltaT.dimensionedInternalField(),
+            rDeltaT(),
             rDeltaTT
         );
     }
diff --git a/applications/solvers/lagrangian/reactingParcelFoam/UEqn.H b/applications/solvers/lagrangian/reactingParcelFoam/UEqn.H
index 775da4caebf..bb7ad20efc6 100644
--- a/applications/solvers/lagrangian/reactingParcelFoam/UEqn.H
+++ b/applications/solvers/lagrangian/reactingParcelFoam/UEqn.H
@@ -6,7 +6,7 @@
       + MRF.DDt(rho, U)
       + turbulence->divDevRhoReff(U)
      ==
-        rho.dimensionedInternalField()*g
+        rho()*g
       + parcels.SU(U)
       + fvOptions(rho, U)
     );
diff --git a/applications/solvers/lagrangian/reactingParcelFoam/setRDeltaT.H b/applications/solvers/lagrangian/reactingParcelFoam/setRDeltaT.H
index 62565f64305..3b52192386b 100644
--- a/applications/solvers/lagrangian/reactingParcelFoam/setRDeltaT.H
+++ b/applications/solvers/lagrangian/reactingParcelFoam/setRDeltaT.H
@@ -58,10 +58,10 @@ License
 
     // Flow time scale
     {
-        rDeltaT.dimensionedInternalFieldRef() =
+        rDeltaT.ref() =
         (
-            fvc::surfaceSum(mag(phi))().dimensionedInternalField()
-           /((2*maxCo)*mesh.V()*rho.dimensionedInternalField())
+            fvc::surfaceSum(mag(phi))()()
+           /((2*maxCo)*mesh.V()*rho())
         );
 
         // Limit the largest time scale
@@ -83,9 +83,9 @@ License
             )
            /(
                alphaTemp
-              *rho.dimensionedInternalField()
-              *thermo.Cp()().dimensionedInternalField()
-              *T.dimensionedInternalField()
+              *rho()
+              *thermo.Cp()()()
+              *T()
            )
         );
 
@@ -93,9 +93,9 @@ License
             << gMin(1/(rDeltaTT.field() + VSMALL)) << ", "
             << gMax(1/(rDeltaTT.field() + VSMALL)) << endl;
 
-        rDeltaT.dimensionedInternalFieldRef() = max
+        rDeltaT.ref() = max
         (
-            rDeltaT.dimensionedInternalField(),
+            rDeltaT(),
             rDeltaTT
         );
     }
diff --git a/applications/solvers/lagrangian/reactingParcelFoam/simpleReactingParcelFoam/UEqn.H b/applications/solvers/lagrangian/reactingParcelFoam/simpleReactingParcelFoam/UEqn.H
index 86cf5362f81..a29d4b8c571 100644
--- a/applications/solvers/lagrangian/reactingParcelFoam/simpleReactingParcelFoam/UEqn.H
+++ b/applications/solvers/lagrangian/reactingParcelFoam/simpleReactingParcelFoam/UEqn.H
@@ -6,7 +6,7 @@
       + MRF.DDt(rho, U)
       + turbulence->divDevRhoReff(U)
      ==
-        rho.dimensionedInternalField()*g
+        rho()*g
       + parcels.SU(U)
       + fvOptions(rho, U)
     );
diff --git a/applications/solvers/lagrangian/sprayFoam/UEqn.H b/applications/solvers/lagrangian/sprayFoam/UEqn.H
index 97a83f7d5b6..62490aa92ec 100644
--- a/applications/solvers/lagrangian/sprayFoam/UEqn.H
+++ b/applications/solvers/lagrangian/sprayFoam/UEqn.H
@@ -8,7 +8,7 @@ tmp<fvVectorMatrix> tUEqn
   + MRF.DDt(rho, U)
   + turbulence->divDevRhoReff(U)
  ==
-    rho.dimensionedInternalField()*g
+    rho()*g
   + parcels.SU(U)
   + fvOptions(rho, U)
 );
diff --git a/applications/solvers/multiphase/interFoam/setRDeltaT.H b/applications/solvers/multiphase/interFoam/setRDeltaT.H
index afeee4cf434..86b7dd9d237 100644
--- a/applications/solvers/multiphase/interFoam/setRDeltaT.H
+++ b/applications/solvers/multiphase/interFoam/setRDeltaT.H
@@ -56,11 +56,11 @@
     volScalarField rDeltaT0("rDeltaT0", rDeltaT);
 
     // Set the reciprocal time-step from the local Courant number
-    rDeltaT.dimensionedInternalFieldRef() = max
+    rDeltaT.ref() = max
     (
         1/dimensionedScalar("maxDeltaT", dimTime, maxDeltaT),
-        fvc::surfaceSum(mag(rhoPhi))().dimensionedInternalField()
-       /((2*maxCo)*mesh.V()*rho.dimensionedInternalField())
+        fvc::surfaceSum(mag(rhoPhi))()()
+       /((2*maxCo)*mesh.V()*rho())
     );
 
     if (maxAlphaCo < maxCo)
@@ -70,12 +70,12 @@
 
         volScalarField alpha1Bar(fvc::average(alpha1));
 
-        rDeltaT.dimensionedInternalFieldRef() = max
+        rDeltaT.ref() = max
         (
-            rDeltaT.dimensionedInternalField(),
-            pos(alpha1Bar.dimensionedInternalField() - alphaSpreadMin)
-           *pos(alphaSpreadMax - alpha1Bar.dimensionedInternalField())
-           *fvc::surfaceSum(mag(phi))().dimensionedInternalField()
+            rDeltaT(),
+            pos(alpha1Bar() - alphaSpreadMin)
+           *pos(alphaSpreadMax - alpha1Bar())
+           *fvc::surfaceSum(mag(phi))()()
            /((2*maxAlphaCo)*mesh.V())
         );
     }
diff --git a/applications/solvers/multiphase/multiphaseEulerFoam/UEqns.H b/applications/solvers/multiphase/multiphaseEulerFoam/UEqns.H
index abad0dfaf04..76f47f8270e 100644
--- a/applications/solvers/multiphase/multiphaseEulerFoam/UEqns.H
+++ b/applications/solvers/multiphase/multiphaseEulerFoam/UEqns.H
@@ -43,7 +43,7 @@ forAllIter(PtrDictionary<phaseModel>, fluid.phases(), iter)
                 slamDampCoeff
                *max
                 (
-                    mag(U.dimensionedInternalField()) - maxSlamVelocity,
+                    mag(U()) - maxSlamVelocity,
                     dimensionedScalar("U0", dimVelocity, 0)
                 )
                /pow(mesh.V(), 1.0/3.0),
diff --git a/applications/solvers/multiphase/reactingEulerFoam/reactingMultiphaseEulerFoam/setRDeltaT.H b/applications/solvers/multiphase/reactingEulerFoam/reactingMultiphaseEulerFoam/setRDeltaT.H
index 686d4506840..052f704cbdb 100644
--- a/applications/solvers/multiphase/reactingEulerFoam/reactingMultiphaseEulerFoam/setRDeltaT.H
+++ b/applications/solvers/multiphase/reactingEulerFoam/reactingMultiphaseEulerFoam/setRDeltaT.H
@@ -26,10 +26,10 @@
     }
 
     // Set the reciprocal time-step from the local Courant number
-    rDeltaT.dimensionedInternalFieldRef() = max
+    rDeltaT.ref() = max
     (
         1/dimensionedScalar("maxDeltaT", dimTime, maxDeltaT),
-        fvc::surfaceSum(maxPhi)().dimensionedInternalField()
+        fvc::surfaceSum(maxPhi)()()
        /((2*maxCo)*mesh.V())
     );
 
diff --git a/applications/solvers/multiphase/reactingEulerFoam/reactingTwoPhaseEulerFoam/setRDeltaT.H b/applications/solvers/multiphase/reactingEulerFoam/reactingTwoPhaseEulerFoam/setRDeltaT.H
index 3c68f2a95f4..f8e880a474b 100644
--- a/applications/solvers/multiphase/reactingEulerFoam/reactingTwoPhaseEulerFoam/setRDeltaT.H
+++ b/applications/solvers/multiphase/reactingEulerFoam/reactingTwoPhaseEulerFoam/setRDeltaT.H
@@ -19,10 +19,10 @@
     );
 
     // Set the reciprocal time-step from the local Courant number
-    rDeltaT.dimensionedInternalFieldRef() = max
+    rDeltaT.ref() = max
     (
         1/dimensionedScalar("maxDeltaT", dimTime, maxDeltaT),
-        fvc::surfaceSum(max(mag(phi1), mag(phi2)))().dimensionedInternalField()
+        fvc::surfaceSum(max(mag(phi1), mag(phi2)))()()
        /((2*maxCo)*mesh.V())
     );
 
diff --git a/applications/solvers/multiphase/reactingEulerFoam/reactingTwoPhaseEulerFoam/twoPhaseSystem/twoPhaseSystem.C b/applications/solvers/multiphase/reactingEulerFoam/reactingTwoPhaseEulerFoam/twoPhaseSystem/twoPhaseSystem.C
index 0864234fe3d..6c039598a3c 100644
--- a/applications/solvers/multiphase/reactingEulerFoam/reactingTwoPhaseEulerFoam/twoPhaseSystem/twoPhaseSystem.C
+++ b/applications/solvers/multiphase/reactingEulerFoam/reactingTwoPhaseEulerFoam/twoPhaseSystem/twoPhaseSystem.C
@@ -212,26 +212,26 @@ void Foam::twoPhaseSystem::solve()
     {
         tdgdt =
         (
-            alpha2.dimensionedInternalField()
-           *phase1_.divU()().dimensionedInternalField()
-          - alpha1.dimensionedInternalField()
-           *phase2_.divU()().dimensionedInternalField()
+            alpha2()
+           *phase1_.divU()()()
+          - alpha1()
+           *phase2_.divU()()()
         );
     }
     else if (phase1_.divU().valid())
     {
         tdgdt =
         (
-            alpha2.dimensionedInternalField()
-           *phase1_.divU()().dimensionedInternalField()
+            alpha2()
+           *phase1_.divU()()()
         );
     }
     else if (phase2_.divU().valid())
     {
         tdgdt =
         (
-          - alpha1.dimensionedInternalField()
-           *phase2_.divU()().dimensionedInternalField()
+          - alpha1()
+           *phase2_.divU()()()
         );
     }
 
diff --git a/applications/utilities/postProcessing/miscellaneous/writeCellCentres/writeCellCentres.C b/applications/utilities/postProcessing/miscellaneous/writeCellCentres/writeCellCentres.C
index 6f1ec306905..5338be0df9f 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.dimensionedInternalFieldRef() = mesh.V();
+        V.ref() = mesh.V();
 
         volScalarField::Boundary& Vbf = V.boundaryFieldRef();
 
diff --git a/applications/utilities/postProcessing/velocityField/Co/Co.C b/applications/utilities/postProcessing/velocityField/Co/Co.C
index ef5953c86f5..b71c8bd62bb 100644
--- a/applications/utilities/postProcessing/velocityField/Co/Co.C
+++ b/applications/utilities/postProcessing/velocityField/Co/Co.C
@@ -87,9 +87,9 @@ void Foam::calc(const argList& args, const Time& runTime, const fvMesh& mesh)
                 mesh
             );
 
-            Co.dimensionedInternalFieldRef() =
+            Co.ref() =
                 (0.5*runTime.deltaT())
-               *fvc::surfaceSum(mag(phi))().dimensionedInternalField()
+               *fvc::surfaceSum(mag(phi))()()
                /(rho*mesh.V());
             Co.correctBoundaryConditions();
         }
@@ -97,9 +97,9 @@ void Foam::calc(const argList& args, const Time& runTime, const fvMesh& mesh)
         {
             Info<< "    Calculating incompressible Co" << endl;
 
-            Co.dimensionedInternalFieldRef() =
+            Co.ref() =
                 (0.5*runTime.deltaT())
-               *fvc::surfaceSum(mag(phi))().dimensionedInternalField()
+               *fvc::surfaceSum(mag(phi))()()
                /mesh.V();
             Co.correctBoundaryConditions();
         }
diff --git a/src/OpenFOAM/fields/GeometricFields/GeometricField/GeometricField.C b/src/OpenFOAM/fields/GeometricFields/GeometricField/GeometricField.C
index 2d43b495cf0..6edd7cf428f 100644
--- a/src/OpenFOAM/fields/GeometricFields/GeometricField/GeometricField.C
+++ b/src/OpenFOAM/fields/GeometricFields/GeometricField/GeometricField.C
@@ -714,7 +714,7 @@ Foam::GeometricField<Type, PatchField, GeoMesh>::~GeometricField()
 template<class Type, template<class> class PatchField, class GeoMesh>
 typename
 Foam::GeometricField<Type, PatchField, GeoMesh>::Internal&
-Foam::GeometricField<Type, PatchField, GeoMesh>::dimensionedInternalFieldRef()
+Foam::GeometricField<Type, PatchField, GeoMesh>::ref()
 {
     this->setUpToDate();
     storeOldTimes();
@@ -1138,7 +1138,7 @@ void Foam::GeometricField<Type, PatchField, GeoMesh>::operator=
 
     // Only assign field contents not ID
 
-    dimensionedInternalFieldRef() = gf.dimensionedInternalField();
+    ref() = gf();
     boundaryFieldRef() = gf.boundaryField();
 }
 
@@ -1182,7 +1182,7 @@ void Foam::GeometricField<Type, PatchField, GeoMesh>::operator=
     const dimensioned<Type>& dt
 )
 {
-    dimensionedInternalFieldRef() = dt;
+    ref() = dt;
     boundaryFieldRef() = dt.value();
 }
 
@@ -1199,7 +1199,7 @@ void Foam::GeometricField<Type, PatchField, GeoMesh>::operator==
 
     // Only assign field contents not ID
 
-    dimensionedInternalFieldRef() = gf.dimensionedInternalField();
+    ref() = gf();
     boundaryFieldRef() == gf.boundaryField();
 
     tgf.clear();
@@ -1212,7 +1212,7 @@ void Foam::GeometricField<Type, PatchField, GeoMesh>::operator==
     const dimensioned<Type>& dt
 )
 {
-    dimensionedInternalFieldRef() = dt;
+    ref() = dt;
     boundaryFieldRef() == dt.value();
 }
 
@@ -1227,7 +1227,7 @@ void Foam::GeometricField<Type, PatchField, GeoMesh>::operator op              \
 {                                                                              \
     checkField(*this, gf, #op);                                                \
                                                                                \
-    dimensionedInternalFieldRef() op gf.dimensionedInternalField();            \
+    ref() op gf();            \
     boundaryFieldRef() op gf.boundaryField();                                  \
 }                                                                              \
                                                                                \
@@ -1247,7 +1247,7 @@ void Foam::GeometricField<Type, PatchField, GeoMesh>::operator op              \
     const dimensioned<TYPE>& dt                                                \
 )                                                                              \
 {                                                                              \
-    dimensionedInternalFieldRef() op dt;                                       \
+    ref() op dt;                                       \
     boundaryFieldRef() op dt.value();                                          \
 }
 
@@ -1268,7 +1268,7 @@ Foam::Ostream& Foam::operator<<
     const GeometricField<Type, PatchField, GeoMesh>& gf
 )
 {
-    gf.dimensionedInternalField().writeData(os, "internalField");
+    gf().writeData(os, "internalField");
     os  << nl;
     gf.boundaryField().writeEntry("boundaryField", os);
 
diff --git a/src/OpenFOAM/fields/GeometricFields/GeometricField/GeometricField.H b/src/OpenFOAM/fields/GeometricFields/GeometricField/GeometricField.H
index bf8b97a1fcc..c9b83b45899 100644
--- a/src/OpenFOAM/fields/GeometricFields/GeometricField/GeometricField.H
+++ b/src/OpenFOAM/fields/GeometricFields/GeometricField/GeometricField.H
@@ -447,7 +447,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.
-        Internal& dimensionedInternalFieldRef();
+        Internal& ref();
 
         //- Return a const-reference to the dimensioned internal field
         inline const Internal& dimensionedInternalField() const;
diff --git a/src/OpenFOAM/fields/GeometricFields/GeometricField/GeometricFieldI.H b/src/OpenFOAM/fields/GeometricFields/GeometricField/GeometricFieldI.H
index 7c93a3d7233..697da6e5989 100644
--- a/src/OpenFOAM/fields/GeometricFields/GeometricField/GeometricFieldI.H
+++ b/src/OpenFOAM/fields/GeometricFields/GeometricField/GeometricFieldI.H
@@ -33,17 +33,6 @@ Foam::GeometricField<Type, PatchField, GeoMesh>::null()
 }
 
 
-template<class Type, template<class> class PatchField, class GeoMesh>
-inline
-const typename
-Foam::GeometricField<Type, PatchField, GeoMesh>::Internal&
-Foam::GeometricField<Type, PatchField, GeoMesh>::
-operator()() const
-{
-    return *this;
-}
-
-
 template<class Type, template<class> class PatchField, class GeoMesh>
 inline
 const typename
@@ -90,4 +79,17 @@ Foam::GeometricField<Type, PatchField, GeoMesh>::timeIndex()
 }
 
 
+// * * * * * * * * * * * * * * * Member Operators  * * * * * * * * * * * * * //
+
+template<class Type, template<class> class PatchField, class GeoMesh>
+inline
+const typename
+Foam::GeometricField<Type, PatchField, GeoMesh>::Internal&
+Foam::GeometricField<Type, PatchField, GeoMesh>::
+operator()() const
+{
+    return *this;
+}
+
+
 // ************************************************************************* //
diff --git a/src/TurbulenceModels/incompressible/turbulentTransportModels/RAS/kkLOmega/kkLOmega.C b/src/TurbulenceModels/incompressible/turbulentTransportModels/RAS/kkLOmega/kkLOmega.C
index ea1e8eb79b1..05533785c7e 100644
--- a/src/TurbulenceModels/incompressible/turbulentTransportModels/RAS/kkLOmega/kkLOmega.C
+++ b/src/TurbulenceModels/incompressible/turbulentTransportModels/RAS/kkLOmega/kkLOmega.C
@@ -695,7 +695,7 @@ void kkLOmega::correct()
       - fvm::Sp(Cw2_*sqr(fw)*omega_, omega_)
       + (
             Cw3_*fOmega(lambdaEff, lambdaT)*alphaTEff*sqr(fw)*sqrt(kt_)
-        )().dimensionedInternalField()/pow3(y_.dimensionedInternalField())
+        )()()/pow3(y_())
     );
 
     omegaEqn.ref().relax();
diff --git a/src/TurbulenceModels/turbulenceModels/LES/LESfilters/laplaceFilter/laplaceFilter.C b/src/TurbulenceModels/turbulenceModels/LES/LESfilters/laplaceFilter/laplaceFilter.C
index 5d8fcb737b0..3fbedbbe19f 100644
--- a/src/TurbulenceModels/turbulenceModels/LES/LESfilters/laplaceFilter/laplaceFilter.C
+++ b/src/TurbulenceModels/turbulenceModels/LES/LESfilters/laplaceFilter/laplaceFilter.C
@@ -57,7 +57,7 @@ Foam::laplaceFilter::laplaceFilter(const fvMesh& mesh, scalar widthCoeff)
         calculatedFvPatchScalarField::typeName
     )
 {
-    coeff_.dimensionedInternalFieldRef() = pow(mesh.V(), 2.0/3.0)/widthCoeff_;
+    coeff_.ref() = pow(mesh.V(), 2.0/3.0)/widthCoeff_;
 }
 
 
@@ -78,7 +78,7 @@ Foam::laplaceFilter::laplaceFilter(const fvMesh& mesh, const dictionary& bd)
         calculatedFvPatchScalarField::typeName
     )
 {
-    coeff_.dimensionedInternalFieldRef() = pow(mesh.V(), 2.0/3.0)/widthCoeff_;
+    coeff_.ref() = 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 73ec7ee3391..39ca2b1a2d9 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().dimensionedInternalFieldRef(), tdTilda(), y_);
+    min(tdTilda.ref().ref(), tdTilda(), y_);
     return tdTilda;
 }
 
diff --git a/src/combustionModels/singleStepCombustion/singleStepCombustion.C b/src/combustionModels/singleStepCombustion/singleStepCombustion.C
index 566d92dee80..8df2f329cf2 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.dimensionedInternalFieldRef() = this->mesh().V()*Sh()();
+        dQ.ref() = this->mesh().V()*Sh()();
     }
     return tdQ;
 }
diff --git a/src/dynamicMesh/fvMeshAdder/fvMeshAdderTemplates.C b/src/dynamicMesh/fvMeshAdder/fvMeshAdderTemplates.C
index f5d9c5e821e..03a97795330 100644
--- a/src/dynamicMesh/fvMeshAdder/fvMeshAdderTemplates.C
+++ b/src/dynamicMesh/fvMeshAdder/fvMeshAdderTemplates.C
@@ -157,7 +157,7 @@ void Foam::fvMeshAdder::MapVolField
                     (
                         bfld[newPatchi],                // old field
                         mesh.boundary()[newPatchi],     // new fvPatch
-                        fld.dimensionedInternalField(), // new internal field
+                        fld(), // new internal field
                         patchMapper                     // mapper (new to old)
                     )
                 );
@@ -211,7 +211,7 @@ void Foam::fvMeshAdder::MapVolField
                         (
                             fldToAdd.boundaryField()[patchi], // added field
                             mesh.boundary()[newPatchi],       // new fvPatch
-                            fld.dimensionedInternalField(),   // new int. field
+                            fld(),   // new int. field
                             patchMapper                       // mapper
                         )
                     );
@@ -464,7 +464,7 @@ void Foam::fvMeshAdder::MapSurfaceField
                     (
                         bfld[newPatchi],                // old field
                         mesh.boundary()[newPatchi],     // new fvPatch
-                        fld.dimensionedInternalField(), // new internal field
+                        fld(), // new internal field
                         patchMapper                     // mapper (new to old)
                     )
                 );
@@ -518,7 +518,7 @@ void Foam::fvMeshAdder::MapSurfaceField
                         (
                             fldToAdd.boundaryField()[patchi],// added field
                             mesh.boundary()[newPatchi],      // new fvPatch
-                            fld.dimensionedInternalField(),  // new int. field
+                            fld(),  // new int. field
                             patchMapper                      // mapper
                         )
                     );
diff --git a/src/dynamicMesh/fvMeshTools/fvMeshToolsTemplates.C b/src/dynamicMesh/fvMeshTools/fvMeshToolsTemplates.C
index 3f5aed90032..4cbc964da24 100644
--- a/src/dynamicMesh/fvMeshTools/fvMeshToolsTemplates.C
+++ b/src/dynamicMesh/fvMeshTools/fvMeshToolsTemplates.C
@@ -61,7 +61,7 @@ void Foam::fvMeshTools::addPatchFields
                 GeoField::Patch::New
                 (
                     mesh.boundary()[sz],
-                    fld.dimensionedInternalField(),
+                    fld(),
                     patchFieldDict.subDict(fld.name())
                 )
             );
@@ -75,7 +75,7 @@ void Foam::fvMeshTools::addPatchFields
                 (
                     defaultPatchFieldType,
                     mesh.boundary()[sz],
-                    fld.dimensionedInternalField()
+                    fld()
                 )
             );
             bfld[sz] == defaultPatchValue;
@@ -112,7 +112,7 @@ void Foam::fvMeshTools::setPatchFields
                 GeoField::Patch::New
                 (
                     mesh.boundary()[patchi],
-                    fld.dimensionedInternalField(),
+                    fld(),
                     patchFieldDict.subDict(fld.name())
                 )
             );
diff --git a/src/finiteVolume/finiteVolume/ddtSchemes/CrankNicolsonDdtScheme/CrankNicolsonDdtScheme.C b/src/finiteVolume/finiteVolume/ddtSchemes/CrankNicolsonDdtScheme/CrankNicolsonDdtScheme.C
index ed793845c1a..6461c0dfe4a 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.dimensionedInternalFieldRef() =
+            ddt0.ref() =
             (
                 (rDtCoef0*dt)*(mesh().V0() - mesh().V00())
               - mesh().V00()*offCentre_(ddt0.dimensionedInternalField())
             )/mesh().V0();
         }
 
-        tdtdt.ref().dimensionedInternalFieldRef() =
+        tdtdt.ref().ref() =
         (
             (rDtCoef*dt)*(mesh().V() - mesh().V0())
           - mesh().V0()*offCentre_(ddt0.dimensionedInternalField())
diff --git a/src/finiteVolume/fvMesh/fvMeshSubset/fvMeshSubsetInterpolate.C b/src/finiteVolume/fvMesh/fvMeshSubset/fvMeshSubsetInterpolate.C
index e830ebbb46d..a9c42ed4e1f 100644
--- a/src/finiteVolume/fvMesh/fvMeshSubset/fvMeshSubsetInterpolate.C
+++ b/src/finiteVolume/fvMesh/fvMeshSubset/fvMeshSubsetInterpolate.C
@@ -144,7 +144,7 @@ tmp<GeometricField<Type, fvPatchField, volMesh>> fvMeshSubset::interpolate
                 (
                     vf.boundaryField()[patchMap[patchi]],
                     subPatch,
-                    resF.dimensionedInternalField(),
+                    resF(),
                     directFvPatchFieldMapper(directAddressing)
                 )
             );
@@ -288,7 +288,7 @@ tmp<GeometricField<Type, fvsPatchField, surfaceMesh>> fvMeshSubset::interpolate
                 (
                     vf.boundaryField()[patchMap[patchi]],
                     subPatch,
-                    resF.dimensionedInternalField(),
+                    resF(),
                     directFvPatchFieldMapper(directAddressing)
                 )
             );
@@ -462,7 +462,7 @@ fvMeshSubset::interpolate
                 (
                     vf.boundaryField()[patchMap[patchi]],
                     subPatch,
-                    resF.dimensionedInternalField(),
+                    resF(),
                     directPointPatchFieldMapper(directAddressing)
                 )
             );
diff --git a/src/finiteVolume/fvMesh/singleCellFvMesh/singleCellFvMeshInterpolate.C b/src/finiteVolume/fvMesh/singleCellFvMesh/singleCellFvMeshInterpolate.C
index fe0c8779d04..be4128fa86d 100644
--- a/src/finiteVolume/fvMesh/singleCellFvMesh/singleCellFvMeshInterpolate.C
+++ b/src/finiteVolume/fvMesh/singleCellFvMesh/singleCellFvMeshInterpolate.C
@@ -115,7 +115,7 @@ tmp<GeometricField<Type, fvPatchField, volMesh>> singleCellFvMesh::interpolate
                 (
                     vf.boundaryField()[patchi],
                     boundary()[patchi],
-                    resF.dimensionedInternalField(),
+                    resF(),
                     agglomPatchFieldMapper(coarseToFine, coarseWeights)
                 )
             );
@@ -134,7 +134,7 @@ tmp<GeometricField<Type, fvPatchField, volMesh>> singleCellFvMesh::interpolate
                 (
                     vf.boundaryField()[patchi],
                     boundary()[patchi],
-                    resF.dimensionedInternalField(),
+                    resF(),
                     directFvPatchFieldMapper(map)
                 )
             );
diff --git a/src/finiteVolume/interpolation/volPointInterpolation/volPointInterpolate.C b/src/finiteVolume/interpolation/volPointInterpolation/volPointInterpolate.C
index 94408ef00c5..19f28f1cb07 100644
--- a/src/finiteVolume/interpolation/volPointInterpolation/volPointInterpolate.C
+++ b/src/finiteVolume/interpolation/volPointInterpolation/volPointInterpolate.C
@@ -87,7 +87,7 @@ void Foam::volPointInterpolation::addSeparated
     }
 
     typename GeometricField<Type, pointPatchField, pointMesh>::
-        Internal& pfi = pf.dimensionedInternalFieldRef();
+        Internal& pfi = pf.ref();
 
     typename GeometricField<Type, pointPatchField, pointMesh>::
         Boundary& pfbf = pf.boundaryFieldRef();
diff --git a/src/fvMotionSolver/pointPatchFields/derived/uniformInterpolatedDisplacement/uniformInterpolatedDisplacementPointPatchVectorField.C b/src/fvMotionSolver/pointPatchFields/derived/uniformInterpolatedDisplacement/uniformInterpolatedDisplacementPointPatchVectorField.C
index ad48d728f97..4a1c4ec6547 100644
--- a/src/fvMotionSolver/pointPatchFields/derived/uniformInterpolatedDisplacement/uniformInterpolatedDisplacementPointPatchVectorField.C
+++ b/src/fvMotionSolver/pointPatchFields/derived/uniformInterpolatedDisplacement/uniformInterpolatedDisplacementPointPatchVectorField.C
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2012-2015 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2012-2016 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -249,7 +249,7 @@ void uniformInterpolatedDisplacementPointPatchVectorField::updateCoeffs()
     // Extract back from the internal field
     this->operator==
     (
-        this->patchInternalField(result.dimensionedInternalField())
+        this->patchInternalField(result())
     );
 
     fixedValuePointPatchField<vector>::updateCoeffs();
diff --git a/src/mesh/snappyHexMesh/meshRefinement/meshRefinementTemplates.C b/src/mesh/snappyHexMesh/meshRefinement/meshRefinementTemplates.C
index 898467c7ee7..d33f648b407 100644
--- a/src/mesh/snappyHexMesh/meshRefinement/meshRefinementTemplates.C
+++ b/src/mesh/snappyHexMesh/meshRefinement/meshRefinementTemplates.C
@@ -226,7 +226,7 @@ void Foam::meshRefinement::addPatchFields
             (
                 patchFieldType,
                 mesh.boundary()[sz],
-                fld.dimensionedInternalField()
+                fld()
             )
         );
     }
diff --git a/src/parallel/decompose/decompose/fvFieldDecomposerDecomposeFields.C b/src/parallel/decompose/decompose/fvFieldDecomposerDecomposeFields.C
index 43ff63310b1..af2475cea3b 100644
--- a/src/parallel/decompose/decompose/fvFieldDecomposerDecomposeFields.C
+++ b/src/parallel/decompose/decompose/fvFieldDecomposerDecomposeFields.C
@@ -96,7 +96,7 @@ Foam::fvFieldDecomposer::decomposeField
                 (
                     field.boundaryField()[boundaryAddressing_[patchi]],
                     procMesh_.boundary()[patchi],
-                    resF.dimensionedInternalField(),
+                    resF(),
                     *patchFieldDecomposerPtrs_[patchi]
                 )
             );
@@ -109,7 +109,7 @@ Foam::fvFieldDecomposer::decomposeField
                 new processorCyclicFvPatchField<Type>
                 (
                     procMesh_.boundary()[patchi],
-                    resF.dimensionedInternalField(),
+                    resF(),
                     Field<Type>
                     (
                         field.internalField(),
@@ -126,7 +126,7 @@ Foam::fvFieldDecomposer::decomposeField
                 new processorFvPatchField<Type>
                 (
                     procMesh_.boundary()[patchi],
-                    resF.dimensionedInternalField(),
+                    resF(),
                     Field<Type>
                     (
                         field.internalField(),
@@ -143,7 +143,7 @@ Foam::fvFieldDecomposer::decomposeField
                 new emptyFvPatchField<Type>
                 (
                     procMesh_.boundary()[patchi],
-                    resF.dimensionedInternalField()
+                    resF()
                 )
             );
         }
@@ -266,7 +266,7 @@ Foam::fvFieldDecomposer::decomposeField
                 (
                     field.boundaryField()[boundaryAddressing_[patchi]],
                     procMesh_.boundary()[patchi],
-                    resF.dimensionedInternalField(),
+                    resF(),
                     *patchFieldDecomposerPtrs_[patchi]
                 )
             );
@@ -279,7 +279,7 @@ Foam::fvFieldDecomposer::decomposeField
                 new processorCyclicFvsPatchField<Type>
                 (
                     procMesh_.boundary()[patchi],
-                    resF.dimensionedInternalField(),
+                    resF(),
                     Field<Type>
                     (
                         allFaceField,
@@ -296,7 +296,7 @@ Foam::fvFieldDecomposer::decomposeField
                 new processorFvsPatchField<Type>
                 (
                     procMesh_.boundary()[patchi],
-                    resF.dimensionedInternalField(),
+                    resF(),
                     Field<Type>
                     (
                         allFaceField,
diff --git a/src/postProcessing/functionObjects/utilities/CourantNo/CourantNo.C b/src/postProcessing/functionObjects/utilities/CourantNo/CourantNo.C
index 32f78e3aa99..a98e6f2c007 100644
--- a/src/postProcessing/functionObjects/utilities/CourantNo/CourantNo.C
+++ b/src/postProcessing/functionObjects/utilities/CourantNo/CourantNo.C
@@ -142,10 +142,10 @@ void Foam::CourantNo::execute()
                 mesh.lookupObject<volScalarField>(type())
             );
 
-        Co.dimensionedInternalFieldRef() = byRho
+        Co.ref() = byRho
         (
             (0.5*mesh.time().deltaT())
-           *fvc::surfaceSum(mag(phi))().dimensionedInternalField()
+           *fvc::surfaceSum(mag(phi))()()
            /mesh.V()
         );
         Co.correctBoundaryConditions();
diff --git a/src/sampling/meshToMesh/meshToMeshTemplates.C b/src/sampling/meshToMesh/meshToMeshTemplates.C
index 000aa35ea58..cff62b8b835 100644
--- a/src/sampling/meshToMesh/meshToMeshTemplates.C
+++ b/src/sampling/meshToMesh/meshToMeshTemplates.C
@@ -351,7 +351,7 @@ void Foam::meshToMesh::mapSrcToTgt
                 (
                     srcField,
                     tgtField.patch(),
-                    result.dimensionedInternalField(),
+                    result(),
                     weightedFvPatchFieldMapper
                     (
                         AMIList[i].tgtAddress(),
@@ -540,7 +540,7 @@ void Foam::meshToMesh::mapTgtToSrc
                 (
                     tgtField,
                     srcField.patch(),
-                    result.dimensionedInternalField(),
+                    result(),
                     weightedFvPatchFieldMapper
                     (
                         AMIList[i].srcAddress(),
diff --git a/src/thermophysicalModels/chemistryModel/chemistryModel/chemistryModel/chemistryModel.C b/src/thermophysicalModels/chemistryModel/chemistryModel/chemistryModel/chemistryModel.C
index 4522edcd18b..347e506901e 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.dimensionedInternalFieldRef() = this->mesh_.V()*Sh()();
+        dQ.ref() = this->mesh_.V()*Sh()();
     }
 
     return tdQ;
diff --git a/src/thermophysicalModels/radiation/radiationModels/P1/P1.C b/src/thermophysicalModels/radiation/radiationModels/P1/P1.C
index ef200e50f32..bf5b738ffc3 100644
--- a/src/thermophysicalModels/radiation/radiationModels/P1/P1.C
+++ b/src/thermophysicalModels/radiation/radiationModels/P1/P1.C
@@ -282,11 +282,11 @@ Foam::tmp<Foam::DimensionedField<Foam::scalar, Foam::volMesh>>
 Foam::radiation::P1::Ru() const
 {
     const DimensionedField<scalar, volMesh>& G =
-        G_.dimensionedInternalField();
+        G_();
     const DimensionedField<scalar, volMesh> E =
-        absorptionEmission_->ECont()().dimensionedInternalField();
+        absorptionEmission_->ECont()()();
     const DimensionedField<scalar, volMesh> a =
-        absorptionEmission_->aCont()().dimensionedInternalField();
+        absorptionEmission_->aCont()()();
 
     return a*G - E;
 }
diff --git a/src/thermophysicalModels/radiation/radiationModels/fvDOM/fvDOM/fvDOM.C b/src/thermophysicalModels/radiation/radiationModels/fvDOM/fvDOM/fvDOM.C
index 9e1fd80e69f..b41056add0d 100644
--- a/src/thermophysicalModels/radiation/radiationModels/fvDOM/fvDOM/fvDOM.C
+++ b/src/thermophysicalModels/radiation/radiationModels/fvDOM/fvDOM/fvDOM.C
@@ -494,14 +494,14 @@ Foam::radiation::fvDOM::Ru() const
 {
 
     const DimensionedField<scalar, volMesh>& G =
-        G_.dimensionedInternalField();
+        G_();
 
     const DimensionedField<scalar, volMesh> E =
-        absorptionEmission_->ECont()().dimensionedInternalField();
+        absorptionEmission_->ECont()()();
 
     // Only include continuous phase absorption
     const DimensionedField<scalar, volMesh> a =
-        absorptionEmission_->aCont()().dimensionedInternalField();
+        absorptionEmission_->aCont()()();
 
     return a*G - E;
 }
diff --git a/src/thermophysicalModels/solidChemistryModel/solidChemistryModel/solidChemistryModel.C b/src/thermophysicalModels/solidChemistryModel/solidChemistryModel/solidChemistryModel.C
index 72f6c52e716..5a626507750 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.dimensionedInternalFieldRef() = this->mesh_.V()*Sh()();
+        dQ.ref() = this->mesh_.V()*Sh()();
     }
 
     return tdQ;
-- 
GitLab