diff --git a/applications/solvers/incompressible/boundaryFoam/boundaryFoam.C b/applications/solvers/incompressible/boundaryFoam/boundaryFoam.C
index 4cd161b3681f7dd673c32dad718bfb7830c2818c..e80c9a83882a1f4e04ccdcd45f8bfe5481324925 100644
--- a/applications/solvers/incompressible/boundaryFoam/boundaryFoam.C
+++ b/applications/solvers/incompressible/boundaryFoam/boundaryFoam.C
@@ -30,7 +30,7 @@ Group
     grpIncompressibleSolvers
 
 Description
-    Steady-state solver for incompressible, 1D turbulent flow, 
+    Steady-state solver for incompressible, 1D turbulent flow,
     typically to generate boundary layer conditions at an inlet.
 
     Boundary layer code to calculate the U, k and epsilon distributions.
diff --git a/applications/utilities/preProcessing/createBoxTurb/createBlockMesh.H b/applications/utilities/preProcessing/createBoxTurb/createBlockMesh.H
index a4c482a954351c6f907827671e29f5a73bd5812b..e85661a40da1bfa5e32b8cdf56f377b8c5b48f4e 100644
--- a/applications/utilities/preProcessing/createBoxTurb/createBlockMesh.H
+++ b/applications/utilities/preProcessing/createBoxTurb/createBlockMesh.H
@@ -73,7 +73,7 @@ forAll(boundaryDicts, patchi)
     }
     else
     {
-        nbrPatchName = "patch" + Foam::name(patchi - 1); 
+        nbrPatchName = "patch" + Foam::name(patchi - 1);
     }
 
     patchDict.add("type", cyclicPolyPatch::typeName);
diff --git a/src/OpenFOAM/fields/GeometricFields/transformGeometricField/transformGeometricField.C b/src/OpenFOAM/fields/GeometricFields/transformGeometricField/transformGeometricField.C
index 6fb7bc506dc2416e3ed8afd0fd738bc8687fc1fa..b5b85da594e7618632d40a015898cb8cb6dce549 100644
--- a/src/OpenFOAM/fields/GeometricFields/transformGeometricField/transformGeometricField.C
+++ b/src/OpenFOAM/fields/GeometricFields/transformGeometricField/transformGeometricField.C
@@ -82,7 +82,7 @@ void Foam::transform
 
 
 template<class Type, template<class> class PatchField, class GeoMesh>
-Foam::tmp<Foam::GeometricField<Type, PatchField, GeoMesh>> 
+Foam::tmp<Foam::GeometricField<Type, PatchField, GeoMesh>>
 Foam::transform
 (
     const GeometricField<tensor, PatchField, GeoMesh>& rot,
diff --git a/src/OpenFOAM/primitives/strings/fileName/fileName.H b/src/OpenFOAM/primitives/strings/fileName/fileName.H
index 65ec0b81dceefa5f64df6162d00c6b760df91615..25e986fbea8ed011a5808f2a58158426247dc6d4 100644
--- a/src/OpenFOAM/primitives/strings/fileName/fileName.H
+++ b/src/OpenFOAM/primitives/strings/fileName/fileName.H
@@ -145,7 +145,7 @@ public:
         inline static bool valid(char c);
 
         //- Construct fileName with no invalid characters, possibly applying
-        //- other transformations such as changing the path separator, 
+        //- other transformations such as changing the path separator,
         //- removing duplicate or trailing slashes, etc.
         static fileName validate(const std::string& s, const bool doClean=true);
 
diff --git a/src/dynamicFvMesh/dynamicRefineBalancedFvMesh/dynamicMeshDict b/src/dynamicFvMesh/dynamicRefineBalancedFvMesh/dynamicMeshDict
index 26266da87ff6b739b59c5045d3fc5188ec5616dd..d19bce3ba5d91e31a796eb3d3e59c04bd28546dd 100644
--- a/src/dynamicFvMesh/dynamicRefineBalancedFvMesh/dynamicMeshDict
+++ b/src/dynamicFvMesh/dynamicRefineBalancedFvMesh/dynamicMeshDict
@@ -20,50 +20,50 @@ dynamicFvMesh   dynamicRefineBalancedFvMesh;
 refinementControls
 {
     enableRefinementControl  true;
-    
+
     fields // must be scalarFields
     (
         //alpha (min max refineLevel)
         alpha (0.01 0.99 2) // refine cells where alpha in [0.01:0.99] with maximal 2 refinement layers
     );
-    
+
     interface // must be a scalarField (only one dictionary!)
     (
-        alpha // refine interface (found based on snGrad of alpha > 0.1) 
+        alpha // refine interface (found based on snGrad of alpha > 0.1)
         {
             innerRefLayers 2; // describes how many cell layers inside phase alpha are to be refined
             outerRefLayers 5; // describes how many cell layers outside phase alpha are to be refined
-            
+
             // optional settings:
             maxRefineLevel 4; // max refinement layers; Default: maxRefinement from dynamicRefineFvMeshCoeffs is used
             // to get slower than 2:1 refinement; add #nAddLayers between each refinement level at the interface
-            nAddLayers 1; //Default: 0 
+            nAddLayers 1; //Default: 0
         }
     );
-    
+
     gradients // must be scalars
     (
         // arguments as in 'fields'
         // min/max values are based on mag(fvc::grad(volScalarField)) * cellVolume
         T    (0.01 10 1)
     );
-    
+
     curls // must be vectors
     (
         // arguments as in 'fields'
         // min/max values are based on mag(fvc::curl(volVectorField))
         U   (0.5 1 2)
     );
-    
+
     regions
     (
         boxToCell
         {
             minLevel 1;
-            
+
             box (-1 0.001 0.002)(1 0.005 0.003);
         }
-        
+
     );
 }
 
@@ -75,27 +75,27 @@ dynamicRefineFvMeshCoeffs
 
     // How often to refine
     refineInterval  10;
-    
+
     // Field to be refinement on (set it to 'internalRefinementField' to use the
     // refinementControls dictionary entries above)
     field           internalRefinementField;
-    
+
     // Refine field inbetween lower..upper
     lowerRefineLevel 0.5; // do not change
     upperRefineLevel 3.5; // maxRefinement+0.5
-    
+
     // If value < unrefineLevel unrefine
     unrefineLevel   -0.5; // do not change
-    
+
     // Have slower than 2:1 refinement
     nBufferLayers   4;
-    
+
     // Refine cells only up to maxRefinement levels
     maxRefinement   3;
-    
+
     // Stop refinement if maxCells reached
     maxCells        200000;
-    
+
     // Flux field and corresponding velocity field. Fluxes on changed
     // faces get recalculated by interpolating the velocity. Use 'none'
     // on surfaceScalarFields that do not need to be reinterpolated.
@@ -116,7 +116,7 @@ dynamicRefineFvMeshCoeffs
         Uf
         Uf_0
     );
-    
+
     // Write the refinement level as a volScalarField
     dumpLevel       true;
 }
diff --git a/src/dynamicMesh/motionSmoother/motionSmootherAlgoTemplates.C b/src/dynamicMesh/motionSmoother/motionSmootherAlgoTemplates.C
index e3f1217e54710c91438984cb399b76aec5a26db2..ebd13df323eae6a6c8113b048a091c1170614610 100644
--- a/src/dynamicMesh/motionSmoother/motionSmootherAlgoTemplates.C
+++ b/src/dynamicMesh/motionSmoother/motionSmootherAlgoTemplates.C
@@ -300,7 +300,7 @@ Type Foam::motionSmootherAlgo::get
 )
 {
     Type val(defaultValue);
-    
+
     if
     (
        !dict.readEntry
diff --git a/src/finiteArea/finiteArea/d2dt2Schemes/faD2dt2Scheme/faD2dt2Schemes.C b/src/finiteArea/finiteArea/d2dt2Schemes/faD2dt2Scheme/faD2dt2Schemes.C
index 618494ec5aada52d40c85fcc501df92bce93ba2d..c17df00db8886fc9dbfe6c1ffc7ed14e1dd7a948 100644
--- a/src/finiteArea/finiteArea/d2dt2Schemes/faD2dt2Scheme/faD2dt2Schemes.C
+++ b/src/finiteArea/finiteArea/d2dt2Schemes/faD2dt2Scheme/faD2dt2Schemes.C
@@ -42,19 +42,19 @@ namespace fa
 
 defineTemplateRunTimeSelectionTable
 (
-    faD2dt2Scheme<scalar>, 
+    faD2dt2Scheme<scalar>,
     Istream
 );
 
 defineTemplateRunTimeSelectionTable
 (
-    faD2dt2Scheme<vector>, 
+    faD2dt2Scheme<vector>,
     Istream
 );
 
 defineTemplateRunTimeSelectionTable
 (
-    faD2dt2Scheme<tensor>, 
+    faD2dt2Scheme<tensor>,
     Istream
 );
 
diff --git a/src/finiteVolume/cfdTools/compressible/createDpdt.H b/src/finiteVolume/cfdTools/compressible/createDpdt.H
index aabc296ae09aebeca9f66314782a91a9057f72cf..de366f284366f570dd3bdee2552225e805defca6 100644
--- a/src/finiteVolume/cfdTools/compressible/createDpdt.H
+++ b/src/finiteVolume/cfdTools/compressible/createDpdt.H
@@ -14,7 +14,7 @@ if (mesh.dynamic())
     // Note
     // - set to READ_IF_PRESENT and AUTO_WRITE to simplify dpdt correction
     //   by meshPhi
-    
+
     dpdtHeader.readOpt() = IOobject::READ_IF_PRESENT;
     dpdtHeader.writeOpt() = IOobject::AUTO_WRITE;
 }
diff --git a/src/finiteVolume/fields/fvPatchFields/derived/turbulentDigitalFilterInlet/turbulentDigitalFilterInletFvPatchVectorField.C b/src/finiteVolume/fields/fvPatchFields/derived/turbulentDigitalFilterInlet/turbulentDigitalFilterInletFvPatchVectorField.C
index c1a2b841ab12d7059d32fd7a0c381e5079bc39c7..7e237d9cd5663be8f30874c76830e86093114032 100644
--- a/src/finiteVolume/fields/fvPatchFields/derived/turbulentDigitalFilterInlet/turbulentDigitalFilterInletFvPatchVectorField.C
+++ b/src/finiteVolume/fields/fvPatchFields/derived/turbulentDigitalFilterInlet/turbulentDigitalFilterInletFvPatchVectorField.C
@@ -344,7 +344,7 @@ initLenRandomBox() const
 
         // Refer to 'computeFilterCoeffs()'
         const label n = ceil(L_[i]);
-        const label twiceN = 4*n;       
+        const label twiceN = 4*n;
 
         // Initialise: Random-number set sizes
         lenRandomBox[i] = lenGrid[sliceI] + twiceN;
@@ -575,7 +575,7 @@ void Foam::turbulentDigitalFilterInletFvPatchVectorField::embedTwoPointCorrs()
         const List<scalar>& filter1 = filterCoeffs_[dir];
         const List<scalar>& filter2 = filterCoeffs_[3 + dir];
         const List<scalar>& filter3 = filterCoeffs_[6 + dir];
-        
+
         const label sz1 = lenRandomBox_[dir];
         const label sz2 = lenRandomBox_[3 + dir];
         const label sz3 = lenRandomBox_[6 + dir];
diff --git a/src/finiteVolume/fields/fvPatchFields/derived/turbulentDigitalFilterInlet/turbulentDigitalFilterInletFvPatchVectorField.H b/src/finiteVolume/fields/fvPatchFields/derived/turbulentDigitalFilterInlet/turbulentDigitalFilterInletFvPatchVectorField.H
index 2ec5ef8c7ebd8e76e7fab791461a278910d91489..22bbe4d8f1acb3527dc09417a5655733cb474718 100644
--- a/src/finiteVolume/fields/fvPatchFields/derived/turbulentDigitalFilterInlet/turbulentDigitalFilterInletFvPatchVectorField.H
+++ b/src/finiteVolume/fields/fvPatchFields/derived/turbulentDigitalFilterInlet/turbulentDigitalFilterInletFvPatchVectorField.H
@@ -37,7 +37,7 @@ Description
 
     \verbatim
     Klein, M., Sadiki, A., and Janicka, J.
-        A digital filter based generation of inflow data for spatially 
+        A digital filter based generation of inflow data for spatially
         developing direct numerical or large eddy simulations,
         Journal of Computational Physics (2003) 186(2):652-665.
         doi:10.1016/S0021-9991(03)00090-1
@@ -47,7 +47,7 @@ Description
 
     \verbatim
     Xie, Z.-T., and Castro, I.
-        Efficient generation of inflow conditions for large eddy simulation of 
+        Efficient generation of inflow conditions for large eddy simulation of
         street-scale flows, Flow, Turbulence and Combustion (2008) 81(3):449-470
         doi:10.1007/s10494-008-9151-5
     \endverbatim
@@ -130,7 +130,7 @@ Usage
         const1FSM           -0.7854         //-0.25*PI;
         const2FSM           -1.5707;        //-0.5*PI;
     }
-    \endverbatim 
+    \endverbatim
 
     Among the dictionary entries, two entries can be input as patch profiles:
 
@@ -308,7 +308,7 @@ class turbulentDigitalFilterInletFvPatchVectorField
         //- Mean inlet velocity profile in global coordinates [m/s]
         vectorField UMean_;
 
-        //- Integral length-scale set per turbulence plane section in local 
+        //- Integral length-scale set per turbulence plane section in local
         //- coordinates (e1u, e1v, e1w, e2u, e2v, e2w, e3u, e3v, e3w) [m]
         //  First three entries should always correspond to the length scales
         //  in association with the convective mean flow direction
diff --git a/src/finiteVolume/fields/fvPatchFields/derived/turbulentDigitalFilterInlet/turbulentDigitalFilterInletFvPatchVectorFieldTemplates.C b/src/finiteVolume/fields/fvPatchFields/derived/turbulentDigitalFilterInlet/turbulentDigitalFilterInletFvPatchVectorFieldTemplates.C
index f43b2a2d9f99679d4e3603d85e4c9faf1187838f..13eecde72ff371ff482853436e776385915a0a0f 100644
--- a/src/finiteVolume/fields/fvPatchFields/derived/turbulentDigitalFilterInlet/turbulentDigitalFilterInletFvPatchVectorFieldTemplates.C
+++ b/src/finiteVolume/fields/fvPatchFields/derived/turbulentDigitalFilterInlet/turbulentDigitalFilterInletFvPatchVectorFieldTemplates.C
@@ -3,7 +3,7 @@
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
     \\  /    A nd           | Copyright (C) 2016 - 2019 OpenCFD Ltd.
-     \\/     M anipulation  | 
+     \\/     M anipulation  |
 -------------------------------------------------------------------------------
                               Copyright (C) 2015 OpenFOAM Foundation
 -------------------------------------------------------------------------------
diff --git a/src/finiteVolume/fvMatrices/solvers/isoAdvection/isoAdvection/isoAdvection.C b/src/finiteVolume/fvMatrices/solvers/isoAdvection/isoAdvection/isoAdvection.C
index edb2d75f1c9ca0d79a39c666e41fc2238ed5e3ee..7a2f65c9404963054eef6a4e4ad4528b509caaca 100644
--- a/src/finiteVolume/fvMatrices/solvers/isoAdvection/isoAdvection/isoAdvection.C
+++ b/src/finiteVolume/fvMatrices/solvers/isoAdvection/isoAdvection/isoAdvection.C
@@ -307,8 +307,8 @@ void Foam::isoAdvection::timeIntegratedFlux()
                 // Note: We will like all point neighbours to interface cells to
                 // be checked. Especially if the interface leaves a cell during
                 // a time step, it may enter a point neighbour which should also
-                // be treated like a surface cell. Its interface normal should 
-                // somehow be inherrited from its upwind cells from which it 
+                // be treated like a surface cell. Its interface normal should
+                // somehow be inherrited from its upwind cells from which it
                 // receives the interface.
                 const labelList& nNeighbourCells = cellCells[otherCell];
                 forAll(nNeighbourCells, ni)
diff --git a/src/finiteVolume/fvMatrices/solvers/isoAdvection/isoCutFace/isoCutFace.H b/src/finiteVolume/fvMatrices/solvers/isoAdvection/isoCutFace/isoCutFace.H
index e1404e74415b978a38e3a1ea53e99ea20f3d6f43..bdc227d93ae41a254b744754a41004532b589491 100644
--- a/src/finiteVolume/fvMatrices/solvers/isoAdvection/isoCutFace/isoCutFace.H
+++ b/src/finiteVolume/fvMatrices/solvers/isoAdvection/isoCutFace/isoCutFace.H
@@ -160,7 +160,7 @@ public:
         const DynamicList<point>& surfacePoints() const;
 
         void clearStorage();
-        
+
         //- Calculate volumetric face transport during dt given the isoFace
         //  data provided as input for face facei
         scalar timeIntegratedFaceFlux
@@ -174,7 +174,7 @@ public:
             const scalar phi,
             const scalar magSf
         );
-        
+
         //- Calculate time integrated area for a face
         scalar timeIntegratedArea
         (
diff --git a/src/functionObjects/field/columnAverage/columnAverage.C b/src/functionObjects/field/columnAverage/columnAverage.C
index 68fafdfe2724c0b2b67be5516c3cdf01c76d8718..b87ed70742d958907f073613c9dd1be2a204ca3f 100644
--- a/src/functionObjects/field/columnAverage/columnAverage.C
+++ b/src/functionObjects/field/columnAverage/columnAverage.C
@@ -111,7 +111,7 @@ const Foam::word Foam::functionObjects::columnAverage::averageName
     const word& fieldName
 ) const
 {
-    return name() + ":columnAverage(" + fieldName + ")"; 
+    return name() + ":columnAverage(" + fieldName + ")";
 }
 
 
diff --git a/src/functionObjects/field/heatTransferCoeff/heatTransferCoeffModels/fixedReferenceTemperature/fixedReferenceTemperature.H b/src/functionObjects/field/heatTransferCoeff/heatTransferCoeffModels/fixedReferenceTemperature/fixedReferenceTemperature.H
index 96b1c5eacc11951484737acf4dc90b9f274b79ee..2c3e153b237bac25ca19ca7b28ea66aefb7423ac 100644
--- a/src/functionObjects/field/heatTransferCoeff/heatTransferCoeffModels/fixedReferenceTemperature/fixedReferenceTemperature.H
+++ b/src/functionObjects/field/heatTransferCoeff/heatTransferCoeffModels/fixedReferenceTemperature/fixedReferenceTemperature.H
@@ -29,7 +29,7 @@ Description
     temperature
 
     The heat transfer coefficient is specified by:
-    
+
     \f[
         h = \frac{q}{T_{ref} - T_w}
     \f]
diff --git a/src/functionObjects/field/heatTransferCoeff/heatTransferCoeffModels/localReferenceTemperature/localReferenceTemperature.H b/src/functionObjects/field/heatTransferCoeff/heatTransferCoeffModels/localReferenceTemperature/localReferenceTemperature.H
index 711196c5e31f8b59a165d1333eec1ff5c46a5e52..3fea1297a2cee356477a619d621455b64e04f7bd 100644
--- a/src/functionObjects/field/heatTransferCoeff/heatTransferCoeffModels/localReferenceTemperature/localReferenceTemperature.H
+++ b/src/functionObjects/field/heatTransferCoeff/heatTransferCoeffModels/localReferenceTemperature/localReferenceTemperature.H
@@ -29,7 +29,7 @@ Description
     field as the reference temperature
 
     The heat transfer coefficient is specified by:
-    
+
     \f[
         h = \frac{q}{T_c - T_w}
     \f]
diff --git a/src/functionObjects/graphics/runTimePostProcessing/pointData.C b/src/functionObjects/graphics/runTimePostProcessing/pointData.C
index 577c6d6c5ce6fd1be0461dce8734f2789b9f9a84..59b373f246aef9b54bacb7678e8877c69cdbc586 100644
--- a/src/functionObjects/graphics/runTimePostProcessing/pointData.C
+++ b/src/functionObjects/graphics/runTimePostProcessing/pointData.C
@@ -3,7 +3,7 @@
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     |
     \\  /    A nd           | Copyright (C) 2004-2010, 2015-2019 OpenCFD Ltd.
-     \\/     M anipulation  | 
+     \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
     This file is part of OpenFOAM.
diff --git a/src/mesh/snappyHexMesh/snappyHexMeshDriver/snappyRefineDriver.C b/src/mesh/snappyHexMesh/snappyHexMeshDriver/snappyRefineDriver.C
index cde402e87224c8caffe0afa487246d37a5158e29..27350487a3b4313b0d6680a0061594eb82aad5d0 100644
--- a/src/mesh/snappyHexMesh/snappyHexMeshDriver/snappyRefineDriver.C
+++ b/src/mesh/snappyHexMesh/snappyHexMeshDriver/snappyRefineDriver.C
@@ -2008,7 +2008,7 @@ void Foam::snappyRefineDriver::mergeAndSmoothRatio
             {
                 if (debug)
                 {
-                    Pout<< "Converged with iteration " << iter 
+                    Pout<< "Converged with iteration " << iter
                         << " initResidual: " << initResidual
                         << " final residual : " << res << endl;
                 }
@@ -2055,7 +2055,7 @@ Foam::label Foam::snappyRefineDriver::directionalSmooth
 
     forAll(shells.nSmoothExpansion(), shellI)
     {
-        if 
+        if
         (
             shells.nSmoothExpansion()[shellI] > 0
          || shells.nSmoothPosition()[shellI] > 0
@@ -2117,20 +2117,20 @@ Foam::label Foam::snappyRefineDriver::directionalSmooth
                 }
             }
 
-            // Get the extreme of smoothing region and 
+            // Get the extreme of smoothing region and
             // normalize all points within
-            const scalar totalLength = 
+            const scalar totalLength =
                 geometry[surfi].bounds().span()
               & userDirection;
-            const scalar startPosition = 
-                geometry[surfi].bounds().min() 
+            const scalar startPosition =
+                geometry[surfi].bounds().min()
               & userDirection;
 
             scalarField normalizedPosition(pointLabels.size(), Zero);
             forAll(pointLabels, i)
             {
                 label pointi = pointLabels[i];
-                normalizedPosition[i] = 
+                normalizedPosition[i] =
                   (
                     ((baseMesh.points()[pointi]&userDirection) - startPosition)
                   / totalLength
@@ -3011,7 +3011,7 @@ void Foam::snappyRefineDriver::doRefine
         100    // maxIter
     );
 
-    if 
+    if
     (
         max(meshRefiner_.shells().nSmoothExpansion()) > 0
      || max(meshRefiner_.shells().nSmoothPosition()) > 0