diff --git a/applications/solvers/heatTransfer/chtMultiRegionFoam/fluid/compressibleMultiRegionCourantNo.H b/applications/solvers/heatTransfer/chtMultiRegionFoam/fluid/compressibleMultiRegionCourantNo.H
index fa5feefbb4beba6e440298d46723e06734d8f0c0..82dc8758475a26bb6907f3ba54448e40ca95f012 100644
--- a/applications/solvers/heatTransfer/chtMultiRegionFoam/fluid/compressibleMultiRegionCourantNo.H
+++ b/applications/solvers/heatTransfer/chtMultiRegionFoam/fluid/compressibleMultiRegionCourantNo.H
@@ -15,7 +15,7 @@
         );
     }
 /*
-    forAll (porousFluidRegions, porousI)
+    forAll(porousFluidRegions, porousI)
     {
         CoNum = max
         (
diff --git a/applications/utilities/mesh/manipulation/checkMesh/checkTopology.C b/applications/utilities/mesh/manipulation/checkMesh/checkTopology.C
index b0c4d37c03770dec2a028c77e7bf25d0b3bca893..e093787090c4fd52d2d7845d3fc5854ef51ed84f 100644
--- a/applications/utilities/mesh/manipulation/checkMesh/checkTopology.C
+++ b/applications/utilities/mesh/manipulation/checkMesh/checkTopology.C
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011-2013 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2016 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -446,7 +446,7 @@ Foam::label Foam::checkTopology
                     if (returnReduce(mp.size(), sumOp<label>()) > 0)
                     {
                         boundBox bb(point::max, point::min);
-                        forAll (mp, i)
+                        forAll(mp, i)
                         {
                             bb.min() = min(bb.min(), pts[mp[i]]);
                             bb.max() = max(bb.max(), pts[mp[i]]);
diff --git a/applications/utilities/preProcessing/viewFactorsGen/viewFactorsGen.C b/applications/utilities/preProcessing/viewFactorsGen/viewFactorsGen.C
index bccf381ba15eaeb6d4f048fdd182ecf67326979b..e01be739e1cbb2b54c19cecea7e9ab5f4933c85f 100644
--- a/applications/utilities/preProcessing/viewFactorsGen/viewFactorsGen.C
+++ b/applications/utilities/preProcessing/viewFactorsGen/viewFactorsGen.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
@@ -381,7 +381,7 @@ int main(int argc, char *argv[])
 
     DynamicList<label> localAgg(nCoarseFaces);
 
-    forAll (viewFactorsPatches, i)
+    forAll(viewFactorsPatches, i)
     {
         const label patchID = viewFactorsPatches[i];
 
@@ -689,7 +689,7 @@ int main(int argc, char *argv[])
 
     if (mesh.nSolutionD() == 3)
     {
-        forAll (localCoarseSf, coarseFaceI)
+        forAll(localCoarseSf, coarseFaceI)
         {
             const List<point>& localFineSf = compactFineSf[coarseFaceI];
             const vector Ai = sum(localFineSf);
@@ -709,12 +709,12 @@ int main(int argc, char *argv[])
                 const label toPatchId = compactPatchId[compactJ];
 
                 scalar Fij = 0;
-                forAll (localFineSf, i)
+                forAll(localFineSf, i)
                 {
                     const vector& dAi = localFineSf[i];
                     const vector& dCi = localFineCf[i];
 
-                    forAll (remoteFineSj, j)
+                    forAll(remoteFineSj, j)
                     {
                         const vector& dAj = remoteFineSj[j];
                         const vector& dCj = remoteFineCj[j];
@@ -762,7 +762,7 @@ int main(int argc, char *argv[])
             patchArea[fromPatchId] += mag(Ai);
 
             const labelList& visCoarseFaces = visibleFaceFaces[coarseFaceI];
-            forAll (visCoarseFaces, visCoarseFaceI)
+            forAll(visCoarseFaces, visCoarseFaceI)
             {
                 F[coarseFaceI].setSize(visCoarseFaces.size());
                 label compactJ = visCoarseFaces[visCoarseFaceI];
@@ -847,7 +847,7 @@ int main(int argc, char *argv[])
                 const scalar Fij = sum(F[compactI]);
                 const label coarseFaceID = coarsePatchFace[coarseI];
                 const labelList& fineFaces = coarseToFine[coarseFaceID];
-                forAll (fineFaces, fineId)
+                forAll(fineFaces, fineId)
                 {
                     const label faceID = fineFaces[fineId];
                     viewFactorField.boundaryField()[patchID][faceID] = Fij;
diff --git a/applications/utilities/surface/surfaceSplitByTopology/surfaceSplitByTopology.C b/applications/utilities/surface/surfaceSplitByTopology/surfaceSplitByTopology.C
index 3e9245136923b2f80d3dde317afe84e95cb90e39..9ab191ae21261541e7be1cf40f15ccca9fe7dff4 100644
--- a/applications/utilities/surface/surfaceSplitByTopology/surfaceSplitByTopology.C
+++ b/applications/utilities/surface/surfaceSplitByTopology/surfaceSplitByTopology.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
@@ -101,7 +101,7 @@ int main(int argc, char *argv[])
             {
                 if (faceZone[f] == z)
                 {
-                    forAll (faceEds[f], fe)
+                    forAll(faceEds[f], fe)
                     {
                         if (edFaces[faceEds[f][fe]].size() < 2)
                         {
diff --git a/src/OpenFOAM/matrices/LduMatrix/LduMatrix/LduMatrixUpdateMatrixInterfaces.C b/src/OpenFOAM/matrices/LduMatrix/LduMatrix/LduMatrixUpdateMatrixInterfaces.C
index b068e47481570b54bcf6116e2b9dba8cb4d6098f..89c3f797eed1ffe1423c8c2add30f99563b9314c 100644
--- a/src/OpenFOAM/matrices/LduMatrix/LduMatrix/LduMatrixUpdateMatrixInterfaces.C
+++ b/src/OpenFOAM/matrices/LduMatrix/LduMatrix/LduMatrixUpdateMatrixInterfaces.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
@@ -42,7 +42,7 @@ void Foam::LduMatrix<Type, DType, LUType>::initMatrixInterfaces
      || Pstream::defaultCommsType == Pstream::nonBlocking
     )
     {
-        forAll (interfaces_, interfaceI)
+        forAll(interfaces_, interfaceI)
         {
             if (interfaces_.set(interfaceI))
             {
@@ -114,7 +114,7 @@ void Foam::LduMatrix<Type, DType, LUType>::updateMatrixInterfaces
             OPstream::waitRequests();
         }
 
-        forAll (interfaces_, interfaceI)
+        forAll(interfaces_, interfaceI)
         {
             if (interfaces_.set(interfaceI))
             {
@@ -134,7 +134,7 @@ void Foam::LduMatrix<Type, DType, LUType>::updateMatrixInterfaces
         const lduSchedule& patchSchedule = this->patchSchedule();
 
         // Loop over all the "normal" interfaces relating to standard patches
-        forAll (patchSchedule, i)
+        forAll(patchSchedule, i)
         {
             label interfaceI = patchSchedule[i].patch;
 
diff --git a/src/OpenFOAM/meshes/polyMesh/polyBoundaryMesh/polyBoundaryMesh.C b/src/OpenFOAM/meshes/polyMesh/polyBoundaryMesh/polyBoundaryMesh.C
index f3311f26e4b6900e0bbd8dbc27e494c7a242cdd1..a795557339a55c4ed51209fefbebbba4cc4996b4 100644
--- a/src/OpenFOAM/meshes/polyMesh/polyBoundaryMesh/polyBoundaryMesh.C
+++ b/src/OpenFOAM/meshes/polyMesh/polyBoundaryMesh/polyBoundaryMesh.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
@@ -179,7 +179,7 @@ Foam::polyBoundaryMesh::polyBoundaryMesh
     {
         polyPatchList& patches = *this;
         patches.setSize(ppl.size());
-        forAll (patches, patchI)
+        forAll(patches, patchI)
         {
             patches.set(patchI, ppl[patchI].clone(*this).ptr());
         }
diff --git a/src/OpenFOAM/meshes/polyMesh/polyMeshCheck/polyMeshCheck.C b/src/OpenFOAM/meshes/polyMesh/polyMeshCheck/polyMeshCheck.C
index 14835981ab812b95ab110ecc950de07b0c4b6b5f..f4716969867a2c9a43877f28f70628348e2582c7 100644
--- a/src/OpenFOAM/meshes/polyMesh/polyMeshCheck/polyMeshCheck.C
+++ b/src/OpenFOAM/meshes/polyMesh/polyMeshCheck/polyMeshCheck.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
@@ -441,7 +441,7 @@ bool Foam::polyMesh::checkCellDeterminant
     scalar minDet = min(cellDeterminant);
     scalar sumDet = sum(cellDeterminant);
 
-    forAll (cellDeterminant, cellI)
+    forAll(cellDeterminant, cellI)
     {
         if (cellDeterminant[cellI] < warnDet)
         {
@@ -529,7 +529,7 @@ bool Foam::polyMesh::checkFaceWeight
     // Statistics only for internal and masters of coupled faces
     PackedBoolList isMasterFace(syncTools::getInternalOrMasterFaces(*this));
 
-    forAll (faceWght, faceI)
+    forAll(faceWght, faceI)
     {
         if (faceWght[faceI] < minWeight)
         {
@@ -618,7 +618,7 @@ bool Foam::polyMesh::checkVolRatio
     // Statistics only for internal and masters of coupled faces
     PackedBoolList isMasterFace(syncTools::getInternalOrMasterFaces(*this));
 
-    forAll (volRatio, faceI)
+    forAll(volRatio, faceI)
     {
         if (volRatio[faceI] < minRatio)
         {
diff --git a/src/OpenFOAM/meshes/polyMesh/zones/ZoneMesh/ZoneMesh.C b/src/OpenFOAM/meshes/polyMesh/zones/ZoneMesh/ZoneMesh.C
index 5e44455f0c2e71a863d5963d69168dacebe0748e..f453dee2a0cb022243c83357bc7ebf0246cf3268 100644
--- a/src/OpenFOAM/meshes/polyMesh/zones/ZoneMesh/ZoneMesh.C
+++ b/src/OpenFOAM/meshes/polyMesh/zones/ZoneMesh/ZoneMesh.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
@@ -186,7 +186,7 @@ Foam::ZoneMesh<ZoneType, MeshType>::ZoneMesh
         // Nothing read. Use supplied zones
         PtrList<ZoneType>& zones = *this;
         zones.setSize(pzm.size());
-        forAll (zones, zoneI)
+        forAll(zones, zoneI)
         {
             zones.set(zoneI, pzm[zoneI].clone(*this).ptr());
         }
diff --git a/src/OpenFOAM/meshes/primitiveMesh/primitiveMeshCheck/primitiveMeshTools.C b/src/OpenFOAM/meshes/primitiveMesh/primitiveMeshCheck/primitiveMeshTools.C
index c833f5ca91ad2384669e1df8c3d245e5435c1ab7..2845ca262bd5d96062f7ac85a302e07fe0fe8b7b 100644
--- a/src/OpenFOAM/meshes/primitiveMesh/primitiveMeshCheck/primitiveMeshTools.C
+++ b/src/OpenFOAM/meshes/primitiveMesh/primitiveMeshCheck/primitiveMeshTools.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
@@ -484,7 +484,7 @@ Foam::tmp<Foam::scalarField> Foam::primitiveMeshTools::cellDeterminant
     }
     else
     {
-        forAll (c, cellI)
+        forAll(c, cellI)
         {
             const labelList& curFaces = c[cellI];
 
diff --git a/src/TurbulenceModels/compressible/turbulentFluidThermoModels/derivedFvPatchFields/externalWallHeatFluxTemperature/externalWallHeatFluxTemperatureFvPatchScalarField.C b/src/TurbulenceModels/compressible/turbulentFluidThermoModels/derivedFvPatchFields/externalWallHeatFluxTemperature/externalWallHeatFluxTemperatureFvPatchScalarField.C
index 2a02d01cac26157b3aaea51698ed80a485608d9d..9a23256da06f03adc59d0f1a16c6f5620434199c 100644
--- a/src/TurbulenceModels/compressible/turbulentFluidThermoModels/derivedFvPatchFields/externalWallHeatFluxTemperature/externalWallHeatFluxTemperatureFvPatchScalarField.C
+++ b/src/TurbulenceModels/compressible/turbulentFluidThermoModels/derivedFvPatchFields/externalWallHeatFluxTemperature/externalWallHeatFluxTemperatureFvPatchScalarField.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
@@ -282,7 +282,7 @@ void Foam::externalWallHeatFluxTemperatureFvPatchScalarField::updateCoeffs()
             scalar totalSolidRes = 0.0;
             if (thicknessLayers_.size() > 0)
             {
-                forAll (thicknessLayers_, iLayer)
+                forAll(thicknessLayers_, iLayer)
                 {
                     const scalar l = thicknessLayers_[iLayer];
                     if (kappaLayers_[iLayer] > 0.0)
diff --git a/src/TurbulenceModels/compressible/turbulentFluidThermoModels/derivedFvPatchFields/turbulentTemperatureCoupledBaffleMixed/turbulentTemperatureCoupledBaffleMixedFvPatchScalarField.C b/src/TurbulenceModels/compressible/turbulentFluidThermoModels/derivedFvPatchFields/turbulentTemperatureCoupledBaffleMixed/turbulentTemperatureCoupledBaffleMixedFvPatchScalarField.C
index 903c50b164e039e2d03520c1beefe572417160b5..ad37059180e7a386e74dae36d5f9ae9bf01066fe 100644
--- a/src/TurbulenceModels/compressible/turbulentFluidThermoModels/derivedFvPatchFields/turbulentTemperatureCoupledBaffleMixed/turbulentTemperatureCoupledBaffleMixedFvPatchScalarField.C
+++ b/src/TurbulenceModels/compressible/turbulentFluidThermoModels/derivedFvPatchFields/turbulentTemperatureCoupledBaffleMixed/turbulentTemperatureCoupledBaffleMixedFvPatchScalarField.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
@@ -109,7 +109,7 @@ turbulentTemperatureCoupledBaffleMixedFvPatchScalarField
         if (thicknessLayers_.size() > 0)
         {
             // Calculate effective thermal resistance by harmonic averaging
-            forAll (thicknessLayers_, iLayer)
+            forAll(thicknessLayers_, iLayer)
             {
                 contactRes_ += thicknessLayers_[iLayer]/kappaLayers_[iLayer];
             }
diff --git a/src/TurbulenceModels/compressible/turbulentFluidThermoModels/derivedFvPatchFields/turbulentTemperatureRadCoupledMixed/turbulentTemperatureRadCoupledMixedFvPatchScalarField.C b/src/TurbulenceModels/compressible/turbulentFluidThermoModels/derivedFvPatchFields/turbulentTemperatureRadCoupledMixed/turbulentTemperatureRadCoupledMixedFvPatchScalarField.C
index 8d563bac65cd8077b3e58c55017dba98c6ff391a..4fa51bc054d8e54ef1a7adfaef01f6a3bfe1e92e 100644
--- a/src/TurbulenceModels/compressible/turbulentFluidThermoModels/derivedFvPatchFields/turbulentTemperatureRadCoupledMixed/turbulentTemperatureRadCoupledMixedFvPatchScalarField.C
+++ b/src/TurbulenceModels/compressible/turbulentFluidThermoModels/derivedFvPatchFields/turbulentTemperatureRadCoupledMixed/turbulentTemperatureRadCoupledMixedFvPatchScalarField.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
@@ -115,7 +115,7 @@ turbulentTemperatureRadCoupledMixedFvPatchScalarField
         if (thicknessLayers_.size() > 0)
         {
             // Calculate effective thermal resistance by harmonic averaging
-            forAll (thicknessLayers_, iLayer)
+            forAll(thicknessLayers_, iLayer)
             {
                 contactRes_ += thicknessLayers_[iLayer]/kappaLayers_[iLayer];
             }
diff --git a/src/dynamicMesh/extrudePatchMesh/extrudePatchMesh.C b/src/dynamicMesh/extrudePatchMesh/extrudePatchMesh.C
index ca8755562787c2c4c7351904fd8525e46e6657a9..d2e00ec96fba1243c6295bfaa4979e24b91467bc 100644
--- a/src/dynamicMesh/extrudePatchMesh/extrudePatchMesh.C
+++ b/src/dynamicMesh/extrudePatchMesh/extrudePatchMesh.C
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011-2013 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2016 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -110,7 +110,7 @@ extrudePatchMesh::extrudePatchMesh
     List<word> patchTypes(regionPatches.size());
     PtrList<dictionary> dicts(regionPatches.size());
 
-    forAll (dicts, patchI)
+    forAll(dicts, patchI)
     {
         if (!dicts.set(patchI))
         {
@@ -122,13 +122,13 @@ extrudePatchMesh::extrudePatchMesh
     dicts[sidePatchID] = dict_.subDict("sideCoeffs");
     dicts[topPatchID] = dict_.subDict("topCoeffs");
 
-    forAll (dicts, patchI)
+    forAll(dicts, patchI)
     {
         dicts[patchI].lookup("name") >> patchNames[patchI];
         dicts[patchI].lookup("type") >> patchTypes[patchI];
     }
 
-    forAll (regionPatches, patchI)
+    forAll(regionPatches, patchI)
     {
         dictionary&  patchDict = dicts[patchI];
         patchDict.set("nFaces", 0);
@@ -267,7 +267,7 @@ void extrudePatchMesh::extrudeMesh(const List<polyPatch*>& regionPatches)
         List<word> patchTypes(regionPatches.size());
         PtrList<dictionary> dicts(regionPatches.size());
 
-        forAll (dicts, patchI)
+        forAll(dicts, patchI)
         {
             if (!dicts.set(patchI))
             {
@@ -279,13 +279,13 @@ void extrudePatchMesh::extrudeMesh(const List<polyPatch*>& regionPatches)
         dicts[sidePatchID] = dict_.subDict("sideCoeffs");
         dicts[topPatchID] = dict_.subDict("topCoeffs");
 
-        forAll (dicts, patchI)
+        forAll(dicts, patchI)
         {
             dicts[patchI].lookup("name") >> patchNames[patchI];
             dicts[patchI].lookup("type") >> patchTypes[patchI];
         }
 
-        forAll (regionPatches, patchI)
+        forAll(regionPatches, patchI)
         {
             dictionary&  patchDict = dicts[patchI];
             patchDict.set("nFaces", 0);
diff --git a/src/finiteVolume/cfdTools/general/porosityModel/DarcyForchheimer/DarcyForchheimer.C b/src/finiteVolume/cfdTools/general/porosityModel/DarcyForchheimer/DarcyForchheimer.C
index 20ac7a29b1f42f4a186063906a0789d0846c6a75..411b8dfc6bc6504e2d405124c4f34b7be1572c72 100644
--- a/src/finiteVolume/cfdTools/general/porosityModel/DarcyForchheimer/DarcyForchheimer.C
+++ b/src/finiteVolume/cfdTools/general/porosityModel/DarcyForchheimer/DarcyForchheimer.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
@@ -79,7 +79,7 @@ void Foam::porosityModels::DarcyForchheimer::calcTransformModelData()
 {
     if (coordSys_.R().uniform())
     {
-        forAll (cellZoneIDs_, zoneI)
+        forAll(cellZoneIDs_, zoneI)
         {
             D_[zoneI].setSize(1);
             F_[zoneI].setSize(1);
diff --git a/src/finiteVolume/cfdTools/general/porosityModel/fixedCoeff/fixedCoeff.C b/src/finiteVolume/cfdTools/general/porosityModel/fixedCoeff/fixedCoeff.C
index eeb4bb3e9c22ea8bbfb6c2fd74e910cf713c1547..6525c6c2c3b8162ec68b28db91699801d15a3f0c 100644
--- a/src/finiteVolume/cfdTools/general/porosityModel/fixedCoeff/fixedCoeff.C
+++ b/src/finiteVolume/cfdTools/general/porosityModel/fixedCoeff/fixedCoeff.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
@@ -135,7 +135,7 @@ void Foam::porosityModels::fixedCoeff::calcTransformModelData()
 {
     if (coordSys_.R().uniform())
     {
-        forAll (cellZoneIDs_, zoneI)
+        forAll(cellZoneIDs_, zoneI)
         {
             alpha_[zoneI].setSize(1);
             beta_[zoneI].setSize(1);
diff --git a/src/finiteVolume/fields/fvPatchFields/derived/activePressureForceBaffleVelocity/activePressureForceBaffleVelocityFvPatchVectorField.C b/src/finiteVolume/fields/fvPatchFields/derived/activePressureForceBaffleVelocity/activePressureForceBaffleVelocityFvPatchVectorField.C
index 02a63dd00d3e1e708ee9de6a598682990eeef5b3..cef5a6e58f537a9dd132b8ccbf283440569840ce 100644
--- a/src/finiteVolume/fields/fvPatchFields/derived/activePressureForceBaffleVelocity/activePressureForceBaffleVelocityFvPatchVectorField.C
+++ b/src/finiteVolume/fields/fvPatchFields/derived/activePressureForceBaffleVelocity/activePressureForceBaffleVelocityFvPatchVectorField.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
@@ -190,7 +190,7 @@ void Foam::activePressureForceBaffleVelocityFvPatchVectorField::autoMap
     //- Note: we don't want to use Sf here since triggers rebuilding of
     //  fvMesh::S() which will give problems when mapped (since already
     //  on new mesh)
-    forAll (patch().boundaryMesh().mesh().faceAreas(), i)
+    forAll(patch().boundaryMesh().mesh().faceAreas(), i)
     {
         if (mag(patch().boundaryMesh().mesh().faceAreas()[i]) == 0)
         {
diff --git a/src/finiteVolume/finiteVolume/gradSchemes/LeastSquaresGrad/LeastSquaresVectors.C b/src/finiteVolume/finiteVolume/gradSchemes/LeastSquaresGrad/LeastSquaresVectors.C
index ea30ffa3dbfb3d7be7d0d8d8d5c40bba52d290b5..536208067a869752d84c54e9fb61de601b3210d5 100644
--- a/src/finiteVolume/finiteVolume/gradSchemes/LeastSquaresGrad/LeastSquaresVectors.C
+++ b/src/finiteVolume/finiteVolume/gradSchemes/LeastSquaresGrad/LeastSquaresVectors.C
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2013 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2013-2016 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -68,7 +68,7 @@ void Foam::fv::LeastSquaresVectors<Stencil>::calcLeastSquaresVectors()
     // including components for the "empty" directions
     symmTensor dd0(sqr((Vector<label>::one - mesh.geometricD())/2));
 
-    forAll (vectors_, i)
+    forAll(vectors_, i)
     {
         List<vector>& lsvi = vectors_[i];
         symmTensor dd(dd0);
diff --git a/src/fvAgglomerationMethods/pairPatchAgglomeration/pairPatchAgglomeration.C b/src/fvAgglomerationMethods/pairPatchAgglomeration/pairPatchAgglomeration.C
index 33c19f801ae58d11210ae1129208f714bf46a2cc..ecceef966aacb8f20b4168055ac23de4a8a62dae 100644
--- a/src/fvAgglomerationMethods/pairPatchAgglomeration/pairPatchAgglomeration.C
+++ b/src/fvAgglomerationMethods/pairPatchAgglomeration/pairPatchAgglomeration.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
@@ -254,7 +254,7 @@ void Foam::pairPatchAgglomeration::mapBaseToTopAgglom
 )
 {
     const labelList& fineToCoarse = restrictAddressing_[fineLevelIndex];
-    forAll (restrictTopBottomAddressing_, i)
+    forAll(restrictTopBottomAddressing_, i)
     {
         restrictTopBottomAddressing_[i] =
             fineToCoarse[restrictTopBottomAddressing_[i]];
diff --git a/src/postProcessing/functionObjects/IO/writeRegisteredObject/writeRegisteredObject.H b/src/postProcessing/functionObjects/IO/writeRegisteredObject/writeRegisteredObject.H
index d08dc7c914c5d97a1cd574563e08f863650135fe..8785424569ac76f929bf06e5b4ce8d34d3d7dd39 100644
--- a/src/postProcessing/functionObjects/IO/writeRegisteredObject/writeRegisteredObject.H
+++ b/src/postProcessing/functionObjects/IO/writeRegisteredObject/writeRegisteredObject.H
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011-2013 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2016 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -94,8 +94,6 @@ class mapPolyMesh;
 
 class writeRegisteredObject
 {
-protected:
-
     // Private data
 
         //- Name of this set of writeRegisteredObject
diff --git a/src/regionModels/regionModel/regionModel1D/regionModel1D.C b/src/regionModels/regionModel/regionModel1D/regionModel1D.C
index d5e80beec8aa74061eb6fd2952144b7f277e5374..63e8145c5f6105d0b332daef337582aab9c5e417 100644
--- a/src/regionModels/regionModel/regionModel1D/regionModel1D.C
+++ b/src/regionModels/regionModel/regionModel1D/regionModel1D.C
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
-    \\  /    A nd           | Copyright (C) 2011-2013 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2016 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -134,7 +134,7 @@ void Foam::regionModels::regionModel1D::initialise()
         {
             const vector& n = pNormals[localFaceI];
             const labelList& faces = boundaryFaceFaces_[localPyrolysisFaceI++];
-            forAll (faces, faceI)
+            forAll(faces, faceI)
             {
                 const label faceID = faces[faceI];
                 nMagSf[faceID] = regionMesh().Sf()[faceID] & n;
diff --git a/src/regionModels/thermalBaffleModels/derivedFvPatchFields/thermalBaffle/thermalBaffleFvPatchScalarField.C b/src/regionModels/thermalBaffleModels/derivedFvPatchFields/thermalBaffle/thermalBaffleFvPatchScalarField.C
index 2231b42999f498bfd771c743dfd6e4c15bdd65ec..e575a1c480e851e2cfc3e6d58f3f1a6b24625c26 100644
--- a/src/regionModels/thermalBaffleModels/derivedFvPatchFields/thermalBaffle/thermalBaffleFvPatchScalarField.C
+++ b/src/regionModels/thermalBaffleModels/derivedFvPatchFields/thermalBaffle/thermalBaffleFvPatchScalarField.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
@@ -208,7 +208,7 @@ void thermalBaffleFvPatchScalarField::createPatchMesh()
     dicts[topPatchID].add("sampleMode", mpp.sampleModeNames_[mpp.mode()]);
 
 
-    forAll (regionPatches, patchI)
+    forAll(regionPatches, patchI)
     {
         dictionary&  patchDict = dicts[patchI];
         patchDict.set("nFaces", 0);
diff --git a/src/regionModels/thermalBaffleModels/thermalBaffleModel/thermalBaffleModel.C b/src/regionModels/thermalBaffleModels/thermalBaffleModel/thermalBaffleModel.C
index c432d922a83920745fe293b24aaecf701ea6ac2e..f56ef9193e5b7a4eeb6b754fe25303840951fa3e 100644
--- a/src/regionModels/thermalBaffleModels/thermalBaffleModel/thermalBaffleModel.C
+++ b/src/regionModels/thermalBaffleModels/thermalBaffleModel/thermalBaffleModel.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
@@ -76,7 +76,7 @@ void thermalBaffleModel::init()
         reduce(nTotalEdges, sumOp<label>());
 
         label nFaces = 0;
-        forAll (rbm, patchi)
+        forAll(rbm, patchi)
         {
             if (
                    rbm[patchi].size()
@@ -157,7 +157,7 @@ void thermalBaffleModel::init()
             // Calculate thickness of the baffle on the first face only.
             if (delta_.value() == 0.0)
             {
-                forAll (ppCoupled, localFaceI)
+                forAll(ppCoupled, localFaceI)
                 {
                     label faceI = ppCoupled.start() + localFaceI;
 
diff --git a/src/sampling/probes/probes.C b/src/sampling/probes/probes.C
index 2ea3a4f43005eaad501e6c6fdc6200b7ca21c00f..9a103e1367c6e44712c0ae02b5cac908916eee90 100644
--- a/src/sampling/probes/probes.C
+++ b/src/sampling/probes/probes.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,7 +67,7 @@ void Foam::probes::findElements(const fvMesh& mesh)
             const vector& cellCentre = mesh.cellCentres()[cellI];
             scalar minDistance = GREAT;
             label minFaceID = -1;
-            forAll (cellFaces, i)
+            forAll(cellFaces, i)
             {
                 label faceI = cellFaces[i];
                 vector dist = mesh.faceCentres()[faceI] - cellCentre;
diff --git a/src/thermophysicalModels/radiation/submodels/absorptionEmissionModel/greyMeanAbsorptionEmission/greyMeanAbsorptionEmission.C b/src/thermophysicalModels/radiation/submodels/absorptionEmissionModel/greyMeanAbsorptionEmission/greyMeanAbsorptionEmission.C
index 985935df96f6a79795095171664f3431f84a7860..ef0ab32012597e821200516bb191349972851a6d 100644
--- a/src/thermophysicalModels/radiation/submodels/absorptionEmissionModel/greyMeanAbsorptionEmission/greyMeanAbsorptionEmission.C
+++ b/src/thermophysicalModels/radiation/submodels/absorptionEmissionModel/greyMeanAbsorptionEmission/greyMeanAbsorptionEmission.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
@@ -234,7 +234,7 @@ Foam::radiation::greyMeanAbsorptionEmission::aCont(const label bandI) const
             else
             {
                 scalar invWt = 0.0;
-                forAll (mixture.Y(), s)
+                forAll(mixture.Y(), s)
                 {
                     invWt += mixture.Y(s)[cellI]/mixture.W(s);
                 }
diff --git a/src/thermophysicalModels/radiation/submodels/absorptionEmissionModel/greyMeanSolidAbsorptionEmission/greyMeanSolidAbsorptionEmission.C b/src/thermophysicalModels/radiation/submodels/absorptionEmissionModel/greyMeanSolidAbsorptionEmission/greyMeanSolidAbsorptionEmission.C
index 14497374c0a31e7cf44c0759f73045a7b58fe4d6..2ab19310291ecc73a6e96dd8568d59ce02c9f8e9 100644
--- a/src/thermophysicalModels/radiation/submodels/absorptionEmissionModel/greyMeanSolidAbsorptionEmission/greyMeanSolidAbsorptionEmission.C
+++ b/src/thermophysicalModels/radiation/submodels/absorptionEmissionModel/greyMeanSolidAbsorptionEmission/greyMeanSolidAbsorptionEmission.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
@@ -64,7 +64,7 @@ greyMeanSolidAbsorptionEmission::X(const word specie) const
     {
         const scalarField& Yi = mixture_.Y()[specieI];
 
-        forAll (rhoInv, iCell)
+        forAll(rhoInv, iCell)
         {
             rhoInv[iCell] +=
                 Yi[iCell]/mixture_.rho(specieI, p[iCell], T[iCell]);