diff --git a/applications/solvers/combustion/reactingFoam/setRDeltaT.H b/applications/solvers/combustion/reactingFoam/setRDeltaT.H
index 12bdceb7e521e0cd809f708697cfb3d2a86e8091..7612886aac92f38d904708076d4760c42e25a86d 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 fb0fbc7079565c6a47d65d3c76117c6bc6b91a8f..683dc165a585fd89980388617cfaec60b28728a3 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 083a1b1b5c1ebb2ed0185e436ea1559a6a295838..af304aeb24e6b344fdae532c87d3060fb06be618 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 806ddd3832433c1a0eaca7995bee31f630a6b2d2..f5dd49e7a3c41b6949dd48ec5918e2054e6b9b44 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 0a38e05ee9fe6972c1b89aaadfea37e24fc25fd7..7c9dc6b870f9f4f285fe5f0f058bd3495c68e38d 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 65b0388e12dcba4447824a85f2dbf740fd1086f8..56c67ca2f21cc49b768bfe89ae1ae2b64053781c 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 f51eeb49bf3ba7f3fa78028e895226faec408b8c..5ee1dc4630d87ae6ec3be86c02fd3ac30e3852f8 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 dd0e6a4da45a946c9fbd7512b7c972da58d7043b..afeee4cf4341946bac11860c481aba1482b1a60b 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 fec017ea30462cb759075c6691600626fea1575d..686d4506840f40091214d54bad515f480a0bcec2 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 4bef17a6bb4a851edbea09e23e8794ad3ff6cbd1..3c68f2a95f45fa112acf2789d726ce89978282bb 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 c6b26e6d3eab80f898c1b5b514496c67d1155d57..6a78ebad1e8b07c8ed1561b6104b21c0a18818f2 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 110c39b4158c723d738af26f003f6617705e06cf..ef5953c86f567bff38d650360354e9e4bae33384 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 b30ca6e5a7bb515e64c0752955cc82aeb1cbaba0..5228c5a630c2390e99b2367be8dc762ee5ed915a 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 1d2c3e825a17c83a99f7f33653499b2417a81992..fe30dc91813d9d67eb4f84cd593243857b621247 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 24db120ffa99b37c454e06e473b8780f30c29ffc..5d8fcb737b03b0c8efcff35b7cc73c41e42a4bd0 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 54db6c6d78e2a7e23c219249b3b2ed44d35e8617..73ec7ee33912bebcd6d8a355e858875507158033 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 d8bc1cfac30a0bcc59404ed732d7d0cb6cc571f3..566d92dee8015a16230a5fd4f81ac2652cd4a0dc 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 b424943e34d0b7806e0d5aa932740ee43a8fa791..c4419ec26e72607ac1dba717bf578e9d8974112f 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 75464c40139f6cd10a231b39aa23a81f4fbbf873..24a3e5b5996697409bc557f41a12d3ebd647b38f 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 ec56dcc94baa8ada811d2379b948752ae0314510..c35709cf6d1b06de245b3d203064df378137337f 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 bf9682d9584b4e7ba841d7391fe6915144cd96b3..4522edcd18beb0d869a2882a9629cf7d9695d720 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 e723ff90ed3956dd2833c9deeb1a4489abf1c805..72f6c52e71670c9364adfb792b7ea0eb0bbcffe0 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;