From 3cd9b4f5d7938608a09df023988b11ae3f6edd90 Mon Sep 17 00:00:00 2001
From: Henry Weller <http://cfd.direct>
Date: Mon, 2 May 2016 18:20:48 +0100
Subject: [PATCH] Change field loop index from "fieldI" to "fieldi"

---
 .../patchSummary/patchSummaryTemplates.C      | 20 ++---
 .../patchSummary/patchSummaryTemplates.H      |  4 +-
 .../dimFieldDecomposerDecomposeFields.C       |  4 +-
 ...lagrangianFieldDecomposerDecomposeFields.C |  8 +-
 .../pointFieldDecomposerDecomposeFields.C     |  4 +-
 .../decomposePar/readFields.C                 |  6 +-
 .../foamToVTK/patchWriterTemplates.C          | 12 +--
 .../foamToVTK/surfaceMeshWriterTemplates.C    |  4 +-
 .../foamToVTK/writeSurfFields.C               |  4 +-
 .../steadyParticleTracksTemplates.C           | 10 +--
 .../dynamicCode/codedFvOptionTemplate.C       |  8 +-
 .../dynamicCode/codedFvOptionTemplate.H       | 12 +--
 .../GeometricField/uniformInterpolate.C       |  4 +-
 .../graph/writers/jplotGraph/jplotGraph.C     |  8 +-
 .../graph/writers/xmgrGraph/xmgrGraph.C       | 10 +--
 .../fvMeshDistributeTemplates.C               |  4 +-
 .../cfdTools/general/fvOptions/fvOption.C     | 52 ++++++------
 .../cfdTools/general/fvOptions/fvOption.H     | 44 +++++-----
 .../cfdTools/general/fvOptions/fvOptionI.H    |  6 +-
 .../general/fvOptions/fvOptionListTemplates.C | 38 ++++-----
 .../pimpleControl/pimpleControl.C             | 20 ++---
 .../simpleControl/simpleControl.C             | 10 +--
 .../solutionControl/solutionControl.C         |  6 +-
 .../fixedTemperatureConstraint.H              |  2 +-
 .../explicitSetValue/ExplicitSetValue.C       |  6 +-
 .../explicitSetValue/ExplicitSetValue.H       |  2 +-
 .../actuationDiskSource/actuationDiskSource.C |  6 +-
 .../actuationDiskSource/actuationDiskSource.H |  4 +-
 .../derived/buoyancyEnergy/buoyancyEnergy.C   |  4 +-
 .../derived/buoyancyEnergy/buoyancyEnergy.H   |  4 +-
 .../derived/buoyancyForce/buoyancyForce.C     |  4 +-
 .../derived/buoyancyForce/buoyancyForce.H     |  4 +-
 .../effectivenessHeatExchangerSource.H        |  4 +-
 .../explicitPorositySource.C                  |  8 +-
 .../explicitPorositySource.H                  |  8 +-
 .../meanVelocityForce/meanVelocityForce.C     |  8 +-
 .../meanVelocityForce/meanVelocityForce.H     |  8 +-
 .../radialActuationDiskSource.C               |  6 +-
 .../radialActuationDiskSource.H               |  4 +-
 .../derived/rotorDiskSource/rotorDiskSource.C |  4 +-
 .../derived/rotorDiskSource/rotorDiskSource.H |  6 +-
 .../solidificationMeltingSource.C             | 10 +--
 .../solidificationMeltingSource.H             | 10 +--
 .../sources/general/codedSource/CodedSource.C | 14 ++--
 .../sources/general/codedSource/CodedSource.H | 10 +--
 .../semiImplicitSource/SemiImplicitSource.C   | 14 ++--
 .../semiImplicitSource/SemiImplicitSource.H   |  4 +-
 .../interRegionExplicitPorositySource.C       |  4 +-
 .../interRegionExplicitPorositySource.H       |  4 +-
 .../interRegionHeatTransferModel.C            |  6 +-
 .../interRegionHeatTransferModel.H            |  4 +-
 .../Templates/ReactingCloud/ReactingCloud.C   | 10 +--
 .../fvFieldDecomposerDecomposeFields.C        |  4 +-
 .../fieldAverage/fieldAverage/fieldAverage.C  | 44 +++++-----
 .../fieldAverage/fieldAverage/fieldAverage.H  | 14 ++--
 .../fieldAverage/fieldAverageTemplates.C      | 82 +++++++++----------
 .../fieldCoordinateSystemTransform.C          | 16 ++--
 .../field/fieldMinMax/fieldMinMax.C           | 18 ++--
 .../field/readFields/readFields.C             |  4 +-
 .../utilities/residuals/residuals.C           |  8 +-
 src/sampling/probes/patchProbesTemplates.C    | 16 ++--
 src/sampling/probes/probesGrouping.C          | 10 +--
 src/sampling/probes/probesTemplates.C         | 16 ++--
 .../sampledSets/sampledSetsGrouping.C         | 10 +--
 .../chemistryModel/chemistryModel.C           |  6 +-
 .../pyrolysisChemistryModel.C                 | 22 ++---
 .../solidChemistryModel/solidChemistryModel.C |  6 +-
 67 files changed, 378 insertions(+), 378 deletions(-)

diff --git a/applications/utilities/miscellaneous/patchSummary/patchSummaryTemplates.C b/applications/utilities/miscellaneous/patchSummary/patchSummaryTemplates.C
index 80ce783613..17a2271298 100644
--- a/applications/utilities/miscellaneous/patchSummary/patchSummaryTemplates.C
+++ b/applications/utilities/miscellaneous/patchSummary/patchSummaryTemplates.C
@@ -33,7 +33,7 @@ void Foam::addToFieldList
 (
     PtrList<GeoField>& fieldList,
     const IOobject& obj,
-    const label fieldI,
+    const label fieldi,
     const typename GeoField::Mesh& mesh
 )
 {
@@ -41,7 +41,7 @@ void Foam::addToFieldList
     {
         fieldList.set
         (
-            fieldI,
+            fieldi,
             new GeoField(obj, mesh)
         );
         Info<< "    " << GeoField::typeName << tab << obj.name() << endl;
@@ -56,14 +56,14 @@ void Foam::outputFieldList
     const label patchi
 )
 {
-    forAll(fieldList, fieldI)
+    forAll(fieldList, fieldi)
     {
-        if (fieldList.set(fieldI))
+        if (fieldList.set(fieldi))
         {
             Info<< "    " << pTraits<typename GeoField::value_type>::typeName
                 << tab << tab
-                << fieldList[fieldI].name() << tab << tab
-                << fieldList[fieldI].boundaryField()[patchi].type() << nl;
+                << fieldList[fieldi].name() << tab << tab
+                << fieldList[fieldi].boundaryField()[patchi].type() << nl;
         }
     }
 }
@@ -77,14 +77,14 @@ void Foam::collectFieldList
     HashTable<word>& fieldToType
 )
 {
-    forAll(fieldList, fieldI)
+    forAll(fieldList, fieldi)
     {
-        if (fieldList.set(fieldI))
+        if (fieldList.set(fieldi))
         {
             fieldToType.insert
             (
-                fieldList[fieldI].name(),
-                fieldList[fieldI].boundaryField()[patchi].type()
+                fieldList[fieldi].name(),
+                fieldList[fieldi].boundaryField()[patchi].type()
             );
         }
     }
diff --git a/applications/utilities/miscellaneous/patchSummary/patchSummaryTemplates.H b/applications/utilities/miscellaneous/patchSummary/patchSummaryTemplates.H
index 534715ae46..f47d6e8dda 100644
--- a/applications/utilities/miscellaneous/patchSummary/patchSummaryTemplates.H
+++ b/applications/utilities/miscellaneous/patchSummary/patchSummaryTemplates.H
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011-2015 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2016 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -38,7 +38,7 @@ namespace Foam
     (
         PtrList<GeoField>& fieldList,
         const IOobject& obj,
-        const label fieldI,
+        const label fieldi,
         const typename GeoField::Mesh& mesh
     );
 
diff --git a/applications/utilities/parallelProcessing/decomposePar/dimFieldDecomposerDecomposeFields.C b/applications/utilities/parallelProcessing/decomposePar/dimFieldDecomposerDecomposeFields.C
index dcdebc31d8..af1ae6f26c 100644
--- a/applications/utilities/parallelProcessing/decomposePar/dimFieldDecomposerDecomposeFields.C
+++ b/applications/utilities/parallelProcessing/decomposePar/dimFieldDecomposerDecomposeFields.C
@@ -65,9 +65,9 @@ void Foam::dimFieldDecomposer::decomposeFields
     const PtrList<GeoField>& fields
 ) const
 {
-    forAll(fields, fieldI)
+    forAll(fields, fieldi)
     {
-        decomposeField(fields[fieldI])().write();
+        decomposeField(fields[fieldi])().write();
     }
 }
 
diff --git a/applications/utilities/parallelProcessing/decomposePar/lagrangianFieldDecomposerDecomposeFields.C b/applications/utilities/parallelProcessing/decomposePar/lagrangianFieldDecomposerDecomposeFields.C
index 1b5caf8e6f..79754c1c05 100644
--- a/applications/utilities/parallelProcessing/decomposePar/lagrangianFieldDecomposerDecomposeFields.C
+++ b/applications/utilities/parallelProcessing/decomposePar/lagrangianFieldDecomposerDecomposeFields.C
@@ -190,9 +190,9 @@ void Foam::lagrangianFieldDecomposer::decomposeFields
 {
     if (particleIndices_.size())
     {
-        forAll(fields, fieldI)
+        forAll(fields, fieldi)
         {
-            decomposeField(cloudName, fields[fieldI])().write();
+            decomposeField(cloudName, fields[fieldi])().write();
         }
     }
 }
@@ -207,9 +207,9 @@ void Foam::lagrangianFieldDecomposer::decomposeFieldFields
 {
     if (particleIndices_.size())
     {
-        forAll(fields, fieldI)
+        forAll(fields, fieldi)
         {
-            decomposeFieldField(cloudName, fields[fieldI])().write();
+            decomposeFieldField(cloudName, fields[fieldi])().write();
         }
     }
 }
diff --git a/applications/utilities/parallelProcessing/decomposePar/pointFieldDecomposerDecomposeFields.C b/applications/utilities/parallelProcessing/decomposePar/pointFieldDecomposerDecomposeFields.C
index 55961704f4..dea901d5dd 100644
--- a/applications/utilities/parallelProcessing/decomposePar/pointFieldDecomposerDecomposeFields.C
+++ b/applications/utilities/parallelProcessing/decomposePar/pointFieldDecomposerDecomposeFields.C
@@ -101,9 +101,9 @@ void Foam::pointFieldDecomposer::decomposeFields
     const PtrList<GeoField>& fields
 ) const
 {
-    forAll(fields, fieldI)
+    forAll(fields, fieldi)
     {
-        decomposeField(fields[fieldI])().write();
+        decomposeField(fields[fieldi])().write();
     }
 }
 
diff --git a/applications/utilities/parallelProcessing/decomposePar/readFields.C b/applications/utilities/parallelProcessing/decomposePar/readFields.C
index e949e0c2fa..7faa5a66c4 100644
--- a/applications/utilities/parallelProcessing/decomposePar/readFields.C
+++ b/applications/utilities/parallelProcessing/decomposePar/readFields.C
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2016 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -48,12 +48,12 @@ void Foam::readFields
     // Construct the fields
     fields.setSize(fieldObjects.size());
 
-    label fieldI = 0;
+    label fieldi = 0;
     forAllIter(IOobjectList, fieldObjects, iter)
     {
         fields.set
         (
-            fieldI++,
+            fieldi++,
             new GeoField(*iter(), mesh)
         );
     }
diff --git a/applications/utilities/postProcessing/dataConversion/foamToVTK/patchWriterTemplates.C b/applications/utilities/postProcessing/dataConversion/foamToVTK/patchWriterTemplates.C
index 5e4dd33a1f..192f7ca2c1 100644
--- a/applications/utilities/postProcessing/dataConversion/foamToVTK/patchWriterTemplates.C
+++ b/applications/utilities/postProcessing/dataConversion/foamToVTK/patchWriterTemplates.C
@@ -34,9 +34,9 @@ void Foam::patchWriter::write
     const PtrList<GeometricField<Type, fvPatchField, volMesh>>& flds
 )
 {
-    forAll(flds, fieldI)
+    forAll(flds, fieldi)
     {
-        const GeometricField<Type, fvPatchField, volMesh>& fld = flds[fieldI];
+        const GeometricField<Type, fvPatchField, volMesh>& fld = flds[fieldi];
 
         os_ << fld.name() << ' ' << pTraits<Type>::nComponents << ' '
             << nFaces_ << " float" << std::endl;
@@ -69,10 +69,10 @@ void Foam::patchWriter::write
     const PtrList<GeometricField<Type, pointPatchField, pointMesh>>& flds
 )
 {
-    forAll(flds, fieldI)
+    forAll(flds, fieldi)
     {
         const GeometricField<Type, pointPatchField, pointMesh>& fld =
-            flds[fieldI];
+            flds[fieldi];
 
         os_ << fld.name() << ' ' << pTraits<Type>::nComponents << ' '
             << nPoints_ << " float" << std::endl;
@@ -99,9 +99,9 @@ void Foam::patchWriter::write
     const PtrList<GeometricField<Type, fvPatchField, volMesh>>& flds
 )
 {
-    forAll(flds, fieldI)
+    forAll(flds, fieldi)
     {
-        const GeometricField<Type, fvPatchField, volMesh>& fld = flds[fieldI];
+        const GeometricField<Type, fvPatchField, volMesh>& fld = flds[fieldi];
 
         os_ << fld.name() << ' ' << pTraits<Type>::nComponents << ' '
             << nPoints_ << " float" << std::endl;
diff --git a/applications/utilities/postProcessing/dataConversion/foamToVTK/surfaceMeshWriterTemplates.C b/applications/utilities/postProcessing/dataConversion/foamToVTK/surfaceMeshWriterTemplates.C
index 052e94203d..b36d401ac4 100644
--- a/applications/utilities/postProcessing/dataConversion/foamToVTK/surfaceMeshWriterTemplates.C
+++ b/applications/utilities/postProcessing/dataConversion/foamToVTK/surfaceMeshWriterTemplates.C
@@ -66,10 +66,10 @@ void Foam::surfaceMeshWriter::write
     const PtrList<GeometricField<Type, fvsPatchField, surfaceMesh>>& sflds
 )
 {
-    forAll(sflds, fieldI)
+    forAll(sflds, fieldi)
     {
         const GeometricField<Type, fvsPatchField, surfaceMesh>& fld =
-            sflds[fieldI];
+            sflds[fieldi];
 
         os_ << fld.name() << ' ' << pTraits<Type>::nComponents << ' '
             << pp_.size() << " float" << std::endl;
diff --git a/applications/utilities/postProcessing/dataConversion/foamToVTK/writeSurfFields.C b/applications/utilities/postProcessing/dataConversion/foamToVTK/writeSurfFields.C
index 0447091626..62381e65d2 100644
--- a/applications/utilities/postProcessing/dataConversion/foamToVTK/writeSurfFields.C
+++ b/applications/utilities/postProcessing/dataConversion/foamToVTK/writeSurfFields.C
@@ -75,9 +75,9 @@ void writeSurfFields
         << "FIELD attributes " << surfVectorFields.size() << std::endl;
 
     // surfVectorFields
-    forAll(surfVectorFields, fieldI)
+    forAll(surfVectorFields, fieldi)
     {
-        const surfaceVectorField& svf = surfVectorFields[fieldI];
+        const surfaceVectorField& svf = surfVectorFields[fieldi];
 
         str << svf.name() << " 3 "
             << mesh.nFaces() << " float" << std::endl;
diff --git a/applications/utilities/postProcessing/lagrangian/steadyParticleTracks/steadyParticleTracksTemplates.C b/applications/utilities/postProcessing/lagrangian/steadyParticleTracks/steadyParticleTracksTemplates.C
index 8499dc509f..1508bb6fe6 100644
--- a/applications/utilities/postProcessing/lagrangian/steadyParticleTracks/steadyParticleTracksTemplates.C
+++ b/applications/utilities/postProcessing/lagrangian/steadyParticleTracks/steadyParticleTracksTemplates.C
@@ -116,17 +116,17 @@ void writeVTKFields
 {
     label step = max(floor(8/pTraits<Type>::nComponents), 1);
 
-    forAll(values, fieldI)
+    forAll(values, fieldi)
     {
-        Info<< "        writing field " << fieldNames[fieldI] << endl;
-        os  << nl << fieldNames[fieldI] << ' ' << pTraits<Type>::nComponents
-            << ' ' << values[fieldI].size() << " float" << nl;
+        Info<< "        writing field " << fieldNames[fieldi] << endl;
+        os  << nl << fieldNames[fieldi] << ' ' << pTraits<Type>::nComponents
+            << ' ' << values[fieldi].size() << " float" << nl;
         label offset = 0;
         forAll(addr, trackI)
         {
             const List<label> ids(addr[trackI]);
 
-            List<Type> data(UIndirectList<Type>(values[fieldI], ids));
+            List<Type> data(UIndirectList<Type>(values[fieldi], ids));
             label nData = data.size() - 1;
             forAll(data, i)
             {
diff --git a/etc/codeTemplates/dynamicCode/codedFvOptionTemplate.C b/etc/codeTemplates/dynamicCode/codedFvOptionTemplate.C
index 35f017f9f3..b3bcb86ecd 100644
--- a/etc/codeTemplates/dynamicCode/codedFvOptionTemplate.C
+++ b/etc/codeTemplates/dynamicCode/codedFvOptionTemplate.C
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2013-2014 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2013-2016 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -147,7 +147,7 @@ void ${typeName}FvOption${SourceType}::correct
 void ${typeName}FvOption${SourceType}::addSup
 (
     fvMatrix<${TemplateType}>& eqn,
-    const label fieldI
+    const label fieldi
 )
 {
     if (${verbose:-false})
@@ -165,7 +165,7 @@ void ${typeName}FvOption${SourceType}::addSup
 (
     const volScalarField& rho,
     fvMatrix<${TemplateType}>& eqn,
-    const label fieldI
+    const label fieldi
 )
 {
     if (${verbose:-false})
@@ -182,7 +182,7 @@ void ${typeName}FvOption${SourceType}::addSup
 void ${typeName}FvOption${SourceType}::setValue
 (
     fvMatrix<${TemplateType}>& eqn,
-    const label fieldI
+    const label fieldi
 )
 {
     if (${verbose:-false})
diff --git a/etc/codeTemplates/dynamicCode/codedFvOptionTemplate.H b/etc/codeTemplates/dynamicCode/codedFvOptionTemplate.H
index 8bc874b708..700ed050c5 100644
--- a/etc/codeTemplates/dynamicCode/codedFvOptionTemplate.H
+++ b/etc/codeTemplates/dynamicCode/codedFvOptionTemplate.H
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2013-2014 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2013-2016 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -33,13 +33,13 @@ Description
     codeAddSup
     (
         fvMatrix<Type}>& eqn,
-        const label fieldI
+        const label fieldi
     )
 
     setValue
     (
          fvMatrix<Type}>& eqn,
-        const label fieldI
+        const label fieldi
     )
 
     where :
@@ -159,7 +159,7 @@ public:
             virtual void addSup
             (
                 fvMatrix<${TemplateType}>& eqn,
-                const label fieldI
+                const label fieldi
             );
 
             //- Explicit and implicit matrix contributions for compressible
@@ -168,14 +168,14 @@ public:
             (
                 const volScalarField& rho,
                 fvMatrix<${TemplateType}>& eqn,
-                const label fieldI
+                const label fieldi
             );
 
             //- Set value
             virtual void setValue
             (
                 fvMatrix<${TemplateType}>& eqn,
-                const label fieldI
+                const label fieldi
             );
 };
 
diff --git a/src/OpenFOAM/fields/GeometricFields/GeometricField/uniformInterpolate.C b/src/OpenFOAM/fields/GeometricFields/GeometricField/uniformInterpolate.C
index a70abece0f..beceeeefc0 100644
--- a/src/OpenFOAM/fields/GeometricFields/GeometricField/uniformInterpolate.C
+++ b/src/OpenFOAM/fields/GeometricFields/GeometricField/uniformInterpolate.C
@@ -103,7 +103,7 @@ Foam::tmp<GeoField> Foam::uniformInterpolate
         (
             times[i]
         );
-        const GeoField& fieldI = timeIFields.lookupObject
+        const GeoField& fieldi = timeIFields.lookupObject
         <
             const GeoField
         >
@@ -111,7 +111,7 @@ Foam::tmp<GeoField> Foam::uniformInterpolate
             fieldName
         );
 
-        fld += weights[i]*fieldI;
+        fld += weights[i]*fieldi;
     }
 
     return tfld;
diff --git a/src/OpenFOAM/graph/writers/jplotGraph/jplotGraph.C b/src/OpenFOAM/graph/writers/jplotGraph/jplotGraph.C
index 1352498cf5..7f9f0920ac 100644
--- a/src/OpenFOAM/graph/writers/jplotGraph/jplotGraph.C
+++ b/src/OpenFOAM/graph/writers/jplotGraph/jplotGraph.C
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011-2012 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2016 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -45,12 +45,12 @@ void Foam::jplotGraph::write(const graph& g, Ostream& os) const
     os  << "# JPlot file" << nl
         << "# column 1: " << g.xName() << endl;
 
-    label fieldI = 0;
+    label fieldi = 0;
 
     forAllConstIter(graph, g, iter)
     {
-        os  << "# column " << fieldI + 2 << ": " << (*iter()).name() << endl;
-        fieldI++;
+        os  << "# column " << fieldi + 2 << ": " << (*iter()).name() << endl;
+        fieldi++;
     }
 
     g.writeTable(os);
diff --git a/src/OpenFOAM/graph/writers/xmgrGraph/xmgrGraph.C b/src/OpenFOAM/graph/writers/xmgrGraph/xmgrGraph.C
index 806ba183a8..2081e530f9 100644
--- a/src/OpenFOAM/graph/writers/xmgrGraph/xmgrGraph.C
+++ b/src/OpenFOAM/graph/writers/xmgrGraph/xmgrGraph.C
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011-2012 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2016 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -46,20 +46,20 @@ void Foam::xmgrGraph::write(const graph& g, Ostream& os) const
         << "@xaxis label " << g.xName() << nl
         << "@yaxis label " << g.yName() << endl;
 
-    label fieldI = 0;
+    label fieldi = 0;
 
     forAllConstIter(graph, g, iter)
     {
-        os  << "@s" << fieldI << " legend "
+        os  << "@s" << fieldi << " legend "
             << iter()->name() << nl
-            << "@target G0.S" << fieldI << nl
+            << "@target G0.S" << fieldi << nl
             << "@type xy" << endl;
 
         writeXY(g.x(), *iter(), os);
 
         os << endl;
 
-        fieldI++;
+        fieldi++;
     }
 }
 
diff --git a/src/dynamicMesh/fvMeshDistribute/fvMeshDistributeTemplates.C b/src/dynamicMesh/fvMeshDistribute/fvMeshDistributeTemplates.C
index 30b43b9778..79c02c23b5 100644
--- a/src/dynamicMesh/fvMeshDistribute/fvMeshDistributeTemplates.C
+++ b/src/dynamicMesh/fvMeshDistribute/fvMeshDistributeTemplates.C
@@ -108,7 +108,7 @@ void Foam::fvMeshDistribute::mapBoundaryFields
             << abort(FatalError);
     }
 
-    label fieldI = 0;
+    label fieldi = 0;
 
     forAllIter(typename HashTable<fldType*>, flds, iter)
     {
@@ -116,7 +116,7 @@ void Foam::fvMeshDistribute::mapBoundaryFields
         typename fldType::Boundary& bfld =
             fld.boundaryFieldRef();
 
-        const FieldField<fvsPatchField, T>& oldBfld = oldBflds[fieldI++];
+        const FieldField<fvsPatchField, T>& oldBfld = oldBflds[fieldi++];
 
         // Pull from old boundary field into bfld.
 
diff --git a/src/finiteVolume/cfdTools/general/fvOptions/fvOption.C b/src/finiteVolume/cfdTools/general/fvOptions/fvOption.C
index 967ee01cea..d6ccd5c66b 100644
--- a/src/finiteVolume/cfdTools/general/fvOptions/fvOption.C
+++ b/src/finiteVolume/cfdTools/general/fvOptions/fvOption.C
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011-2015 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2016 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -126,7 +126,7 @@ void Foam::fv::option::checkApplied() const
 void Foam::fv::option::addSup
 (
     fvMatrix<scalar>& eqn,
-    const label fieldI
+    const label fieldi
 )
 {}
 
@@ -134,7 +134,7 @@ void Foam::fv::option::addSup
 void Foam::fv::option::addSup
 (
     fvMatrix<vector>& eqn,
-    const label fieldI
+    const label fieldi
 )
 {}
 
@@ -142,7 +142,7 @@ void Foam::fv::option::addSup
 void Foam::fv::option::addSup
 (
     fvMatrix<sphericalTensor>& eqn,
-    const label fieldI
+    const label fieldi
 )
 {}
 
@@ -150,7 +150,7 @@ void Foam::fv::option::addSup
 void Foam::fv::option::addSup
 (
     fvMatrix<symmTensor>& eqn,
-    const label fieldI
+    const label fieldi
 )
 {}
 
@@ -158,7 +158,7 @@ void Foam::fv::option::addSup
 void Foam::fv::option::addSup
 (
     fvMatrix<tensor>& eqn,
-    const label fieldI
+    const label fieldi
 )
 {}
 
@@ -167,7 +167,7 @@ void Foam::fv::option::addSup
 (
     const volScalarField& rho,
     fvMatrix<scalar>& eqn,
-    const label fieldI
+    const label fieldi
 )
 {}
 
@@ -176,7 +176,7 @@ void Foam::fv::option::addSup
 (
     const volScalarField& rho,
     fvMatrix<vector>& eqn,
-    const label fieldI
+    const label fieldi
 )
 {}
 
@@ -185,7 +185,7 @@ void Foam::fv::option::addSup
 (
     const volScalarField& rho,
     fvMatrix<sphericalTensor>& eqn,
-    const label fieldI
+    const label fieldi
 )
 {}
 
@@ -194,7 +194,7 @@ void Foam::fv::option::addSup
 (
     const volScalarField& rho,
     fvMatrix<symmTensor>& eqn,
-    const label fieldI
+    const label fieldi
 )
 {}
 
@@ -203,7 +203,7 @@ void Foam::fv::option::addSup
 (
     const volScalarField& rho,
     fvMatrix<tensor>& eqn,
-    const label fieldI
+    const label fieldi
 )
 {}
 
@@ -213,10 +213,10 @@ void Foam::fv::option::addSup
     const volScalarField& alpha,
     const volScalarField& rho,
     fvMatrix<scalar>& eqn,
-    const label fieldI
+    const label fieldi
 )
 {
-    addSup(alpha*rho, eqn, fieldI);
+    addSup(alpha*rho, eqn, fieldi);
 }
 
 
@@ -225,10 +225,10 @@ void Foam::fv::option::addSup
     const volScalarField& alpha,
     const volScalarField& rho,
     fvMatrix<vector>& eqn,
-    const label fieldI
+    const label fieldi
 )
 {
-    addSup(alpha*rho, eqn, fieldI);
+    addSup(alpha*rho, eqn, fieldi);
 }
 
 
@@ -237,10 +237,10 @@ void Foam::fv::option::addSup
     const volScalarField& alpha,
     const volScalarField& rho,
     fvMatrix<sphericalTensor>& eqn,
-    const label fieldI
+    const label fieldi
 )
 {
-    addSup(alpha*rho, eqn, fieldI);
+    addSup(alpha*rho, eqn, fieldi);
 }
 
 
@@ -249,10 +249,10 @@ void Foam::fv::option::addSup
     const volScalarField& alpha,
     const volScalarField& rho,
     fvMatrix<symmTensor>& eqn,
-    const label fieldI
+    const label fieldi
 )
 {
-    addSup(alpha*rho, eqn, fieldI);
+    addSup(alpha*rho, eqn, fieldi);
 }
 
 
@@ -261,25 +261,25 @@ void Foam::fv::option::addSup
     const volScalarField& alpha,
     const volScalarField& rho,
     fvMatrix<tensor>& eqn,
-    const label fieldI
+    const label fieldi
 )
 {
-    addSup(alpha*rho, eqn, fieldI);
+    addSup(alpha*rho, eqn, fieldi);
 }
 
 
-void Foam::fv::option::constrain(fvMatrix<scalar>& eqn, const label fieldI)
+void Foam::fv::option::constrain(fvMatrix<scalar>& eqn, const label fieldi)
 {}
 
 
-void Foam::fv::option::constrain(fvMatrix<vector>& eqn, const label fieldI)
+void Foam::fv::option::constrain(fvMatrix<vector>& eqn, const label fieldi)
 {}
 
 
 void Foam::fv::option::constrain
 (
     fvMatrix<sphericalTensor>& eqn,
-    const label fieldI
+    const label fieldi
 )
 {}
 
@@ -287,12 +287,12 @@ void Foam::fv::option::constrain
 void Foam::fv::option::constrain
 (
     fvMatrix<symmTensor>& eqn,
-    const label fieldI
+    const label fieldi
 )
 {}
 
 
-void Foam::fv::option::constrain(fvMatrix<tensor>& eqn, const label fieldI)
+void Foam::fv::option::constrain(fvMatrix<tensor>& eqn, const label fieldi)
 {}
 
 
diff --git a/src/finiteVolume/cfdTools/general/fvOptions/fvOption.H b/src/finiteVolume/cfdTools/general/fvOptions/fvOption.H
index 56e3612b60..4beb6d612a 100644
--- a/src/finiteVolume/cfdTools/general/fvOptions/fvOption.H
+++ b/src/finiteVolume/cfdTools/general/fvOptions/fvOption.H
@@ -201,8 +201,8 @@ public:
             //- Return const access to the source active flag
             inline bool active() const;
 
-            //- Set the applied flag to true for field index fieldI
-            inline void setApplied(const label fieldI);
+            //- Set the applied flag to true for field index fieldi
+            inline void setApplied(const label fieldi);
 
 
         // Edit
@@ -230,31 +230,31 @@ public:
                 virtual void addSup
                 (
                     fvMatrix<scalar>& eqn,
-                    const label fieldI
+                    const label fieldi
                 );
 
                 virtual void addSup
                 (
                     fvMatrix<vector>& eqn,
-                    const label fieldI
+                    const label fieldi
                 );
 
                 virtual void addSup
                 (
                     fvMatrix<symmTensor>& eqn,
-                    const label fieldI
+                    const label fieldi
                 );
 
                 virtual void addSup
                 (
                     fvMatrix<sphericalTensor>& eqn,
-                    const label fieldI
+                    const label fieldi
                 );
 
                 virtual void addSup
                 (
                     fvMatrix<tensor>& eqn,
-                    const label fieldI
+                    const label fieldi
                 );
 
 
@@ -264,35 +264,35 @@ public:
                 (
                     const volScalarField& rho,
                     fvMatrix<scalar>& eqn,
-                    const label fieldI
+                    const label fieldi
                 );
 
                 virtual void addSup
                 (
                     const volScalarField& rho,
                     fvMatrix<vector>& eqn,
-                    const label fieldI
+                    const label fieldi
                 );
 
                 virtual void addSup
                 (
                     const volScalarField& rho,
                     fvMatrix<symmTensor>& eqn,
-                    const label fieldI
+                    const label fieldi
                 );
 
                 virtual void addSup
                 (
                     const volScalarField& rho,
                     fvMatrix<sphericalTensor>& eqn,
-                    const label fieldI
+                    const label fieldi
                 );
 
                 virtual void addSup
                 (
                     const volScalarField& rho,
                     fvMatrix<tensor>& eqn,
-                    const label fieldI
+                    const label fieldi
                 );
 
 
@@ -303,7 +303,7 @@ public:
                     const volScalarField& alpha,
                     const volScalarField& rho,
                     fvMatrix<scalar>& eqn,
-                    const label fieldI
+                    const label fieldi
                 );
 
                 virtual void addSup
@@ -311,7 +311,7 @@ public:
                     const volScalarField& alpha,
                     const volScalarField& rho,
                     fvMatrix<vector>& eqn,
-                    const label fieldI
+                    const label fieldi
                 );
 
                 virtual void addSup
@@ -319,7 +319,7 @@ public:
                     const volScalarField& alpha,
                     const volScalarField& rho,
                     fvMatrix<symmTensor>& eqn,
-                    const label fieldI
+                    const label fieldi
                 );
 
                 virtual void addSup
@@ -327,7 +327,7 @@ public:
                     const volScalarField& alpha,
                     const volScalarField& rho,
                     fvMatrix<sphericalTensor>& eqn,
-                    const label fieldI
+                    const label fieldi
                 );
 
                 virtual void addSup
@@ -335,7 +335,7 @@ public:
                     const volScalarField& alpha,
                     const volScalarField& rho,
                     fvMatrix<tensor>& eqn,
-                    const label fieldI
+                    const label fieldi
                 );
 
 
@@ -344,31 +344,31 @@ public:
                 virtual void constrain
                 (
                     fvMatrix<scalar>& eqn,
-                    const label fieldI
+                    const label fieldi
                 );
 
                 virtual void constrain
                 (
                     fvMatrix<vector>& eqn,
-                    const label fieldI
+                    const label fieldi
                 );
 
                 virtual void constrain
                 (
                     fvMatrix<sphericalTensor>& eqn,
-                    const label fieldI
+                    const label fieldi
                 );
 
                 virtual void constrain
                 (
                     fvMatrix<symmTensor>& eqn,
-                    const label fieldI
+                    const label fieldi
                 );
 
                 virtual void constrain
                 (
                     fvMatrix<tensor>& eqn,
-                    const label fieldI
+                    const label fieldi
                 );
 
 
diff --git a/src/finiteVolume/cfdTools/general/fvOptions/fvOptionI.H b/src/finiteVolume/cfdTools/general/fvOptions/fvOptionI.H
index 5a1a4319d5..c188a17678 100644
--- a/src/finiteVolume/cfdTools/general/fvOptions/fvOptionI.H
+++ b/src/finiteVolume/cfdTools/general/fvOptions/fvOptionI.H
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011-2015 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2016 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -49,9 +49,9 @@ inline bool Foam::fv::option::active() const
 }
 
 
-inline void Foam::fv::option::setApplied(const label fieldI)
+inline void Foam::fv::option::setApplied(const label fieldi)
 {
-    applied_[fieldI] = true;
+    applied_[fieldi] = true;
 }
 
 
diff --git a/src/finiteVolume/cfdTools/general/fvOptions/fvOptionListTemplates.C b/src/finiteVolume/cfdTools/general/fvOptions/fvOptionListTemplates.C
index 8b9c65856c..b09af6f2c1 100644
--- a/src/finiteVolume/cfdTools/general/fvOptions/fvOptionListTemplates.C
+++ b/src/finiteVolume/cfdTools/general/fvOptions/fvOptionListTemplates.C
@@ -53,11 +53,11 @@ Foam::tmp<Foam::fvMatrix<Type>> Foam::fv::optionList::operator()
     {
         option& source = this->operator[](i);
 
-        label fieldI = source.applyToField(fieldName);
+        label fieldi = source.applyToField(fieldName);
 
-        if (fieldI != -1)
+        if (fieldi != -1)
         {
-            source.setApplied(fieldI);
+            source.setApplied(fieldi);
 
             if (source.isActive())
             {
@@ -67,7 +67,7 @@ Foam::tmp<Foam::fvMatrix<Type>> Foam::fv::optionList::operator()
                         << fieldName << endl;
                 }
 
-                source.addSup(mtx, fieldI);
+                source.addSup(mtx, fieldi);
             }
         }
     }
@@ -109,11 +109,11 @@ Foam::tmp<Foam::fvMatrix<Type>> Foam::fv::optionList::operator()
     {
         option& source = this->operator[](i);
 
-        label fieldI = source.applyToField(fieldName);
+        label fieldi = source.applyToField(fieldName);
 
-        if (fieldI != -1)
+        if (fieldi != -1)
         {
-            source.setApplied(fieldI);
+            source.setApplied(fieldi);
 
             if (source.isActive())
             {
@@ -123,7 +123,7 @@ Foam::tmp<Foam::fvMatrix<Type>> Foam::fv::optionList::operator()
                         << fieldName << endl;
                 }
 
-                source.addSup(rho, mtx, fieldI);
+                source.addSup(rho, mtx, fieldi);
             }
         }
     }
@@ -168,11 +168,11 @@ Foam::tmp<Foam::fvMatrix<Type>> Foam::fv::optionList::operator()
     {
         option& source = this->operator[](i);
 
-        label fieldI = source.applyToField(fieldName);
+        label fieldi = source.applyToField(fieldName);
 
-        if (fieldI != -1)
+        if (fieldi != -1)
         {
-            source.setApplied(fieldI);
+            source.setApplied(fieldi);
 
             if (source.isActive())
             {
@@ -182,7 +182,7 @@ Foam::tmp<Foam::fvMatrix<Type>> Foam::fv::optionList::operator()
                         << fieldName << endl;
                 }
 
-                source.addSup(alpha, rho, mtx, fieldI);
+                source.addSup(alpha, rho, mtx, fieldi);
             }
         }
     }
@@ -251,11 +251,11 @@ void Foam::fv::optionList::constrain(fvMatrix<Type>& eqn)
     {
         option& source = this->operator[](i);
 
-        label fieldI = source.applyToField(eqn.psi().name());
+        label fieldi = source.applyToField(eqn.psi().name());
 
-        if (fieldI != -1)
+        if (fieldi != -1)
         {
-            source.setApplied(fieldI);
+            source.setApplied(fieldi);
 
             if (source.isActive())
             {
@@ -265,7 +265,7 @@ void Foam::fv::optionList::constrain(fvMatrix<Type>& eqn)
                         << " to field " << eqn.psi().name() << endl;
                 }
 
-                source.constrain(eqn, fieldI);
+                source.constrain(eqn, fieldi);
             }
         }
     }
@@ -284,11 +284,11 @@ void Foam::fv::optionList::correct
     {
         option& source = this->operator[](i);
 
-        label fieldI = source.applyToField(fieldName);
+        label fieldi = source.applyToField(fieldName);
 
-        if (fieldI != -1)
+        if (fieldi != -1)
         {
-            source.setApplied(fieldI);
+            source.setApplied(fieldi);
 
             if (source.isActive())
             {
diff --git a/src/finiteVolume/cfdTools/general/solutionControl/pimpleControl/pimpleControl.C b/src/finiteVolume/cfdTools/general/solutionControl/pimpleControl/pimpleControl.C
index 7fa666071c..2622f94867 100644
--- a/src/finiteVolume/cfdTools/general/solutionControl/pimpleControl/pimpleControl.C
+++ b/src/finiteVolume/cfdTools/general/solutionControl/pimpleControl/pimpleControl.C
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011-2015 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2016 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -67,8 +67,8 @@ bool Foam::pimpleControl::criteriaSatisfied()
     forAllConstIter(dictionary, solverDict, iter)
     {
         const word& variableName = iter().keyword();
-        const label fieldI = applyToField(variableName);
-        if (fieldI != -1)
+        const label fieldi = applyToField(variableName);
+        if (fieldi != -1)
         {
             scalar residual = 0;
             const scalar firstResidual =
@@ -78,21 +78,21 @@ bool Foam::pimpleControl::criteriaSatisfied()
 
             if (storeIni)
             {
-                residualControl_[fieldI].initialResidual = firstResidual;
+                residualControl_[fieldi].initialResidual = firstResidual;
             }
 
-            const bool absCheck = residual < residualControl_[fieldI].absTol;
+            const bool absCheck = residual < residualControl_[fieldi].absTol;
             bool relCheck = false;
 
             scalar relative = 0.0;
             if (!storeIni)
             {
                 const scalar iniRes =
-                    residualControl_[fieldI].initialResidual
+                    residualControl_[fieldi].initialResidual
                   + ROOTVSMALL;
 
                 relative = residual/iniRes;
-                relCheck = relative < residualControl_[fieldI].relTol;
+                relCheck = relative < residualControl_[fieldi].relTol;
             }
 
             achieved = achieved && (absCheck || relCheck);
@@ -104,11 +104,11 @@ bool Foam::pimpleControl::criteriaSatisfied()
                 Info<< "    " << variableName
                     << " PIMPLE iter " << corr_
                     << ": ini res = "
-                    << residualControl_[fieldI].initialResidual
+                    << residualControl_[fieldi].initialResidual
                     << ", abs tol = " << residual
-                    << " (" << residualControl_[fieldI].absTol << ")"
+                    << " (" << residualControl_[fieldi].absTol << ")"
                     << ", rel tol = " << relative
-                    << " (" << residualControl_[fieldI].relTol << ")"
+                    << " (" << residualControl_[fieldi].relTol << ")"
                     << endl;
             }
         }
diff --git a/src/finiteVolume/cfdTools/general/solutionControl/simpleControl/simpleControl.C b/src/finiteVolume/cfdTools/general/solutionControl/simpleControl/simpleControl.C
index 5544497e50..1dc9938681 100644
--- a/src/finiteVolume/cfdTools/general/solutionControl/simpleControl/simpleControl.C
+++ b/src/finiteVolume/cfdTools/general/solutionControl/simpleControl/simpleControl.C
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011-2015 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2016 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -56,8 +56,8 @@ bool Foam::simpleControl::criteriaSatisfied()
     forAllConstIter(dictionary, solverDict, iter)
     {
         const word& variableName = iter().keyword();
-        const label fieldI = applyToField(variableName);
-        if (fieldI != -1)
+        const label fieldi = applyToField(variableName);
+        if (fieldi != -1)
         {
             scalar lastResidual = 0;
             const scalar residual =
@@ -65,7 +65,7 @@ bool Foam::simpleControl::criteriaSatisfied()
 
             checked = true;
 
-            bool absCheck = residual < residualControl_[fieldI].absTol;
+            bool absCheck = residual < residualControl_[fieldi].absTol;
             achieved = achieved && absCheck;
 
             if (debug)
@@ -73,7 +73,7 @@ bool Foam::simpleControl::criteriaSatisfied()
                 Info<< algorithmName_ << " solution statistics:" << endl;
 
                 Info<< "    " << variableName << ": tolerance = " << residual
-                    << " (" << residualControl_[fieldI].absTol << ")"
+                    << " (" << residualControl_[fieldi].absTol << ")"
                     << endl;
             }
         }
diff --git a/src/finiteVolume/cfdTools/general/solutionControl/solutionControl/solutionControl.C b/src/finiteVolume/cfdTools/general/solutionControl/solutionControl/solutionControl.C
index fb5a15414f..6e686a10f5 100644
--- a/src/finiteVolume/cfdTools/general/solutionControl/solutionControl/solutionControl.C
+++ b/src/finiteVolume/cfdTools/general/solutionControl/solutionControl/solutionControl.C
@@ -58,8 +58,8 @@ void Foam::solutionControl::read(const bool absTolOnly)
     forAllConstIter(dictionary, residualDict, iter)
     {
         const word& fName = iter().keyword();
-        const label fieldI = applyToField(fName, false);
-        if (fieldI == -1)
+        const label fieldi = applyToField(fName, false);
+        if (fieldi == -1)
         {
             fieldData fd;
             fd.name = fName.c_str();
@@ -92,7 +92,7 @@ void Foam::solutionControl::read(const bool absTolOnly)
         }
         else
         {
-            fieldData& fd = data[fieldI];
+            fieldData& fd = data[fieldi];
             if (absTolOnly)
             {
                 fd.absTol = readScalar(residualDict.lookup(fName));
diff --git a/src/fvOptions/constraints/derived/fixedTemperatureConstraint/fixedTemperatureConstraint.H b/src/fvOptions/constraints/derived/fixedTemperatureConstraint/fixedTemperatureConstraint.H
index f2b7029425..41e28a0cbb 100644
--- a/src/fvOptions/constraints/derived/fixedTemperatureConstraint/fixedTemperatureConstraint.H
+++ b/src/fvOptions/constraints/derived/fixedTemperatureConstraint/fixedTemperatureConstraint.H
@@ -137,7 +137,7 @@ public:
     // Member Functions
 
         //- Constrain energy equation to fix the temperature
-        virtual void constrain(fvMatrix<scalar>& eqn, const label fieldI);
+        virtual void constrain(fvMatrix<scalar>& eqn, const label fieldi);
 
 
         // IO
diff --git a/src/fvOptions/constraints/general/explicitSetValue/ExplicitSetValue.C b/src/fvOptions/constraints/general/explicitSetValue/ExplicitSetValue.C
index cf48f43fdf..271dd70cb0 100644
--- a/src/fvOptions/constraints/general/explicitSetValue/ExplicitSetValue.C
+++ b/src/fvOptions/constraints/general/explicitSetValue/ExplicitSetValue.C
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011-2015 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2016 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -72,7 +72,7 @@ template<class Type>
 void Foam::fv::ExplicitSetValue<Type>::constrain
 (
     fvMatrix<Type>& eqn,
-    const label fieldI
+    const label fieldi
 )
 {
     if (debug)
@@ -81,7 +81,7 @@ void Foam::fv::ExplicitSetValue<Type>::constrain
             << ">::constrain for source " << name_ << endl;
     }
 
-    List<Type> values(cells_.size(), injectionRate_[fieldI]);
+    List<Type> values(cells_.size(), injectionRate_[fieldi]);
 
     eqn.setValues(cells_, values);
 }
diff --git a/src/fvOptions/constraints/general/explicitSetValue/ExplicitSetValue.H b/src/fvOptions/constraints/general/explicitSetValue/ExplicitSetValue.H
index 780ff55787..5ad58ef3cf 100644
--- a/src/fvOptions/constraints/general/explicitSetValue/ExplicitSetValue.H
+++ b/src/fvOptions/constraints/general/explicitSetValue/ExplicitSetValue.H
@@ -108,7 +108,7 @@ public:
         // Evaluation
 
             //- Set value on field
-            virtual void constrain(fvMatrix<Type>& eqn, const label fieldI);
+            virtual void constrain(fvMatrix<Type>& eqn, const label fieldi);
 
 
         // IO
diff --git a/src/fvOptions/sources/derived/actuationDiskSource/actuationDiskSource.C b/src/fvOptions/sources/derived/actuationDiskSource/actuationDiskSource.C
index 9b9049e6bc..5f7f717976 100644
--- a/src/fvOptions/sources/derived/actuationDiskSource/actuationDiskSource.C
+++ b/src/fvOptions/sources/derived/actuationDiskSource/actuationDiskSource.C
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011-2015 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2016 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -112,7 +112,7 @@ Foam::fv::actuationDiskSource::actuationDiskSource
 void Foam::fv::actuationDiskSource::addSup
 (
     fvMatrix<vector>& eqn,
-    const label fieldI
+    const label fieldi
 )
 {
     const scalarField& cellsV = mesh_.V();
@@ -137,7 +137,7 @@ void Foam::fv::actuationDiskSource::addSup
 (
     const volScalarField& rho,
     fvMatrix<vector>& eqn,
-    const label fieldI
+    const label fieldi
 )
 {
     const scalarField& cellsV = mesh_.V();
diff --git a/src/fvOptions/sources/derived/actuationDiskSource/actuationDiskSource.H b/src/fvOptions/sources/derived/actuationDiskSource/actuationDiskSource.H
index c825d0fd27..ced22b540e 100644
--- a/src/fvOptions/sources/derived/actuationDiskSource/actuationDiskSource.H
+++ b/src/fvOptions/sources/derived/actuationDiskSource/actuationDiskSource.H
@@ -193,7 +193,7 @@ public:
             virtual void addSup
             (
                 fvMatrix<vector>& eqn,
-                const label fieldI
+                const label fieldi
             );
 
             //- Source term to compressible momentum equation
@@ -201,7 +201,7 @@ public:
             (
                 const volScalarField& rho,
                 fvMatrix<vector>& eqn,
-                const label fieldI
+                const label fieldi
             );
 
 
diff --git a/src/fvOptions/sources/derived/buoyancyEnergy/buoyancyEnergy.C b/src/fvOptions/sources/derived/buoyancyEnergy/buoyancyEnergy.C
index 70238da9b7..57b05575dc 100644
--- a/src/fvOptions/sources/derived/buoyancyEnergy/buoyancyEnergy.C
+++ b/src/fvOptions/sources/derived/buoyancyEnergy/buoyancyEnergy.C
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2015 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2015-2016 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -76,7 +76,7 @@ void Foam::fv::buoyancyEnergy::addSup
 (
     const volScalarField& rho,
     fvMatrix<scalar>& eqn,
-    const label fieldI
+    const label fieldi
 )
 {
     const uniformDimensionedVectorField& g =
diff --git a/src/fvOptions/sources/derived/buoyancyEnergy/buoyancyEnergy.H b/src/fvOptions/sources/derived/buoyancyEnergy/buoyancyEnergy.H
index 7c59a950ac..2dd706fde7 100644
--- a/src/fvOptions/sources/derived/buoyancyEnergy/buoyancyEnergy.H
+++ b/src/fvOptions/sources/derived/buoyancyEnergy/buoyancyEnergy.H
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2015 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2015-2016 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -105,7 +105,7 @@ public:
             (
                 const volScalarField& rho,
                 fvMatrix<scalar>& eqn,
-                const label fieldI
+                const label fieldi
             );
 
 
diff --git a/src/fvOptions/sources/derived/buoyancyForce/buoyancyForce.C b/src/fvOptions/sources/derived/buoyancyForce/buoyancyForce.C
index 63a0195e40..e513532a84 100644
--- a/src/fvOptions/sources/derived/buoyancyForce/buoyancyForce.C
+++ b/src/fvOptions/sources/derived/buoyancyForce/buoyancyForce.C
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2015 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2015-2016 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -86,7 +86,7 @@ void Foam::fv::buoyancyForce::addSup
 (
     const volScalarField& rho,
     fvMatrix<vector>& eqn,
-    const label fieldI
+    const label fieldi
 )
 {
     eqn += rho*g_;
diff --git a/src/fvOptions/sources/derived/buoyancyForce/buoyancyForce.H b/src/fvOptions/sources/derived/buoyancyForce/buoyancyForce.H
index a1ac3cc2ad..9bb75bb833 100644
--- a/src/fvOptions/sources/derived/buoyancyForce/buoyancyForce.H
+++ b/src/fvOptions/sources/derived/buoyancyForce/buoyancyForce.H
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2015 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2015-2016 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -104,7 +104,7 @@ public:
             (
                 const volScalarField& rho,
                 fvMatrix<vector>& eqn,
-                const label fieldI
+                const label fieldi
             );
 
 
diff --git a/src/fvOptions/sources/derived/effectivenessHeatExchangerSource/effectivenessHeatExchangerSource.H b/src/fvOptions/sources/derived/effectivenessHeatExchangerSource/effectivenessHeatExchangerSource.H
index a1629d9624..6d514ba08e 100644
--- a/src/fvOptions/sources/derived/effectivenessHeatExchangerSource/effectivenessHeatExchangerSource.H
+++ b/src/fvOptions/sources/derived/effectivenessHeatExchangerSource/effectivenessHeatExchangerSource.H
@@ -251,7 +251,7 @@ public:
             virtual void addSup
             (
                 fvMatrix<scalar>& eqn,
-                const label fieldI
+                const label fieldi
             )
             {
                 NotImplemented;
@@ -265,7 +265,7 @@ public:
             (
                 const volScalarField& rho,
                 fvMatrix<scalar>& eqn,
-                const label fieldI
+                const label fieldi
             );
 
 
diff --git a/src/fvOptions/sources/derived/explicitPorositySource/explicitPorositySource.C b/src/fvOptions/sources/derived/explicitPorositySource/explicitPorositySource.C
index deca3d4445..49c73adc3b 100644
--- a/src/fvOptions/sources/derived/explicitPorositySource/explicitPorositySource.C
+++ b/src/fvOptions/sources/derived/explicitPorositySource/explicitPorositySource.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
@@ -86,7 +86,7 @@ Foam::fv::explicitPorositySource::explicitPorositySource
 void Foam::fv::explicitPorositySource::addSup
 (
     fvMatrix<vector>& eqn,
-    const label fieldI
+    const label fieldi
 )
 {
     fvMatrix<vector> porosityEqn(eqn.psi(), eqn.dimensions());
@@ -99,7 +99,7 @@ void Foam::fv::explicitPorositySource::addSup
 (
     const volScalarField& rho,
     fvMatrix<vector>& eqn,
-    const label fieldI
+    const label fieldi
 )
 {
     fvMatrix<vector> porosityEqn(eqn.psi(), eqn.dimensions());
@@ -113,7 +113,7 @@ void Foam::fv::explicitPorositySource::addSup
     const volScalarField& alpha,
     const volScalarField& rho,
     fvMatrix<vector>& eqn,
-    const label fieldI
+    const label fieldi
 )
 {
     fvMatrix<vector> porosityEqn(eqn.psi(), eqn.dimensions());
diff --git a/src/fvOptions/sources/derived/explicitPorositySource/explicitPorositySource.H b/src/fvOptions/sources/derived/explicitPorositySource/explicitPorositySource.H
index 8fa468916e..8d92b69984 100644
--- a/src/fvOptions/sources/derived/explicitPorositySource/explicitPorositySource.H
+++ b/src/fvOptions/sources/derived/explicitPorositySource/explicitPorositySource.H
@@ -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
@@ -138,7 +138,7 @@ public:
             virtual void addSup
             (
                 fvMatrix<vector>& eqn,
-                const label fieldI
+                const label fieldi
             );
 
             //- Add implicit contribution to compressible momentum equation
@@ -146,7 +146,7 @@ public:
             (
                 const volScalarField& rho,
                 fvMatrix<vector>& eqn,
-                const label fieldI
+                const label fieldi
             );
 
             //- Add implicit contribution to phase momentum equation
@@ -155,7 +155,7 @@ public:
                 const volScalarField& alpha,
                 const volScalarField& rho,
                 fvMatrix<vector>& eqn,
-                const label fieldI
+                const label fieldi
             );
 
 
diff --git a/src/fvOptions/sources/derived/meanVelocityForce/meanVelocityForce.C b/src/fvOptions/sources/derived/meanVelocityForce/meanVelocityForce.C
index 64f7307438..5883fcc72c 100644
--- a/src/fvOptions/sources/derived/meanVelocityForce/meanVelocityForce.C
+++ b/src/fvOptions/sources/derived/meanVelocityForce/meanVelocityForce.C
@@ -190,14 +190,14 @@ void Foam::fv::meanVelocityForce::correct(volVectorField& U)
 void Foam::fv::meanVelocityForce::addSup
 (
     fvMatrix<vector>& eqn,
-    const label fieldI
+    const label fieldi
 )
 {
     DimensionedField<vector, volMesh> Su
     (
         IOobject
         (
-            name_ + fieldNames_[fieldI] + "Sup",
+            name_ + fieldNames_[fieldi] + "Sup",
             mesh_.time().timeName(),
             mesh_,
             IOobject::NO_READ,
@@ -219,10 +219,10 @@ void Foam::fv::meanVelocityForce::addSup
 (
     const volScalarField& rho,
     fvMatrix<vector>& eqn,
-    const label fieldI
+    const label fieldi
 )
 {
-    this->addSup(eqn, fieldI);
+    this->addSup(eqn, fieldi);
 }
 
 
diff --git a/src/fvOptions/sources/derived/meanVelocityForce/meanVelocityForce.H b/src/fvOptions/sources/derived/meanVelocityForce/meanVelocityForce.H
index 72809cfc09..4ae0aad9af 100644
--- a/src/fvOptions/sources/derived/meanVelocityForce/meanVelocityForce.H
+++ b/src/fvOptions/sources/derived/meanVelocityForce/meanVelocityForce.H
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011-2015 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2016 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -148,7 +148,7 @@ public:
             virtual void addSup
             (
                 fvMatrix<vector>& eqn,
-                const label fieldI
+                const label fieldi
             );
 
             //- Add explicit contribution to compressible momentum equation
@@ -156,14 +156,14 @@ public:
             (
                 const volScalarField& rho,
                 fvMatrix<vector>& eqn,
-                const label fieldI
+                const label fieldi
             );
 
             //- Set 1/A coefficient
             virtual void constrain
             (
                 fvMatrix<vector>& eqn,
-                const label fieldI
+                const label fieldi
             );
 
 
diff --git a/src/fvOptions/sources/derived/radialActuationDiskSource/radialActuationDiskSource.C b/src/fvOptions/sources/derived/radialActuationDiskSource/radialActuationDiskSource.C
index 39250a9ee2..e77262715c 100644
--- a/src/fvOptions/sources/derived/radialActuationDiskSource/radialActuationDiskSource.C
+++ b/src/fvOptions/sources/derived/radialActuationDiskSource/radialActuationDiskSource.C
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011-2015 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2016 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -65,7 +65,7 @@ Foam::fv::radialActuationDiskSource::radialActuationDiskSource
 void Foam::fv::radialActuationDiskSource::addSup
 (
     fvMatrix<vector>& eqn,
-    const label fieldI
+    const label fieldi
 )
 {
     const scalarField& cellsV = mesh_.V();
@@ -90,7 +90,7 @@ void Foam::fv::radialActuationDiskSource::addSup
 (
     const volScalarField& rho,
     fvMatrix<vector>& eqn,
-    const label fieldI
+    const label fieldi
 )
 {
     const scalarField& cellsV = mesh_.V();
diff --git a/src/fvOptions/sources/derived/radialActuationDiskSource/radialActuationDiskSource.H b/src/fvOptions/sources/derived/radialActuationDiskSource/radialActuationDiskSource.H
index 0df0d1347c..80c5d4bfc9 100644
--- a/src/fvOptions/sources/derived/radialActuationDiskSource/radialActuationDiskSource.H
+++ b/src/fvOptions/sources/derived/radialActuationDiskSource/radialActuationDiskSource.H
@@ -149,7 +149,7 @@ public:
         virtual void addSup
         (
             fvMatrix<vector>& eqn,
-            const label fieldI
+            const label fieldi
         );
 
         //- Source term to compressible momentum equation
@@ -157,7 +157,7 @@ public:
         (
             const volScalarField& rho,
             fvMatrix<vector>& eqn,
-            const label fieldI
+            const label fieldi
         );
 
 
diff --git a/src/fvOptions/sources/derived/rotorDiskSource/rotorDiskSource.C b/src/fvOptions/sources/derived/rotorDiskSource/rotorDiskSource.C
index 821a6cc019..840a29e70e 100644
--- a/src/fvOptions/sources/derived/rotorDiskSource/rotorDiskSource.C
+++ b/src/fvOptions/sources/derived/rotorDiskSource/rotorDiskSource.C
@@ -507,7 +507,7 @@ Foam::fv::rotorDiskSource::~rotorDiskSource()
 void Foam::fv::rotorDiskSource::addSup
 (
     fvMatrix<vector>& eqn,
-    const label fieldI
+    const label fieldi
 )
 {
     volVectorField force
@@ -548,7 +548,7 @@ void Foam::fv::rotorDiskSource::addSup
 (
     const volScalarField& rho,
     fvMatrix<vector>& eqn,
-    const label fieldI
+    const label fieldi
 )
 {
     volVectorField force
diff --git a/src/fvOptions/sources/derived/rotorDiskSource/rotorDiskSource.H b/src/fvOptions/sources/derived/rotorDiskSource/rotorDiskSource.H
index f94a463eb7..ea5d7ff806 100644
--- a/src/fvOptions/sources/derived/rotorDiskSource/rotorDiskSource.H
+++ b/src/fvOptions/sources/derived/rotorDiskSource/rotorDiskSource.H
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011-2015 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2016 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -306,7 +306,7 @@ public:
             virtual void addSup
             (
                 fvMatrix<vector>& eqn,
-                const label fieldI
+                const label fieldi
             );
 
             //- Source term to compressible momentum equation
@@ -314,7 +314,7 @@ public:
             (
                 const volScalarField& rho,
                 fvMatrix<vector>& eqn,
-                const label fieldI
+                const label fieldi
             );
 
 
diff --git a/src/fvOptions/sources/derived/solidificationMeltingSource/solidificationMeltingSource.C b/src/fvOptions/sources/derived/solidificationMeltingSource/solidificationMeltingSource.C
index 77a0f971be..654b359be1 100644
--- a/src/fvOptions/sources/derived/solidificationMeltingSource/solidificationMeltingSource.C
+++ b/src/fvOptions/sources/derived/solidificationMeltingSource/solidificationMeltingSource.C
@@ -252,7 +252,7 @@ Foam::fv::solidificationMeltingSource::solidificationMeltingSource
 void Foam::fv::solidificationMeltingSource::addSup
 (
     fvMatrix<scalar>& eqn,
-    const label fieldI
+    const label fieldi
 )
 {
     apply(geometricOneField(), eqn);
@@ -263,7 +263,7 @@ void Foam::fv::solidificationMeltingSource::addSup
 (
     const volScalarField& rho,
     fvMatrix<scalar>& eqn,
-    const label fieldI
+    const label fieldi
 )
 {
     apply(rho, eqn);
@@ -273,7 +273,7 @@ void Foam::fv::solidificationMeltingSource::addSup
 void Foam::fv::solidificationMeltingSource::addSup
 (
     fvMatrix<vector>& eqn,
-    const label fieldI
+    const label fieldi
 )
 {
     if (debug)
@@ -311,11 +311,11 @@ void Foam::fv::solidificationMeltingSource::addSup
 (
     const volScalarField& rho,
     fvMatrix<vector>& eqn,
-    const label fieldI
+    const label fieldi
 )
 {
     // Momentum source uses a Boussinesq approximation - redirect
-    addSup(eqn, fieldI);
+    addSup(eqn, fieldi);
 }
 
 
diff --git a/src/fvOptions/sources/derived/solidificationMeltingSource/solidificationMeltingSource.H b/src/fvOptions/sources/derived/solidificationMeltingSource/solidificationMeltingSource.H
index 552c3d8531..1987ac991e 100644
--- a/src/fvOptions/sources/derived/solidificationMeltingSource/solidificationMeltingSource.H
+++ b/src/fvOptions/sources/derived/solidificationMeltingSource/solidificationMeltingSource.H
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2014-2015 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2014-2016 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -221,10 +221,10 @@ public:
         // Add explicit and implicit contributions
 
             //- Add explicit contribution to enthalpy equation
-            virtual void addSup(fvMatrix<scalar>& eqn, const label fieldI);
+            virtual void addSup(fvMatrix<scalar>& eqn, const label fieldi);
 
             //- Add implicit contribution to momentum equation
-            virtual void addSup(fvMatrix<vector>& eqn, const label fieldI);
+            virtual void addSup(fvMatrix<vector>& eqn, const label fieldi);
 
 
         // Add explicit and implicit contributions to compressible equation
@@ -234,7 +234,7 @@ public:
             (
                 const volScalarField& rho,
                 fvMatrix<scalar>& eqn,
-                const label fieldI
+                const label fieldi
             );
 
             //- Add implicit contribution to compressible momentum equation
@@ -242,7 +242,7 @@ public:
             (
                 const volScalarField& rho,
                 fvMatrix<vector>& eqn,
-                const label fieldI
+                const label fieldi
             );
 
 
diff --git a/src/fvOptions/sources/general/codedSource/CodedSource.C b/src/fvOptions/sources/general/codedSource/CodedSource.C
index c657bf55fa..b605061495 100644
--- a/src/fvOptions/sources/general/codedSource/CodedSource.C
+++ b/src/fvOptions/sources/general/codedSource/CodedSource.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
@@ -166,7 +166,7 @@ template<class Type>
 void Foam::fv::CodedSource<Type>::addSup
 (
     fvMatrix<Type>& eqn,
-    const label fieldI
+    const label fieldi
 )
 {
     if (debug)
@@ -176,7 +176,7 @@ void Foam::fv::CodedSource<Type>::addSup
     }
 
     updateLibrary(redirectType_);
-    redirectFvOption().addSup(eqn, fieldI);
+    redirectFvOption().addSup(eqn, fieldi);
 }
 
 
@@ -185,7 +185,7 @@ void Foam::fv::CodedSource<Type>::addSup
 (
     const volScalarField& rho,
     fvMatrix<Type>& eqn,
-    const label fieldI
+    const label fieldi
 )
 {
     if (debug)
@@ -195,7 +195,7 @@ void Foam::fv::CodedSource<Type>::addSup
     }
 
     updateLibrary(redirectType_);
-    redirectFvOption().addSup(rho, eqn, fieldI);
+    redirectFvOption().addSup(rho, eqn, fieldi);
 }
 
 
@@ -203,7 +203,7 @@ template<class Type>
 void Foam::fv::CodedSource<Type>::constrain
 (
     fvMatrix<Type>& eqn,
-    const label fieldI
+    const label fieldi
 )
 {
     if (debug)
@@ -213,7 +213,7 @@ void Foam::fv::CodedSource<Type>::constrain
     }
 
     updateLibrary(redirectType_);
-    redirectFvOption().constrain(eqn, fieldI);
+    redirectFvOption().constrain(eqn, fieldi);
 }
 
 
diff --git a/src/fvOptions/sources/general/codedSource/CodedSource.H b/src/fvOptions/sources/general/codedSource/CodedSource.H
index 6961faffbd..ef2b130f62 100644
--- a/src/fvOptions/sources/general/codedSource/CodedSource.H
+++ b/src/fvOptions/sources/general/codedSource/CodedSource.H
@@ -37,13 +37,13 @@ Description
     codeAddSup
     (
         fvMatrix<Type}>& eqn,
-        const label fieldI
+        const label fieldi
     )
 
     constrain
     (
         fvMatrix<Type}>& eqn,
-        const label fieldI
+        const label fieldi
     )
 
     where :
@@ -204,7 +204,7 @@ public:
             virtual void addSup
             (
                 fvMatrix<Type>& eqn,
-                const label fieldI
+                const label fieldi
             );
 
             //- Explicit and implicit matrix contributions
@@ -213,14 +213,14 @@ public:
             (
                 const volScalarField& rho,
                 fvMatrix<Type>& eqn,
-                const label fieldI
+                const label fieldi
             );
 
             //- Set value
             virtual void constrain
             (
                 fvMatrix<Type>& eqn,
-                const label fieldI
+                const label fieldi
             );
 
 
diff --git a/src/fvOptions/sources/general/semiImplicitSource/SemiImplicitSource.C b/src/fvOptions/sources/general/semiImplicitSource/SemiImplicitSource.C
index 459ded8cd9..bdcf3e1758 100644
--- a/src/fvOptions/sources/general/semiImplicitSource/SemiImplicitSource.C
+++ b/src/fvOptions/sources/general/semiImplicitSource/SemiImplicitSource.C
@@ -131,7 +131,7 @@ template<class Type>
 void Foam::fv::SemiImplicitSource<Type>::addSup
 (
     fvMatrix<Type>& eqn,
-    const label fieldI
+    const label fieldi
 )
 {
     if (debug)
@@ -146,7 +146,7 @@ void Foam::fv::SemiImplicitSource<Type>::addSup
     (
         IOobject
         (
-            name_ + fieldNames_[fieldI] + "Su",
+            name_ + fieldNames_[fieldi] + "Su",
             mesh_.time().timeName(),
             mesh_,
             IOobject::NO_READ,
@@ -162,13 +162,13 @@ void Foam::fv::SemiImplicitSource<Type>::addSup
         false
     );
 
-    UIndirectList<Type>(Su, cells_) = injectionRate_[fieldI].first()/VDash_;
+    UIndirectList<Type>(Su, cells_) = injectionRate_[fieldi].first()/VDash_;
 
     DimensionedField<scalar, volMesh> Sp
     (
         IOobject
         (
-            name_ + fieldNames_[fieldI] + "Sp",
+            name_ + fieldNames_[fieldi] + "Sp",
             mesh_.time().timeName(),
             mesh_,
             IOobject::NO_READ,
@@ -184,7 +184,7 @@ void Foam::fv::SemiImplicitSource<Type>::addSup
         false
     );
 
-    UIndirectList<scalar>(Sp, cells_) = injectionRate_[fieldI].second()/VDash_;
+    UIndirectList<scalar>(Sp, cells_) = injectionRate_[fieldi].second()/VDash_;
 
     eqn += Su + fvm::SuSp(Sp, psi);
 }
@@ -195,7 +195,7 @@ void Foam::fv::SemiImplicitSource<Type>::addSup
 (
     const volScalarField& rho,
     fvMatrix<Type>& eqn,
-    const label fieldI
+    const label fieldi
 )
 {
     if (debug)
@@ -204,7 +204,7 @@ void Foam::fv::SemiImplicitSource<Type>::addSup
             << ">::addSup for source " << name_ << endl;
     }
 
-    return this->addSup(eqn, fieldI);
+    return this->addSup(eqn, fieldi);
 }
 
 
diff --git a/src/fvOptions/sources/general/semiImplicitSource/SemiImplicitSource.H b/src/fvOptions/sources/general/semiImplicitSource/SemiImplicitSource.H
index 9a61f1b94a..7255dcad99 100644
--- a/src/fvOptions/sources/general/semiImplicitSource/SemiImplicitSource.H
+++ b/src/fvOptions/sources/general/semiImplicitSource/SemiImplicitSource.H
@@ -188,7 +188,7 @@ public:
             virtual void addSup
             (
                 fvMatrix<Type>& eqn,
-                const label fieldI
+                const label fieldi
             );
 
             //- Add explicit contribution to compressible equation
@@ -196,7 +196,7 @@ public:
             (
                 const volScalarField& rho,
                 fvMatrix<Type>& eqn,
-                const label fieldI
+                const label fieldi
             );
 
 
diff --git a/src/fvOptions/sources/interRegion/interRegionExplicitPorositySource/interRegionExplicitPorositySource.C b/src/fvOptions/sources/interRegion/interRegionExplicitPorositySource/interRegionExplicitPorositySource.C
index 98a6bcb9e0..b88ba38f49 100644
--- a/src/fvOptions/sources/interRegion/interRegionExplicitPorositySource/interRegionExplicitPorositySource.C
+++ b/src/fvOptions/sources/interRegion/interRegionExplicitPorositySource/interRegionExplicitPorositySource.C
@@ -134,7 +134,7 @@ Foam::fv::interRegionExplicitPorositySource::interRegionExplicitPorositySource
 void Foam::fv::interRegionExplicitPorositySource::addSup
 (
     fvMatrix<vector>& eqn,
-    const label fieldI
+    const label fieldi
 )
 {
     initialise();
@@ -188,7 +188,7 @@ void Foam::fv::interRegionExplicitPorositySource::addSup
 (
     const volScalarField& rho,
     fvMatrix<vector>& eqn,
-    const label fieldI
+    const label fieldi
 )
 {
     initialise();
diff --git a/src/fvOptions/sources/interRegion/interRegionExplicitPorositySource/interRegionExplicitPorositySource.H b/src/fvOptions/sources/interRegion/interRegionExplicitPorositySource/interRegionExplicitPorositySource.H
index 93f50a3930..84af20aec4 100644
--- a/src/fvOptions/sources/interRegion/interRegionExplicitPorositySource/interRegionExplicitPorositySource.H
+++ b/src/fvOptions/sources/interRegion/interRegionExplicitPorositySource/interRegionExplicitPorositySource.H
@@ -149,7 +149,7 @@ public:
             virtual void addSup
             (
                 fvMatrix<vector>& eqn,
-                const label fieldI
+                const label fieldi
             );
 
 
@@ -160,7 +160,7 @@ public:
             (
                 const volScalarField& rho,
                 fvMatrix<vector>& eqn,
-                const label fieldI
+                const label fieldi
             );
 
 
diff --git a/src/fvOptions/sources/interRegion/interRegionHeatTransfer/interRegionHeatTransferModel/interRegionHeatTransferModel.C b/src/fvOptions/sources/interRegion/interRegionHeatTransfer/interRegionHeatTransferModel/interRegionHeatTransferModel.C
index c838f42e20..cb29866afd 100644
--- a/src/fvOptions/sources/interRegion/interRegionHeatTransfer/interRegionHeatTransferModel/interRegionHeatTransferModel.C
+++ b/src/fvOptions/sources/interRegion/interRegionHeatTransfer/interRegionHeatTransferModel/interRegionHeatTransferModel.C
@@ -167,7 +167,7 @@ Foam::fv::interRegionHeatTransferModel::~interRegionHeatTransferModel()
 void Foam::fv::interRegionHeatTransferModel::addSup
 (
     fvMatrix<scalar>& eqn,
-    const label fieldI
+    const label fieldi
 )
 {
     setNbrModel();
@@ -265,10 +265,10 @@ void Foam::fv::interRegionHeatTransferModel::addSup
 (
     const volScalarField& rho,
     fvMatrix<scalar>& eqn,
-    const label fieldI
+    const label fieldi
 )
 {
-    addSup(eqn, fieldI);
+    addSup(eqn, fieldi);
 }
 
 
diff --git a/src/fvOptions/sources/interRegion/interRegionHeatTransfer/interRegionHeatTransferModel/interRegionHeatTransferModel.H b/src/fvOptions/sources/interRegion/interRegionHeatTransfer/interRegionHeatTransferModel/interRegionHeatTransferModel.H
index c5810cc321..6d69df2e18 100644
--- a/src/fvOptions/sources/interRegion/interRegionHeatTransfer/interRegionHeatTransferModel/interRegionHeatTransferModel.H
+++ b/src/fvOptions/sources/interRegion/interRegionHeatTransfer/interRegionHeatTransferModel/interRegionHeatTransferModel.H
@@ -174,7 +174,7 @@ public:
             virtual void addSup
             (
                 fvMatrix<scalar>& eqn,
-                const label fieldI
+                const label fieldi
             );
 
             //- Source term to compressible energy equation
@@ -182,7 +182,7 @@ public:
             (
                 const volScalarField& rho,
                 fvMatrix<scalar>& eqn,
-                const label fieldI
+                const label fieldi
             );
 
             //- Calculate heat transfer coefficient
diff --git a/src/lagrangian/intermediate/clouds/Templates/ReactingCloud/ReactingCloud.C b/src/lagrangian/intermediate/clouds/Templates/ReactingCloud/ReactingCloud.C
index 15dfe5f6f3..4d042fb2a6 100644
--- a/src/lagrangian/intermediate/clouds/Templates/ReactingCloud/ReactingCloud.C
+++ b/src/lagrangian/intermediate/clouds/Templates/ReactingCloud/ReactingCloud.C
@@ -292,10 +292,10 @@ void Foam::ReactingCloud<CloudType>::relaxSources
 
     typedef DimensionedField<scalar, volMesh> dsfType;
 
-    forAll(rhoTrans_, fieldI)
+    forAll(rhoTrans_, fieldi)
     {
-        dsfType& rhoT = rhoTrans_[fieldI];
-        const dsfType& rhoT0 = cloudOldTime.rhoTrans()[fieldI];
+        dsfType& rhoT = rhoTrans_[fieldi];
+        const dsfType& rhoT0 = cloudOldTime.rhoTrans()[fieldi];
         this->relax(rhoT, rhoT0, "rho");
     }
 }
@@ -308,9 +308,9 @@ void Foam::ReactingCloud<CloudType>::scaleSources()
 
     typedef DimensionedField<scalar, volMesh> dsfType;
 
-    forAll(rhoTrans_, fieldI)
+    forAll(rhoTrans_, fieldi)
     {
-        dsfType& rhoT = rhoTrans_[fieldI];
+        dsfType& rhoT = rhoTrans_[fieldi];
         this->scale(rhoT, "rho");
     }
 }
diff --git a/src/parallel/decompose/decompose/fvFieldDecomposerDecomposeFields.C b/src/parallel/decompose/decompose/fvFieldDecomposerDecomposeFields.C
index e00abe07b2..a5e87d2097 100644
--- a/src/parallel/decompose/decompose/fvFieldDecomposerDecomposeFields.C
+++ b/src/parallel/decompose/decompose/fvFieldDecomposerDecomposeFields.C
@@ -323,9 +323,9 @@ void Foam::fvFieldDecomposer::decomposeFields
     const PtrList<GeoField>& fields
 ) const
 {
-    forAll(fields, fieldI)
+    forAll(fields, fieldi)
     {
-        decomposeField(fields[fieldI])().write();
+        decomposeField(fields[fieldi])().write();
     }
 }
 
diff --git a/src/postProcessing/functionObjects/field/fieldAverage/fieldAverage/fieldAverage.C b/src/postProcessing/functionObjects/field/fieldAverage/fieldAverage/fieldAverage.C
index 0efc524823..d6829f16c9 100644
--- a/src/postProcessing/functionObjects/field/fieldAverage/fieldAverage/fieldAverage.C
+++ b/src/postProcessing/functionObjects/field/fieldAverage/fieldAverage/fieldAverage.C
@@ -71,20 +71,20 @@ void Foam::functionObjects::fieldAverage::initialize()
     Info<< type() << " " << name_ << ":" << nl;
 
     // Add mean fields to the field lists
-    forAll(faItems_, fieldI)
+    forAll(faItems_, fieldi)
     {
-        addMeanField<scalar>(fieldI);
-        addMeanField<vector>(fieldI);
-        addMeanField<sphericalTensor>(fieldI);
-        addMeanField<symmTensor>(fieldI);
-        addMeanField<tensor>(fieldI);
+        addMeanField<scalar>(fieldi);
+        addMeanField<vector>(fieldi);
+        addMeanField<sphericalTensor>(fieldi);
+        addMeanField<symmTensor>(fieldi);
+        addMeanField<tensor>(fieldi);
     }
 
     // Add prime-squared mean fields to the field lists
-    forAll(faItems_, fieldI)
+    forAll(faItems_, fieldi)
     {
-        addPrime2MeanField<scalar, scalar>(fieldI);
-        addPrime2MeanField<vector, symmTensor>(fieldI);
+        addPrime2MeanField<scalar, scalar>(fieldi);
+        addPrime2MeanField<vector, symmTensor>(fieldi);
     }
 
     // ensure first averaging works unconditionally
@@ -152,10 +152,10 @@ void Foam::functionObjects::fieldAverage::calcAverages()
     calculatePrime2MeanFields<scalar, scalar>();
     calculatePrime2MeanFields<vector, symmTensor>();
 
-    forAll(faItems_, fieldI)
+    forAll(faItems_, fieldi)
     {
-        totalIter_[fieldI]++;
-        totalTime_[fieldI] += obr_.time().deltaTValue();
+        totalIter_[fieldi]++;
+        totalTime_[fieldi] += obr_.time().deltaTValue();
     }
 }
 
@@ -188,12 +188,12 @@ void Foam::functionObjects::fieldAverage::writeAveragingProperties() const
         )
     );
 
-    forAll(faItems_, fieldI)
+    forAll(faItems_, fieldi)
     {
-        const word& fieldName = faItems_[fieldI].fieldName();
+        const word& fieldName = faItems_[fieldi].fieldName();
         propsDict.add(fieldName, dictionary());
-        propsDict.subDict(fieldName).add("totalIter", totalIter_[fieldI]);
-        propsDict.subDict(fieldName).add("totalTime", totalTime_[fieldI]);
+        propsDict.subDict(fieldName).add("totalIter", totalIter_[fieldi]);
+        propsDict.subDict(fieldName).add("totalTime", totalTime_[fieldi]);
     }
 
     propsDict.regIOobject::write();
@@ -236,18 +236,18 @@ void Foam::functionObjects::fieldAverage::readAveragingProperties()
         IOdictionary propsDict(propsDictHeader);
 
         Info<< "    Restarting averaging for fields:" << nl;
-        forAll(faItems_, fieldI)
+        forAll(faItems_, fieldi)
         {
-            const word& fieldName = faItems_[fieldI].fieldName();
+            const word& fieldName = faItems_[fieldi].fieldName();
             if (propsDict.found(fieldName))
             {
                 dictionary fieldDict(propsDict.subDict(fieldName));
 
-                totalIter_[fieldI] = readLabel(fieldDict.lookup("totalIter"));
-                totalTime_[fieldI] = readScalar(fieldDict.lookup("totalTime"));
+                totalIter_[fieldi] = readLabel(fieldDict.lookup("totalIter"));
+                totalTime_[fieldi] = readScalar(fieldDict.lookup("totalTime"));
                 Info<< "        " << fieldName
-                    << " iters = " << totalIter_[fieldI]
-                    << " time = " << totalTime_[fieldI] << nl;
+                    << " iters = " << totalIter_[fieldi]
+                    << " time = " << totalTime_[fieldi] << nl;
             }
         }
     }
diff --git a/src/postProcessing/functionObjects/field/fieldAverage/fieldAverage/fieldAverage.H b/src/postProcessing/functionObjects/field/fieldAverage/fieldAverage/fieldAverage.H
index ec0403c533..34e03e462c 100644
--- a/src/postProcessing/functionObjects/field/fieldAverage/fieldAverage/fieldAverage.H
+++ b/src/postProcessing/functionObjects/field/fieldAverage/fieldAverage/fieldAverage.H
@@ -211,19 +211,19 @@ protected:
 
             //- Add mean average field to database
             template<class Type>
-            void addMeanFieldType(const label fieldI);
+            void addMeanFieldType(const label fieldi);
 
             //- Add mean average field to database
             template<class Type>
-            void addMeanField(const label fieldI);
+            void addMeanField(const label fieldi);
 
             //- Add prime-squared average field to database
             template<class Type1, class Type2>
-            void addPrime2MeanFieldType(const label fieldI);
+            void addPrime2MeanFieldType(const label fieldi);
 
             //- Add prime-squared average field to database
             template<class Type1, class Type2>
-            void addPrime2MeanField(const label fieldI);
+            void addPrime2MeanField(const label fieldi);
 
 
         // Calculation functions
@@ -233,7 +233,7 @@ protected:
 
             //- Calculate mean average fields
             template<class Type>
-            void calculateMeanFieldType(const label fieldI) const;
+            void calculateMeanFieldType(const label fieldi) const;
 
             //- Calculate mean average fields
             template<class Type>
@@ -241,7 +241,7 @@ protected:
 
             //- Calculate prime-squared average fields
             template<class Type1, class Type2>
-            void calculatePrime2MeanFieldType(const label fieldI) const;
+            void calculatePrime2MeanFieldType(const label fieldi) const;
 
             //- Calculate prime-squared average fields
             template<class Type1, class Type2>
@@ -249,7 +249,7 @@ protected:
 
             //- Add mean-squared field value to prime-squared mean field
             template<class Type1, class Type2>
-            void addMeanSqrToPrime2MeanType(const label fieldI) const;
+            void addMeanSqrToPrime2MeanType(const label fieldi) const;
 
             //- Add mean-squared field value to prime-squared mean field
             template<class Type1, class Type2>
diff --git a/src/postProcessing/functionObjects/field/fieldAverage/fieldAverage/fieldAverageTemplates.C b/src/postProcessing/functionObjects/field/fieldAverage/fieldAverage/fieldAverageTemplates.C
index 3995e81e83..0715b54493 100644
--- a/src/postProcessing/functionObjects/field/fieldAverage/fieldAverage/fieldAverageTemplates.C
+++ b/src/postProcessing/functionObjects/field/fieldAverage/fieldAverage/fieldAverageTemplates.C
@@ -31,10 +31,10 @@ License
 // * * * * * * * * * * * * * Private Member Functions  * * * * * * * * * * * //
 
 template<class Type>
-void Foam::functionObjects::fieldAverage::addMeanFieldType(const label fieldI)
+void Foam::functionObjects::fieldAverage::addMeanFieldType(const label fieldi)
 {
-    const word& fieldName = faItems_[fieldI].fieldName();
-    const word& meanFieldName = faItems_[fieldI].meanFieldName();
+    const word& fieldName = faItems_[fieldi].fieldName();
+    const word& meanFieldName = faItems_[fieldi].meanFieldName();
 
     Info<< "    Reading/initialising field " << meanFieldName << endl;
 
@@ -48,7 +48,7 @@ void Foam::functionObjects::fieldAverage::addMeanFieldType(const label fieldI)
             << " since an object with that name already exists."
             << " Disabling averaging for field." << endl;
 
-        faItems_[fieldI].mean() = false;
+        faItems_[fieldi].mean() = false;
     }
     else
     {
@@ -77,22 +77,22 @@ void Foam::functionObjects::fieldAverage::addMeanFieldType(const label fieldI)
 
 
 template<class Type>
-void Foam::functionObjects::fieldAverage::addMeanField(const label fieldI)
+void Foam::functionObjects::fieldAverage::addMeanField(const label fieldi)
 {
-    if (faItems_[fieldI].mean())
+    if (faItems_[fieldi].mean())
     {
         typedef GeometricField<Type, fvPatchField, volMesh> volFieldType;
         typedef GeometricField<Type, fvsPatchField, surfaceMesh> surfFieldType;
 
-        const word& fieldName = faItems_[fieldI].fieldName();
+        const word& fieldName = faItems_[fieldi].fieldName();
 
         if (obr_.foundObject<volFieldType>(fieldName))
         {
-            addMeanFieldType<volFieldType>(fieldI);
+            addMeanFieldType<volFieldType>(fieldi);
         }
         else if (obr_.foundObject<surfFieldType>(fieldName))
         {
-            addMeanFieldType<surfFieldType>(fieldI);
+            addMeanFieldType<surfFieldType>(fieldi);
         }
     }
 }
@@ -101,12 +101,12 @@ void Foam::functionObjects::fieldAverage::addMeanField(const label fieldI)
 template<class Type1, class Type2>
 void Foam::functionObjects::fieldAverage::addPrime2MeanFieldType
 (
-    const label fieldI
+    const label fieldi
 )
 {
-    const word& fieldName = faItems_[fieldI].fieldName();
-    const word& meanFieldName = faItems_[fieldI].meanFieldName();
-    const word& prime2MeanFieldName = faItems_[fieldI].prime2MeanFieldName();
+    const word& fieldName = faItems_[fieldi].fieldName();
+    const word& meanFieldName = faItems_[fieldi].meanFieldName();
+    const word& prime2MeanFieldName = faItems_[fieldi].prime2MeanFieldName();
 
     Info<< "    Reading/initialising field " << prime2MeanFieldName << nl;
 
@@ -120,7 +120,7 @@ void Foam::functionObjects::fieldAverage::addPrime2MeanFieldType
             << " since an object with that name already exists."
             << " Disabling averaging for field." << nl;
 
-        faItems_[fieldI].prime2Mean() = false;
+        faItems_[fieldi].prime2Mean() = false;
     }
     else
     {
@@ -150,7 +150,7 @@ void Foam::functionObjects::fieldAverage::addPrime2MeanFieldType
 
 
 template<class Type1, class Type2>
-void Foam::functionObjects::fieldAverage::addPrime2MeanField(const label fieldI)
+void Foam::functionObjects::fieldAverage::addPrime2MeanField(const label fieldi)
 {
     typedef GeometricField<Type1, fvPatchField, volMesh> volFieldType1;
     typedef GeometricField<Type1, fvsPatchField, surfaceMesh> surfFieldType1;
@@ -158,11 +158,11 @@ void Foam::functionObjects::fieldAverage::addPrime2MeanField(const label fieldI)
     typedef GeometricField<Type2, fvPatchField, volMesh> volFieldType2;
     typedef GeometricField<Type2, fvsPatchField, surfaceMesh> surfFieldType2;
 
-    if (faItems_[fieldI].prime2Mean())
+    if (faItems_[fieldi].prime2Mean())
     {
-        const word& fieldName = faItems_[fieldI].fieldName();
+        const word& fieldName = faItems_[fieldi].fieldName();
 
-        if (!faItems_[fieldI].mean())
+        if (!faItems_[fieldi].mean())
         {
             FatalErrorInFunction
                 << "To calculate the prime-squared average, the "
@@ -172,11 +172,11 @@ void Foam::functionObjects::fieldAverage::addPrime2MeanField(const label fieldI)
 
         if (obr_.foundObject<volFieldType1>(fieldName))
         {
-            addPrime2MeanFieldType<volFieldType1, volFieldType2>(fieldI);
+            addPrime2MeanFieldType<volFieldType1, volFieldType2>(fieldi);
         }
         else if (obr_.foundObject<surfFieldType1>(fieldName))
         {
-            addPrime2MeanFieldType<surfFieldType1, surfFieldType2>(fieldI);
+            addPrime2MeanFieldType<surfFieldType1, surfFieldType2>(fieldi);
         }
     }
 }
@@ -185,10 +185,10 @@ void Foam::functionObjects::fieldAverage::addPrime2MeanField(const label fieldI)
 template<class Type>
 void Foam::functionObjects::fieldAverage::calculateMeanFieldType
 (
-    const label fieldI
+    const label fieldi
 ) const
 {
-    const word& fieldName = faItems_[fieldI].fieldName();
+    const word& fieldName = faItems_[fieldi].fieldName();
 
     if (obr_.foundObject<Type>(fieldName))
     {
@@ -196,24 +196,24 @@ void Foam::functionObjects::fieldAverage::calculateMeanFieldType
 
         Type& meanField = const_cast<Type&>
         (
-            obr_.lookupObject<Type>(faItems_[fieldI].meanFieldName())
+            obr_.lookupObject<Type>(faItems_[fieldi].meanFieldName())
         );
 
         scalar dt = obr_.time().deltaTValue();
-        scalar Dt = totalTime_[fieldI];
+        scalar Dt = totalTime_[fieldi];
 
-        if (faItems_[fieldI].iterBase())
+        if (faItems_[fieldi].iterBase())
         {
             dt = 1.0;
-            Dt = scalar(totalIter_[fieldI]);
+            Dt = scalar(totalIter_[fieldi]);
         }
 
         scalar alpha = (Dt - dt)/Dt;
         scalar beta = dt/Dt;
 
-        if (faItems_[fieldI].window() > 0)
+        if (faItems_[fieldi].window() > 0)
         {
-            const scalar w = faItems_[fieldI].window();
+            const scalar w = faItems_[fieldi].window();
 
             if (Dt - dt >= w)
             {
@@ -247,37 +247,37 @@ void Foam::functionObjects::fieldAverage::calculateMeanFields() const
 template<class Type1, class Type2>
 void Foam::functionObjects::fieldAverage::calculatePrime2MeanFieldType
 (
-    const label fieldI
+    const label fieldi
 ) const
 {
-    const word& fieldName = faItems_[fieldI].fieldName();
+    const word& fieldName = faItems_[fieldi].fieldName();
 
     if (obr_.foundObject<Type1>(fieldName))
     {
         const Type1& baseField = obr_.lookupObject<Type1>(fieldName);
         const Type1& meanField =
-            obr_.lookupObject<Type1>(faItems_[fieldI].meanFieldName());
+            obr_.lookupObject<Type1>(faItems_[fieldi].meanFieldName());
 
         Type2& prime2MeanField = const_cast<Type2&>
         (
-            obr_.lookupObject<Type2>(faItems_[fieldI].prime2MeanFieldName())
+            obr_.lookupObject<Type2>(faItems_[fieldi].prime2MeanFieldName())
         );
 
         scalar dt = obr_.time().deltaTValue();
-        scalar Dt = totalTime_[fieldI];
+        scalar Dt = totalTime_[fieldi];
 
-        if (faItems_[fieldI].iterBase())
+        if (faItems_[fieldi].iterBase())
         {
             dt = 1.0;
-            Dt = scalar(totalIter_[fieldI]);
+            Dt = scalar(totalIter_[fieldi]);
         }
 
         scalar alpha = (Dt - dt)/Dt;
         scalar beta = dt/Dt;
 
-        if (faItems_[fieldI].window() > 0)
+        if (faItems_[fieldi].window() > 0)
         {
-            const scalar w = faItems_[fieldI].window();
+            const scalar w = faItems_[fieldi].window();
 
             if (Dt - dt >= w)
             {
@@ -317,19 +317,19 @@ void Foam::functionObjects::fieldAverage::calculatePrime2MeanFields() const
 template<class Type1, class Type2>
 void Foam::functionObjects::fieldAverage::addMeanSqrToPrime2MeanType
 (
-    const label fieldI
+    const label fieldi
 ) const
 {
-    const word& fieldName = faItems_[fieldI].fieldName();
+    const word& fieldName = faItems_[fieldi].fieldName();
 
     if (obr_.foundObject<Type1>(fieldName))
     {
         const Type1& meanField =
-            obr_.lookupObject<Type1>(faItems_[fieldI].meanFieldName());
+            obr_.lookupObject<Type1>(faItems_[fieldi].meanFieldName());
 
         Type2& prime2MeanField = const_cast<Type2&>
         (
-            obr_.lookupObject<Type2>(faItems_[fieldI].prime2MeanFieldName())
+            obr_.lookupObject<Type2>(faItems_[fieldi].prime2MeanFieldName())
         );
 
         prime2MeanField += sqr(meanField);
diff --git a/src/postProcessing/functionObjects/field/fieldCoordinateSystemTransform/fieldCoordinateSystemTransform.C b/src/postProcessing/functionObjects/field/fieldCoordinateSystemTransform/fieldCoordinateSystemTransform.C
index 3198b91cc6..97a366a517 100644
--- a/src/postProcessing/functionObjects/field/fieldCoordinateSystemTransform/fieldCoordinateSystemTransform.C
+++ b/src/postProcessing/functionObjects/field/fieldCoordinateSystemTransform/fieldCoordinateSystemTransform.C
@@ -96,14 +96,14 @@ void Foam::functionObjects::fieldCoordinateSystemTransform::execute()
 {
     Info<< type() << " " << name_ << " output:" << nl;
 
-    forAll(fieldSet_, fieldI)
+    forAll(fieldSet_, fieldi)
     {
         // If necessary load field
-        transform<scalar>(fieldSet_[fieldI]);
-        transform<vector>(fieldSet_[fieldI]);
-        transform<sphericalTensor>(fieldSet_[fieldI]);
-        transform<symmTensor>(fieldSet_[fieldI]);
-        transform<tensor>(fieldSet_[fieldI]);
+        transform<scalar>(fieldSet_[fieldi]);
+        transform<vector>(fieldSet_[fieldi]);
+        transform<sphericalTensor>(fieldSet_[fieldi]);
+        transform<symmTensor>(fieldSet_[fieldi]);
+        transform<tensor>(fieldSet_[fieldi]);
     }
 }
 
@@ -122,9 +122,9 @@ void Foam::functionObjects::fieldCoordinateSystemTransform::write()
 {
     Info<< type() << " " << name_ << " output:" << nl;
 
-    forAll(fieldSet_, fieldI)
+    forAll(fieldSet_, fieldi)
     {
-        const word fieldName = fieldSet_[fieldI] + ":Transformed";
+        const word fieldName = fieldSet_[fieldi] + ":Transformed";
 
         const regIOobject& field =
             obr_.lookupObject<regIOobject>(fieldName);
diff --git a/src/postProcessing/functionObjects/field/fieldMinMax/fieldMinMax.C b/src/postProcessing/functionObjects/field/fieldMinMax/fieldMinMax.C
index 7b29a3cb20..ad80d03c31 100644
--- a/src/postProcessing/functionObjects/field/fieldMinMax/fieldMinMax.C
+++ b/src/postProcessing/functionObjects/field/fieldMinMax/fieldMinMax.C
@@ -132,10 +132,10 @@ void Foam::functionObjects::fieldMinMax::writeFileHeader(const label i)
     }
     else
     {
-        forAll(fieldSet_, fieldI)
+        forAll(fieldSet_, fieldi)
         {
-            writeTabbed(file, "min(" + fieldSet_[fieldI] + ')');
-            writeTabbed(file, "max(" + fieldSet_[fieldI] + ')');
+            writeTabbed(file, "min(" + fieldSet_[fieldi] + ')');
+            writeTabbed(file, "max(" + fieldSet_[fieldi] + ')');
         }
     }
 
@@ -162,13 +162,13 @@ void Foam::functionObjects::fieldMinMax::write()
     if (!location_) writeTime(file());
     if (log_) Info<< type() << " " << name_ <<  " output:" << nl;
 
-    forAll(fieldSet_, fieldI)
+    forAll(fieldSet_, fieldi)
     {
-        calcMinMaxFields<scalar>(fieldSet_[fieldI], mdCmpt);
-        calcMinMaxFields<vector>(fieldSet_[fieldI], mode_);
-        calcMinMaxFields<sphericalTensor>(fieldSet_[fieldI], mode_);
-        calcMinMaxFields<symmTensor>(fieldSet_[fieldI], mode_);
-        calcMinMaxFields<tensor>(fieldSet_[fieldI], mode_);
+        calcMinMaxFields<scalar>(fieldSet_[fieldi], mdCmpt);
+        calcMinMaxFields<vector>(fieldSet_[fieldi], mode_);
+        calcMinMaxFields<sphericalTensor>(fieldSet_[fieldi], mode_);
+        calcMinMaxFields<symmTensor>(fieldSet_[fieldi], mode_);
+        calcMinMaxFields<tensor>(fieldSet_[fieldi], mode_);
     }
 
     if (!location_) file()<< endl;
diff --git a/src/postProcessing/functionObjects/field/readFields/readFields.C b/src/postProcessing/functionObjects/field/readFields/readFields.C
index 0f792c7265..d9c4951963 100644
--- a/src/postProcessing/functionObjects/field/readFields/readFields.C
+++ b/src/postProcessing/functionObjects/field/readFields/readFields.C
@@ -97,9 +97,9 @@ void Foam::functionObjects::readFields::execute()
     sSymmtf_.clear();
     stf_.clear();
 
-    forAll(fieldSet_, fieldI)
+    forAll(fieldSet_, fieldi)
     {
-        const word& fieldName = fieldSet_[fieldI];
+        const word& fieldName = fieldSet_[fieldi];
 
         // If necessary load field
         loadField<scalar>(fieldName, vsf_, ssf_);
diff --git a/src/postProcessing/functionObjects/utilities/residuals/residuals.C b/src/postProcessing/functionObjects/utilities/residuals/residuals.C
index ee63506ac3..d82b5120ea 100644
--- a/src/postProcessing/functionObjects/utilities/residuals/residuals.C
+++ b/src/postProcessing/functionObjects/utilities/residuals/residuals.C
@@ -92,9 +92,9 @@ void Foam::functionObjects::residuals::writeFileHeader(const label i)
         writeHeader(file(), "Residuals");
         writeCommented(file(), "Time");
 
-        forAll(fieldSet_, fieldI)
+        forAll(fieldSet_, fieldi)
         {
-            const word& fieldName = fieldSet_[fieldI];
+            const word& fieldName = fieldSet_[fieldi];
 
             writeFileHeader<scalar>(fieldName);
             writeFileHeader<vector>(fieldName);
@@ -128,9 +128,9 @@ void Foam::functionObjects::residuals::write()
     {
         writeTime(file());
 
-        forAll(fieldSet_, fieldI)
+        forAll(fieldSet_, fieldi)
         {
-            const word& fieldName = fieldSet_[fieldI];
+            const word& fieldName = fieldSet_[fieldi];
 
             writeResidual<scalar>(fieldName);
             writeResidual<vector>(fieldName);
diff --git a/src/sampling/probes/patchProbesTemplates.C b/src/sampling/probes/patchProbesTemplates.C
index f891925d3f..935b1bd790 100644
--- a/src/sampling/probes/patchProbesTemplates.C
+++ b/src/sampling/probes/patchProbesTemplates.C
@@ -88,7 +88,7 @@ void Foam::patchProbes::sampleAndWrite
     const fieldGroup<Type>& fields
 )
 {
-    forAll(fields, fieldI)
+    forAll(fields, fieldi)
     {
         if (loadFromFiles_)
         {
@@ -98,7 +98,7 @@ void Foam::patchProbes::sampleAndWrite
                 (
                     IOobject
                     (
-                        fields[fieldI],
+                        fields[fieldi],
                         mesh_.time().timeName(),
                         mesh_,
                         IOobject::MUST_READ,
@@ -111,7 +111,7 @@ void Foam::patchProbes::sampleAndWrite
         }
         else
         {
-            objectRegistry::const_iterator iter = mesh_.find(fields[fieldI]);
+            objectRegistry::const_iterator iter = mesh_.find(fields[fieldi]);
 
             if
             (
@@ -125,7 +125,7 @@ void Foam::patchProbes::sampleAndWrite
                     mesh_.lookupObject
                     <GeometricField<Type, fvPatchField, volMesh>>
                     (
-                        fields[fieldI]
+                        fields[fieldi]
                     )
                 );
             }
@@ -140,7 +140,7 @@ void Foam::patchProbes::sampleAndWriteSurfaceFields
     const fieldGroup<Type>& fields
 )
 {
-    forAll(fields, fieldI)
+    forAll(fields, fieldi)
     {
         if (loadFromFiles_)
         {
@@ -150,7 +150,7 @@ void Foam::patchProbes::sampleAndWriteSurfaceFields
                 (
                     IOobject
                     (
-                        fields[fieldI],
+                        fields[fieldi],
                         mesh_.time().timeName(),
                         mesh_,
                         IOobject::MUST_READ,
@@ -163,7 +163,7 @@ void Foam::patchProbes::sampleAndWriteSurfaceFields
         }
         else
         {
-            objectRegistry::const_iterator iter = mesh_.find(fields[fieldI]);
+            objectRegistry::const_iterator iter = mesh_.find(fields[fieldi]);
 
             if
             (
@@ -177,7 +177,7 @@ void Foam::patchProbes::sampleAndWriteSurfaceFields
                     mesh_.lookupObject
                     <GeometricField<Type, fvsPatchField, surfaceMesh>>
                     (
-                        fields[fieldI]
+                        fields[fieldi]
                     )
                 );
             }
diff --git a/src/sampling/probes/probesGrouping.C b/src/sampling/probes/probesGrouping.C
index 1ad09613f3..4465c515a2 100644
--- a/src/sampling/probes/probesGrouping.C
+++ b/src/sampling/probes/probesGrouping.C
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2016 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -121,9 +121,9 @@ Foam::label Foam::probes::classifyFields()
 
         labelList indices = findStrings(fieldSelection_, allFields);
 
-        forAll(indices, fieldI)
+        forAll(indices, fieldi)
         {
-            const word& fieldName = allFields[indices[fieldI]];
+            const word& fieldName = allFields[indices[fieldi]];
 
             nFields += appendFieldGroup
             (
@@ -138,9 +138,9 @@ Foam::label Foam::probes::classifyFields()
         wordList allFields = mesh_.sortedNames();
         labelList indices = findStrings(fieldSelection_, allFields);
 
-        forAll(indices, fieldI)
+        forAll(indices, fieldi)
         {
-            const word& fieldName = allFields[indices[fieldI]];
+            const word& fieldName = allFields[indices[fieldi]];
 
             nFields += appendFieldGroup
             (
diff --git a/src/sampling/probes/probesTemplates.C b/src/sampling/probes/probesTemplates.C
index 9f13325478..4ccfad82bf 100644
--- a/src/sampling/probes/probesTemplates.C
+++ b/src/sampling/probes/probesTemplates.C
@@ -114,7 +114,7 @@ void Foam::probes::sampleAndWrite
 template<class Type>
 void Foam::probes::sampleAndWrite(const fieldGroup<Type>& fields)
 {
-    forAll(fields, fieldI)
+    forAll(fields, fieldi)
     {
         if (loadFromFiles_)
         {
@@ -124,7 +124,7 @@ void Foam::probes::sampleAndWrite(const fieldGroup<Type>& fields)
                 (
                     IOobject
                     (
-                        fields[fieldI],
+                        fields[fieldi],
                         mesh_.time().timeName(),
                         mesh_,
                         IOobject::MUST_READ,
@@ -137,7 +137,7 @@ void Foam::probes::sampleAndWrite(const fieldGroup<Type>& fields)
         }
         else
         {
-            objectRegistry::const_iterator iter = mesh_.find(fields[fieldI]);
+            objectRegistry::const_iterator iter = mesh_.find(fields[fieldi]);
 
             if
             (
@@ -151,7 +151,7 @@ void Foam::probes::sampleAndWrite(const fieldGroup<Type>& fields)
                     mesh_.lookupObject
                     <GeometricField<Type, fvPatchField, volMesh>>
                     (
-                        fields[fieldI]
+                        fields[fieldi]
                     )
                 );
             }
@@ -163,7 +163,7 @@ void Foam::probes::sampleAndWrite(const fieldGroup<Type>& fields)
 template<class Type>
 void Foam::probes::sampleAndWriteSurfaceFields(const fieldGroup<Type>& fields)
 {
-    forAll(fields, fieldI)
+    forAll(fields, fieldi)
     {
         if (loadFromFiles_)
         {
@@ -173,7 +173,7 @@ void Foam::probes::sampleAndWriteSurfaceFields(const fieldGroup<Type>& fields)
                 (
                     IOobject
                     (
-                        fields[fieldI],
+                        fields[fieldi],
                         mesh_.time().timeName(),
                         mesh_,
                         IOobject::MUST_READ,
@@ -186,7 +186,7 @@ void Foam::probes::sampleAndWriteSurfaceFields(const fieldGroup<Type>& fields)
         }
         else
         {
-            objectRegistry::const_iterator iter = mesh_.find(fields[fieldI]);
+            objectRegistry::const_iterator iter = mesh_.find(fields[fieldi]);
 
             if
             (
@@ -200,7 +200,7 @@ void Foam::probes::sampleAndWriteSurfaceFields(const fieldGroup<Type>& fields)
                     mesh_.lookupObject
                     <GeometricField<Type, fvsPatchField, surfaceMesh>>
                     (
-                        fields[fieldI]
+                        fields[fieldi]
                     )
                 );
             }
diff --git a/src/sampling/sampledSet/sampledSets/sampledSetsGrouping.C b/src/sampling/sampledSet/sampledSets/sampledSetsGrouping.C
index b2092a5915..bdf8c18581 100644
--- a/src/sampling/sampledSet/sampledSets/sampledSetsGrouping.C
+++ b/src/sampling/sampledSet/sampledSets/sampledSetsGrouping.C
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011-2015 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2016 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -93,9 +93,9 @@ Foam::label Foam::sampledSets::classifyFields()
 
             if (indices.size())
             {
-                forAll(indices, fieldI)
+                forAll(indices, fieldi)
                 {
-                    const word& fieldName = allFields[indices[fieldI]];
+                    const word& fieldName = allFields[indices[fieldi]];
 
                     nFields += appendFieldGroup
                     (
@@ -124,9 +124,9 @@ Foam::label Foam::sampledSets::classifyFields()
 
             if (indices.size())
             {
-                forAll(indices, fieldI)
+                forAll(indices, fieldi)
                 {
-                    const word& fieldName = allFields[indices[fieldI]];
+                    const word& fieldName = allFields[indices[fieldi]];
 
                     nFields += appendFieldGroup
                     (
diff --git a/src/thermophysicalModels/chemistryModel/chemistryModel/chemistryModel/chemistryModel.C b/src/thermophysicalModels/chemistryModel/chemistryModel/chemistryModel/chemistryModel.C
index 347e506901..9747e979c3 100644
--- a/src/thermophysicalModels/chemistryModel/chemistryModel/chemistryModel/chemistryModel.C
+++ b/src/thermophysicalModels/chemistryModel/chemistryModel/chemistryModel/chemistryModel.C
@@ -56,16 +56,16 @@ Foam::chemistryModel<CompType, ThermoType>::chemistryModel
     RR_(nSpecie_)
 {
     // create the fields for the chemistry sources
-    forAll(RR_, fieldI)
+    forAll(RR_, fieldi)
     {
         RR_.set
         (
-            fieldI,
+            fieldi,
             new DimensionedField<scalar, volMesh>
             (
                 IOobject
                 (
-                    "RR." + Y_[fieldI].name(),
+                    "RR." + Y_[fieldi].name(),
                     mesh.time().timeName(),
                     mesh,
                     IOobject::NO_READ,
diff --git a/src/thermophysicalModels/solidChemistryModel/pyrolysisChemistryModel/pyrolysisChemistryModel.C b/src/thermophysicalModels/solidChemistryModel/pyrolysisChemistryModel/pyrolysisChemistryModel.C
index 982eecb5e6..e889e25645 100644
--- a/src/thermophysicalModels/solidChemistryModel/pyrolysisChemistryModel/pyrolysisChemistryModel.C
+++ b/src/thermophysicalModels/solidChemistryModel/pyrolysisChemistryModel/pyrolysisChemistryModel.C
@@ -47,11 +47,11 @@ pyrolysisChemistryModel
     cellCounter_(0)
 {
     // create the fields for the chemistry sources
-    forAll(this->RRs_, fieldI)
+    forAll(this->RRs_, fieldi)
     {
         IOobject header
         (
-            this->Ys_[fieldI].name() + "0",
+            this->Ys_[fieldi].name() + "0",
             mesh.time().timeName(),
             mesh,
             IOobject::NO_READ
@@ -62,12 +62,12 @@ pyrolysisChemistryModel
         {
             Ys0_.set
             (
-                fieldI,
+                fieldi,
                 new volScalarField
                 (
                     IOobject
                     (
-                        this->Ys_[fieldI].name() + "0",
+                        this->Ys_[fieldi].name() + "0",
                         mesh.time().timeName(),
                         mesh,
                         IOobject::MUST_READ,
@@ -94,12 +94,12 @@ pyrolysisChemistryModel
 
             Ys0_.set
             (
-                fieldI,
+                fieldi,
                 new volScalarField
                 (
                     IOobject
                     (
-                        this->Ys_[fieldI].name() + "0",
+                        this->Ys_[fieldi].name() + "0",
                         mesh.time().timeName(),
                         mesh,
                         IOobject::NO_READ,
@@ -110,22 +110,22 @@ pyrolysisChemistryModel
             );
 
             // Calculate inital values of Ysi0 = rho*delta*Yi
-            Ys0_[fieldI].primitiveFieldRef() =
+            Ys0_[fieldi].primitiveFieldRef() =
                 this->solidThermo().rho()
-               *max(this->Ys_[fieldI], scalar(0.001))*mesh.V();
+               *max(this->Ys_[fieldi], scalar(0.001))*mesh.V();
         }
     }
 
-    forAll(RRg_, fieldI)
+    forAll(RRg_, fieldi)
     {
         RRg_.set
         (
-            fieldI,
+            fieldi,
             new DimensionedField<scalar, volMesh>
             (
                 IOobject
                 (
-                    "RRg." + pyrolisisGases_[fieldI],
+                    "RRg." + pyrolisisGases_[fieldi],
                     mesh.time().timeName(),
                     mesh,
                     IOobject::NO_READ,
diff --git a/src/thermophysicalModels/solidChemistryModel/solidChemistryModel/solidChemistryModel.C b/src/thermophysicalModels/solidChemistryModel/solidChemistryModel/solidChemistryModel.C
index 5a62650775..9ef8c5af58 100644
--- a/src/thermophysicalModels/solidChemistryModel/solidChemistryModel/solidChemistryModel.C
+++ b/src/thermophysicalModels/solidChemistryModel/solidChemistryModel/solidChemistryModel.C
@@ -59,16 +59,16 @@ solidChemistryModel
     reactingCells_(mesh.nCells(), true)
 {
     // create the fields for the chemistry sources
-    forAll(RRs_, fieldI)
+    forAll(RRs_, fieldi)
     {
         RRs_.set
         (
-            fieldI,
+            fieldi,
             new DimensionedField<scalar, volMesh>
             (
                 IOobject
                 (
-                    "RRs." + Ys_[fieldI].name(),
+                    "RRs." + Ys_[fieldi].name(),
                     mesh.time().timeName(),
                     mesh,
                     IOobject::NO_READ,
-- 
GitLab