diff --git a/applications/solvers/modules/solid/solid.H b/applications/solvers/modules/solid/solid.H
index f13cab185a..70caee3af4 100644
--- a/applications/solvers/modules/solid/solid.H
+++ b/applications/solvers/modules/solid/solid.H
@@ -25,7 +25,7 @@ Class
     Foam::solvers::solid
 
 Description
-    Solver module for thermal transport is solid domains and regions for
+    Solver module for thermal transport in solid domains and regions for
     conjugate heat transfer, HVAC and similar applications, with optional mesh
     motion and mesh topology changes.
 
diff --git a/applications/utilities/postProcessing/graphics/PVReaders/vtkPVFoam/vtkPVFoam.H b/applications/utilities/postProcessing/graphics/PVReaders/vtkPVFoam/vtkPVFoam.H
index e0453478c7..77f754a4b2 100644
--- a/applications/utilities/postProcessing/graphics/PVReaders/vtkPVFoam/vtkPVFoam.H
+++ b/applications/utilities/postProcessing/graphics/PVReaders/vtkPVFoam/vtkPVFoam.H
@@ -292,7 +292,7 @@ class vtkPVFoam
         //  TODO: regions
         List<polyDecomp> regionPolyDecomp_;
 
-        //- Decomposed cells information (cellZonas)
+        //- Decomposed cells information (cellZones)
         List<polyDecomp> zonePolyDecomp_;
 
         //- Decomposed cells information (cellSets)
diff --git a/src/OpenFOAM/fields/Fields/Field/Field.H b/src/OpenFOAM/fields/Fields/Field/Field.H
index f204c097f6..365aee67d3 100644
--- a/src/OpenFOAM/fields/Fields/Field/Field.H
+++ b/src/OpenFOAM/fields/Fields/Field/Field.H
@@ -128,7 +128,7 @@ public:
         //- Construct given size and initial value
         Field(const label, const Type&);
 
-        //- Construct given size and initialed to zero
+        //- Construct given size and initialised to zero
         Field(const label, const zero);
 
         //- Copy constructor of a UList\<Type\>
diff --git a/src/OpenFOAM/fields/pointPatchFields/pointPatchField/pointConstraint/pointConstraintI.H b/src/OpenFOAM/fields/pointPatchFields/pointPatchField/pointConstraint/pointConstraintI.H
index a2ab324eb2..3d7fdd5520 100644
--- a/src/OpenFOAM/fields/pointPatchFields/pointPatchField/pointConstraint/pointConstraintI.H
+++ b/src/OpenFOAM/fields/pointPatchFields/pointPatchField/pointConstraint/pointConstraintI.H
@@ -84,7 +84,7 @@ inline void Foam::pointConstraint::combine(const pointConstraint& pc)
     {
         // Save single normal
         vector n = second();
-        // Apply to supplied point constaint
+        // Apply to supplied point constant
         operator=(pc);
         applyConstraint(n);
     }
diff --git a/src/OpenFOAM/global/fileOperations/masterUncollatedFileOperation/masterUncollatedFileOperation.H b/src/OpenFOAM/global/fileOperations/masterUncollatedFileOperation/masterUncollatedFileOperation.H
index af181d5d09..5c577e0801 100644
--- a/src/OpenFOAM/global/fileOperations/masterUncollatedFileOperation/masterUncollatedFileOperation.H
+++ b/src/OpenFOAM/global/fileOperations/masterUncollatedFileOperation/masterUncollatedFileOperation.H
@@ -481,7 +481,7 @@ protected:
         );
 
         //- Helper: check IO for local existence. Like filePathInfo but
-        //  without parent searchign and instance searching
+        //  without parent searching and instance searching
         bool exists(const dirIndexList&, IOobject& io) const;
 
 
diff --git a/src/OpenFOAM/matrices/lduMatrix/solvers/GAMG/GAMGSolver.H b/src/OpenFOAM/matrices/lduMatrix/solvers/GAMG/GAMGSolver.H
index 10fc424329..cf0f62bfe1 100644
--- a/src/OpenFOAM/matrices/lduMatrix/solvers/GAMG/GAMGSolver.H
+++ b/src/OpenFOAM/matrices/lduMatrix/solvers/GAMG/GAMGSolver.H
@@ -127,7 +127,7 @@ class GAMGSolver
         //- Hierarchy of interface internal coefficients
         PtrList<FieldField<Field, scalar>> interfaceLevelsIntCoeffs_;
 
-        //- LU decompsed coarsest matrix
+        //- LU decomposed coarsest matrix
         autoPtr<LUscalarMatrix> coarsestLUMatrixPtr_;
 
 
diff --git a/src/OpenFOAM/meshes/lduMesh/lduPrimitiveMesh.H b/src/OpenFOAM/meshes/lduMesh/lduPrimitiveMesh.H
index e77932e37c..ff2ebe7978 100644
--- a/src/OpenFOAM/meshes/lduMesh/lduPrimitiveMesh.H
+++ b/src/OpenFOAM/meshes/lduMesh/lduPrimitiveMesh.H
@@ -25,7 +25,7 @@ Class
     Foam::lduPrimitiveMesh
 
 Description
-    Simplest contrete lduMesh which stores the addressing needed by lduMatrix.
+    Simplest concrete lduMesh which stores the addressing needed by lduMatrix.
 
 SourceFiles
     lduPrimitiveMesh.C
diff --git a/src/OpenFOAM/meshes/meshShapes/cellModel/cellModelI.H b/src/OpenFOAM/meshes/meshShapes/cellModel/cellModelI.H
index 1fec6a597b..9195cf42c4 100644
--- a/src/OpenFOAM/meshes/meshShapes/cellModel/cellModelI.H
+++ b/src/OpenFOAM/meshes/meshShapes/cellModel/cellModelI.H
@@ -71,7 +71,7 @@ inline edgeList cellModel::edges(const labelList& pointLabels) const
 {
     edgeList e(edges_.size());
 
-    // Translate model lebels into global labels
+    // Translate model labels into global labels
     forAll(edges_, edgeI)
     {
          e[edgeI] =
diff --git a/src/OpenFOAM/meshes/polyMesh/polyPatches/constraint/processor/processorPolyPatch.H b/src/OpenFOAM/meshes/polyMesh/polyPatches/constraint/processor/processorPolyPatch.H
index 02c526bb57..fae25015ee 100644
--- a/src/OpenFOAM/meshes/polyMesh/polyPatches/constraint/processor/processorPolyPatch.H
+++ b/src/OpenFOAM/meshes/polyMesh/polyPatches/constraint/processor/processorPolyPatch.H
@@ -62,13 +62,13 @@ class processorPolyPatch
         int myProcNo_;
         int neighbProcNo_;
 
-        //- Processor-neighbbour patch face centres
+        //- Processor-neighbour patch face centres
         vectorField neighbFaceCentres_;
 
-        //- Processor-neighbbour patch face areas
+        //- Processor-neighbour patch face areas
         vectorField neighbFaceAreas_;
 
-        //- Processor-neighbbour patch neighbour cell centres
+        //- Processor-neighbour patch neighbour cell centres
         vectorField neighbFaceCellCentres_;
 
         //- Corresponding neighbouring local point label for every local point
@@ -243,19 +243,19 @@ public:
             const label neighbProcNo
         );
 
-        //- Return processor-neighbbour patch face centres
+        //- Return processor-neighbour patch face centres
         const vectorField& neighbFaceCentres() const
         {
             return neighbFaceCentres_;
         }
 
-        //- Return processor-neighbbour patch face areas
+        //- Return processor-neighbour patch face areas
         const vectorField& neighbFaceAreas() const
         {
             return neighbFaceAreas_;
         }
 
-        //- Return processor-neighbbour patch neighbour cell centres
+        //- Return processor-neighbour patch neighbour cell centres
         const vectorField& neighbFaceCellCentres() const
         {
             return neighbFaceCellCentres_;
diff --git a/src/finiteVolume/cfdTools/general/MRF/MRFZoneList.H b/src/finiteVolume/cfdTools/general/MRF/MRFZoneList.H
index 115681b955..99362d321a 100644
--- a/src/finiteVolume/cfdTools/general/MRF/MRFZoneList.H
+++ b/src/finiteVolume/cfdTools/general/MRF/MRFZoneList.H
@@ -25,7 +25,7 @@ Class
     Foam::MRFZoneList
 
 Description
-    List container for MRF zomes
+    List container for MRF zones
 
 SourceFiles
     MRFZoneList.C
diff --git a/src/finiteVolume/cfdTools/general/buoyancy/buoyancy.H b/src/finiteVolume/cfdTools/general/buoyancy/buoyancy.H
index 88d292abc7..cd39fa5986 100644
--- a/src/finiteVolume/cfdTools/general/buoyancy/buoyancy.H
+++ b/src/finiteVolume/cfdTools/general/buoyancy/buoyancy.H
@@ -40,7 +40,7 @@ Description
 
     The \c Foam::solvers::buoyancy::New function returns an \c autoPtr<buoyancy>
     pointer containing either a \c buoyancy class pointer if the \c p_rgh field
-    file is available othewise a \c nullptr which can be checked using
+    file is available otherwise a \c nullptr which can be checked using
     the \c autoPtr::valid() member function.
 
 SourceFiles
diff --git a/src/finiteVolume/fields/fvPatchFields/derived/activeBaffleVelocity/activeBaffleVelocityFvPatchVectorField.H b/src/finiteVolume/fields/fvPatchFields/derived/activeBaffleVelocity/activeBaffleVelocityFvPatchVectorField.H
index ca9fac17cf..1a92ff3750 100644
--- a/src/finiteVolume/fields/fvPatchFields/derived/activeBaffleVelocity/activeBaffleVelocityFvPatchVectorField.H
+++ b/src/finiteVolume/fields/fvPatchFields/derived/activeBaffleVelocity/activeBaffleVelocityFvPatchVectorField.H
@@ -57,7 +57,7 @@ Usage
         p            | pressure field name     | no          | p
         cyclicPatch  | cyclic patch name      | yes         |
         orientation  | 1 or -1 used to switch flow direction | yes|
-        openFraction | current opatch open fraction [0-1]| yes |
+        openFraction | current patch open fraction [0-1]| yes |
         openingTime  | time taken to open the baffle | yes |
         maxOpenFractionDelta | max open fraction change per timestep | yes |
     \endtable
diff --git a/src/finiteVolume/finiteVolume/ddtSchemes/CrankNicolsonDdtScheme/CrankNicolsonDdtScheme.H b/src/finiteVolume/finiteVolume/ddtSchemes/CrankNicolsonDdtScheme/CrankNicolsonDdtScheme.H
index 894e6370fe..5915d827de 100644
--- a/src/finiteVolume/finiteVolume/ddtSchemes/CrankNicolsonDdtScheme/CrankNicolsonDdtScheme.H
+++ b/src/finiteVolume/finiteVolume/ddtSchemes/CrankNicolsonDdtScheme/CrankNicolsonDdtScheme.H
@@ -133,7 +133,7 @@ class CrankNicolsonDdtScheme
                 const fvMesh& mesh
             );
 
-            //- Constructor from components, initisalised to zero with given
+            //- Constructor from components, initialised to zero with given
             //  dimensions.
             DDt0Field
             (
@@ -191,7 +191,7 @@ class CrankNicolsonDdtScheme
         template<class GeoField>
         dimensionedScalar rDtCoef0_(const DDt0Field<GeoField>&) const;
 
-        //- Return ddt0 multiplied by the off-centreing coefficient
+        //- Return ddt0 multiplied by the off-centering coefficient
         template<class GeoField>
         tmp<GeoField> offCentre_(const GeoField& ddt0) const;
 
@@ -222,7 +222,7 @@ public:
             return fv::ddtScheme<Type>::mesh();
         }
 
-        //- Return the current off-centreing coefficient
+        //- Return the current off-centering coefficient
         scalar ocCoeff() const
         {
             return ocCoeff_->value(mesh().time().value());
diff --git a/src/finiteVolume/interpolation/surfaceInterpolation/surfaceInterpolationScheme/surfaceInterpolationScheme.H b/src/finiteVolume/interpolation/surfaceInterpolation/surfaceInterpolationScheme/surfaceInterpolationScheme.H
index f293ab1974..14bfa7ebef 100644
--- a/src/finiteVolume/interpolation/surfaceInterpolation/surfaceInterpolationScheme/surfaceInterpolationScheme.H
+++ b/src/finiteVolume/interpolation/surfaceInterpolation/surfaceInterpolationScheme/surfaceInterpolationScheme.H
@@ -142,7 +142,7 @@ public:
 
 
         //- Return the face-interpolate of the given cell field
-        //  with the given owner and neighbour weigting factors
+        //  with the given owner and neighbour weighting factors
         static tmp<SurfaceField<Type>>
         interpolate
         (
diff --git a/src/functionObjects/field/comfort/comfort.H b/src/functionObjects/field/comfort/comfort.H
index 455d9d703b..b54c7777b5 100644
--- a/src/functionObjects/field/comfort/comfort.H
+++ b/src/functionObjects/field/comfort/comfort.H
@@ -132,7 +132,7 @@ class comfort
         //- Maximum number of correctors for cloth temperature
         int maxClothIter_;
 
-        //- Switch to use volume weighted velocity field for caluclation
+        //- Switch to use volume weighted velocity field for calculation
         Switch meanVelocity_;
 
 
diff --git a/src/functionObjects/field/wallHeatTransferCoeff/wallHeatTransferCoeffModels/kappaEff/kappaEff.H b/src/functionObjects/field/wallHeatTransferCoeff/wallHeatTransferCoeffModels/kappaEff/kappaEff.H
index 97000bb6b7..932d2abf7d 100644
--- a/src/functionObjects/field/wallHeatTransferCoeff/wallHeatTransferCoeffModels/kappaEff/kappaEff.H
+++ b/src/functionObjects/field/wallHeatTransferCoeff/wallHeatTransferCoeffModels/kappaEff/kappaEff.H
@@ -26,7 +26,7 @@ Class
 
 Description
     Calculates the estimated flow heat transfer coefficient at wall patches
-    as the volScalarField field 'kappaEff' using one of equeations bellow.
+    as the volScalarField field 'kappaEff' using one of equations bellow.
 
     kappaEff model, given by:
 
@@ -99,7 +99,7 @@ Usage
     \endtable
 
     Note:
-        Cp and rho are required only for incompressible flow calclulations.
+        Cp and rho are required only for incompressible flow calculations.
 
 SourceFiles
     kappaEff.C
diff --git a/src/fvMeshDistributors/loadBalancer/fvMeshDistributorsLoadBalancer.H b/src/fvMeshDistributors/loadBalancer/fvMeshDistributorsLoadBalancer.H
index ef060f6400..1215b757b4 100644
--- a/src/fvMeshDistributors/loadBalancer/fvMeshDistributorsLoadBalancer.H
+++ b/src/fvMeshDistributors/loadBalancer/fvMeshDistributorsLoadBalancer.H
@@ -78,7 +78,7 @@ class loadBalancer
         cpuTime cpuTime_;
 
         //- Enable multi-constraint load-balancing in which separate weights
-        //  are provided to the distrubutor for each of the CPU loads.
+        //  are provided to the distributor for each of the CPU loads.
         //  When disabled the CPU loads are summed and a single weight per cell
         //  is provided to the distrubutor.
         //  Defaults to true.
diff --git a/src/fvMeshStitchers/moving/fvMeshStitchersMoving.H b/src/fvMeshStitchers/moving/fvMeshStitchersMoving.H
index 2003af766d..9dbb056f84 100644
--- a/src/fvMeshStitchers/moving/fvMeshStitchersMoving.H
+++ b/src/fvMeshStitchers/moving/fvMeshStitchersMoving.H
@@ -25,7 +25,7 @@ Class
     Foam::fvMeshStitchers::moving
 
 Description
-    Mesh stitcher for movng meshes
+    Mesh stitcher for moving meshes
 
 SourceFiles
     fvMeshStitchersMoving.C
diff --git a/src/fvModels/derived/solidificationMeltingSource/solidificationMeltingSource.H b/src/fvModels/derived/solidificationMeltingSource/solidificationMeltingSource.H
index 080c0a2402..c2b9e7fd3e 100644
--- a/src/fvModels/derived/solidificationMeltingSource/solidificationMeltingSource.H
+++ b/src/fvModels/derived/solidificationMeltingSource/solidificationMeltingSource.H
@@ -109,7 +109,7 @@ Usage
         Cu         | Model coefficient [1/s]             | no       | 100000
         q          | Model coefficient                   | no       | 0.001
         beta       | Thermal expansion coefficient [1/K] | yes      |
-        g          | Accelerartion due to gravity        | no       |
+        g          | Acceleration due to gravity         | no       |
     \endtable
 
 SourceFiles
diff --git a/src/fvMotionSolver/motionDiffusivity/manipulators/exponential/exponentialDiffusivity.H b/src/fvMotionSolver/motionDiffusivity/manipulators/exponential/exponentialDiffusivity.H
index ee9d354871..4ba8dda3e8 100644
--- a/src/fvMotionSolver/motionDiffusivity/manipulators/exponential/exponentialDiffusivity.H
+++ b/src/fvMotionSolver/motionDiffusivity/manipulators/exponential/exponentialDiffusivity.H
@@ -25,7 +25,7 @@ Class
     Foam::exponentialDiffusivity
 
 Description
-    Mesh motion diffusivity maipulator which returns the exp(-alpha/D)
+    Mesh motion diffusivity manipulator which returns the exp(-alpha/D)
     of the given diffusivity D.
 
 SourceFiles
diff --git a/src/fvMotionSolver/motionDiffusivity/manipulators/quadratic/quadraticDiffusivity.H b/src/fvMotionSolver/motionDiffusivity/manipulators/quadratic/quadraticDiffusivity.H
index a666b82745..d970f4d670 100644
--- a/src/fvMotionSolver/motionDiffusivity/manipulators/quadratic/quadraticDiffusivity.H
+++ b/src/fvMotionSolver/motionDiffusivity/manipulators/quadratic/quadraticDiffusivity.H
@@ -25,7 +25,7 @@ Class
     Foam::quadraticDiffusivity
 
 Description
-    Mesh motion diffusivity maipulator which returns the sqr of the given
+    Mesh motion diffusivity manipulator which returns the sqr of the given
     diffusivity.
 
 SourceFiles
diff --git a/src/lagrangian/parcel/clouds/Templates/SprayCloud/SprayCloud.C b/src/lagrangian/parcel/clouds/Templates/SprayCloud/SprayCloud.C
index a3ef21cd69..0b6e2c236e 100644
--- a/src/lagrangian/parcel/clouds/Templates/SprayCloud/SprayCloud.C
+++ b/src/lagrangian/parcel/clouds/Templates/SprayCloud/SprayCloud.C
@@ -221,9 +221,9 @@ void Foam::SprayCloud<CloudType>::info()
     scalar dMax = 1.0e+6*this->Dmax();
     scalar pen = this->penetration(0.95);
 
-    Info << "    D10, D32, Dmax (mu)             = " << d10 << ", " << d32
-         << ", " << dMax << nl
-         << "    Liquid penetration 95% mass (m) = " << pen << endl;
+    Info<< "    D10, D32, Dmax (mu)             = " << d10 << ", " << d32
+        << ", " << dMax << nl
+        << "    Liquid penetration 95% mass (m) = " << pen << endl;
 }
 
 
diff --git a/src/lagrangian/parcel/integrationScheme/integrationScheme/integrationScheme.H b/src/lagrangian/parcel/integrationScheme/integrationScheme/integrationScheme.H
index 2ab93e7ad0..f291101b3c 100644
--- a/src/lagrangian/parcel/integrationScheme/integrationScheme/integrationScheme.H
+++ b/src/lagrangian/parcel/integrationScheme/integrationScheme/integrationScheme.H
@@ -26,7 +26,7 @@ Class
 
 Description
     Base for a set of schemes which integrate simple ODEs which arise from
-    semi-implcit rate expressions.
+    semi-implicit rate expressions.
 
         \f[
             \frac{d \phi}{d t} = A - B \phi
diff --git a/src/lagrangian/parcel/submodels/MPPIC/PackingModels/Implicit/Implicit.C b/src/lagrangian/parcel/submodels/MPPIC/PackingModels/Implicit/Implicit.C
index 99b8c7ffd8..bab81be171 100644
--- a/src/lagrangian/parcel/submodels/MPPIC/PackingModels/Implicit/Implicit.C
+++ b/src/lagrangian/parcel/submodels/MPPIC/PackingModels/Implicit/Implicit.C
@@ -312,11 +312,11 @@ void Foam::PackingModels::Implicit<CloudType>::cacheFields(const bool store)
         );
         uCorrect_->correctBoundaryConditions();
 
-        // Info << endl;
-        // Info << "     alpha: " << alpha_.primitiveField() << endl;
-        // Info << "phiCorrect: " << phiCorrect_->primitiveField() << endl;
-        // Info << "  uCorrect: " << uCorrect_->primitiveField() << endl;
-        // Info << endl;
+        // Info<< endl;
+        // Info<< "     alpha: " << alpha_.primitiveField() << endl;
+        // Info<< "phiCorrect: " << phiCorrect_->primitiveField() << endl;
+        // Info<< "  uCorrect: " << uCorrect_->primitiveField() << endl;
+        // Info<< endl;
     }
     else
     {
diff --git a/src/mesh/snappyHexMesh/snappyHexMeshDriver/layerParameters/layerParameters.H b/src/mesh/snappyHexMesh/snappyHexMeshDriver/layerParameters/layerParameters.H
index 312293cd6e..33d2e0d961 100644
--- a/src/mesh/snappyHexMesh/snappyHexMeshDriver/layerParameters/layerParameters.H
+++ b/src/mesh/snappyHexMesh/snappyHexMeshDriver/layerParameters/layerParameters.H
@@ -309,8 +309,8 @@ public:
             scalar layerThickness
             (
                 const label nLayers,
-                const scalar firstLayerThickess,
-                const scalar finalLayerThickess,
+                const scalar firstLayerThickness,
+                const scalar finalLayerThickness,
                 const scalar totalThickness,
                 const scalar expansionRatio
             ) const;
@@ -320,8 +320,8 @@ public:
             scalar layerExpansionRatio
             (
                 const label nLayers,
-                const scalar firstLayerThickess,
-                const scalar finalLayerThickess,
+                const scalar firstLayerThickness,
+                const scalar finalLayerThickness,
                 const scalar totalThickness,
                 const scalar expansionRatio
             ) const;
@@ -331,8 +331,8 @@ public:
             scalar firstLayerThickness
             (
                 const label nLayers,
-                const scalar firstLayerThickess,
-                const scalar finalLayerThickess,
+                const scalar firstLayerThickness,
+                const scalar finalLayerThickness,
                 const scalar totalThickness,
                 const scalar expansionRatio
             ) const;
diff --git a/src/thermophysicalModels/specie/reaction/Reactions/NonEquilibriumReversibleReaction/NonEquilibriumReversibleReaction.H b/src/thermophysicalModels/specie/reaction/Reactions/NonEquilibriumReversibleReaction/NonEquilibriumReversibleReaction.H
index d702021596..e261b3883e 100644
--- a/src/thermophysicalModels/specie/reaction/Reactions/NonEquilibriumReversibleReaction/NonEquilibriumReversibleReaction.H
+++ b/src/thermophysicalModels/specie/reaction/Reactions/NonEquilibriumReversibleReaction/NonEquilibriumReversibleReaction.H
@@ -25,8 +25,7 @@ Class
     Foam::NonEquilibriumReversibleReaction
 
 Description
-    Simple extension of Reaction to handle reversible reactions using
-    equilibrium thermodynamics.
+    Simple extension of Reaction to handle non-equilibrium reversible reactions.
 
 SourceFiles
     NonEquilibriumReversibleReaction.C
diff --git a/src/twoPhaseModels/interfaceCompression/MPLIC/MPLICcell.H b/src/twoPhaseModels/interfaceCompression/MPLIC/MPLICcell.H
index 9842187452..6daa7bf900 100644
--- a/src/twoPhaseModels/interfaceCompression/MPLIC/MPLICcell.H
+++ b/src/twoPhaseModels/interfaceCompression/MPLIC/MPLICcell.H
@@ -195,7 +195,7 @@ class MPLICcell
 
         // Multicut addressing
 
-            //- Is addressnig computed?
+            //- Is addressing computed?
             bool addressingCalculated_;
 
             //- Local edge faces
