diff --git a/applications/test/CompactListList/Test-CompactListList.C b/applications/test/CompactListList/Test-CompactListList.C
index ab5911d2b..991275823 100644
--- a/applications/test/CompactListList/Test-CompactListList.C
+++ b/applications/test/CompactListList/Test-CompactListList.C
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     | Website:  https://openfoam.org
-    \\  /    A nd           | Copyright (C) 2011-2018 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2019 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -145,7 +145,7 @@ int main(int argc, char *argv[])
         fcs[1] = face(labelList(2, 222));
 
         CompactListList<label, face> compactFcs(fcs);
-        Info<< "comactFcs:" << compactFcs << endl;
+        Info<< "compactFcs:" << compactFcs << endl;
 
         faceList fcs2 = compactFcs();
         Info<< "fcs2:" << fcs2 << endl;
diff --git a/applications/test/alloc/Test-new.C b/applications/test/alloc/Test-new.C
index 7609172b0..050c19349 100644
--- a/applications/test/alloc/Test-new.C
+++ b/applications/test/alloc/Test-new.C
@@ -22,7 +22,7 @@ main()
 
     cerr << "deallocated ints\n";
 
-    cerr << "alloacting doubles\n";
+    cerr << "allocating doubles\n";
 
     double* doubles = new double[500000];
 
diff --git a/applications/utilities/mesh/advanced/modifyMesh/modifyMesh.C b/applications/utilities/mesh/advanced/modifyMesh/modifyMesh.C
index 0ccbe5132..388171897 100644
--- a/applications/utilities/mesh/advanced/modifyMesh/modifyMesh.C
+++ b/applications/utilities/mesh/advanced/modifyMesh/modifyMesh.C
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     | Website:  https://openfoam.org
-    \\  /    A nd           | Copyright (C) 2011-2018 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2019 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -517,7 +517,7 @@ int main(int argc, char *argv[])
         {
             Info<< "Could not insert mesh edge " << edgeI
                 << " for input point " << pts.first() << nl
-                << "Perhaps the edge is already marked for collaping?" << endl;
+                << "Perhaps the edge is already marked for collapsing?" << endl;
 
             validInputs = false;
         }
diff --git a/applications/utilities/mesh/conversion/plot3dToFoam/hexBlock.C b/applications/utilities/mesh/conversion/plot3dToFoam/hexBlock.C
index b3d0d748b..95a2f1a58 100644
--- a/applications/utilities/mesh/conversion/plot3dToFoam/hexBlock.C
+++ b/applications/utilities/mesh/conversion/plot3dToFoam/hexBlock.C
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     | Website:  https://openfoam.org
-    \\  /    A nd           | Copyright (C) 2011-2018 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2019 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -112,7 +112,7 @@ hexBlock::hexBlock(const label nx, const label ny, const label nz)
 void hexBlock::readPoints
 (
     const bool readBlank,
-    const scalar twoDThicknes,
+    const scalar twoDThickness,
     Istream& is
 )
 {
@@ -120,7 +120,7 @@ void hexBlock::readPoints
 
     label nPoints = points_.size();
 
-    if (twoDThicknes > 0)
+    if (twoDThickness > 0)
     {
         nPoints /= 2;
     }
@@ -137,7 +137,7 @@ void hexBlock::readPoints
         is  >> points_[i].y();
     }
 
-    if (twoDThicknes > 0)
+    if (twoDThickness > 0)
     {
         Info<< "Extruding " << nPoints << " points in z direction..." << endl;
         // Duplicate points
@@ -148,7 +148,7 @@ void hexBlock::readPoints
         for (label i=0; i < nPoints; i++)
         {
             points_[i].z() = 0;
-            points_[i+nPoints].z() = twoDThicknes;
+            points_[i+nPoints].z() = twoDThickness;
         }
     }
     else
diff --git a/applications/utilities/mesh/conversion/plot3dToFoam/hexBlock.H b/applications/utilities/mesh/conversion/plot3dToFoam/hexBlock.H
index 8ca50256b..e54df8ec9 100644
--- a/applications/utilities/mesh/conversion/plot3dToFoam/hexBlock.H
+++ b/applications/utilities/mesh/conversion/plot3dToFoam/hexBlock.H
@@ -149,7 +149,7 @@ public:
         void readPoints
         (
             const bool readBlank,
-            const scalar twoDThicknes,
+            const scalar twoDThickness,
             Istream&
         );
 };
diff --git a/applications/utilities/mesh/conversion/sammToFoam/fixCollapsedEdges.C b/applications/utilities/mesh/conversion/sammToFoam/fixCollapsedEdges.C
index 133215288..ca667488e 100644
--- a/applications/utilities/mesh/conversion/sammToFoam/fixCollapsedEdges.C
+++ b/applications/utilities/mesh/conversion/sammToFoam/fixCollapsedEdges.C
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     | Website:  https://openfoam.org
-    \\  /    A nd           | Copyright (C) 2011-2018 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2019 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -93,7 +93,7 @@ void Foam::sammMesh::fixCollapsedEdges()
                 forAll(vertexLabels, vI)
                 {
                     // In order for a face to be a valid entity, duplicate
-                    // vertices can only be consecutive (othervise, the
+                    // vertices can only be consecutive (otherwise, the
                     // collapse creates an invalid face). We shall use this
                     // property in the creation of the collapsed face
 
@@ -130,7 +130,7 @@ void Foam::sammMesh::fixCollapsedEdges()
                 {
                     FatalErrorInFunction
                         << "face " << facei << " of cell " << celli
-                        << " is colapsed down to a point or edge, which is "
+                        << " is collapsed down to a point or edge, which is "
                         << "not permitted" << endl
                         << "original face: " << vertexLabels << endl
                         << "purged face: " << newFace << endl
diff --git a/applications/utilities/mesh/conversion/star3ToFoam/fixCollapsedEdges.C b/applications/utilities/mesh/conversion/star3ToFoam/fixCollapsedEdges.C
index 87bc29b29..a01ebc0fc 100644
--- a/applications/utilities/mesh/conversion/star3ToFoam/fixCollapsedEdges.C
+++ b/applications/utilities/mesh/conversion/star3ToFoam/fixCollapsedEdges.C
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     | Website:  https://openfoam.org
-    \\  /    A nd           | Copyright (C) 2011-2018 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2019 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -92,7 +92,7 @@ void Foam::starMesh::fixCollapsedEdges()
                 forAll(vertexLabels, vI)
                 {
                     // In order for a face to be a valid entity, duplicate
-                    // vertices can only be consecutive (othervise, the
+                    // vertices can only be consecutive (otherwise, the
                     // collapse creates an invalid face). We shall use this
                     // property in the creation of the collapsed face
 
@@ -129,7 +129,7 @@ void Foam::starMesh::fixCollapsedEdges()
                 {
                     FatalErrorInFunction
                         << "Face " << facei << " of cell " << celli
-                        << " is colapsed down to a point or edge, which is "
+                        << " is collapsed down to a point or edge, which is "
                         << "not permitted" << endl
                         << "original face: " << vertexLabels << endl
                         << "purged face: " << newFace << endl
diff --git a/applications/utilities/mesh/conversion/tetgenToFoam/tetgenToFoam.C b/applications/utilities/mesh/conversion/tetgenToFoam/tetgenToFoam.C
index d4846b1db..1e57763b4 100644
--- a/applications/utilities/mesh/conversion/tetgenToFoam/tetgenToFoam.C
+++ b/applications/utilities/mesh/conversion/tetgenToFoam/tetgenToFoam.C
@@ -268,7 +268,7 @@ int main(int argc, char *argv[])
     if (nElemAttr != 0)
     {
         WarningInFunction
-            << "Element attributes (third elemenent in .ele header)"
+            << "Element attributes (third element in .ele header)"
             << " not used" << endl;
     }
 
diff --git a/applications/utilities/thermophysical/chemkinToFoam/chemkinReader/chemkinReader.H b/applications/utilities/thermophysical/chemkinToFoam/chemkinReader/chemkinReader.H
index e30e881c9..8f55e2604 100644
--- a/applications/utilities/thermophysical/chemkinToFoam/chemkinReader/chemkinReader.H
+++ b/applications/utilities/thermophysical/chemkinToFoam/chemkinReader/chemkinReader.H
@@ -232,7 +232,7 @@ private:
         void checkCoeffs
         (
             const scalarList& reactionCoeffs,
-            const char* reationRateName,
+            const char* reactionRateName,
             const label nCoeffs
         ) const;
 
diff --git a/src/OpenFOAM/matrices/LduMatrix/LduMatrix/LduMatrixPreconditioner.C b/src/OpenFOAM/matrices/LduMatrix/LduMatrix/LduMatrixPreconditioner.C
index 7f1142462..2264a98db 100644
--- a/src/OpenFOAM/matrices/LduMatrix/LduMatrix/LduMatrixPreconditioner.C
+++ b/src/OpenFOAM/matrices/LduMatrix/LduMatrix/LduMatrixPreconditioner.C
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     | Website:  https://openfoam.org
-    \\  /    A nd           | Copyright (C) 2011-2018 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2019 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -94,7 +94,7 @@ Foam::LduMatrix<Type, DType, LUType>::preconditioner::New
         FatalIOErrorInFunction
         (
             preconditionerDict
-        )   << "cannot preconditione incomplete matrix, "
+        )   << "cannot precondition incomplete matrix, "
                "no diagonal or off-diagonal coefficient"
             << exit(FatalIOError);
 
diff --git a/src/OpenFOAM/matrices/lduMatrix/solvers/GAMG/interfaces/processorGAMGInterface/processorGAMGInterface.C b/src/OpenFOAM/matrices/lduMatrix/solvers/GAMG/interfaces/processorGAMGInterface/processorGAMGInterface.C
index bca58cde0..8eaff8df6 100644
--- a/src/OpenFOAM/matrices/lduMatrix/solvers/GAMG/interfaces/processorGAMGInterface/processorGAMGInterface.C
+++ b/src/OpenFOAM/matrices/lduMatrix/solvers/GAMG/interfaces/processorGAMGInterface/processorGAMGInterface.C
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     | Website:  https://openfoam.org
-    \\  /    A nd           | Copyright (C) 2011-2018 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2019 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -142,7 +142,7 @@ Foam::processorGAMGInterface::processorGAMGInterface
     const label index,
     const lduInterfacePtrsList& coarseInterfaces,
     const labelUList& faceCells,
-    const labelUList& faceRestrictAddresssing,
+    const labelUList& faceRestrictAddressing,
     const label coarseComm,
     const label myProcNo,
     const label neighbProcNo,
@@ -155,7 +155,7 @@ Foam::processorGAMGInterface::processorGAMGInterface
         index,
         coarseInterfaces,
         faceCells,
-        faceRestrictAddresssing
+        faceRestrictAddressing
     ),
     comm_(coarseComm),
     myProcNo_(myProcNo),
diff --git a/src/dynamicMesh/polyTopoChange/polyTopoChange/hexRef8/hexRef8.C b/src/dynamicMesh/polyTopoChange/polyTopoChange/hexRef8/hexRef8.C
index 3358a0604..1e0748237 100644
--- a/src/dynamicMesh/polyTopoChange/polyTopoChange/hexRef8/hexRef8.C
+++ b/src/dynamicMesh/polyTopoChange/polyTopoChange/hexRef8/hexRef8.C
@@ -5642,7 +5642,7 @@ void Foam::hexRef8::setUnrefinement
         if (facesToRemove.size() != splitFaces.size())
         {
             FatalErrorInFunction
-                << "Ininitial set of split points to unrefine does not"
+                << "Initial set of split points to unrefine does not"
                 << " seem to be consistent or not mid points of refined cells"
                 << abort(FatalError);
         }
@@ -5685,7 +5685,7 @@ void Foam::hexRef8::setUnrefinement
                 if (region == -1)
                 {
                     FatalErrorInFunction
-                        << "Ininitial set of split points to unrefine does not"
+                        << "Initial set of split points to unrefine does not"
                         << " seem to be consistent or not mid points"
                         << " of refined cells" << nl
                         << "cell:" << celli << " on splitPoint " << pointi
diff --git a/src/lagrangian/DSMC/submodels/InflowBoundaryModel/FreeStream/FreeStream.C b/src/lagrangian/DSMC/submodels/InflowBoundaryModel/FreeStream/FreeStream.C
index 0db5728fa..702711d40 100644
--- a/src/lagrangian/DSMC/submodels/InflowBoundaryModel/FreeStream/FreeStream.C
+++ b/src/lagrangian/DSMC/submodels/InflowBoundaryModel/FreeStream/FreeStream.C
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     | Website:  https://openfoam.org
-    \\  /    A nd           | Copyright (C) 2011-2018 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2019 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -246,7 +246,7 @@ void Foam::FreeStream<CloudType>::inflow()
             // Cumulative triangle area fractions
             List<scalar> cTriAFracs(faceTets.size(), 0.0);
 
-            scalar previousCummulativeSum = 0.0;
+            scalar previousCumulativeSum = 0.0;
 
             forAll(faceTets, triI)
             {
@@ -254,9 +254,9 @@ void Foam::FreeStream<CloudType>::inflow()
 
                 cTriAFracs[triI] =
                     faceTetIs.faceTri(mesh).mag()/fA
-                  + previousCummulativeSum;
+                  + previousCumulativeSum;
 
-                previousCummulativeSum = cTriAFracs[triI];
+                previousCumulativeSum = cTriAFracs[triI];
             }
 
             // Force the last area fraction value to 1.0 to avoid any
diff --git a/src/lagrangian/molecularDynamics/molecule/mdTools/createAutoCorrelationFunctions.H b/src/lagrangian/molecularDynamics/molecule/mdTools/createAutoCorrelationFunctions.H
index f5b726619..59cf32fc6 100644
--- a/src/lagrangian/molecularDynamics/molecule/mdTools/createAutoCorrelationFunctions.H
+++ b/src/lagrangian/molecularDynamics/molecule/mdTools/createAutoCorrelationFunctions.H
@@ -45,7 +45,7 @@ const dictionary& autocorrelationFunctionDict
 
 //- Velocity autocorrelation function
 
-Info << tab << "velocty" << endl;
+Info << tab << "velocity" << endl;
 
 const dictionary& velocityACFDict
 (
diff --git a/src/lagrangian/molecularDynamics/molecule/reducedUnits/reducedUnits.C b/src/lagrangian/molecularDynamics/molecule/reducedUnits/reducedUnits.C
index 1168c67e8..e7a937556 100644
--- a/src/lagrangian/molecularDynamics/molecule/reducedUnits/reducedUnits.C
+++ b/src/lagrangian/molecularDynamics/molecule/reducedUnits/reducedUnits.C
@@ -42,7 +42,7 @@ void Foam::reducedUnits::calcRefValues()
     )
     {
         FatalErrorInFunction
-            << "One of more referencence values too small for floating point "
+            << "One of more reference values too small for floating point "
             << "calculation: "
             << "refTime_ = " << refTime_
             << ", refLength = " << refTemp_
diff --git a/src/mesh/snappyHexMesh/snappyHexMeshDriver/layerParameters/layerParameters.C b/src/mesh/snappyHexMesh/snappyHexMeshDriver/layerParameters/layerParameters.C
index e949b8280..b8a16d630 100644
--- a/src/mesh/snappyHexMesh/snappyHexMeshDriver/layerParameters/layerParameters.C
+++ b/src/mesh/snappyHexMesh/snappyHexMeshDriver/layerParameters/layerParameters.C
@@ -392,8 +392,8 @@ Foam::layerParameters::layerParameters
 Foam::scalar Foam::layerParameters::layerThickness
 (
     const label nLayers,
-    const scalar firstLayerThickess,
-    const scalar finalLayerThickess,
+    const scalar firstLayerThickness,
+    const scalar finalLayerThickness,
     const scalar totalThickness,
     const scalar expansionRatio
 ) const
@@ -412,11 +412,11 @@ Foam::scalar Foam::layerParameters::layerThickness
         {
             if (mag(expansionRatio-1) < small)
             {
-                return firstLayerThickess * nLayers;
+                return firstLayerThickness * nLayers;
             }
             else
             {
-                return firstLayerThickess
+                return firstLayerThickness
                    *(1 - pow(expansionRatio, nLayers))
                    /(1 - expansionRatio);
             }
@@ -427,13 +427,13 @@ Foam::scalar Foam::layerParameters::layerThickness
         {
             if (mag(expansionRatio-1) < small)
             {
-                return finalLayerThickess * nLayers;
+                return finalLayerThickness * nLayers;
             }
             else
             {
                 const scalar invExpansion = 1.0/expansionRatio;
 
-                return finalLayerThickess
+                return finalLayerThickness
                    *(1 - pow(invExpansion, nLayers))
                    /(1 - invExpansion);
             }
@@ -453,8 +453,8 @@ Foam::scalar Foam::layerParameters::layerThickness
 Foam::scalar Foam::layerParameters::layerExpansionRatio
 (
     const label nLayers,
-    const scalar firstLayerThickess,
-    const scalar finalLayerThickess,
+    const scalar firstLayerThickness,
+    const scalar finalLayerThickness,
     const scalar totalThickness,
     const scalar expansionRatio
 ) const
@@ -474,7 +474,7 @@ Foam::scalar Foam::layerParameters::layerExpansionRatio
             return layerExpansionRatio
             (
                 nLayers,
-                totalThickness/firstLayerThickess
+                totalThickness/firstLayerThickness
             );
         }
         break;
@@ -486,7 +486,7 @@ Foam::scalar Foam::layerParameters::layerExpansionRatio
                /layerExpansionRatio
                 (
                     nLayers,
-                    totalThickness/finalLayerThickess
+                    totalThickness/finalLayerThickness
                 );
         }
         break;
@@ -504,8 +504,8 @@ Foam::scalar Foam::layerParameters::layerExpansionRatio
 Foam::scalar Foam::layerParameters::firstLayerThickness
 (
     const label nLayers,
-    const scalar firstLayerThickess,
-    const scalar finalLayerThickess,
+    const scalar firstLayerThickness,
+    const scalar finalLayerThickness,
     const scalar totalThickness,
     const scalar expansionRatio
 ) const
@@ -515,12 +515,12 @@ Foam::scalar Foam::layerParameters::firstLayerThickness
         case FIRST_AND_EXPANSION:
         case FIRST_AND_TOTAL:
         {
-            return firstLayerThickess;
+            return firstLayerThickness;
         }
 
         case FINAL_AND_EXPANSION:
         {
-            return finalLayerThickess*pow(1.0/expansionRatio, nLayers-1);
+            return finalLayerThickness*pow(1.0/expansionRatio, nLayers-1);
         }
         break;
 
@@ -529,13 +529,13 @@ Foam::scalar Foam::layerParameters::firstLayerThickness
             const scalar r = layerExpansionRatio
             (
                 nLayers,
-                firstLayerThickess,
-                finalLayerThickess,
+                firstLayerThickness,
+                finalLayerThickness,
                 totalThickness,
                 expansionRatio
             );
 
-            return finalLayerThickess/pow(r, nLayers-1);
+            return finalLayerThickness/pow(r, nLayers-1);
         }
         break;
 
diff --git a/src/mesh/snappyHexMesh/snappyHexMeshDriver/snappyLayerDriver.C b/src/mesh/snappyHexMesh/snappyHexMeshDriver/snappyLayerDriver.C
index 185658ce6..e881c15cd 100644
--- a/src/mesh/snappyHexMesh/snappyHexMeshDriver/snappyLayerDriver.C
+++ b/src/mesh/snappyHexMesh/snappyHexMeshDriver/snappyLayerDriver.C
@@ -414,7 +414,7 @@ void Foam::snappyLayerDriver::handleFeatureAngle
 
             forAll(eFaces, i)
             {
-                nomalsCombine()
+                normalsCombine()
                 (
                     edgeNormal[meshEdgeI],
                     pp.faceNormals()[eFaces[i]]
@@ -426,7 +426,7 @@ void Foam::snappyLayerDriver::handleFeatureAngle
         (
             mesh,
             edgeNormal,
-            nomalsCombine(),
+            normalsCombine(),
             point::max          // null value
         );
 
@@ -970,7 +970,7 @@ void Foam::snappyLayerDriver::determineSidePatches
     // Sometimes edges-to-be-extruded are on more than 2 processors.
     // Work out which 2 hold the faces to be extruded and thus which procpatch
     // the side-face should be in. As an additional complication this might
-    // mean that 2 procesors that were only edge-connected now suddenly need
+    // mean that 2 processors that were only edge-connected now suddenly need
     // to become face-connected i.e. have a processor patch between them.
 
     fvMesh& mesh = meshRefiner_.mesh();
@@ -2738,7 +2738,7 @@ bool Foam::snappyLayerDriver::writeLayerData
                     faceRealThickness
                 );
 
-                // Convert patchReal to relavtive thickness
+                // Convert patchReal to relative thickness
                 scalarField pfld(patchReal.size(), 0.0);
                 forAll(patchReal, i)
                 {
diff --git a/src/mesh/snappyHexMesh/snappyHexMeshDriver/snappyLayerDriver.H b/src/mesh/snappyHexMesh/snappyHexMeshDriver/snappyLayerDriver.H
index 325f87ee9..eab547072 100644
--- a/src/mesh/snappyHexMesh/snappyHexMeshDriver/snappyLayerDriver.H
+++ b/src/mesh/snappyHexMesh/snappyHexMeshDriver/snappyLayerDriver.H
@@ -75,7 +75,7 @@ private:
     // Private classes
 
         //- Combine operator class to combine normal with other normal.
-        class nomalsCombine
+        class normalsCombine
         {
         public:
 
diff --git a/src/meshTools/coordinateSystems/coordinateRotation/axesRotation.C b/src/meshTools/coordinateSystems/coordinateRotation/axesRotation.C
index 444114970..b5acd3903 100644
--- a/src/meshTools/coordinateSystems/coordinateRotation/axesRotation.C
+++ b/src/meshTools/coordinateSystems/coordinateRotation/axesRotation.C
@@ -87,7 +87,7 @@ void Foam::axesRotation::calcTransform
         default:
         {
             FatalErrorInFunction
-                << "Unhandled axes specifictation" << endl
+                << "Unhandled axes specification" << endl
                 << abort(FatalError);
 
             Rtr = Zero;
diff --git a/src/meshTools/coordinateSystems/coordinateRotation/cylindrical.C b/src/meshTools/coordinateSystems/coordinateRotation/cylindrical.C
index f6b63a18d..50f8ccb40 100644
--- a/src/meshTools/coordinateSystems/coordinateRotation/cylindrical.C
+++ b/src/meshTools/coordinateSystems/coordinateRotation/cylindrical.C
@@ -165,7 +165,7 @@ Foam::cylindrical::cylindrical(const dictionary& dict)
 {
     FatalErrorInFunction
         << " cylindrical can not be constructed from dictionary "
-        << " use the construtctor : "
+        << " use the constructor : "
            "("
            "    const dictionary&, const objectRegistry&"
            ")"
diff --git a/src/meshTools/sets/cellSources/rotatedBoxToCell/rotatedBoxToCell.C b/src/meshTools/sets/cellSources/rotatedBoxToCell/rotatedBoxToCell.C
index 3d4ced517..2a83fef61 100644
--- a/src/meshTools/sets/cellSources/rotatedBoxToCell/rotatedBoxToCell.C
+++ b/src/meshTools/sets/cellSources/rotatedBoxToCell/rotatedBoxToCell.C
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     | Website:  https://openfoam.org
-    \\  /    A nd           | Copyright (C) 2011-2018 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2019 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -43,7 +43,7 @@ Foam::topoSetSource::addToUsageTable Foam::rotatedBoxToCell::usage_
     rotatedBoxToCell::typeName,
     "\n    Usage: rotatedBoxToCell (originx originy originz)"
     " (ix iy iz) (jx jy jz) (kx ky kz)\n\n"
-    "    Select all cells with cellCentre within parallelopiped\n\n"
+    "    Select all cells with cellCentre within parallelepiped\n\n"
 );
 
 
diff --git a/src/parallel/decompose/decompositionMethods/hierarchGeomDecomp/hierarchGeomDecomp.C b/src/parallel/decompose/decompositionMethods/hierarchGeomDecomp/hierarchGeomDecomp.C
index 038f0436a..516d1b10e 100644
--- a/src/parallel/decompose/decompositionMethods/hierarchGeomDecomp/hierarchGeomDecomp.C
+++ b/src/parallel/decompose/decompositionMethods/hierarchGeomDecomp/hierarchGeomDecomp.C
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     | Website:  https://openfoam.org
-    \\  /    A nd           | Copyright (C) 2011-2018 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2019 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -306,7 +306,7 @@ void Foam::hierarchGeomDecomp::findBinary
         if (returnReduce(hasNotChanged, andOp<bool>()))
         {
             WarningInFunction
-                << "unable to find desired deomposition split, making do!"
+                << "unable to find desired decomposition split, making do!"
                 << endl;
             break;
         }
diff --git a/src/parallel/decompose/ptscotchDecomp/ptscotchDecomp.C b/src/parallel/decompose/ptscotchDecomp/ptscotchDecomp.C
index 1555a1f6c..05d69c060 100644
--- a/src/parallel/decompose/ptscotchDecomp/ptscotchDecomp.C
+++ b/src/parallel/decompose/ptscotchDecomp/ptscotchDecomp.C
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     | Website:  https://openfoam.org
-    \\  /    A nd           | Copyright (C) 2011-2018 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2019 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -543,7 +543,7 @@ Foam::label Foam::ptscotchDecomp::decompose
     {
         if (debug)
         {
-            Info<< "ptscotchDecomp : Using procesor weights "
+            Info<< "ptscotchDecomp : Using processor weights "
                 << processorWeights
                 << endl;
         }
diff --git a/src/parallel/decompose/scotchDecomp/scotchDecomp.C b/src/parallel/decompose/scotchDecomp/scotchDecomp.C
index f97192bee..f1ecc5e20 100644
--- a/src/parallel/decompose/scotchDecomp/scotchDecomp.C
+++ b/src/parallel/decompose/scotchDecomp/scotchDecomp.C
@@ -2,7 +2,7 @@
   =========                 |
   \\      /  F ield         | OpenFOAM: The Open Source CFD Toolbox
    \\    /   O peration     | Website:  https://openfoam.org
-    \\  /    A nd           | Copyright (C) 2011-2018 OpenFOAM Foundation
+    \\  /    A nd           | Copyright (C) 2011-2019 OpenFOAM Foundation
      \\/     M anipulation  |
 -------------------------------------------------------------------------------
 License
@@ -375,7 +375,7 @@ Foam::label Foam::scotchDecomp::decomposeOneProc
     {
         if (debug)
         {
-            Info<< "scotchDecomp : Using procesor weights " << processorWeights
+            Info<< "scotchDecomp : Using processor weights " << processorWeights
                 << endl;
         }
         check
