View Issue Details
ID | Project | Category | View Status | Date Submitted | Last Update |
---|---|---|---|---|---|
0003952 | OpenFOAM | Patch | public | 2023-01-24 12:19 | 2023-01-24 18:28 |
Reporter | tniemi | Assigned To | henry | ||
Priority | low | Severity | text | Reproducibility | N/A |
Status | resolved | Resolution | fixed | ||
Product Version | dev | ||||
Fixed in Version | dev | ||||
Summary | 0003952: Fixes for typos and formatting | ||||
Description | Hi, I have attached a couple of patches which contains fixes to typos and centering of class declarations. As the full diff is quite large, I have also split it to two smaller pieces. All changes are text-only. The files are typos.diff: fixes to typos + formatting of couple of Info statements declarations.diff: fixes class declaration centering fullDiff.diff: typos+declarations+automatic update of copyrights | ||||
Tags | No tags attached. | ||||
|
typos.diff (21,675 bytes)
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 declarations.diff (235,565 bytes)
diff --git a/applications/solvers/foamMultiRun/regionSolvers/regionSolvers.H b/applications/solvers/foamMultiRun/regionSolvers/regionSolvers.H index a15888ed47..de231eb84e 100644 --- a/applications/solvers/foamMultiRun/regionSolvers/regionSolvers.H +++ b/applications/solvers/foamMultiRun/regionSolvers/regionSolvers.H @@ -46,7 +46,7 @@ namespace Foam class Time; /*---------------------------------------------------------------------------*\ - Class regionSolvers Declaration + Class regionSolvers Declaration \*---------------------------------------------------------------------------*/ class regionSolvers diff --git a/applications/solvers/modules/VoFSolver/VoFMixture/VoFMixture.H b/applications/solvers/modules/VoFSolver/VoFMixture/VoFMixture.H index 6b1d54bd62..37edc706d6 100644 --- a/applications/solvers/modules/VoFSolver/VoFMixture/VoFMixture.H +++ b/applications/solvers/modules/VoFSolver/VoFMixture/VoFMixture.H @@ -46,7 +46,7 @@ namespace Foam class fvMesh; /*---------------------------------------------------------------------------*\ - Class VoFMixture Declaration + Class VoFMixture Declaration \*---------------------------------------------------------------------------*/ class VoFMixture diff --git a/applications/solvers/modules/XiFluid/XiFluid.H b/applications/solvers/modules/XiFluid/XiFluid.H index cfd5b96105..6ef450dc51 100644 --- a/applications/solvers/modules/XiFluid/XiFluid.H +++ b/applications/solvers/modules/XiFluid/XiFluid.H @@ -89,7 +89,7 @@ namespace solvers { /*---------------------------------------------------------------------------*\ - Class XiFluid Declaration + Class XiFluid Declaration \*---------------------------------------------------------------------------*/ class XiFluid diff --git a/applications/solvers/modules/compressibleMultiphaseVoF/compressibleMultiphaseVoF.H b/applications/solvers/modules/compressibleMultiphaseVoF/compressibleMultiphaseVoF.H index bbb0d54cb2..2567ef7319 100644 --- a/applications/solvers/modules/compressibleMultiphaseVoF/compressibleMultiphaseVoF.H +++ b/applications/solvers/modules/compressibleMultiphaseVoF/compressibleMultiphaseVoF.H @@ -64,7 +64,7 @@ namespace solvers { /*---------------------------------------------------------------------------*\ - Class compressibleMultiphaseVoF Declaration + Class compressibleMultiphaseVoF Declaration \*---------------------------------------------------------------------------*/ class compressibleMultiphaseVoF diff --git a/applications/solvers/modules/compressibleMultiphaseVoF/compressibleMultiphaseVoFMixture/compressibleMultiphaseVoFMixture.H b/applications/solvers/modules/compressibleMultiphaseVoF/compressibleMultiphaseVoFMixture/compressibleMultiphaseVoFMixture.H index 5657d023fb..df2c152d5b 100644 --- a/applications/solvers/modules/compressibleMultiphaseVoF/compressibleMultiphaseVoFMixture/compressibleMultiphaseVoFMixture.H +++ b/applications/solvers/modules/compressibleMultiphaseVoF/compressibleMultiphaseVoFMixture/compressibleMultiphaseVoFMixture.H @@ -57,7 +57,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class compressibleMultiphaseVoFMixture Declaration + Class compressibleMultiphaseVoFMixture Declaration \*---------------------------------------------------------------------------*/ class compressibleMultiphaseVoFMixture diff --git a/applications/solvers/modules/compressibleMultiphaseVoF/compressibleMultiphaseVoFMixture/compressibleMultiphaseVoFMixtureThermo/compressibleMultiphaseVoFMixtureThermo.H b/applications/solvers/modules/compressibleMultiphaseVoF/compressibleMultiphaseVoFMixture/compressibleMultiphaseVoFMixtureThermo/compressibleMultiphaseVoFMixtureThermo.H index 4b5c1c6343..e45ccef362 100644 --- a/applications/solvers/modules/compressibleMultiphaseVoF/compressibleMultiphaseVoFMixture/compressibleMultiphaseVoFMixtureThermo/compressibleMultiphaseVoFMixtureThermo.H +++ b/applications/solvers/modules/compressibleMultiphaseVoF/compressibleMultiphaseVoFMixture/compressibleMultiphaseVoFMixtureThermo/compressibleMultiphaseVoFMixtureThermo.H @@ -42,7 +42,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class compressibleMultiphaseVoFMixtureThermo Declaration + Class compressibleMultiphaseVoFMixtureThermo Declaration \*---------------------------------------------------------------------------*/ class compressibleMultiphaseVoFMixtureThermo diff --git a/applications/solvers/modules/compressibleMultiphaseVoF/compressibleMultiphaseVoFMixture/compressibleVoFphase/compressibleVoFphase.H b/applications/solvers/modules/compressibleMultiphaseVoF/compressibleMultiphaseVoFMixture/compressibleVoFphase/compressibleVoFphase.H index bbc8fe982f..287511f44a 100644 --- a/applications/solvers/modules/compressibleMultiphaseVoF/compressibleMultiphaseVoFMixture/compressibleVoFphase/compressibleVoFphase.H +++ b/applications/solvers/modules/compressibleMultiphaseVoF/compressibleMultiphaseVoFMixture/compressibleVoFphase/compressibleVoFphase.H @@ -51,7 +51,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class compressibleVoFphase Declaration + Class compressibleVoFphase Declaration \*---------------------------------------------------------------------------*/ class compressibleVoFphase diff --git a/applications/solvers/modules/compressibleVoF/compressibleInterPhaseThermophysicalTransportModel/compressibleInterPhaseThermophysicalTransportModel.H b/applications/solvers/modules/compressibleVoF/compressibleInterPhaseThermophysicalTransportModel/compressibleInterPhaseThermophysicalTransportModel.H index 178a819e9f..e1e8766e16 100644 --- a/applications/solvers/modules/compressibleVoF/compressibleInterPhaseThermophysicalTransportModel/compressibleInterPhaseThermophysicalTransportModel.H +++ b/applications/solvers/modules/compressibleVoF/compressibleInterPhaseThermophysicalTransportModel/compressibleInterPhaseThermophysicalTransportModel.H @@ -48,7 +48,7 @@ namespace Foam class compressibleInterPhaseTransportModel; /*---------------------------------------------------------------------------*\ - Class compressibleInterPhaseThermophysicalTransportModel Declaration + Class compressibleInterPhaseThermophysicalTransportModel Declaration \*---------------------------------------------------------------------------*/ class compressibleInterPhaseThermophysicalTransportModel diff --git a/applications/solvers/modules/compressibleVoF/compressibleTwoPhaseVoFMixture/compressibleTwoPhaseVoFMixture.H b/applications/solvers/modules/compressibleVoF/compressibleTwoPhaseVoFMixture/compressibleTwoPhaseVoFMixture.H index f40c0d5a94..ac883f99e9 100644 --- a/applications/solvers/modules/compressibleVoF/compressibleTwoPhaseVoFMixture/compressibleTwoPhaseVoFMixture.H +++ b/applications/solvers/modules/compressibleVoF/compressibleTwoPhaseVoFMixture/compressibleTwoPhaseVoFMixture.H @@ -45,7 +45,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class compressibleTwoPhaseVoFMixture Declaration + Class compressibleTwoPhaseVoFMixture Declaration \*---------------------------------------------------------------------------*/ class compressibleTwoPhaseVoFMixture diff --git a/applications/solvers/modules/compressibleVoF/compressibleVoF.H b/applications/solvers/modules/compressibleVoF/compressibleVoF.H index a51e0a6a8b..0bddb0a63e 100644 --- a/applications/solvers/modules/compressibleVoF/compressibleVoF.H +++ b/applications/solvers/modules/compressibleVoF/compressibleVoF.H @@ -71,7 +71,7 @@ namespace solvers { /*---------------------------------------------------------------------------*\ - Class compressibleVoF Declaration + Class compressibleVoF Declaration \*---------------------------------------------------------------------------*/ class compressibleVoF diff --git a/applications/solvers/modules/compressibleVoF/fvModels/VoFCavitation/VoFCavitation.H b/applications/solvers/modules/compressibleVoF/fvModels/VoFCavitation/VoFCavitation.H index 8432d4d1ee..ed0190ff2a 100644 --- a/applications/solvers/modules/compressibleVoF/fvModels/VoFCavitation/VoFCavitation.H +++ b/applications/solvers/modules/compressibleVoF/fvModels/VoFCavitation/VoFCavitation.H @@ -94,7 +94,7 @@ namespace compressible { /*---------------------------------------------------------------------------*\ - Class VoFCavitation Declaration + Class VoFCavitation Declaration \*---------------------------------------------------------------------------*/ class VoFCavitation diff --git a/applications/solvers/modules/compressibleVoF/fvModels/VoFClouds/VoFClouds.H b/applications/solvers/modules/compressibleVoF/fvModels/VoFClouds/VoFClouds.H index 9a9ae34924..ba0dd3bc5e 100644 --- a/applications/solvers/modules/compressibleVoF/fvModels/VoFClouds/VoFClouds.H +++ b/applications/solvers/modules/compressibleVoF/fvModels/VoFClouds/VoFClouds.H @@ -57,7 +57,7 @@ namespace fv { /*---------------------------------------------------------------------------*\ - Class VoFClouds Declaration + Class VoFClouds Declaration \*---------------------------------------------------------------------------*/ class VoFClouds diff --git a/applications/solvers/modules/compressibleVoF/fvModels/VoFTurbulenceDamping/VoFTurbulenceDamping.H b/applications/solvers/modules/compressibleVoF/fvModels/VoFTurbulenceDamping/VoFTurbulenceDamping.H index d2e81c6528..d18912e945 100644 --- a/applications/solvers/modules/compressibleVoF/fvModels/VoFTurbulenceDamping/VoFTurbulenceDamping.H +++ b/applications/solvers/modules/compressibleVoF/fvModels/VoFTurbulenceDamping/VoFTurbulenceDamping.H @@ -90,7 +90,7 @@ namespace compressible { /*---------------------------------------------------------------------------*\ - Class VoFTurbulenceDamping Declaration + Class VoFTurbulenceDamping Declaration \*---------------------------------------------------------------------------*/ class VoFTurbulenceDamping diff --git a/applications/solvers/modules/fluid/fluid.H b/applications/solvers/modules/fluid/fluid.H index 3978559db1..cd3e219302 100644 --- a/applications/solvers/modules/fluid/fluid.H +++ b/applications/solvers/modules/fluid/fluid.H @@ -62,7 +62,7 @@ namespace solvers { /*---------------------------------------------------------------------------*\ - Class fluid Declaration + Class fluid Declaration \*---------------------------------------------------------------------------*/ class fluid diff --git a/applications/solvers/modules/fluidSolver/fluidSolver.H b/applications/solvers/modules/fluidSolver/fluidSolver.H index 6c5f9155ea..dfb325a908 100644 --- a/applications/solvers/modules/fluidSolver/fluidSolver.H +++ b/applications/solvers/modules/fluidSolver/fluidSolver.H @@ -54,7 +54,7 @@ namespace solvers { /*---------------------------------------------------------------------------*\ - Class fluidSolver Declaration + Class fluidSolver Declaration \*---------------------------------------------------------------------------*/ class fluidSolver diff --git a/applications/solvers/modules/incompressibleFluid/incompressibleFluid.H b/applications/solvers/modules/incompressibleFluid/incompressibleFluid.H index 61cb5f18fb..b91ab9f24d 100644 --- a/applications/solvers/modules/incompressibleFluid/incompressibleFluid.H +++ b/applications/solvers/modules/incompressibleFluid/incompressibleFluid.H @@ -68,7 +68,7 @@ namespace solvers { /*---------------------------------------------------------------------------*\ - Class incompressibleFluid Declaration + Class incompressibleFluid Declaration \*---------------------------------------------------------------------------*/ class incompressibleFluid diff --git a/applications/solvers/modules/incompressibleMultiphaseVoF/incompressibleMultiphaseVoF.H b/applications/solvers/modules/incompressibleMultiphaseVoF/incompressibleMultiphaseVoF.H index 66b30c74c7..5eb17d8961 100644 --- a/applications/solvers/modules/incompressibleMultiphaseVoF/incompressibleMultiphaseVoF.H +++ b/applications/solvers/modules/incompressibleMultiphaseVoF/incompressibleMultiphaseVoF.H @@ -63,7 +63,7 @@ namespace solvers { /*---------------------------------------------------------------------------*\ - Class incompressibleMultiphaseVoF Declaration + Class incompressibleMultiphaseVoF Declaration \*---------------------------------------------------------------------------*/ class incompressibleMultiphaseVoF diff --git a/applications/solvers/modules/incompressibleMultiphaseVoF/incompressibleMultiphaseVoFMixture/incompressibleMultiphaseVoFMixture.H b/applications/solvers/modules/incompressibleMultiphaseVoF/incompressibleMultiphaseVoFMixture/incompressibleMultiphaseVoFMixture.H index e43df61dd6..3daf3a5284 100644 --- a/applications/solvers/modules/incompressibleMultiphaseVoF/incompressibleMultiphaseVoFMixture/incompressibleMultiphaseVoFMixture.H +++ b/applications/solvers/modules/incompressibleMultiphaseVoF/incompressibleMultiphaseVoFMixture/incompressibleMultiphaseVoFMixture.H @@ -56,7 +56,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class incompressibleMultiphaseVoFMixture Declaration + Class incompressibleMultiphaseVoFMixture Declaration \*---------------------------------------------------------------------------*/ class incompressibleMultiphaseVoFMixture diff --git a/applications/solvers/modules/incompressibleMultiphaseVoF/incompressibleMultiphaseVoFMixture/incompressibleVoFphase/incompressibleVoFphase.H b/applications/solvers/modules/incompressibleMultiphaseVoF/incompressibleMultiphaseVoFMixture/incompressibleVoFphase/incompressibleVoFphase.H index 31753ff583..7fb7e7583b 100644 --- a/applications/solvers/modules/incompressibleMultiphaseVoF/incompressibleMultiphaseVoFMixture/incompressibleVoFphase/incompressibleVoFphase.H +++ b/applications/solvers/modules/incompressibleMultiphaseVoF/incompressibleMultiphaseVoFMixture/incompressibleVoFphase/incompressibleVoFphase.H @@ -51,7 +51,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class incompressibleVoFphase Declaration + Class incompressibleVoFphase Declaration \*---------------------------------------------------------------------------*/ class incompressibleVoFphase diff --git a/applications/solvers/modules/incompressibleVoF/fvModels/VoFCavitation/VoFCavitation.H b/applications/solvers/modules/incompressibleVoF/fvModels/VoFCavitation/VoFCavitation.H index bab531ce4d..48c6d64785 100644 --- a/applications/solvers/modules/incompressibleVoF/fvModels/VoFCavitation/VoFCavitation.H +++ b/applications/solvers/modules/incompressibleVoF/fvModels/VoFCavitation/VoFCavitation.H @@ -92,7 +92,7 @@ namespace fv { /*---------------------------------------------------------------------------*\ - Class VoFCavitation Declaration + Class VoFCavitation Declaration \*---------------------------------------------------------------------------*/ class VoFCavitation diff --git a/applications/solvers/modules/incompressibleVoF/fvModels/VoFTurbulenceDamping/VoFTurbulenceDamping.H b/applications/solvers/modules/incompressibleVoF/fvModels/VoFTurbulenceDamping/VoFTurbulenceDamping.H index 1e94222934..440646efd8 100644 --- a/applications/solvers/modules/incompressibleVoF/fvModels/VoFTurbulenceDamping/VoFTurbulenceDamping.H +++ b/applications/solvers/modules/incompressibleVoF/fvModels/VoFTurbulenceDamping/VoFTurbulenceDamping.H @@ -88,7 +88,7 @@ namespace fv { /*---------------------------------------------------------------------------*\ - Class VoFTurbulenceDamping Declaration + Class VoFTurbulenceDamping Declaration \*---------------------------------------------------------------------------*/ class VoFTurbulenceDamping diff --git a/applications/solvers/modules/incompressibleVoF/incompressibleInterPhaseTransportModel/incompressibleInterPhaseTransportModel.H b/applications/solvers/modules/incompressibleVoF/incompressibleInterPhaseTransportModel/incompressibleInterPhaseTransportModel.H index 588e6c01b9..ae10241e76 100644 --- a/applications/solvers/modules/incompressibleVoF/incompressibleInterPhaseTransportModel/incompressibleInterPhaseTransportModel.H +++ b/applications/solvers/modules/incompressibleVoF/incompressibleInterPhaseTransportModel/incompressibleInterPhaseTransportModel.H @@ -53,7 +53,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class incompressibleInterPhaseTransportModel Declaration + Class incompressibleInterPhaseTransportModel Declaration \*---------------------------------------------------------------------------*/ class incompressibleInterPhaseTransportModel diff --git a/applications/solvers/modules/incompressibleVoF/incompressibleTwoPhaseVoFMixture/incompressibleTwoPhaseVoFMixture.H b/applications/solvers/modules/incompressibleVoF/incompressibleTwoPhaseVoFMixture/incompressibleTwoPhaseVoFMixture.H index d195791671..d09383cd15 100644 --- a/applications/solvers/modules/incompressibleVoF/incompressibleTwoPhaseVoFMixture/incompressibleTwoPhaseVoFMixture.H +++ b/applications/solvers/modules/incompressibleVoF/incompressibleTwoPhaseVoFMixture/incompressibleTwoPhaseVoFMixture.H @@ -45,7 +45,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class incompressibleTwoPhaseVoFMixture Declaration + Class incompressibleTwoPhaseVoFMixture Declaration \*---------------------------------------------------------------------------*/ class incompressibleTwoPhaseVoFMixture diff --git a/applications/solvers/modules/incompressibleVoF/incompressibleVoF.H b/applications/solvers/modules/incompressibleVoF/incompressibleVoF.H index 054cc4b0d5..c587587c01 100644 --- a/applications/solvers/modules/incompressibleVoF/incompressibleVoF.H +++ b/applications/solvers/modules/incompressibleVoF/incompressibleVoF.H @@ -70,7 +70,7 @@ namespace solvers { /*---------------------------------------------------------------------------*\ - Class incompressibleVoF Declaration + Class incompressibleVoF Declaration \*---------------------------------------------------------------------------*/ class incompressibleVoF diff --git a/applications/solvers/modules/isothermalFluid/isothermalFluid.H b/applications/solvers/modules/isothermalFluid/isothermalFluid.H index 95d6a0ad7d..41a0564267 100644 --- a/applications/solvers/modules/isothermalFluid/isothermalFluid.H +++ b/applications/solvers/modules/isothermalFluid/isothermalFluid.H @@ -69,7 +69,7 @@ namespace solvers { /*---------------------------------------------------------------------------*\ - Class isothermalFluid Declaration + Class isothermalFluid Declaration \*---------------------------------------------------------------------------*/ class isothermalFluid diff --git a/applications/solvers/modules/multicomponentFluid/multicomponentFluid.H b/applications/solvers/modules/multicomponentFluid/multicomponentFluid.H index f8482bcdc1..44916ecfc4 100644 --- a/applications/solvers/modules/multicomponentFluid/multicomponentFluid.H +++ b/applications/solvers/modules/multicomponentFluid/multicomponentFluid.H @@ -69,7 +69,7 @@ namespace solvers { /*---------------------------------------------------------------------------*\ - Class multicomponentFluid Declaration + Class multicomponentFluid Declaration \*---------------------------------------------------------------------------*/ class multicomponentFluid diff --git a/applications/solvers/modules/multiphaseEuler/functionObjects/populationBalanceSizeDistribution/populationBalanceSizeDistribution.H b/applications/solvers/modules/multiphaseEuler/functionObjects/populationBalanceSizeDistribution/populationBalanceSizeDistribution.H index d9b8832b03..5811d1010a 100644 --- a/applications/solvers/modules/multiphaseEuler/functionObjects/populationBalanceSizeDistribution/populationBalanceSizeDistribution.H +++ b/applications/solvers/modules/multiphaseEuler/functionObjects/populationBalanceSizeDistribution/populationBalanceSizeDistribution.H @@ -92,7 +92,7 @@ namespace functionObjects { /*---------------------------------------------------------------------------*\ - Class populationBalanceSizeDistribution Declaration + Class populationBalanceSizeDistribution Declaration \*---------------------------------------------------------------------------*/ class populationBalanceSizeDistribution diff --git a/applications/solvers/modules/multiphaseEuler/functionObjects/wallBoilingProperties/wallBoilingProperties.H b/applications/solvers/modules/multiphaseEuler/functionObjects/wallBoilingProperties/wallBoilingProperties.H index 71cb65f921..f23aa804db 100644 --- a/applications/solvers/modules/multiphaseEuler/functionObjects/wallBoilingProperties/wallBoilingProperties.H +++ b/applications/solvers/modules/multiphaseEuler/functionObjects/wallBoilingProperties/wallBoilingProperties.H @@ -72,7 +72,7 @@ namespace functionObjects { /*---------------------------------------------------------------------------*\ - Class wallBoilingProperties Declaration + Class wallBoilingProperties Declaration \*---------------------------------------------------------------------------*/ class wallBoilingProperties diff --git a/applications/solvers/modules/multiphaseEuler/fvModels/interfaceTurbulenceDamping/interfaceTurbulenceDamping.H b/applications/solvers/modules/multiphaseEuler/fvModels/interfaceTurbulenceDamping/interfaceTurbulenceDamping.H index b8b0a7504b..4e2fb56643 100644 --- a/applications/solvers/modules/multiphaseEuler/fvModels/interfaceTurbulenceDamping/interfaceTurbulenceDamping.H +++ b/applications/solvers/modules/multiphaseEuler/fvModels/interfaceTurbulenceDamping/interfaceTurbulenceDamping.H @@ -85,7 +85,7 @@ namespace fv { /*---------------------------------------------------------------------------*\ - Class interfaceTurbulenceDamping Declaration + Class interfaceTurbulenceDamping Declaration \*---------------------------------------------------------------------------*/ class interfaceTurbulenceDamping diff --git a/applications/solvers/modules/multiphaseEuler/fvModels/phaseTurbulenceStabilisation/phaseTurbulenceStabilisation.H b/applications/solvers/modules/multiphaseEuler/fvModels/phaseTurbulenceStabilisation/phaseTurbulenceStabilisation.H index 12546a7ba9..e8d1b23023 100644 --- a/applications/solvers/modules/multiphaseEuler/fvModels/phaseTurbulenceStabilisation/phaseTurbulenceStabilisation.H +++ b/applications/solvers/modules/multiphaseEuler/fvModels/phaseTurbulenceStabilisation/phaseTurbulenceStabilisation.H @@ -84,7 +84,7 @@ namespace fv { /*---------------------------------------------------------------------------*\ - Class phaseTurbulenceStabilisation Declaration + Class phaseTurbulenceStabilisation Declaration \*---------------------------------------------------------------------------*/ class phaseTurbulenceStabilisation diff --git a/applications/solvers/modules/multiphaseEuler/interfacialCompositionModels/diffusiveMassTransferModels/diffusiveMassTransferModel/diffusiveMassTransferModel.H b/applications/solvers/modules/multiphaseEuler/interfacialCompositionModels/diffusiveMassTransferModels/diffusiveMassTransferModel/diffusiveMassTransferModel.H index 108156f8c3..07e0e26f3f 100644 --- a/applications/solvers/modules/multiphaseEuler/interfacialCompositionModels/diffusiveMassTransferModels/diffusiveMassTransferModel/diffusiveMassTransferModel.H +++ b/applications/solvers/modules/multiphaseEuler/interfacialCompositionModels/diffusiveMassTransferModels/diffusiveMassTransferModel/diffusiveMassTransferModel.H @@ -116,7 +116,7 @@ public: /*---------------------------------------------------------------------------*\ - Class blendedDiffusiveMassTransferModel Declaration + Class blendedDiffusiveMassTransferModel Declaration \*---------------------------------------------------------------------------*/ class blendedDiffusiveMassTransferModel @@ -151,7 +151,7 @@ public: /*---------------------------------------------------------------------------*\ - Class sidedBlendedDiffusiveMassTransferModel Declaration + Class sidedBlendedDiffusiveMassTransferModel Declaration \*---------------------------------------------------------------------------*/ class sidedBlendedDiffusiveMassTransferModel diff --git a/applications/solvers/modules/multiphaseEuler/interfacialCompositionModels/interfaceCompositionModels/interfaceCompositionModel/interfaceCompositionModel.H b/applications/solvers/modules/multiphaseEuler/interfacialCompositionModels/interfaceCompositionModels/interfaceCompositionModel/interfaceCompositionModel.H index 36be57c8bb..e090234183 100644 --- a/applications/solvers/modules/multiphaseEuler/interfacialCompositionModels/interfaceCompositionModels/interfaceCompositionModel/interfaceCompositionModel.H +++ b/applications/solvers/modules/multiphaseEuler/interfacialCompositionModels/interfaceCompositionModels/interfaceCompositionModel/interfaceCompositionModel.H @@ -189,7 +189,7 @@ public: /*---------------------------------------------------------------------------*\ - Class sidedInterfaceCompositionModel Declaration + Class sidedInterfaceCompositionModel Declaration \*---------------------------------------------------------------------------*/ class sidedInterfaceCompositionModel diff --git a/applications/solvers/modules/multiphaseEuler/interfacialCompositionModels/interfaceSurfaceTensionModels/interfaceSurfaceTensionModel/interfaceSurfaceTensionModel.H b/applications/solvers/modules/multiphaseEuler/interfacialCompositionModels/interfaceSurfaceTensionModels/interfaceSurfaceTensionModel/interfaceSurfaceTensionModel.H index f76092d2ca..09393c95ea 100644 --- a/applications/solvers/modules/multiphaseEuler/interfacialCompositionModels/interfaceSurfaceTensionModels/interfaceSurfaceTensionModel/interfaceSurfaceTensionModel.H +++ b/applications/solvers/modules/multiphaseEuler/interfacialCompositionModels/interfaceSurfaceTensionModels/interfaceSurfaceTensionModel/interfaceSurfaceTensionModel.H @@ -48,7 +48,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class interfaceSurfaceTensionModel Declaration + Class interfaceSurfaceTensionModel Declaration \*---------------------------------------------------------------------------*/ class interfaceSurfaceTensionModel diff --git a/applications/solvers/modules/multiphaseEuler/interfacialModels/dragModels/dispersedDragModel/dispersedDragModel.H b/applications/solvers/modules/multiphaseEuler/interfacialModels/dragModels/dispersedDragModel/dispersedDragModel.H index b38d4179d3..26f4c46cb8 100644 --- a/applications/solvers/modules/multiphaseEuler/interfacialModels/dragModels/dispersedDragModel/dispersedDragModel.H +++ b/applications/solvers/modules/multiphaseEuler/interfacialModels/dragModels/dispersedDragModel/dispersedDragModel.H @@ -48,7 +48,7 @@ namespace dragModels { /*---------------------------------------------------------------------------*\ - Class dispersedDragModel Declaration + Class dispersedDragModel Declaration \*---------------------------------------------------------------------------*/ class dispersedDragModel diff --git a/applications/solvers/modules/multiphaseEuler/interfacialModels/heatTransferModels/heatTransferModel/heatTransferModel.H b/applications/solvers/modules/multiphaseEuler/interfacialModels/heatTransferModels/heatTransferModel/heatTransferModel.H index 8b130b390e..d793188350 100644 --- a/applications/solvers/modules/multiphaseEuler/interfacialModels/heatTransferModels/heatTransferModel/heatTransferModel.H +++ b/applications/solvers/modules/multiphaseEuler/interfacialModels/heatTransferModels/heatTransferModel/heatTransferModel.H @@ -130,7 +130,7 @@ public: /*---------------------------------------------------------------------------*\ - Class blendedHeatTransferModel Declaration + Class blendedHeatTransferModel Declaration \*---------------------------------------------------------------------------*/ class blendedHeatTransferModel @@ -167,7 +167,7 @@ public: /*---------------------------------------------------------------------------*\ - Class sidedBlendedHeatTransferModel Declaration + Class sidedBlendedHeatTransferModel Declaration \*---------------------------------------------------------------------------*/ class sidedBlendedHeatTransferModel diff --git a/applications/solvers/modules/multiphaseEuler/interfacialModels/liftModels/dispersedLiftModel/dispersedLiftModel.H b/applications/solvers/modules/multiphaseEuler/interfacialModels/liftModels/dispersedLiftModel/dispersedLiftModel.H index c47f03f48d..ae2228e96f 100644 --- a/applications/solvers/modules/multiphaseEuler/interfacialModels/liftModels/dispersedLiftModel/dispersedLiftModel.H +++ b/applications/solvers/modules/multiphaseEuler/interfacialModels/liftModels/dispersedLiftModel/dispersedLiftModel.H @@ -48,7 +48,7 @@ namespace liftModels { /*---------------------------------------------------------------------------*\ - Class dispersedLiftModel Declaration + Class dispersedLiftModel Declaration \*---------------------------------------------------------------------------*/ class dispersedLiftModel diff --git a/applications/solvers/modules/multiphaseEuler/interfacialModels/phaseTransferModels/cavitation/cavitation.H b/applications/solvers/modules/multiphaseEuler/interfacialModels/phaseTransferModels/cavitation/cavitation.H index 13f3bda73e..0947457dd2 100644 --- a/applications/solvers/modules/multiphaseEuler/interfacialModels/phaseTransferModels/cavitation/cavitation.H +++ b/applications/solvers/modules/multiphaseEuler/interfacialModels/phaseTransferModels/cavitation/cavitation.H @@ -73,7 +73,7 @@ namespace phaseTransferModels { /*---------------------------------------------------------------------------*\ - Class cavitation Declaration + Class cavitation Declaration \*---------------------------------------------------------------------------*/ class cavitation diff --git a/applications/solvers/modules/multiphaseEuler/interfacialModels/phaseTransferModels/phaseTransferModel/phaseTransferModel.H b/applications/solvers/modules/multiphaseEuler/interfacialModels/phaseTransferModels/phaseTransferModel/phaseTransferModel.H index c7bead966c..56b2168ac9 100644 --- a/applications/solvers/modules/multiphaseEuler/interfacialModels/phaseTransferModels/phaseTransferModel/phaseTransferModel.H +++ b/applications/solvers/modules/multiphaseEuler/interfacialModels/phaseTransferModels/phaseTransferModel/phaseTransferModel.H @@ -138,7 +138,7 @@ public: /*---------------------------------------------------------------------------*\ - Class blendedPhaseTransferModel Declaration + Class blendedPhaseTransferModel Declaration \*---------------------------------------------------------------------------*/ class blendedPhaseTransferModel diff --git a/applications/solvers/modules/multiphaseEuler/interfacialModels/turbulentDispersionModels/dispersedTurbulentDispersionModel/dispersedTurbulentDispersionModel.H b/applications/solvers/modules/multiphaseEuler/interfacialModels/turbulentDispersionModels/dispersedTurbulentDispersionModel/dispersedTurbulentDispersionModel.H index 9c951c1e1b..e1aad6ef5b 100644 --- a/applications/solvers/modules/multiphaseEuler/interfacialModels/turbulentDispersionModels/dispersedTurbulentDispersionModel/dispersedTurbulentDispersionModel.H +++ b/applications/solvers/modules/multiphaseEuler/interfacialModels/turbulentDispersionModels/dispersedTurbulentDispersionModel/dispersedTurbulentDispersionModel.H @@ -48,7 +48,7 @@ namespace turbulentDispersionModels { /*---------------------------------------------------------------------------*\ - Class dispersedTurbulentDispersionModel Declaration + Class dispersedTurbulentDispersionModel Declaration \*---------------------------------------------------------------------------*/ class dispersedTurbulentDispersionModel diff --git a/applications/solvers/modules/multiphaseEuler/interfacialModels/turbulentDispersionModels/turbulentDispersionModel/turbulentDispersionModel.H b/applications/solvers/modules/multiphaseEuler/interfacialModels/turbulentDispersionModels/turbulentDispersionModel/turbulentDispersionModel.H index 3f4b0e4625..97034846f5 100644 --- a/applications/solvers/modules/multiphaseEuler/interfacialModels/turbulentDispersionModels/turbulentDispersionModel/turbulentDispersionModel.H +++ b/applications/solvers/modules/multiphaseEuler/interfacialModels/turbulentDispersionModels/turbulentDispersionModel/turbulentDispersionModel.H @@ -114,7 +114,7 @@ public: /*---------------------------------------------------------------------------*\ - Class blendedTurbulentDispersionModel Declaration + Class blendedTurbulentDispersionModel Declaration \*---------------------------------------------------------------------------*/ class blendedTurbulentDispersionModel diff --git a/applications/solvers/modules/multiphaseEuler/interfacialModels/virtualMassModels/dispersedVirtualMassModel/dispersedVirtualMassModel.H b/applications/solvers/modules/multiphaseEuler/interfacialModels/virtualMassModels/dispersedVirtualMassModel/dispersedVirtualMassModel.H index df18b8da0b..40ce8cfa23 100644 --- a/applications/solvers/modules/multiphaseEuler/interfacialModels/virtualMassModels/dispersedVirtualMassModel/dispersedVirtualMassModel.H +++ b/applications/solvers/modules/multiphaseEuler/interfacialModels/virtualMassModels/dispersedVirtualMassModel/dispersedVirtualMassModel.H @@ -48,7 +48,7 @@ namespace virtualMassModels { /*---------------------------------------------------------------------------*\ - Class dispersedVirtualMassModel Declaration + Class dispersedVirtualMassModel Declaration \*---------------------------------------------------------------------------*/ class dispersedVirtualMassModel diff --git a/applications/solvers/modules/multiphaseEuler/interfacialModels/virtualMassModels/virtualMassModel/virtualMassModel.H b/applications/solvers/modules/multiphaseEuler/interfacialModels/virtualMassModels/virtualMassModel/virtualMassModel.H index 627368f6dd..a0c50fcdf8 100644 --- a/applications/solvers/modules/multiphaseEuler/interfacialModels/virtualMassModels/virtualMassModel/virtualMassModel.H +++ b/applications/solvers/modules/multiphaseEuler/interfacialModels/virtualMassModels/virtualMassModel/virtualMassModel.H @@ -129,7 +129,7 @@ public: /*---------------------------------------------------------------------------*\ - Class blendedVirtualMassModel Declaration + Class blendedVirtualMassModel Declaration \*---------------------------------------------------------------------------*/ class blendedVirtualMassModel diff --git a/applications/solvers/modules/multiphaseEuler/interfacialModels/wallLubricationModels/dispersedWallLubricationModel/dispersedWallLubricationModel.H b/applications/solvers/modules/multiphaseEuler/interfacialModels/wallLubricationModels/dispersedWallLubricationModel/dispersedWallLubricationModel.H index 2ef3527ac7..c9996e2d49 100644 --- a/applications/solvers/modules/multiphaseEuler/interfacialModels/wallLubricationModels/dispersedWallLubricationModel/dispersedWallLubricationModel.H +++ b/applications/solvers/modules/multiphaseEuler/interfacialModels/wallLubricationModels/dispersedWallLubricationModel/dispersedWallLubricationModel.H @@ -47,7 +47,7 @@ namespace wallLubricationModels { /*---------------------------------------------------------------------------*\ - Class dispersedWallLubricationModel Declaration + Class dispersedWallLubricationModel Declaration \*---------------------------------------------------------------------------*/ class dispersedWallLubricationModel diff --git a/applications/solvers/modules/multiphaseEuler/interfacialModels/wallLubricationModels/wallLubricationModel/wallLubricationModel.H b/applications/solvers/modules/multiphaseEuler/interfacialModels/wallLubricationModels/wallLubricationModel/wallLubricationModel.H index cbb275fc8a..02c5978a44 100644 --- a/applications/solvers/modules/multiphaseEuler/interfacialModels/wallLubricationModels/wallLubricationModel/wallLubricationModel.H +++ b/applications/solvers/modules/multiphaseEuler/interfacialModels/wallLubricationModels/wallLubricationModel/wallLubricationModel.H @@ -128,7 +128,7 @@ public: /*---------------------------------------------------------------------------*\ - Class blendedWallLubricationModel Declaration + Class blendedWallLubricationModel Declaration \*---------------------------------------------------------------------------*/ class blendedWallLubricationModel diff --git a/applications/solvers/modules/multiphaseEuler/multiphaseEuler/multiphaseEuler.H b/applications/solvers/modules/multiphaseEuler/multiphaseEuler/multiphaseEuler.H index 8bb33e5b28..e792e7faec 100644 --- a/applications/solvers/modules/multiphaseEuler/multiphaseEuler/multiphaseEuler.H +++ b/applications/solvers/modules/multiphaseEuler/multiphaseEuler/multiphaseEuler.H @@ -65,7 +65,7 @@ namespace solvers { /*---------------------------------------------------------------------------*\ - Class multiphaseEuler Declaration + Class multiphaseEuler Declaration \*---------------------------------------------------------------------------*/ class multiphaseEuler diff --git a/applications/solvers/modules/multiphaseEuler/multiphaseReactions/phaseSurfaceArrheniusReactionRate/phaseSurfaceArrheniusReactionRate.H b/applications/solvers/modules/multiphaseEuler/multiphaseReactions/phaseSurfaceArrheniusReactionRate/phaseSurfaceArrheniusReactionRate.H index 0ad91c8d0d..8a9a41ccc3 100644 --- a/applications/solvers/modules/multiphaseEuler/multiphaseReactions/phaseSurfaceArrheniusReactionRate/phaseSurfaceArrheniusReactionRate.H +++ b/applications/solvers/modules/multiphaseEuler/multiphaseReactions/phaseSurfaceArrheniusReactionRate/phaseSurfaceArrheniusReactionRate.H @@ -56,7 +56,7 @@ class phaseSurfaceArrheniusReactionRate; Ostream& operator<<(Ostream&, const phaseSurfaceArrheniusReactionRate&); /*---------------------------------------------------------------------------*\ - Class phaseSurfaceArrheniusReactionRate Declaration + Class phaseSurfaceArrheniusReactionRate Declaration \*---------------------------------------------------------------------------*/ class phaseSurfaceArrheniusReactionRate diff --git a/applications/solvers/modules/multiphaseEuler/multiphaseThermophysicalTransportModels/derivedFvPatchFields/alphatPhaseChangeWallFunctionBase/alphatPhaseChangeWallFunctionBase.H b/applications/solvers/modules/multiphaseEuler/multiphaseThermophysicalTransportModels/derivedFvPatchFields/alphatPhaseChangeWallFunctionBase/alphatPhaseChangeWallFunctionBase.H index c0beeaf51f..51cb1219d1 100644 --- a/applications/solvers/modules/multiphaseEuler/multiphaseThermophysicalTransportModels/derivedFvPatchFields/alphatPhaseChangeWallFunctionBase/alphatPhaseChangeWallFunctionBase.H +++ b/applications/solvers/modules/multiphaseEuler/multiphaseThermophysicalTransportModels/derivedFvPatchFields/alphatPhaseChangeWallFunctionBase/alphatPhaseChangeWallFunctionBase.H @@ -48,7 +48,7 @@ namespace compressible { /*---------------------------------------------------------------------------*\ - Class alphatPhaseChangeWallFunctionBase Declaration + Class alphatPhaseChangeWallFunctionBase Declaration \*---------------------------------------------------------------------------*/ class alphatPhaseChangeWallFunctionBase diff --git a/applications/solvers/modules/multiphaseEuler/multiphaseThermophysicalTransportModels/derivedFvPatchFields/coupledMultiphaseTemperature/coupledMultiphaseTemperatureFvPatchScalarField.H b/applications/solvers/modules/multiphaseEuler/multiphaseThermophysicalTransportModels/derivedFvPatchFields/coupledMultiphaseTemperature/coupledMultiphaseTemperatureFvPatchScalarField.H index 673052e5f4..95e4cbf94f 100644 --- a/applications/solvers/modules/multiphaseEuler/multiphaseThermophysicalTransportModels/derivedFvPatchFields/coupledMultiphaseTemperature/coupledMultiphaseTemperatureFvPatchScalarField.H +++ b/applications/solvers/modules/multiphaseEuler/multiphaseThermophysicalTransportModels/derivedFvPatchFields/coupledMultiphaseTemperature/coupledMultiphaseTemperatureFvPatchScalarField.H @@ -49,7 +49,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class coupledMultiphaseTemperatureFvPatchScalarField Declaration + Class coupledMultiphaseTemperatureFvPatchScalarField Declaration \*---------------------------------------------------------------------------*/ class coupledMultiphaseTemperatureFvPatchScalarField diff --git a/applications/solvers/modules/multiphaseEuler/phaseSystems/PhaseSystems/TwoResistanceHeatTransferPhaseSystem/twoResistanceHeatTransferPhaseSystem.H b/applications/solvers/modules/multiphaseEuler/phaseSystems/PhaseSystems/TwoResistanceHeatTransferPhaseSystem/twoResistanceHeatTransferPhaseSystem.H index 3b3adcb8e5..8b1fb50827 100644 --- a/applications/solvers/modules/multiphaseEuler/phaseSystems/PhaseSystems/TwoResistanceHeatTransferPhaseSystem/twoResistanceHeatTransferPhaseSystem.H +++ b/applications/solvers/modules/multiphaseEuler/phaseSystems/PhaseSystems/TwoResistanceHeatTransferPhaseSystem/twoResistanceHeatTransferPhaseSystem.H @@ -40,7 +40,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class twoResistanceHeatTransferPhaseSystem Declaration + Class twoResistanceHeatTransferPhaseSystem Declaration \*---------------------------------------------------------------------------*/ class twoResistanceHeatTransferPhaseSystem diff --git a/applications/solvers/modules/multiphaseEuler/phaseSystems/SidedInterfacialModel/SidedInterfacialModel.H b/applications/solvers/modules/multiphaseEuler/phaseSystems/SidedInterfacialModel/SidedInterfacialModel.H index a45167ccb7..1827cb2a29 100644 --- a/applications/solvers/modules/multiphaseEuler/phaseSystems/SidedInterfacialModel/SidedInterfacialModel.H +++ b/applications/solvers/modules/multiphaseEuler/phaseSystems/SidedInterfacialModel/SidedInterfacialModel.H @@ -42,7 +42,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class SidedInterfacialModel Declaration + Class SidedInterfacialModel Declaration \*---------------------------------------------------------------------------*/ template<class ModelType> diff --git a/applications/solvers/modules/multiphaseEuler/phaseSystems/diameterModels/noDiameter/noDiameter.H b/applications/solvers/modules/multiphaseEuler/phaseSystems/diameterModels/noDiameter/noDiameter.H index 3ed2ea4c48..d0a16199c2 100644 --- a/applications/solvers/modules/multiphaseEuler/phaseSystems/diameterModels/noDiameter/noDiameter.H +++ b/applications/solvers/modules/multiphaseEuler/phaseSystems/diameterModels/noDiameter/noDiameter.H @@ -45,7 +45,7 @@ namespace diameterModels { /*---------------------------------------------------------------------------*\ - Class noDiameter Declaration + Class noDiameter Declaration \*---------------------------------------------------------------------------*/ class noDiameter diff --git a/applications/solvers/modules/multiphaseEuler/phaseSystems/phaseInterface/dispersedDisplacedPhaseInterface/dispersedDisplacedPhaseInterface.H b/applications/solvers/modules/multiphaseEuler/phaseSystems/phaseInterface/dispersedDisplacedPhaseInterface/dispersedDisplacedPhaseInterface.H index 885b854944..f00341a31a 100644 --- a/applications/solvers/modules/multiphaseEuler/phaseSystems/phaseInterface/dispersedDisplacedPhaseInterface/dispersedDisplacedPhaseInterface.H +++ b/applications/solvers/modules/multiphaseEuler/phaseSystems/phaseInterface/dispersedDisplacedPhaseInterface/dispersedDisplacedPhaseInterface.H @@ -46,7 +46,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class dispersedDisplacedPhaseInterface Declaration + Class dispersedDisplacedPhaseInterface Declaration \*---------------------------------------------------------------------------*/ class dispersedDisplacedPhaseInterface diff --git a/applications/solvers/modules/multiphaseEuler/phaseSystems/phaseInterface/dispersedDisplacedSidedPhaseInterface/dispersedDisplacedSidedPhaseInterface.H b/applications/solvers/modules/multiphaseEuler/phaseSystems/phaseInterface/dispersedDisplacedSidedPhaseInterface/dispersedDisplacedSidedPhaseInterface.H index cf7c87afe1..3d77860170 100644 --- a/applications/solvers/modules/multiphaseEuler/phaseSystems/phaseInterface/dispersedDisplacedSidedPhaseInterface/dispersedDisplacedSidedPhaseInterface.H +++ b/applications/solvers/modules/multiphaseEuler/phaseSystems/phaseInterface/dispersedDisplacedSidedPhaseInterface/dispersedDisplacedSidedPhaseInterface.H @@ -47,7 +47,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class dispersedDisplacedSidedPhaseInterface Declaration + Class dispersedDisplacedSidedPhaseInterface Declaration \*---------------------------------------------------------------------------*/ class dispersedDisplacedSidedPhaseInterface diff --git a/applications/solvers/modules/multiphaseEuler/phaseSystems/phaseInterface/dispersedPhaseInterface/dispersedPhaseInterface.H b/applications/solvers/modules/multiphaseEuler/phaseSystems/phaseInterface/dispersedPhaseInterface/dispersedPhaseInterface.H index e32b2f8031..f65c9d05e6 100644 --- a/applications/solvers/modules/multiphaseEuler/phaseSystems/phaseInterface/dispersedPhaseInterface/dispersedPhaseInterface.H +++ b/applications/solvers/modules/multiphaseEuler/phaseSystems/phaseInterface/dispersedPhaseInterface/dispersedPhaseInterface.H @@ -44,7 +44,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class dispersedPhaseInterface Declaration + Class dispersedPhaseInterface Declaration \*---------------------------------------------------------------------------*/ class dispersedPhaseInterface diff --git a/applications/solvers/modules/multiphaseEuler/phaseSystems/phaseInterface/dispersedSidedPhaseInterface/dispersedSidedPhaseInterface.H b/applications/solvers/modules/multiphaseEuler/phaseSystems/phaseInterface/dispersedSidedPhaseInterface/dispersedSidedPhaseInterface.H index 40a00b116c..85b0611ca9 100644 --- a/applications/solvers/modules/multiphaseEuler/phaseSystems/phaseInterface/dispersedSidedPhaseInterface/dispersedSidedPhaseInterface.H +++ b/applications/solvers/modules/multiphaseEuler/phaseSystems/phaseInterface/dispersedSidedPhaseInterface/dispersedSidedPhaseInterface.H @@ -45,7 +45,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class dispersedSidedPhaseInterface Declaration + Class dispersedSidedPhaseInterface Declaration \*---------------------------------------------------------------------------*/ class dispersedSidedPhaseInterface diff --git a/applications/solvers/modules/multiphaseEuler/phaseSystems/phaseInterface/displacedSidedPhaseInterface/displacedSidedPhaseInterface.H b/applications/solvers/modules/multiphaseEuler/phaseSystems/phaseInterface/displacedSidedPhaseInterface/displacedSidedPhaseInterface.H index dd7bd92c8a..2afcdfaf10 100644 --- a/applications/solvers/modules/multiphaseEuler/phaseSystems/phaseInterface/displacedSidedPhaseInterface/displacedSidedPhaseInterface.H +++ b/applications/solvers/modules/multiphaseEuler/phaseSystems/phaseInterface/displacedSidedPhaseInterface/displacedSidedPhaseInterface.H @@ -46,7 +46,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class displacedSidedPhaseInterface Declaration + Class displacedSidedPhaseInterface Declaration \*---------------------------------------------------------------------------*/ class displacedSidedPhaseInterface diff --git a/applications/solvers/modules/multiphaseEuler/phaseSystems/phaseInterface/phaseInterface/phaseInterface.H b/applications/solvers/modules/multiphaseEuler/phaseSystems/phaseInterface/phaseInterface/phaseInterface.H index f830acdee3..20687df4a0 100644 --- a/applications/solvers/modules/multiphaseEuler/phaseSystems/phaseInterface/phaseInterface/phaseInterface.H +++ b/applications/solvers/modules/multiphaseEuler/phaseSystems/phaseInterface/phaseInterface/phaseInterface.H @@ -51,7 +51,7 @@ namespace Foam class phaseInterfaceKey; /*---------------------------------------------------------------------------*\ - Class phaseInterface Declaration + Class phaseInterface Declaration \*---------------------------------------------------------------------------*/ class phaseInterface diff --git a/applications/solvers/modules/multiphaseEuler/phaseSystems/phaseInterface/phaseInterfaceKey/phaseInterfaceKey.H b/applications/solvers/modules/multiphaseEuler/phaseSystems/phaseInterface/phaseInterfaceKey/phaseInterfaceKey.H index c1a7f70a2d..7fadc0caf9 100644 --- a/applications/solvers/modules/multiphaseEuler/phaseSystems/phaseInterface/phaseInterfaceKey/phaseInterfaceKey.H +++ b/applications/solvers/modules/multiphaseEuler/phaseSystems/phaseInterface/phaseInterfaceKey/phaseInterfaceKey.H @@ -56,7 +56,7 @@ Istream& operator>>(Istream&, phaseInterfaceKey&); Ostream& operator<<(Ostream&, const phaseInterfaceKey&); /*---------------------------------------------------------------------------*\ - Class phaseInterfaceKey Declaration + Class phaseInterfaceKey Declaration \*---------------------------------------------------------------------------*/ class phaseInterfaceKey diff --git a/applications/solvers/modules/multiphaseEuler/phaseSystems/phaseInterface/segregatedDisplacedPhaseInterface/segregatedDisplacedPhaseInterface.H b/applications/solvers/modules/multiphaseEuler/phaseSystems/phaseInterface/segregatedDisplacedPhaseInterface/segregatedDisplacedPhaseInterface.H index f967c17c7b..7fd677651c 100644 --- a/applications/solvers/modules/multiphaseEuler/phaseSystems/phaseInterface/segregatedDisplacedPhaseInterface/segregatedDisplacedPhaseInterface.H +++ b/applications/solvers/modules/multiphaseEuler/phaseSystems/phaseInterface/segregatedDisplacedPhaseInterface/segregatedDisplacedPhaseInterface.H @@ -46,7 +46,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class segregatedDisplacedPhaseInterface Declaration + Class segregatedDisplacedPhaseInterface Declaration \*---------------------------------------------------------------------------*/ class segregatedDisplacedPhaseInterface diff --git a/applications/solvers/modules/multiphaseEuler/phaseSystems/phaseInterface/segregatedDisplacedSidedPhaseInterface/segregatedDisplacedSidedPhaseInterface.H b/applications/solvers/modules/multiphaseEuler/phaseSystems/phaseInterface/segregatedDisplacedSidedPhaseInterface/segregatedDisplacedSidedPhaseInterface.H index 6954b2cc84..6125c178dc 100644 --- a/applications/solvers/modules/multiphaseEuler/phaseSystems/phaseInterface/segregatedDisplacedSidedPhaseInterface/segregatedDisplacedSidedPhaseInterface.H +++ b/applications/solvers/modules/multiphaseEuler/phaseSystems/phaseInterface/segregatedDisplacedSidedPhaseInterface/segregatedDisplacedSidedPhaseInterface.H @@ -47,7 +47,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class segregatedDisplacedSidedPhaseInterface Declaration + Class segregatedDisplacedSidedPhaseInterface Declaration \*---------------------------------------------------------------------------*/ class segregatedDisplacedSidedPhaseInterface diff --git a/applications/solvers/modules/multiphaseEuler/phaseSystems/phaseInterface/segregatedPhaseInterface/segregatedPhaseInterface.H b/applications/solvers/modules/multiphaseEuler/phaseSystems/phaseInterface/segregatedPhaseInterface/segregatedPhaseInterface.H index b07c9dfe77..811b438de1 100644 --- a/applications/solvers/modules/multiphaseEuler/phaseSystems/phaseInterface/segregatedPhaseInterface/segregatedPhaseInterface.H +++ b/applications/solvers/modules/multiphaseEuler/phaseSystems/phaseInterface/segregatedPhaseInterface/segregatedPhaseInterface.H @@ -45,7 +45,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class segregatedPhaseInterface Declaration + Class segregatedPhaseInterface Declaration \*---------------------------------------------------------------------------*/ class segregatedPhaseInterface diff --git a/applications/solvers/modules/multiphaseEuler/phaseSystems/phaseInterface/segregatedSidedPhaseInterface/segregatedSidedPhaseInterface.H b/applications/solvers/modules/multiphaseEuler/phaseSystems/phaseInterface/segregatedSidedPhaseInterface/segregatedSidedPhaseInterface.H index 396e2a26e3..a35be119bc 100644 --- a/applications/solvers/modules/multiphaseEuler/phaseSystems/phaseInterface/segregatedSidedPhaseInterface/segregatedSidedPhaseInterface.H +++ b/applications/solvers/modules/multiphaseEuler/phaseSystems/phaseInterface/segregatedSidedPhaseInterface/segregatedSidedPhaseInterface.H @@ -45,7 +45,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class segregatedSidedPhaseInterface Declaration + Class segregatedSidedPhaseInterface Declaration \*---------------------------------------------------------------------------*/ class segregatedSidedPhaseInterface diff --git a/applications/solvers/modules/multiphaseEuler/phaseSystems/phaseInterface/sidedPhaseInterface/sidedPhaseInterface.H b/applications/solvers/modules/multiphaseEuler/phaseSystems/phaseInterface/sidedPhaseInterface/sidedPhaseInterface.H index 92970ea7d4..665fb3eb09 100644 --- a/applications/solvers/modules/multiphaseEuler/phaseSystems/phaseInterface/sidedPhaseInterface/sidedPhaseInterface.H +++ b/applications/solvers/modules/multiphaseEuler/phaseSystems/phaseInterface/sidedPhaseInterface/sidedPhaseInterface.H @@ -43,7 +43,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class sidedPhaseInterface Declaration + Class sidedPhaseInterface Declaration \*---------------------------------------------------------------------------*/ class sidedPhaseInterface diff --git a/applications/solvers/modules/multiphaseEuler/phaseSystems/populationBalanceModel/daughterSizeDistributionModels/uniformBinary/uniformBinary.H b/applications/solvers/modules/multiphaseEuler/phaseSystems/populationBalanceModel/daughterSizeDistributionModels/uniformBinary/uniformBinary.H index b5f4fb153c..d64b5ce8d2 100644 --- a/applications/solvers/modules/multiphaseEuler/phaseSystems/populationBalanceModel/daughterSizeDistributionModels/uniformBinary/uniformBinary.H +++ b/applications/solvers/modules/multiphaseEuler/phaseSystems/populationBalanceModel/daughterSizeDistributionModels/uniformBinary/uniformBinary.H @@ -47,7 +47,7 @@ namespace daughterSizeDistributionModels { /*---------------------------------------------------------------------------*\ - Class uniformBinary Declaration + Class uniformBinary Declaration \*---------------------------------------------------------------------------*/ class uniformBinary diff --git a/applications/solvers/modules/multiphaseVoFSolver/multiphaseVoFMixture/VoFphase/VoFphase.H b/applications/solvers/modules/multiphaseVoFSolver/multiphaseVoFMixture/VoFphase/VoFphase.H index ebbd1004a7..8abd639e48 100644 --- a/applications/solvers/modules/multiphaseVoFSolver/multiphaseVoFMixture/VoFphase/VoFphase.H +++ b/applications/solvers/modules/multiphaseVoFSolver/multiphaseVoFMixture/VoFphase/VoFphase.H @@ -45,7 +45,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class VoFphase Declaration + Class VoFphase Declaration \*---------------------------------------------------------------------------*/ class VoFphase diff --git a/applications/solvers/modules/multiphaseVoFSolver/multiphaseVoFMixture/multiphaseVoFMixture.H b/applications/solvers/modules/multiphaseVoFSolver/multiphaseVoFMixture/multiphaseVoFMixture.H index 11b2fb19ae..2f2eb2e52e 100644 --- a/applications/solvers/modules/multiphaseVoFSolver/multiphaseVoFMixture/multiphaseVoFMixture.H +++ b/applications/solvers/modules/multiphaseVoFSolver/multiphaseVoFMixture/multiphaseVoFMixture.H @@ -49,7 +49,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class multiphaseVoFMixture Declaration + Class multiphaseVoFMixture Declaration \*---------------------------------------------------------------------------*/ class multiphaseVoFMixture diff --git a/applications/solvers/modules/multiphaseVoFSolver/multiphaseVoFSolver.H b/applications/solvers/modules/multiphaseVoFSolver/multiphaseVoFSolver.H index 4af7bb2706..233a1340e9 100644 --- a/applications/solvers/modules/multiphaseVoFSolver/multiphaseVoFSolver.H +++ b/applications/solvers/modules/multiphaseVoFSolver/multiphaseVoFSolver.H @@ -59,7 +59,7 @@ namespace solvers { /*---------------------------------------------------------------------------*\ - Class multiphaseVoFSolver Declaration + Class multiphaseVoFSolver Declaration \*---------------------------------------------------------------------------*/ class multiphaseVoFSolver diff --git a/applications/solvers/modules/shockFluid/shockFluid.H b/applications/solvers/modules/shockFluid/shockFluid.H index 42331c8395..93700ce8e9 100644 --- a/applications/solvers/modules/shockFluid/shockFluid.H +++ b/applications/solvers/modules/shockFluid/shockFluid.H @@ -65,7 +65,7 @@ namespace solvers { /*---------------------------------------------------------------------------*\ - Class shockFluid Declaration + Class shockFluid Declaration \*---------------------------------------------------------------------------*/ class shockFluid diff --git a/applications/solvers/modules/solid/solid.H b/applications/solvers/modules/solid/solid.H index f13cab185a..e93190ac23 100644 --- a/applications/solvers/modules/solid/solid.H +++ b/applications/solvers/modules/solid/solid.H @@ -48,7 +48,7 @@ namespace solvers { /*---------------------------------------------------------------------------*\ - Class solid Declaration + Class solid Declaration \*---------------------------------------------------------------------------*/ class solid diff --git a/applications/solvers/modules/solidDisplacement/solidDisplacement.H b/applications/solvers/modules/solidDisplacement/solidDisplacement.H index 95ea10d4a0..809967515d 100644 --- a/applications/solvers/modules/solidDisplacement/solidDisplacement.H +++ b/applications/solvers/modules/solidDisplacement/solidDisplacement.H @@ -51,7 +51,7 @@ namespace solvers { /*---------------------------------------------------------------------------*\ - Class solidDisplacement Declaration + Class solidDisplacement Declaration \*---------------------------------------------------------------------------*/ class solidDisplacement diff --git a/applications/solvers/modules/twoPhaseVoFSolver/twoPhaseVoFMixture/twoPhaseVoFMixture.H b/applications/solvers/modules/twoPhaseVoFSolver/twoPhaseVoFMixture/twoPhaseVoFMixture.H index e427147002..2dd76537ce 100644 --- a/applications/solvers/modules/twoPhaseVoFSolver/twoPhaseVoFMixture/twoPhaseVoFMixture.H +++ b/applications/solvers/modules/twoPhaseVoFSolver/twoPhaseVoFMixture/twoPhaseVoFMixture.H @@ -44,7 +44,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class twoPhaseVoFMixture Declaration + Class twoPhaseVoFMixture Declaration \*---------------------------------------------------------------------------*/ class twoPhaseVoFMixture diff --git a/applications/solvers/modules/twoPhaseVoFSolver/twoPhaseVoFSolver.H b/applications/solvers/modules/twoPhaseVoFSolver/twoPhaseVoFSolver.H index 0eea7a50f5..dabda60a56 100644 --- a/applications/solvers/modules/twoPhaseVoFSolver/twoPhaseVoFSolver.H +++ b/applications/solvers/modules/twoPhaseVoFSolver/twoPhaseVoFSolver.H @@ -67,7 +67,7 @@ namespace solvers { /*---------------------------------------------------------------------------*\ - Class twoPhaseVoFSolver Declaration + Class twoPhaseVoFSolver Declaration \*---------------------------------------------------------------------------*/ class twoPhaseVoFSolver diff --git a/applications/solvers/multiphase/cavitatingFoam/cavitatingTwoPhaseMixture/cavitatingTwoPhaseMixture.H b/applications/solvers/multiphase/cavitatingFoam/cavitatingTwoPhaseMixture/cavitatingTwoPhaseMixture.H index 963cdae0cb..b194b5a4c6 100644 --- a/applications/solvers/multiphase/cavitatingFoam/cavitatingTwoPhaseMixture/cavitatingTwoPhaseMixture.H +++ b/applications/solvers/multiphase/cavitatingFoam/cavitatingTwoPhaseMixture/cavitatingTwoPhaseMixture.H @@ -46,7 +46,7 @@ namespace Foam class barotropicCompressibilityModel; /*---------------------------------------------------------------------------*\ - Class cavitatingTwoPhaseMixture Declaration + Class cavitatingTwoPhaseMixture Declaration \*---------------------------------------------------------------------------*/ class cavitatingTwoPhaseMixture diff --git a/applications/solvers/multiphase/driftFluxFoam/relativeVelocityModels/MichaelsBolger/MichaelsBolger.H b/applications/solvers/multiphase/driftFluxFoam/relativeVelocityModels/MichaelsBolger/MichaelsBolger.H index d14e609def..f5e46d61de 100644 --- a/applications/solvers/multiphase/driftFluxFoam/relativeVelocityModels/MichaelsBolger/MichaelsBolger.H +++ b/applications/solvers/multiphase/driftFluxFoam/relativeVelocityModels/MichaelsBolger/MichaelsBolger.H @@ -65,7 +65,7 @@ namespace relativeVelocityModels { /*---------------------------------------------------------------------------*\ - Class MichaelsBolger Declaration + Class MichaelsBolger Declaration \*---------------------------------------------------------------------------*/ class MichaelsBolger diff --git a/src/MomentumTransportModels/momentumTransportModels/RAS/kOmega2006/kOmega2006.H b/src/MomentumTransportModels/momentumTransportModels/RAS/kOmega2006/kOmega2006.H index 60993847e4..cf78b3dd02 100644 --- a/src/MomentumTransportModels/momentumTransportModels/RAS/kOmega2006/kOmega2006.H +++ b/src/MomentumTransportModels/momentumTransportModels/RAS/kOmega2006/kOmega2006.H @@ -71,7 +71,7 @@ namespace RASModels { /*---------------------------------------------------------------------------*\ - Class kOmega2006 Declaration + Class kOmega2006 Declaration \*---------------------------------------------------------------------------*/ template<class BasicMomentumTransportModel> diff --git a/src/MomentumTransportModels/momentumTransportModels/laminar/generalisedNewtonian/generalisedNewtonianViscosityModels/Newtonian/NewtonianViscosityModel.H b/src/MomentumTransportModels/momentumTransportModels/laminar/generalisedNewtonian/generalisedNewtonianViscosityModels/Newtonian/NewtonianViscosityModel.H index 14be0ad536..d992662dbc 100644 --- a/src/MomentumTransportModels/momentumTransportModels/laminar/generalisedNewtonian/generalisedNewtonianViscosityModels/Newtonian/NewtonianViscosityModel.H +++ b/src/MomentumTransportModels/momentumTransportModels/laminar/generalisedNewtonian/generalisedNewtonianViscosityModels/Newtonian/NewtonianViscosityModel.H @@ -47,7 +47,7 @@ namespace generalisedNewtonianViscosityModels { /*---------------------------------------------------------------------------*\ - Class Newtonian Declaration + Class Newtonian Declaration \*---------------------------------------------------------------------------*/ class Newtonian diff --git a/src/MomentumTransportModels/momentumTransportModels/laminar/generalisedNewtonian/generalisedNewtonianViscosityModels/strainRateViscosityModels/strainRateViscosityModel/strainRateViscosityModel.H b/src/MomentumTransportModels/momentumTransportModels/laminar/generalisedNewtonian/generalisedNewtonianViscosityModels/strainRateViscosityModels/strainRateViscosityModel/strainRateViscosityModel.H index feb6a29a4b..ccd7e578fb 100644 --- a/src/MomentumTransportModels/momentumTransportModels/laminar/generalisedNewtonian/generalisedNewtonianViscosityModels/strainRateViscosityModels/strainRateViscosityModel/strainRateViscosityModel.H +++ b/src/MomentumTransportModels/momentumTransportModels/laminar/generalisedNewtonian/generalisedNewtonianViscosityModels/strainRateViscosityModels/strainRateViscosityModel/strainRateViscosityModel.H @@ -50,7 +50,7 @@ namespace generalisedNewtonianViscosityModels { /*---------------------------------------------------------------------------*\ - Class strainRateViscosityModel Declaration + Class strainRateViscosityModel Declaration \*---------------------------------------------------------------------------*/ class strainRateViscosityModel diff --git a/src/MomentumTransportModels/momentumTransportModels/laminar/lambdaThixotropic/lambdaThixotropic.H b/src/MomentumTransportModels/momentumTransportModels/laminar/lambdaThixotropic/lambdaThixotropic.H index 8037c3f1cc..51c02588ed 100644 --- a/src/MomentumTransportModels/momentumTransportModels/laminar/lambdaThixotropic/lambdaThixotropic.H +++ b/src/MomentumTransportModels/momentumTransportModels/laminar/lambdaThixotropic/lambdaThixotropic.H @@ -81,7 +81,7 @@ namespace laminarModels { /*---------------------------------------------------------------------------*\ - Class lambdaThixotropic Declaration + Class lambdaThixotropic Declaration \*---------------------------------------------------------------------------*/ template<class BasicMomentumTransportModel> diff --git a/src/MomentumTransportModels/phaseCompressible/derivedFvPatchFields/wallFunctions/epsilonWallFunctions/epsilonmWallFunction/epsilonmWallFunctionFvPatchScalarField.H b/src/MomentumTransportModels/phaseCompressible/derivedFvPatchFields/wallFunctions/epsilonWallFunctions/epsilonmWallFunction/epsilonmWallFunctionFvPatchScalarField.H index 19988bdb84..ade8bb54e6 100644 --- a/src/MomentumTransportModels/phaseCompressible/derivedFvPatchFields/wallFunctions/epsilonWallFunctions/epsilonmWallFunction/epsilonmWallFunctionFvPatchScalarField.H +++ b/src/MomentumTransportModels/phaseCompressible/derivedFvPatchFields/wallFunctions/epsilonWallFunctions/epsilonmWallFunction/epsilonmWallFunctionFvPatchScalarField.H @@ -44,7 +44,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class epsilonmWallFunctionFvPatchScalarField Declaration + Class epsilonmWallFunctionFvPatchScalarField Declaration \*---------------------------------------------------------------------------*/ class epsilonmWallFunctionFvPatchScalarField diff --git a/src/OpenFOAM/algorithms/polygonTriangulate/polygonTriangulate.H b/src/OpenFOAM/algorithms/polygonTriangulate/polygonTriangulate.H index 2003861672..bc864ebd99 100644 --- a/src/OpenFOAM/algorithms/polygonTriangulate/polygonTriangulate.H +++ b/src/OpenFOAM/algorithms/polygonTriangulate/polygonTriangulate.H @@ -46,7 +46,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class polygonTriangulate Declaration + Class polygonTriangulate Declaration \*---------------------------------------------------------------------------*/ class polygonTriangulate diff --git a/src/OpenFOAM/containers/Dictionaries/UPtrListDictionary/UPtrListDictionary.H b/src/OpenFOAM/containers/Dictionaries/UPtrListDictionary/UPtrListDictionary.H index 06da46660a..8a374ad98f 100644 --- a/src/OpenFOAM/containers/Dictionaries/UPtrListDictionary/UPtrListDictionary.H +++ b/src/OpenFOAM/containers/Dictionaries/UPtrListDictionary/UPtrListDictionary.H @@ -50,7 +50,7 @@ template<class T> class PtrListDictionary; /*---------------------------------------------------------------------------*\ - Class UPtrListDictionary Declaration + Class UPtrListDictionary Declaration \*---------------------------------------------------------------------------*/ template<class T> diff --git a/src/OpenFOAM/containers/Lists/UCompactListList/UCompactListList.H b/src/OpenFOAM/containers/Lists/UCompactListList/UCompactListList.H index e8b4ac19c3..7996d12f63 100644 --- a/src/OpenFOAM/containers/Lists/UCompactListList/UCompactListList.H +++ b/src/OpenFOAM/containers/Lists/UCompactListList/UCompactListList.H @@ -51,7 +51,7 @@ template<class T> class UCompactListList; template<class T> Ostream& operator<<(Ostream&, const UCompactListList<T>&); /*---------------------------------------------------------------------------*\ - Class UCompactListList Declaration + Class UCompactListList Declaration \*---------------------------------------------------------------------------*/ template<class T> diff --git a/src/OpenFOAM/db/IOobject/IOobject.H b/src/OpenFOAM/db/IOobject/IOobject.H index 0da237b583..43c8b3ef1b 100644 --- a/src/OpenFOAM/db/IOobject/IOobject.H +++ b/src/OpenFOAM/db/IOobject/IOobject.H @@ -523,7 +523,7 @@ inline IOobject unregister(const IOobject& io) /*---------------------------------------------------------------------------*\ - Class typeIOobject Declaration + Class typeIOobject Declaration \*---------------------------------------------------------------------------*/ template<class Type> diff --git a/src/OpenFOAM/db/IOobjects/CompactIOList/CompactIOList.H b/src/OpenFOAM/db/IOobjects/CompactIOList/CompactIOList.H index 9ad389d645..7fe26dd425 100644 --- a/src/OpenFOAM/db/IOobjects/CompactIOList/CompactIOList.H +++ b/src/OpenFOAM/db/IOobjects/CompactIOList/CompactIOList.H @@ -98,7 +98,7 @@ Ostream& operator<< /*---------------------------------------------------------------------------*\ - Class CompactIOListBase Declaration + Class CompactIOListBase Declaration \*---------------------------------------------------------------------------*/ template diff --git a/src/OpenFOAM/db/IOobjects/GlobalIOField/GlobalIOField.H b/src/OpenFOAM/db/IOobjects/GlobalIOField/GlobalIOField.H index ec4acd29fe..6fe722b061 100644 --- a/src/OpenFOAM/db/IOobjects/GlobalIOField/GlobalIOField.H +++ b/src/OpenFOAM/db/IOobjects/GlobalIOField/GlobalIOField.H @@ -41,7 +41,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class GlobalIOField Declaration + Class GlobalIOField Declaration \*---------------------------------------------------------------------------*/ template<class Type> diff --git a/src/OpenFOAM/db/IOobjects/GlobalIOList/GlobalIOList.H b/src/OpenFOAM/db/IOobjects/GlobalIOList/GlobalIOList.H index b1e823db28..161e391e49 100644 --- a/src/OpenFOAM/db/IOobjects/GlobalIOList/GlobalIOList.H +++ b/src/OpenFOAM/db/IOobjects/GlobalIOList/GlobalIOList.H @@ -44,7 +44,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class GlobalIOListBase Declaration + Class GlobalIOListBase Declaration \*---------------------------------------------------------------------------*/ template @@ -114,7 +114,7 @@ public: /*---------------------------------------------------------------------------*\ - Class GlobalIOList Declaration + Class GlobalIOList Declaration \*---------------------------------------------------------------------------*/ template<class Type> diff --git a/src/OpenFOAM/db/IOobjects/IOList/IOList.H b/src/OpenFOAM/db/IOobjects/IOList/IOList.H index a31c202cf6..ed48443715 100644 --- a/src/OpenFOAM/db/IOobjects/IOList/IOList.H +++ b/src/OpenFOAM/db/IOobjects/IOList/IOList.H @@ -44,7 +44,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class IOListBase Declaration + Class IOListBase Declaration \*---------------------------------------------------------------------------*/ template diff --git a/src/OpenFOAM/db/Time/userTime/engineTime/engineTime.H b/src/OpenFOAM/db/Time/userTime/engineTime/engineTime.H index 043bba2400..70bacc0150 100644 --- a/src/OpenFOAM/db/Time/userTime/engineTime/engineTime.H +++ b/src/OpenFOAM/db/Time/userTime/engineTime/engineTime.H @@ -46,7 +46,7 @@ namespace userTimes { /*---------------------------------------------------------------------------*\ - Class engine Declaration + Class engine Declaration \*---------------------------------------------------------------------------*/ class engine diff --git a/src/OpenFOAM/db/Time/userTime/realTime/realTime.H b/src/OpenFOAM/db/Time/userTime/realTime/realTime.H index c36a523245..3d5768fb3d 100644 --- a/src/OpenFOAM/db/Time/userTime/realTime/realTime.H +++ b/src/OpenFOAM/db/Time/userTime/realTime/realTime.H @@ -45,7 +45,7 @@ namespace userTimes { /*---------------------------------------------------------------------------*\ - Class real Declaration + Class real Declaration \*---------------------------------------------------------------------------*/ class real diff --git a/src/OpenFOAM/db/Time/userTime/userTime/userTime.H b/src/OpenFOAM/db/Time/userTime/userTime/userTime.H index ddc91869b6..6202de3d20 100644 --- a/src/OpenFOAM/db/Time/userTime/userTime/userTime.H +++ b/src/OpenFOAM/db/Time/userTime/userTime/userTime.H @@ -46,7 +46,7 @@ namespace userTimes { /*---------------------------------------------------------------------------*\ - Class userTime Declaration + Class userTime Declaration \*---------------------------------------------------------------------------*/ class userTime diff --git a/src/OpenFOAM/fields/GeometricFields/GeometricField/GeometricBoundaryField.H b/src/OpenFOAM/fields/GeometricFields/GeometricField/GeometricBoundaryField.H index cf5668c1e4..420ba640e1 100644 --- a/src/OpenFOAM/fields/GeometricFields/GeometricField/GeometricBoundaryField.H +++ b/src/OpenFOAM/fields/GeometricFields/GeometricField/GeometricBoundaryField.H @@ -52,7 +52,7 @@ template<class Type, template<class> class PatchField, class GeoMesh> class GeometricField; /*---------------------------------------------------------------------------*\ - Class GeometricBoundaryField Declaration + Class GeometricBoundaryField Declaration \*---------------------------------------------------------------------------*/ template<class Type, template<class> class PatchField, class GeoMesh> diff --git a/src/OpenFOAM/meshes/meshObjects/DemandDrivenMeshObject.H b/src/OpenFOAM/meshes/meshObjects/DemandDrivenMeshObject.H index c71e84abbb..db35bb23ac 100644 --- a/src/OpenFOAM/meshes/meshObjects/DemandDrivenMeshObject.H +++ b/src/OpenFOAM/meshes/meshObjects/DemandDrivenMeshObject.H @@ -83,7 +83,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class DemandDrivenMeshObject Declaration + Class DemandDrivenMeshObject Declaration \*---------------------------------------------------------------------------*/ template<class Mesh, template<class> class MeshObjectType, class Type> diff --git a/src/OpenFOAM/meshes/meshObjects/MeshObjects.H b/src/OpenFOAM/meshes/meshObjects/MeshObjects.H index 7bb7a6dfb7..8618ff23ca 100644 --- a/src/OpenFOAM/meshes/meshObjects/MeshObjects.H +++ b/src/OpenFOAM/meshes/meshObjects/MeshObjects.H @@ -117,7 +117,7 @@ public: /*---------------------------------------------------------------------------*\ - Class DistributeableMeshObject Declaration + Class DistributeableMeshObject Declaration \*---------------------------------------------------------------------------*/ template<class Mesh> diff --git a/src/OpenFOAM/meshes/meshObjects/meshObjects.H b/src/OpenFOAM/meshes/meshObjects/meshObjects.H index 42b5823f0d..691e13451b 100644 --- a/src/OpenFOAM/meshes/meshObjects/meshObjects.H +++ b/src/OpenFOAM/meshes/meshObjects/meshObjects.H @@ -82,7 +82,7 @@ class polyMeshMap; class polyDistributionMap; /*---------------------------------------------------------------------------*\ - Class meshObjects Declaration + Class meshObjects Declaration \*---------------------------------------------------------------------------*/ class meshObjects diff --git a/src/OpenFOAM/meshes/polyMesh/polyDistributionMap/IOdistributionMap.H b/src/OpenFOAM/meshes/polyMesh/polyDistributionMap/IOdistributionMap.H index e78a31307e..e1f8989700 100644 --- a/src/OpenFOAM/meshes/polyMesh/polyDistributionMap/IOdistributionMap.H +++ b/src/OpenFOAM/meshes/polyMesh/polyDistributionMap/IOdistributionMap.H @@ -46,7 +46,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class IOdistributionMap Declaration + Class IOdistributionMap Declaration \*---------------------------------------------------------------------------*/ class IOdistributionMap diff --git a/src/OpenFOAM/meshes/polyMesh/polyDistributionMap/distributionMap.H b/src/OpenFOAM/meshes/polyMesh/polyDistributionMap/distributionMap.H index 02036b8960..5b6aea4fdf 100644 --- a/src/OpenFOAM/meshes/polyMesh/polyDistributionMap/distributionMap.H +++ b/src/OpenFOAM/meshes/polyMesh/polyDistributionMap/distributionMap.H @@ -152,7 +152,7 @@ Ostream& operator<<(Ostream&, const distributionMap&); /*---------------------------------------------------------------------------*\ - Class distributionMap Declaration + Class distributionMap Declaration \*---------------------------------------------------------------------------*/ class distributionMap diff --git a/src/OpenFOAM/meshes/polyMesh/polyDistributionMap/distributionMapBase.H b/src/OpenFOAM/meshes/polyMesh/polyDistributionMap/distributionMapBase.H index 8241284a27..2f1262f374 100644 --- a/src/OpenFOAM/meshes/polyMesh/polyDistributionMap/distributionMapBase.H +++ b/src/OpenFOAM/meshes/polyMesh/polyDistributionMap/distributionMapBase.H @@ -91,7 +91,7 @@ Ostream& operator<<(Ostream&, const distributionMapBase&); /*---------------------------------------------------------------------------*\ - Class distributionMapBase Declaration + Class distributionMapBase Declaration \*---------------------------------------------------------------------------*/ class distributionMapBase diff --git a/src/OpenFOAM/meshes/polyMesh/polyDistributionMap/lagrangianDistributionMap.H b/src/OpenFOAM/meshes/polyMesh/polyDistributionMap/lagrangianDistributionMap.H index 4fcde4a8db..1c117421b8 100644 --- a/src/OpenFOAM/meshes/polyMesh/polyDistributionMap/lagrangianDistributionMap.H +++ b/src/OpenFOAM/meshes/polyMesh/polyDistributionMap/lagrangianDistributionMap.H @@ -43,7 +43,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class lagrangianDistributionMap Declaration + Class lagrangianDistributionMap Declaration \*---------------------------------------------------------------------------*/ class lagrangianDistributionMap diff --git a/src/OpenFOAM/meshes/polyMesh/polyDistributionMap/polyDistributionMap.H b/src/OpenFOAM/meshes/polyMesh/polyDistributionMap/polyDistributionMap.H index 0eb73a2fbc..a87b9fc7f7 100644 --- a/src/OpenFOAM/meshes/polyMesh/polyDistributionMap/polyDistributionMap.H +++ b/src/OpenFOAM/meshes/polyMesh/polyDistributionMap/polyDistributionMap.H @@ -59,7 +59,7 @@ Ostream& operator<<(Ostream&, const polyDistributionMap&); /*---------------------------------------------------------------------------*\ - Class polyDistributionMap Declaration + Class polyDistributionMap Declaration \*---------------------------------------------------------------------------*/ class polyDistributionMap diff --git a/src/OpenFOAM/meshes/polyMesh/polyMeshMap/polyMeshMap.H b/src/OpenFOAM/meshes/polyMesh/polyMeshMap/polyMeshMap.H index 760d434b4e..8c859d40bd 100644 --- a/src/OpenFOAM/meshes/polyMesh/polyMeshMap/polyMeshMap.H +++ b/src/OpenFOAM/meshes/polyMesh/polyMeshMap/polyMeshMap.H @@ -45,7 +45,7 @@ namespace Foam class meshToMesh; /*---------------------------------------------------------------------------*\ - Class polyMeshMap Declaration + Class polyMeshMap Declaration \*---------------------------------------------------------------------------*/ class polyMeshMap diff --git a/src/OpenFOAM/meshes/polyMesh/polyTopoChangeMap/polyTopoChangeMap.H b/src/OpenFOAM/meshes/polyMesh/polyTopoChangeMap/polyTopoChangeMap.H index a109de66a7..803a2f8c37 100644 --- a/src/OpenFOAM/meshes/polyMesh/polyTopoChangeMap/polyTopoChangeMap.H +++ b/src/OpenFOAM/meshes/polyMesh/polyTopoChangeMap/polyTopoChangeMap.H @@ -153,7 +153,7 @@ namespace Foam class polyMesh; /*---------------------------------------------------------------------------*\ - Class polyTopoChangeMap Declaration + Class polyTopoChangeMap Declaration \*---------------------------------------------------------------------------*/ class polyTopoChangeMap diff --git a/src/OpenFOAM/primitives/Barycentric2D/BarycentricTensor2D.H b/src/OpenFOAM/primitives/Barycentric2D/BarycentricTensor2D.H index 9923ab7db1..0799ec51ec 100644 --- a/src/OpenFOAM/primitives/Barycentric2D/BarycentricTensor2D.H +++ b/src/OpenFOAM/primitives/Barycentric2D/BarycentricTensor2D.H @@ -48,7 +48,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class BarycentricTensor2D Declaration + Class BarycentricTensor2D Declaration \*---------------------------------------------------------------------------*/ template<class Cmpt> diff --git a/src/OpenFOAM/primitives/RemoteData/RemoteData.H b/src/OpenFOAM/primitives/RemoteData/RemoteData.H index e3183f48c8..e52361e30c 100644 --- a/src/OpenFOAM/primitives/RemoteData/RemoteData.H +++ b/src/OpenFOAM/primitives/RemoteData/RemoteData.H @@ -56,7 +56,7 @@ template<class Type> inline Ostream& operator<<(Ostream&, const RemoteData<Type>&); /*---------------------------------------------------------------------------*\ - Class RemoteData Declaration + Class RemoteData Declaration \*---------------------------------------------------------------------------*/ template<class Type> diff --git a/src/OpenFOAM/primitives/functions/Function1/Table/Table.H b/src/OpenFOAM/primitives/functions/Function1/Table/Table.H index e6816ee75b..c4dba7fcad 100644 --- a/src/OpenFOAM/primitives/functions/Function1/Table/Table.H +++ b/src/OpenFOAM/primitives/functions/Function1/Table/Table.H @@ -112,7 +112,7 @@ namespace Function1s { /*---------------------------------------------------------------------------*\ - Class Table Declaration + Class Table Declaration \*---------------------------------------------------------------------------*/ template<class Type> diff --git a/src/OpenFOAM/primitives/functions/Function1/Table/TableReader/TableFileReader/TableFileReader.H b/src/OpenFOAM/primitives/functions/Function1/Table/TableReader/TableFileReader/TableFileReader.H index a617aecc33..35546d9ce3 100644 --- a/src/OpenFOAM/primitives/functions/Function1/Table/TableReader/TableFileReader/TableFileReader.H +++ b/src/OpenFOAM/primitives/functions/Function1/Table/TableReader/TableFileReader/TableFileReader.H @@ -43,7 +43,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class TableFileReader Declaration + Class TableFileReader Declaration \*---------------------------------------------------------------------------*/ template<class Type> diff --git a/src/OpenFOAM/primitives/functions/Function1/UniformTable1/UniformTable1.H b/src/OpenFOAM/primitives/functions/Function1/UniformTable1/UniformTable1.H index 858436602c..dad35aa2a3 100644 --- a/src/OpenFOAM/primitives/functions/Function1/UniformTable1/UniformTable1.H +++ b/src/OpenFOAM/primitives/functions/Function1/UniformTable1/UniformTable1.H @@ -69,7 +69,7 @@ namespace Function1s { /*---------------------------------------------------------------------------*\ - Class UniformTable Declaration + Class UniformTable Declaration \*---------------------------------------------------------------------------*/ template<class Type> diff --git a/src/OpenFOAM/primitives/functions/Function1/exponentialSqrRamp/exponentialSqrRamp.H b/src/OpenFOAM/primitives/functions/Function1/exponentialSqrRamp/exponentialSqrRamp.H index 4924bdfe13..649deb1d76 100644 --- a/src/OpenFOAM/primitives/functions/Function1/exponentialSqrRamp/exponentialSqrRamp.H +++ b/src/OpenFOAM/primitives/functions/Function1/exponentialSqrRamp/exponentialSqrRamp.H @@ -53,7 +53,7 @@ namespace Function1s { /*---------------------------------------------------------------------------*\ - Class exponentialSqrRamp Declaration + Class exponentialSqrRamp Declaration \*---------------------------------------------------------------------------*/ class exponentialSqrRamp diff --git a/src/OpenFOAM/primitives/functions/Function1/omega/omega.H b/src/OpenFOAM/primitives/functions/Function1/omega/omega.H index ea67b36dc4..b4df9355b3 100644 --- a/src/OpenFOAM/primitives/functions/Function1/omega/omega.H +++ b/src/OpenFOAM/primitives/functions/Function1/omega/omega.H @@ -102,7 +102,7 @@ namespace Function1s { /*---------------------------------------------------------------------------*\ - Class omega Declaration + Class omega Declaration \*---------------------------------------------------------------------------*/ class omega diff --git a/src/OpenFOAM/primitives/functions/Function1/squarePulse/squarePulse.H b/src/OpenFOAM/primitives/functions/Function1/squarePulse/squarePulse.H index a98b140fdf..54189ed91c 100644 --- a/src/OpenFOAM/primitives/functions/Function1/squarePulse/squarePulse.H +++ b/src/OpenFOAM/primitives/functions/Function1/squarePulse/squarePulse.H @@ -76,7 +76,7 @@ namespace Function1s { /*---------------------------------------------------------------------------*\ - Class squarePulse Declaration + Class squarePulse Declaration \*---------------------------------------------------------------------------*/ class squarePulse diff --git a/src/OpenFOAM/primitives/functions/Function1/unknownTypeFunction1/unknownTypeFunction1.H b/src/OpenFOAM/primitives/functions/Function1/unknownTypeFunction1/unknownTypeFunction1.H index fbc9fb2bdd..8b4360d838 100644 --- a/src/OpenFOAM/primitives/functions/Function1/unknownTypeFunction1/unknownTypeFunction1.H +++ b/src/OpenFOAM/primitives/functions/Function1/unknownTypeFunction1/unknownTypeFunction1.H @@ -49,7 +49,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class unknownTypeFunction1 Declaration + Class unknownTypeFunction1 Declaration \*---------------------------------------------------------------------------*/ class unknownTypeFunction1 diff --git a/src/OpenFOAM/primitives/functions/Function2/UniformTable2/UniformTable2.H b/src/OpenFOAM/primitives/functions/Function2/UniformTable2/UniformTable2.H index 3ed8061b63..a9195a2b79 100644 --- a/src/OpenFOAM/primitives/functions/Function2/UniformTable2/UniformTable2.H +++ b/src/OpenFOAM/primitives/functions/Function2/UniformTable2/UniformTable2.H @@ -72,7 +72,7 @@ namespace Function2s { /*---------------------------------------------------------------------------*\ - Class UniformTable Declaration + Class UniformTable Declaration \*---------------------------------------------------------------------------*/ template<class Type> diff --git a/src/OpenFOAM/primitives/remote/remote.H b/src/OpenFOAM/primitives/remote/remote.H index 8c568c28ff..5ef4e2e9b3 100644 --- a/src/OpenFOAM/primitives/remote/remote.H +++ b/src/OpenFOAM/primitives/remote/remote.H @@ -51,7 +51,7 @@ inline Istream& operator>>(Istream&, remote&); inline Ostream& operator<<(Ostream&, const remote&); /*---------------------------------------------------------------------------*\ - Class remote Declaration + Class remote Declaration \*---------------------------------------------------------------------------*/ class remote diff --git a/src/ThermophysicalTransportModels/coupledThermophysicalTransportModels/externalTemperature/externalTemperatureFvPatchScalarField.H b/src/ThermophysicalTransportModels/coupledThermophysicalTransportModels/externalTemperature/externalTemperatureFvPatchScalarField.H index fb93497455..77a795c157 100644 --- a/src/ThermophysicalTransportModels/coupledThermophysicalTransportModels/externalTemperature/externalTemperatureFvPatchScalarField.H +++ b/src/ThermophysicalTransportModels/coupledThermophysicalTransportModels/externalTemperature/externalTemperatureFvPatchScalarField.H @@ -104,7 +104,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class externalTemperatureFvPatchScalarField Declaration + Class externalTemperatureFvPatchScalarField Declaration \*---------------------------------------------------------------------------*/ class externalTemperatureFvPatchScalarField diff --git a/src/ThermophysicalTransportModels/fluid/laminar/Fickian/Fickian.H b/src/ThermophysicalTransportModels/fluid/laminar/Fickian/Fickian.H index 67d9938eab..19950185aa 100644 --- a/src/ThermophysicalTransportModels/fluid/laminar/Fickian/Fickian.H +++ b/src/ThermophysicalTransportModels/fluid/laminar/Fickian/Fickian.H @@ -51,7 +51,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class Fickian Declaration + Class Fickian Declaration \*---------------------------------------------------------------------------*/ template<class BasicThermophysicalTransportModel> diff --git a/src/ThermophysicalTransportModels/fluid/laminar/FickianFourier/FickianFourier.H b/src/ThermophysicalTransportModels/fluid/laminar/FickianFourier/FickianFourier.H index f845989ed1..7c67474aa1 100644 --- a/src/ThermophysicalTransportModels/fluid/laminar/FickianFourier/FickianFourier.H +++ b/src/ThermophysicalTransportModels/fluid/laminar/FickianFourier/FickianFourier.H @@ -107,7 +107,7 @@ namespace laminarThermophysicalTransportModels { /*---------------------------------------------------------------------------*\ - Class FickianFourier Declaration + Class FickianFourier Declaration \*---------------------------------------------------------------------------*/ template<class laminarThermophysicalTransportModel> diff --git a/src/ThermophysicalTransportModels/fluid/laminar/MaxwellStefan/MaxwellStefan.H b/src/ThermophysicalTransportModels/fluid/laminar/MaxwellStefan/MaxwellStefan.H index dfe5767694..5f618c261d 100644 --- a/src/ThermophysicalTransportModels/fluid/laminar/MaxwellStefan/MaxwellStefan.H +++ b/src/ThermophysicalTransportModels/fluid/laminar/MaxwellStefan/MaxwellStefan.H @@ -66,7 +66,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class MaxwellStefan Declaration + Class MaxwellStefan Declaration \*---------------------------------------------------------------------------*/ template<class BasicThermophysicalTransportModel> diff --git a/src/ThermophysicalTransportModels/fluid/laminar/MaxwellStefanFourier/MaxwellStefanFourier.H b/src/ThermophysicalTransportModels/fluid/laminar/MaxwellStefanFourier/MaxwellStefanFourier.H index 4c21be14ec..751ea019c1 100644 --- a/src/ThermophysicalTransportModels/fluid/laminar/MaxwellStefanFourier/MaxwellStefanFourier.H +++ b/src/ThermophysicalTransportModels/fluid/laminar/MaxwellStefanFourier/MaxwellStefanFourier.H @@ -80,7 +80,7 @@ namespace laminarThermophysicalTransportModels { /*---------------------------------------------------------------------------*\ - Class MaxwellStefanFourier Declaration + Class MaxwellStefanFourier Declaration \*---------------------------------------------------------------------------*/ template<class laminarThermophysicalTransportModel> diff --git a/src/ThermophysicalTransportModels/fluid/laminar/laminarThermophysicalTransportModel/laminarThermophysicalTransportModel.H b/src/ThermophysicalTransportModels/fluid/laminar/laminarThermophysicalTransportModel/laminarThermophysicalTransportModel.H index e7b29d7775..8f3b8eb41b 100644 --- a/src/ThermophysicalTransportModels/fluid/laminar/laminarThermophysicalTransportModel/laminarThermophysicalTransportModel.H +++ b/src/ThermophysicalTransportModels/fluid/laminar/laminarThermophysicalTransportModel/laminarThermophysicalTransportModel.H @@ -43,7 +43,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class laminarThermophysicalTransportModel Declaration + Class laminarThermophysicalTransportModel Declaration \*---------------------------------------------------------------------------*/ template<class BasicThermophysicalTransportModel> diff --git a/src/ThermophysicalTransportModels/fluid/laminar/unityLewisFourier/unityLewisFourier.H b/src/ThermophysicalTransportModels/fluid/laminar/unityLewisFourier/unityLewisFourier.H index ee9da39c65..31deabb302 100644 --- a/src/ThermophysicalTransportModels/fluid/laminar/unityLewisFourier/unityLewisFourier.H +++ b/src/ThermophysicalTransportModels/fluid/laminar/unityLewisFourier/unityLewisFourier.H @@ -46,7 +46,7 @@ namespace laminarThermophysicalTransportModels { /*---------------------------------------------------------------------------*\ - Class unityLewisFourier Declaration + Class unityLewisFourier Declaration \*---------------------------------------------------------------------------*/ template<class BasicThermophysicalTransportModel> diff --git a/src/ThermophysicalTransportModels/fluid/turbulence/FickianEddyDiffusivity/FickianEddyDiffusivity.H b/src/ThermophysicalTransportModels/fluid/turbulence/FickianEddyDiffusivity/FickianEddyDiffusivity.H index 8e7320a805..7b0a971816 100644 --- a/src/ThermophysicalTransportModels/fluid/turbulence/FickianEddyDiffusivity/FickianEddyDiffusivity.H +++ b/src/ThermophysicalTransportModels/fluid/turbulence/FickianEddyDiffusivity/FickianEddyDiffusivity.H @@ -114,7 +114,7 @@ namespace turbulenceThermophysicalTransportModels { /*---------------------------------------------------------------------------*\ - Class FickianEddyDiffusivity Declaration + Class FickianEddyDiffusivity Declaration \*---------------------------------------------------------------------------*/ template<class TurbulenceThermophysicalTransportModel> diff --git a/src/ThermophysicalTransportModels/fluid/turbulence/unityLewisEddyDiffusivity/unityLewisEddyDiffusivity.H b/src/ThermophysicalTransportModels/fluid/turbulence/unityLewisEddyDiffusivity/unityLewisEddyDiffusivity.H index 771adb5e34..a43a1a09ff 100644 --- a/src/ThermophysicalTransportModels/fluid/turbulence/unityLewisEddyDiffusivity/unityLewisEddyDiffusivity.H +++ b/src/ThermophysicalTransportModels/fluid/turbulence/unityLewisEddyDiffusivity/unityLewisEddyDiffusivity.H @@ -54,7 +54,7 @@ namespace turbulenceThermophysicalTransportModels { /*---------------------------------------------------------------------------*\ - Class unityLewisEddyDiffusivity Declaration + Class unityLewisEddyDiffusivity Declaration \*---------------------------------------------------------------------------*/ template<class TurbulenceThermophysicalTransportModel> diff --git a/src/ThermophysicalTransportModels/solid/anisotropic/anisotropic.H b/src/ThermophysicalTransportModels/solid/anisotropic/anisotropic.H index 0a10518f78..a3b54948d1 100644 --- a/src/ThermophysicalTransportModels/solid/anisotropic/anisotropic.H +++ b/src/ThermophysicalTransportModels/solid/anisotropic/anisotropic.H @@ -111,7 +111,7 @@ namespace solidThermophysicalTransportModels { /*---------------------------------------------------------------------------*\ - Class anisotropic Declaration + Class anisotropic Declaration \*---------------------------------------------------------------------------*/ class anisotropic diff --git a/src/ThermophysicalTransportModels/solid/isotropic/isotropic.H b/src/ThermophysicalTransportModels/solid/isotropic/isotropic.H index a86b2d5b03..3854413756 100644 --- a/src/ThermophysicalTransportModels/solid/isotropic/isotropic.H +++ b/src/ThermophysicalTransportModels/solid/isotropic/isotropic.H @@ -49,7 +49,7 @@ namespace solidThermophysicalTransportModels { /*---------------------------------------------------------------------------*\ - Class isotropic Declaration + Class isotropic Declaration \*---------------------------------------------------------------------------*/ class isotropic diff --git a/src/dynamicMesh/motionSolvers/displacement/solidBody/solidBodyMotionFunctions/sixDoFMotion/sixDoFMotion.H b/src/dynamicMesh/motionSolvers/displacement/solidBody/solidBodyMotionFunctions/sixDoFMotion/sixDoFMotion.H index 9be61037e3..840e57d593 100644 --- a/src/dynamicMesh/motionSolvers/displacement/solidBody/solidBodyMotionFunctions/sixDoFMotion/sixDoFMotion.H +++ b/src/dynamicMesh/motionSolvers/displacement/solidBody/solidBodyMotionFunctions/sixDoFMotion/sixDoFMotion.H @@ -52,7 +52,7 @@ namespace solidBodyMotionFunctions { /*---------------------------------------------------------------------------*\ - Class sixDoFMotion Declaration + Class sixDoFMotion Declaration \*---------------------------------------------------------------------------*/ class sixDoFMotion diff --git a/src/dynamicMesh/repatchMesh/repatchMesh.H b/src/dynamicMesh/repatchMesh/repatchMesh.H index 9b01c89a25..702b91f72a 100644 --- a/src/dynamicMesh/repatchMesh/repatchMesh.H +++ b/src/dynamicMesh/repatchMesh/repatchMesh.H @@ -52,7 +52,7 @@ class polyMesh; class primitiveMesh; /*---------------------------------------------------------------------------*\ - Class repatchMesh Declaration + Class repatchMesh Declaration \*---------------------------------------------------------------------------*/ class repatchMesh diff --git a/src/fileFormats/vtk/vtkWritePolyData.H b/src/fileFormats/vtk/vtkWritePolyData.H index db2f5cf18e..3e181f035e 100644 --- a/src/fileFormats/vtk/vtkWritePolyData.H +++ b/src/fileFormats/vtk/vtkWritePolyData.H @@ -46,7 +46,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Namespace vtkWritePolyData Declaration + Namespace vtkWritePolyData Declaration \*---------------------------------------------------------------------------*/ namespace vtkWritePolyData diff --git a/src/finiteVolume/algorithms/FvFaceCellWave/FvFaceCellWave.H b/src/finiteVolume/algorithms/FvFaceCellWave/FvFaceCellWave.H index 6642314ca7..9a44530f5b 100644 --- a/src/finiteVolume/algorithms/FvFaceCellWave/FvFaceCellWave.H +++ b/src/finiteVolume/algorithms/FvFaceCellWave/FvFaceCellWave.H @@ -61,14 +61,14 @@ class fvPatch; class transformer; /*---------------------------------------------------------------------------*\ - Class FvFaceCellWaveName Declaration + Class FvFaceCellWaveName Declaration \*---------------------------------------------------------------------------*/ TemplateName(FvFaceCellWave); /*---------------------------------------------------------------------------*\ - Class FvFaceCellWave Declaration + Class FvFaceCellWave Declaration \*---------------------------------------------------------------------------*/ template<class Type, class TrackingData = int> diff --git a/src/finiteVolume/cfdTools/general/MRF/derivedFvPatchFields/MRFPatchField/MRFPatchField.H b/src/finiteVolume/cfdTools/general/MRF/derivedFvPatchFields/MRFPatchField/MRFPatchField.H index 9d148b7240..3e30451dad 100644 --- a/src/finiteVolume/cfdTools/general/MRF/derivedFvPatchFields/MRFPatchField/MRFPatchField.H +++ b/src/finiteVolume/cfdTools/general/MRF/derivedFvPatchFields/MRFPatchField/MRFPatchField.H @@ -46,7 +46,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class MRFPatchField Declaration + Class MRFPatchField Declaration \*---------------------------------------------------------------------------*/ class MRFPatchField diff --git a/src/finiteVolume/cfdTools/general/MRF/derivedFvPatchFields/MRFnoSlip/MRFnoSlipFvPatchVectorField.H b/src/finiteVolume/cfdTools/general/MRF/derivedFvPatchFields/MRFnoSlip/MRFnoSlipFvPatchVectorField.H index 7c6629ad32..17b0607a3a 100644 --- a/src/finiteVolume/cfdTools/general/MRF/derivedFvPatchFields/MRFnoSlip/MRFnoSlipFvPatchVectorField.H +++ b/src/finiteVolume/cfdTools/general/MRF/derivedFvPatchFields/MRFnoSlip/MRFnoSlipFvPatchVectorField.H @@ -72,7 +72,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class MRFnoSlipFvPatchVectorField Declaration + Class MRFnoSlipFvPatchVectorField Declaration \*---------------------------------------------------------------------------*/ class MRFnoSlipFvPatchVectorField diff --git a/src/finiteVolume/cfdTools/general/MRF/derivedFvPatchFields/MRFslip/MRFslipFvPatchVectorField.H b/src/finiteVolume/cfdTools/general/MRF/derivedFvPatchFields/MRFslip/MRFslipFvPatchVectorField.H index f2cf4918c5..a20d50bc83 100644 --- a/src/finiteVolume/cfdTools/general/MRF/derivedFvPatchFields/MRFslip/MRFslipFvPatchVectorField.H +++ b/src/finiteVolume/cfdTools/general/MRF/derivedFvPatchFields/MRFslip/MRFslipFvPatchVectorField.H @@ -71,7 +71,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class MRFslipFvPatchVectorField Declaration + Class MRFslipFvPatchVectorField Declaration \*---------------------------------------------------------------------------*/ class MRFslipFvPatchVectorField diff --git a/src/finiteVolume/cfdTools/general/fvConstraints/fvConstraints.H b/src/finiteVolume/cfdTools/general/fvConstraints/fvConstraints.H index b5738329d8..19f173dbd4 100644 --- a/src/finiteVolume/cfdTools/general/fvConstraints/fvConstraints.H +++ b/src/finiteVolume/cfdTools/general/fvConstraints/fvConstraints.H @@ -52,7 +52,7 @@ Ostream& operator<<(Ostream& os, const fvConstraints& constraints); /*---------------------------------------------------------------------------*\ - Class fvConstraints Declaration + Class fvConstraints Declaration \*---------------------------------------------------------------------------*/ class fvConstraints diff --git a/src/finiteVolume/cfdTools/general/fvModels/fvModels.H b/src/finiteVolume/cfdTools/general/fvModels/fvModels.H index 97aa006cb9..2672483ea4 100644 --- a/src/finiteVolume/cfdTools/general/fvModels/fvModels.H +++ b/src/finiteVolume/cfdTools/general/fvModels/fvModels.H @@ -55,7 +55,7 @@ Ostream& operator<<(Ostream& os, const fvModels& models); /*---------------------------------------------------------------------------*\ - Class fvModels Declaration + Class fvModels Declaration \*---------------------------------------------------------------------------*/ class fvModels diff --git a/src/finiteVolume/cfdTools/general/pressureReference/pressureReference.H b/src/finiteVolume/cfdTools/general/pressureReference/pressureReference.H index bcf977c6f0..d2f6cca5bb 100644 --- a/src/finiteVolume/cfdTools/general/pressureReference/pressureReference.H +++ b/src/finiteVolume/cfdTools/general/pressureReference/pressureReference.H @@ -45,7 +45,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class pressureReference Declaration + Class pressureReference Declaration \*---------------------------------------------------------------------------*/ class pressureReference diff --git a/src/finiteVolume/cfdTools/general/solutionControl/pimpleControl/pimpleSingleRegionControl/pimpleSingleRegionControl.H b/src/finiteVolume/cfdTools/general/solutionControl/pimpleControl/pimpleSingleRegionControl/pimpleSingleRegionControl.H index 5ad3cc8282..2a4734c24b 100644 --- a/src/finiteVolume/cfdTools/general/solutionControl/pimpleControl/pimpleSingleRegionControl/pimpleSingleRegionControl.H +++ b/src/finiteVolume/cfdTools/general/solutionControl/pimpleControl/pimpleSingleRegionControl/pimpleSingleRegionControl.H @@ -67,7 +67,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class pimpleSingleRegionControl Declaration + Class pimpleSingleRegionControl Declaration \*---------------------------------------------------------------------------*/ class pimpleSingleRegionControl diff --git a/src/finiteVolume/fields/fvPatchFields/constraint/internal/internalFvPatchField.H b/src/finiteVolume/fields/fvPatchFields/constraint/internal/internalFvPatchField.H index 7716278256..a81657589c 100644 --- a/src/finiteVolume/fields/fvPatchFields/constraint/internal/internalFvPatchField.H +++ b/src/finiteVolume/fields/fvPatchFields/constraint/internal/internalFvPatchField.H @@ -54,7 +54,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class internalFvPatchField Declaration + Class internalFvPatchField Declaration \*---------------------------------------------------------------------------*/ template<class Type> diff --git a/src/finiteVolume/fields/fvPatchFields/constraint/nonConformalCyclic/nonConformalCyclicFvPatchField.H b/src/finiteVolume/fields/fvPatchFields/constraint/nonConformalCyclic/nonConformalCyclicFvPatchField.H index a91bf344cf..35cfaae14d 100644 --- a/src/finiteVolume/fields/fvPatchFields/constraint/nonConformalCyclic/nonConformalCyclicFvPatchField.H +++ b/src/finiteVolume/fields/fvPatchFields/constraint/nonConformalCyclic/nonConformalCyclicFvPatchField.H @@ -59,7 +59,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class nonConformalCyclicFvPatch Declaration + Class nonConformalCyclicFvPatch Declaration \*---------------------------------------------------------------------------*/ template<class Type> diff --git a/src/finiteVolume/fields/fvPatchFields/constraint/nonConformalError/nonConformalErrorFvPatchField.H b/src/finiteVolume/fields/fvPatchFields/constraint/nonConformalError/nonConformalErrorFvPatchField.H index c66a98ed73..cc8394ac91 100644 --- a/src/finiteVolume/fields/fvPatchFields/constraint/nonConformalError/nonConformalErrorFvPatchField.H +++ b/src/finiteVolume/fields/fvPatchFields/constraint/nonConformalError/nonConformalErrorFvPatchField.H @@ -53,7 +53,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class nonConformalErrorFvPatch Declaration + Class nonConformalErrorFvPatch Declaration \*---------------------------------------------------------------------------*/ template<class Type> diff --git a/src/finiteVolume/fields/fvPatchFields/constraint/nonConformalProcessorCyclic/nonConformalProcessorCyclicFvPatchField.H b/src/finiteVolume/fields/fvPatchFields/constraint/nonConformalProcessorCyclic/nonConformalProcessorCyclicFvPatchField.H index b0c73d19ed..70a8b62f50 100644 --- a/src/finiteVolume/fields/fvPatchFields/constraint/nonConformalProcessorCyclic/nonConformalProcessorCyclicFvPatchField.H +++ b/src/finiteVolume/fields/fvPatchFields/constraint/nonConformalProcessorCyclic/nonConformalProcessorCyclicFvPatchField.H @@ -60,7 +60,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class nonConformalProcessorCyclicFvPatchField Declaration + Class nonConformalProcessorCyclicFvPatchField Declaration \*---------------------------------------------------------------------------*/ template<class Type> diff --git a/src/finiteVolume/fields/fvPatchFields/derived/fixedValueInletOutlet/fixedValueInletOutletFvPatchField.H b/src/finiteVolume/fields/fvPatchFields/derived/fixedValueInletOutlet/fixedValueInletOutletFvPatchField.H index fd1892bcd2..1897904746 100644 --- a/src/finiteVolume/fields/fvPatchFields/derived/fixedValueInletOutlet/fixedValueInletOutletFvPatchField.H +++ b/src/finiteVolume/fields/fvPatchFields/derived/fixedValueInletOutlet/fixedValueInletOutletFvPatchField.H @@ -69,7 +69,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class fixedValueInletOutletFvPatchField Declaration + Class fixedValueInletOutletFvPatchField Declaration \*---------------------------------------------------------------------------*/ template<class Type> diff --git a/src/finiteVolume/fields/fvPatchFields/derived/flowRateInletVelocity/laminarBL/laminarBL.H b/src/finiteVolume/fields/fvPatchFields/derived/flowRateInletVelocity/laminarBL/laminarBL.H index 098757c780..6571c15251 100644 --- a/src/finiteVolume/fields/fvPatchFields/derived/flowRateInletVelocity/laminarBL/laminarBL.H +++ b/src/finiteVolume/fields/fvPatchFields/derived/flowRateInletVelocity/laminarBL/laminarBL.H @@ -56,7 +56,7 @@ namespace Function1s { /*---------------------------------------------------------------------------*\ - Class laminarBL Declaration + Class laminarBL Declaration \*---------------------------------------------------------------------------*/ class laminarBL diff --git a/src/finiteVolume/fields/fvPatchFields/derived/flowRateInletVelocity/turbulentBL/turbulentBL.H b/src/finiteVolume/fields/fvPatchFields/derived/flowRateInletVelocity/turbulentBL/turbulentBL.H index 9fe44d35f1..97b8f48f91 100644 --- a/src/finiteVolume/fields/fvPatchFields/derived/flowRateInletVelocity/turbulentBL/turbulentBL.H +++ b/src/finiteVolume/fields/fvPatchFields/derived/flowRateInletVelocity/turbulentBL/turbulentBL.H @@ -65,7 +65,7 @@ namespace Function1s { /*---------------------------------------------------------------------------*\ - Class turbulentBL Declaration + Class turbulentBL Declaration \*---------------------------------------------------------------------------*/ class turbulentBL diff --git a/src/finiteVolume/fields/fvPatchFields/derived/mappedFlowRateVelocity/mappedFlowRateVelocityFvPatchVectorField.H b/src/finiteVolume/fields/fvPatchFields/derived/mappedFlowRateVelocity/mappedFlowRateVelocityFvPatchVectorField.H index 3abbf052e8..fa2fdd39be 100644 --- a/src/finiteVolume/fields/fvPatchFields/derived/mappedFlowRateVelocity/mappedFlowRateVelocityFvPatchVectorField.H +++ b/src/finiteVolume/fields/fvPatchFields/derived/mappedFlowRateVelocity/mappedFlowRateVelocityFvPatchVectorField.H @@ -70,7 +70,7 @@ SourceFiles namespace Foam { /*---------------------------------------------------------------------------*\ - Class mappedFlowRateVelocityFvPatchVectorField Declaration + Class mappedFlowRateVelocityFvPatchVectorField Declaration \*---------------------------------------------------------------------------*/ class mappedFlowRateVelocityFvPatchVectorField diff --git a/src/finiteVolume/fields/fvPatchFields/derived/mappedInternalValue/mappedInternalValueFvPatchField.H b/src/finiteVolume/fields/fvPatchFields/derived/mappedInternalValue/mappedInternalValueFvPatchField.H index 1dcb6978dd..c31e30aa9d 100644 --- a/src/finiteVolume/fields/fvPatchFields/derived/mappedInternalValue/mappedInternalValueFvPatchField.H +++ b/src/finiteVolume/fields/fvPatchFields/derived/mappedInternalValue/mappedInternalValueFvPatchField.H @@ -80,7 +80,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class mappedInternalValueFvPatchField Declaration + Class mappedInternalValueFvPatchField Declaration \*---------------------------------------------------------------------------*/ template<class Type> diff --git a/src/finiteVolume/fields/fvPatchFields/derived/mappedValueAndPatchInternalValue/mappedValueAndPatchInternalValueFvPatchField.H b/src/finiteVolume/fields/fvPatchFields/derived/mappedValueAndPatchInternalValue/mappedValueAndPatchInternalValueFvPatchField.H index 7bcd876570..dd4780013a 100644 --- a/src/finiteVolume/fields/fvPatchFields/derived/mappedValueAndPatchInternalValue/mappedValueAndPatchInternalValueFvPatchField.H +++ b/src/finiteVolume/fields/fvPatchFields/derived/mappedValueAndPatchInternalValue/mappedValueAndPatchInternalValueFvPatchField.H @@ -78,7 +78,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class mappedValueAndPatchInternalValueFvPatchField Declaration + Class mappedValueAndPatchInternalValueFvPatchField Declaration \*---------------------------------------------------------------------------*/ template<class Type> diff --git a/src/finiteVolume/fields/fvPatchFields/derived/mappedVelocityFlux/mappedVelocityFluxFvPatchField.H b/src/finiteVolume/fields/fvPatchFields/derived/mappedVelocityFlux/mappedVelocityFluxFvPatchField.H index e9975c090b..3d16dd46a1 100644 --- a/src/finiteVolume/fields/fvPatchFields/derived/mappedVelocityFlux/mappedVelocityFluxFvPatchField.H +++ b/src/finiteVolume/fields/fvPatchFields/derived/mappedVelocityFlux/mappedVelocityFluxFvPatchField.H @@ -69,7 +69,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class mappedVelocityFluxFvPatch Declaration + Class mappedVelocityFluxFvPatch Declaration \*---------------------------------------------------------------------------*/ class mappedVelocityFluxFvPatchField diff --git a/src/finiteVolume/fields/fvPatchFields/derived/movingWallSlipVelocity/movingWallSlipVelocityFvPatchVectorField.H b/src/finiteVolume/fields/fvPatchFields/derived/movingWallSlipVelocity/movingWallSlipVelocityFvPatchVectorField.H index 59477e4c38..37f8708286 100644 --- a/src/finiteVolume/fields/fvPatchFields/derived/movingWallSlipVelocity/movingWallSlipVelocityFvPatchVectorField.H +++ b/src/finiteVolume/fields/fvPatchFields/derived/movingWallSlipVelocity/movingWallSlipVelocityFvPatchVectorField.H @@ -54,7 +54,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class movingWallSlipVelocityFvPatchVectorField Declaration + Class movingWallSlipVelocityFvPatchVectorField Declaration \*---------------------------------------------------------------------------*/ class movingWallSlipVelocityFvPatchVectorField diff --git a/src/finiteVolume/fields/fvPatchFields/derived/transonicEntrainmentPressure/transonicEntrainmentPressureFvPatchScalarField.H b/src/finiteVolume/fields/fvPatchFields/derived/transonicEntrainmentPressure/transonicEntrainmentPressureFvPatchScalarField.H index 31b57b1b18..857d79bdd5 100644 --- a/src/finiteVolume/fields/fvPatchFields/derived/transonicEntrainmentPressure/transonicEntrainmentPressureFvPatchScalarField.H +++ b/src/finiteVolume/fields/fvPatchFields/derived/transonicEntrainmentPressure/transonicEntrainmentPressureFvPatchScalarField.H @@ -70,7 +70,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class transonicEntrainmentPressureFvPatchScalarField Declaration + Class transonicEntrainmentPressureFvPatchScalarField Declaration \*---------------------------------------------------------------------------*/ class transonicEntrainmentPressureFvPatchScalarField diff --git a/src/finiteVolume/fields/fvsPatchFields/basic/nonConformalCalculated/nonConformalCalculatedFvsPatchField.H b/src/finiteVolume/fields/fvsPatchFields/basic/nonConformalCalculated/nonConformalCalculatedFvsPatchField.H index 8ebe6d5227..24d6c0182d 100644 --- a/src/finiteVolume/fields/fvsPatchFields/basic/nonConformalCalculated/nonConformalCalculatedFvsPatchField.H +++ b/src/finiteVolume/fields/fvsPatchFields/basic/nonConformalCalculated/nonConformalCalculatedFvsPatchField.H @@ -43,7 +43,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class nonConformalCalculatedFvsPatch Declaration + Class nonConformalCalculatedFvsPatch Declaration \*---------------------------------------------------------------------------*/ template<class Type> diff --git a/src/finiteVolume/fields/fvsPatchFields/constraint/internal/internalFvsPatchField.H b/src/finiteVolume/fields/fvsPatchFields/constraint/internal/internalFvsPatchField.H index 813a2fca3f..baf2ac2394 100644 --- a/src/finiteVolume/fields/fvsPatchFields/constraint/internal/internalFvsPatchField.H +++ b/src/finiteVolume/fields/fvsPatchFields/constraint/internal/internalFvsPatchField.H @@ -45,7 +45,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class internalFvsPatch Declaration + Class internalFvsPatch Declaration \*---------------------------------------------------------------------------*/ template<class Type> diff --git a/src/finiteVolume/fields/fvsPatchFields/constraint/nonConformalCyclic/nonConformalCyclicFvsPatchField.H b/src/finiteVolume/fields/fvsPatchFields/constraint/nonConformalCyclic/nonConformalCyclicFvsPatchField.H index af1f3b1fb1..e8ba4d5d49 100644 --- a/src/finiteVolume/fields/fvsPatchFields/constraint/nonConformalCyclic/nonConformalCyclicFvsPatchField.H +++ b/src/finiteVolume/fields/fvsPatchFields/constraint/nonConformalCyclic/nonConformalCyclicFvsPatchField.H @@ -44,7 +44,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class nonConformalCyclicFvsPatch Declaration + Class nonConformalCyclicFvsPatch Declaration \*---------------------------------------------------------------------------*/ template<class Type> diff --git a/src/finiteVolume/fields/fvsPatchFields/constraint/nonConformalError/nonConformalErrorFvsPatchField.H b/src/finiteVolume/fields/fvsPatchFields/constraint/nonConformalError/nonConformalErrorFvsPatchField.H index 40fcc8a8f1..a7940d32f7 100644 --- a/src/finiteVolume/fields/fvsPatchFields/constraint/nonConformalError/nonConformalErrorFvsPatchField.H +++ b/src/finiteVolume/fields/fvsPatchFields/constraint/nonConformalError/nonConformalErrorFvsPatchField.H @@ -44,7 +44,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class nonConformalErrorFvsPatch Declaration + Class nonConformalErrorFvsPatch Declaration \*---------------------------------------------------------------------------*/ template<class Type> diff --git a/src/finiteVolume/fields/fvsPatchFields/constraint/nonConformalProcessorCyclic/nonConformalProcessorCyclicFvsPatchField.H b/src/finiteVolume/fields/fvsPatchFields/constraint/nonConformalProcessorCyclic/nonConformalProcessorCyclicFvsPatchField.H index 64033ec437..a44148a104 100644 --- a/src/finiteVolume/fields/fvsPatchFields/constraint/nonConformalProcessorCyclic/nonConformalProcessorCyclicFvsPatchField.H +++ b/src/finiteVolume/fields/fvsPatchFields/constraint/nonConformalProcessorCyclic/nonConformalProcessorCyclicFvsPatchField.H @@ -44,7 +44,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class nonConformalProcessorCyclicFvsPatch Declaration + Class nonConformalProcessorCyclicFvsPatch Declaration \*---------------------------------------------------------------------------*/ template<class Type> diff --git a/src/finiteVolume/finiteVolume/snGradSchemes/phaseStabilisedSnGrad/phaseStabilisedSnGrad.H b/src/finiteVolume/finiteVolume/snGradSchemes/phaseStabilisedSnGrad/phaseStabilisedSnGrad.H index 65705329a3..f966dd6a2d 100644 --- a/src/finiteVolume/finiteVolume/snGradSchemes/phaseStabilisedSnGrad/phaseStabilisedSnGrad.H +++ b/src/finiteVolume/finiteVolume/snGradSchemes/phaseStabilisedSnGrad/phaseStabilisedSnGrad.H @@ -51,7 +51,7 @@ namespace fv { /*---------------------------------------------------------------------------*\ - Class phaseStabilisedSnGrad Declaration + Class phaseStabilisedSnGrad Declaration \*---------------------------------------------------------------------------*/ template<class Type> diff --git a/src/finiteVolume/fvMesh/fvCellSet/fvCellSet.H b/src/finiteVolume/fvMesh/fvCellSet/fvCellSet.H index c9adc6634d..7dbeea952e 100644 --- a/src/finiteVolume/fvMesh/fvCellSet/fvCellSet.H +++ b/src/finiteVolume/fvMesh/fvCellSet/fvCellSet.H @@ -80,7 +80,7 @@ class polyMeshMap; class polyDistributionMap; /*---------------------------------------------------------------------------*\ - Class fvCellSet Declaration + Class fvCellSet Declaration \*---------------------------------------------------------------------------*/ class fvCellSet diff --git a/src/finiteVolume/fvMesh/fvMeshDistributors/cpuLoad/cpuLoad.H b/src/finiteVolume/fvMesh/fvMeshDistributors/cpuLoad/cpuLoad.H index fcc815db46..0227af7c59 100644 --- a/src/finiteVolume/fvMesh/fvMeshDistributors/cpuLoad/cpuLoad.H +++ b/src/finiteVolume/fvMesh/fvMeshDistributors/cpuLoad/cpuLoad.H @@ -109,7 +109,7 @@ public: /*---------------------------------------------------------------------------*\ - Class cpuLoad Declaration + Class cpuLoad Declaration \*---------------------------------------------------------------------------*/ class cpuLoad diff --git a/src/finiteVolume/fvMesh/fvMeshDistributors/fvMeshDistributor/fvMeshDistributor.H b/src/finiteVolume/fvMesh/fvMeshDistributors/fvMeshDistributor/fvMeshDistributor.H index 7d6ee58daa..522fdf8ae5 100644 --- a/src/finiteVolume/fvMesh/fvMeshDistributors/fvMeshDistributor/fvMeshDistributor.H +++ b/src/finiteVolume/fvMesh/fvMeshDistributors/fvMeshDistributor/fvMeshDistributor.H @@ -47,7 +47,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class fvMeshDistributor Declaration + Class fvMeshDistributor Declaration \*---------------------------------------------------------------------------*/ class fvMeshDistributor diff --git a/src/finiteVolume/fvMesh/fvMeshDistributors/none/fvMeshDistributorsNone.H b/src/finiteVolume/fvMesh/fvMeshDistributors/none/fvMeshDistributorsNone.H index c268fb3e95..3f1288d1e9 100644 --- a/src/finiteVolume/fvMesh/fvMeshDistributors/none/fvMeshDistributorsNone.H +++ b/src/finiteVolume/fvMesh/fvMeshDistributors/none/fvMeshDistributorsNone.H @@ -45,7 +45,7 @@ namespace fvMeshDistributors { /*---------------------------------------------------------------------------*\ - Class none Declaration + Class none Declaration \*---------------------------------------------------------------------------*/ class none diff --git a/src/finiteVolume/fvMesh/fvMeshMovers/fvMeshMover/fvMeshMover.H b/src/finiteVolume/fvMesh/fvMeshMovers/fvMeshMover/fvMeshMover.H index c7550902be..ad01aaf18f 100644 --- a/src/finiteVolume/fvMesh/fvMeshMovers/fvMeshMover/fvMeshMover.H +++ b/src/finiteVolume/fvMesh/fvMeshMovers/fvMeshMover/fvMeshMover.H @@ -47,7 +47,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class fvMeshMover Declaration + Class fvMeshMover Declaration \*---------------------------------------------------------------------------*/ class fvMeshMover diff --git a/src/finiteVolume/fvMesh/fvMeshMovers/none/fvMeshMoversNone.H b/src/finiteVolume/fvMesh/fvMeshMovers/none/fvMeshMoversNone.H index cff24ada40..a0a00f3103 100644 --- a/src/finiteVolume/fvMesh/fvMeshMovers/none/fvMeshMoversNone.H +++ b/src/finiteVolume/fvMesh/fvMeshMovers/none/fvMeshMoversNone.H @@ -45,7 +45,7 @@ namespace fvMeshMovers { /*---------------------------------------------------------------------------*\ - Class fvMeshMovers::none Declaration + Class fvMeshMovers::none Declaration \*---------------------------------------------------------------------------*/ class none diff --git a/src/finiteVolume/fvMesh/fvMeshStitchers/fvMeshStitcher/fvMeshStitcher.H b/src/finiteVolume/fvMesh/fvMeshStitchers/fvMeshStitcher/fvMeshStitcher.H index 01bd250f5b..bb30fe9eed 100644 --- a/src/finiteVolume/fvMesh/fvMeshStitchers/fvMeshStitcher/fvMeshStitcher.H +++ b/src/finiteVolume/fvMesh/fvMeshStitchers/fvMeshStitcher/fvMeshStitcher.H @@ -48,7 +48,7 @@ namespace Foam class nonConformalCyclicFvPatch; /*---------------------------------------------------------------------------*\ - Class fvMeshStitcher Declaration + Class fvMeshStitcher Declaration \*---------------------------------------------------------------------------*/ class fvMeshStitcher diff --git a/src/finiteVolume/fvMesh/fvMeshStitchers/stationary/fvMeshStitchersStationary.H b/src/finiteVolume/fvMesh/fvMeshStitchers/stationary/fvMeshStitchersStationary.H index 4cbab54e09..0912d25655 100644 --- a/src/finiteVolume/fvMesh/fvMeshStitchers/stationary/fvMeshStitchersStationary.H +++ b/src/finiteVolume/fvMesh/fvMeshStitchers/stationary/fvMeshStitchersStationary.H @@ -45,7 +45,7 @@ namespace fvMeshStitchers { /*---------------------------------------------------------------------------*\ - Class fvMeshStitchers::stationary Declaration + Class fvMeshStitchers::stationary Declaration \*---------------------------------------------------------------------------*/ class stationary diff --git a/src/finiteVolume/fvMesh/fvMeshTopoChangers/fvMeshTopoChanger/fvMeshTopoChanger.H b/src/finiteVolume/fvMesh/fvMeshTopoChangers/fvMeshTopoChanger/fvMeshTopoChanger.H index b708010142..039944616c 100644 --- a/src/finiteVolume/fvMesh/fvMeshTopoChangers/fvMeshTopoChanger/fvMeshTopoChanger.H +++ b/src/finiteVolume/fvMesh/fvMeshTopoChangers/fvMeshTopoChanger/fvMeshTopoChanger.H @@ -47,7 +47,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class fvMeshTopoChanger Declaration + Class fvMeshTopoChanger Declaration \*---------------------------------------------------------------------------*/ class fvMeshTopoChanger diff --git a/src/finiteVolume/fvMesh/fvMeshTopoChangers/list/fvMeshTopoChangersList.H b/src/finiteVolume/fvMesh/fvMeshTopoChangers/list/fvMeshTopoChangersList.H index 3ef1f09574..761d9ec22b 100644 --- a/src/finiteVolume/fvMesh/fvMeshTopoChangers/list/fvMeshTopoChangersList.H +++ b/src/finiteVolume/fvMesh/fvMeshTopoChangers/list/fvMeshTopoChangersList.H @@ -46,7 +46,7 @@ namespace fvMeshTopoChangers { /*---------------------------------------------------------------------------*\ - Class fvMeshTopoChangers::list Declaration + Class fvMeshTopoChangers::list Declaration \*---------------------------------------------------------------------------*/ class list diff --git a/src/finiteVolume/fvMesh/fvMeshTopoChangers/none/fvMeshTopoChangersNone.H b/src/finiteVolume/fvMesh/fvMeshTopoChangers/none/fvMeshTopoChangersNone.H index e12d98fa65..9a28d25156 100644 --- a/src/finiteVolume/fvMesh/fvMeshTopoChangers/none/fvMeshTopoChangersNone.H +++ b/src/finiteVolume/fvMesh/fvMeshTopoChangers/none/fvMeshTopoChangersNone.H @@ -45,7 +45,7 @@ namespace fvMeshTopoChangers { /*---------------------------------------------------------------------------*\ - Class none Declaration + Class none Declaration \*---------------------------------------------------------------------------*/ class none diff --git a/src/finiteVolume/fvMesh/fvPatches/constraint/nonConformal/nonConformalFvPatch.H b/src/finiteVolume/fvMesh/fvPatches/constraint/nonConformal/nonConformalFvPatch.H index e2768377b6..c0eef84513 100644 --- a/src/finiteVolume/fvMesh/fvPatches/constraint/nonConformal/nonConformalFvPatch.H +++ b/src/finiteVolume/fvMesh/fvPatches/constraint/nonConformal/nonConformalFvPatch.H @@ -51,7 +51,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class nonConformalFvPatch Declaration + Class nonConformalFvPatch Declaration \*---------------------------------------------------------------------------*/ class nonConformalFvPatch diff --git a/src/finiteVolume/fvMesh/fvPatches/constraint/nonConformalCoupled/nonConformalCoupledFvPatch.H b/src/finiteVolume/fvMesh/fvPatches/constraint/nonConformalCoupled/nonConformalCoupledFvPatch.H index bf2ff71377..739745f566 100644 --- a/src/finiteVolume/fvMesh/fvPatches/constraint/nonConformalCoupled/nonConformalCoupledFvPatch.H +++ b/src/finiteVolume/fvMesh/fvPatches/constraint/nonConformalCoupled/nonConformalCoupledFvPatch.H @@ -52,7 +52,7 @@ namespace Foam class nonConformalErrorFvPatch; /*---------------------------------------------------------------------------*\ - Class nonConformalCoupledFvPatch Declaration + Class nonConformalCoupledFvPatch Declaration \*---------------------------------------------------------------------------*/ class nonConformalCoupledFvPatch diff --git a/src/finiteVolume/fvMesh/fvPatches/constraint/nonConformalProcessorCyclic/nonConformalProcessorCyclicFvPatch.H b/src/finiteVolume/fvMesh/fvPatches/constraint/nonConformalProcessorCyclic/nonConformalProcessorCyclicFvPatch.H index a59209b609..5529739661 100644 --- a/src/finiteVolume/fvMesh/fvPatches/constraint/nonConformalProcessorCyclic/nonConformalProcessorCyclicFvPatch.H +++ b/src/finiteVolume/fvMesh/fvPatches/constraint/nonConformalProcessorCyclic/nonConformalProcessorCyclicFvPatch.H @@ -50,7 +50,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class nonConformalProcessorCyclicFvPatch Declaration + Class nonConformalProcessorCyclicFvPatch Declaration \*---------------------------------------------------------------------------*/ class nonConformalProcessorCyclicFvPatch diff --git a/src/finiteVolume/fvMesh/fvPatches/derived/mapped/mappedExtrudedWallFvPatch.H b/src/finiteVolume/fvMesh/fvPatches/derived/mapped/mappedExtrudedWallFvPatch.H index 4e1b3eff94..5933709293 100644 --- a/src/finiteVolume/fvMesh/fvPatches/derived/mapped/mappedExtrudedWallFvPatch.H +++ b/src/finiteVolume/fvMesh/fvPatches/derived/mapped/mappedExtrudedWallFvPatch.H @@ -41,7 +41,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class mappedExtrudedWallFvPatch Declaration + Class mappedExtrudedWallFvPatch Declaration \*---------------------------------------------------------------------------*/ class mappedExtrudedWallFvPatch diff --git a/src/finiteVolume/fvMesh/fvPatches/derived/mapped/mappedInternalFvPatch.H b/src/finiteVolume/fvMesh/fvPatches/derived/mapped/mappedInternalFvPatch.H index 0a837beed8..ccd67108b0 100644 --- a/src/finiteVolume/fvMesh/fvPatches/derived/mapped/mappedInternalFvPatch.H +++ b/src/finiteVolume/fvMesh/fvPatches/derived/mapped/mappedInternalFvPatch.H @@ -41,7 +41,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class mappedInternalFvPatch Declaration + Class mappedInternalFvPatch Declaration \*---------------------------------------------------------------------------*/ class mappedInternalFvPatch diff --git a/src/finiteVolume/fvMesh/wallDist/FvWallInfo/FvWallInfo.H b/src/finiteVolume/fvMesh/wallDist/FvWallInfo/FvWallInfo.H index dc3abc3ebf..7bea8b4657 100644 --- a/src/finiteVolume/fvMesh/wallDist/FvWallInfo/FvWallInfo.H +++ b/src/finiteVolume/fvMesh/wallDist/FvWallInfo/FvWallInfo.H @@ -50,7 +50,7 @@ class fvMesh; class transformer; /*---------------------------------------------------------------------------*\ - Class FvWallInfoBase Declaration + Class FvWallInfoBase Declaration \*---------------------------------------------------------------------------*/ template<class WallInfo, class Derived> @@ -117,7 +117,7 @@ public: }; /*---------------------------------------------------------------------------*\ - Class FvWallInfo Declaration + Class FvWallInfo Declaration \*---------------------------------------------------------------------------*/ template<class WallInfo> diff --git a/src/finiteVolume/fvMesh/wallDist/FvWallInfo/FvWallInfoData.H b/src/finiteVolume/fvMesh/wallDist/FvWallInfo/FvWallInfoData.H index b9b778eee8..b0e859f71c 100644 --- a/src/finiteVolume/fvMesh/wallDist/FvWallInfo/FvWallInfoData.H +++ b/src/finiteVolume/fvMesh/wallDist/FvWallInfo/FvWallInfoData.H @@ -65,7 +65,7 @@ Ostream& operator<< /*---------------------------------------------------------------------------*\ - Class FvWallInfoDataBase Declaration + Class FvWallInfoDataBase Declaration \*---------------------------------------------------------------------------*/ template<class WallInfo, class Type, class Derived> @@ -159,7 +159,7 @@ public: /*---------------------------------------------------------------------------*\ - Class FvWallInfoData Declaration + Class FvWallInfoData Declaration \*---------------------------------------------------------------------------*/ template<class WallInfo, class Type> diff --git a/src/finiteVolume/fvMesh/wallDist/FvWallInfo/FvWallInfoYPlus.H b/src/finiteVolume/fvMesh/wallDist/FvWallInfo/FvWallInfoYPlus.H index 6dbd55d1ec..c15b41e906 100644 --- a/src/finiteVolume/fvMesh/wallDist/FvWallInfo/FvWallInfoYPlus.H +++ b/src/finiteVolume/fvMesh/wallDist/FvWallInfo/FvWallInfoYPlus.H @@ -48,7 +48,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class FvWallInfoYPlusBase Declaration + Class FvWallInfoYPlusBase Declaration \*---------------------------------------------------------------------------*/ template<class WallInfo, class Derived> diff --git a/src/finiteVolume/fvMeshToFvMesh/fvMeshToFvMesh.H b/src/finiteVolume/fvMeshToFvMesh/fvMeshToFvMesh.H index 2adcb32383..c396811b2e 100644 --- a/src/finiteVolume/fvMeshToFvMesh/fvMeshToFvMesh.H +++ b/src/finiteVolume/fvMeshToFvMesh/fvMeshToFvMesh.H @@ -43,7 +43,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class fvMeshToFvMesh Declaration + Class fvMeshToFvMesh Declaration \*---------------------------------------------------------------------------*/ class fvMeshToFvMesh diff --git a/src/finiteVolume/fvMeshToFvMesh/patchToPatchFvPatchFieldMapper.H b/src/finiteVolume/fvMeshToFvMesh/patchToPatchFvPatchFieldMapper.H index 52121f2f91..7ec6104dcf 100644 --- a/src/finiteVolume/fvMeshToFvMesh/patchToPatchFvPatchFieldMapper.H +++ b/src/finiteVolume/fvMeshToFvMesh/patchToPatchFvPatchFieldMapper.H @@ -43,7 +43,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class patchToPatchFvPatchFieldMapper Declaration + Class patchToPatchFvPatchFieldMapper Declaration \*---------------------------------------------------------------------------*/ class patchToPatchFvPatchFieldMapper diff --git a/src/finiteVolume/interpolation/interpolation/interpolationVolPointInterpolation/interpolationVolPointInterpolation.H b/src/finiteVolume/interpolation/interpolation/interpolationVolPointInterpolation/interpolationVolPointInterpolation.H index 777297a2cf..fba8b0d266 100644 --- a/src/finiteVolume/interpolation/interpolation/interpolationVolPointInterpolation/interpolationVolPointInterpolation.H +++ b/src/finiteVolume/interpolation/interpolation/interpolationVolPointInterpolation/interpolationVolPointInterpolation.H @@ -41,7 +41,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class interpolationVolPointInterpolation Declaration + Class interpolationVolPointInterpolation Declaration \*---------------------------------------------------------------------------*/ template<class Type> diff --git a/src/finiteVolume/interpolation/surfaceInterpolation/schemes/deferred/deferred.H b/src/finiteVolume/interpolation/surfaceInterpolation/schemes/deferred/deferred.H index f47b067220..a374e0a47b 100644 --- a/src/finiteVolume/interpolation/surfaceInterpolation/schemes/deferred/deferred.H +++ b/src/finiteVolume/interpolation/surfaceInterpolation/schemes/deferred/deferred.H @@ -49,7 +49,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class deferred Declaration + Class deferred Declaration \*---------------------------------------------------------------------------*/ template<class Type> diff --git a/src/finiteVolume/interpolation/surfaceInterpolation/schemes/phaseStabilised/phaseStabilised.H b/src/finiteVolume/interpolation/surfaceInterpolation/schemes/phaseStabilised/phaseStabilised.H index b4bcd3b272..e20b068044 100644 --- a/src/finiteVolume/interpolation/surfaceInterpolation/schemes/phaseStabilised/phaseStabilised.H +++ b/src/finiteVolume/interpolation/surfaceInterpolation/schemes/phaseStabilised/phaseStabilised.H @@ -46,7 +46,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class phaseStabilised Declaration + Class phaseStabilised Declaration \*---------------------------------------------------------------------------*/ template<class Type> diff --git a/src/finiteVolume/solver/solver.H b/src/finiteVolume/solver/solver.H index a589147bc7..c79e1f6298 100644 --- a/src/finiteVolume/solver/solver.H +++ b/src/finiteVolume/solver/solver.H @@ -47,7 +47,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class solver Declaration + Class solver Declaration \*---------------------------------------------------------------------------*/ class solver diff --git a/src/functionObjects/field/cylindrical/cylindricalFunctionObject.H b/src/functionObjects/field/cylindrical/cylindricalFunctionObject.H index 278b39f445..0daa4e22ff 100644 --- a/src/functionObjects/field/cylindrical/cylindricalFunctionObject.H +++ b/src/functionObjects/field/cylindrical/cylindricalFunctionObject.H @@ -90,7 +90,7 @@ namespace functionObjects { /*---------------------------------------------------------------------------*\ - Class cylindrical Declaration + Class cylindrical Declaration \*---------------------------------------------------------------------------*/ class cylindrical diff --git a/src/functionObjects/field/divide/divide.H b/src/functionObjects/field/divide/divide.H index d85ff510ff..0f64d917fa 100644 --- a/src/functionObjects/field/divide/divide.H +++ b/src/functionObjects/field/divide/divide.H @@ -65,7 +65,7 @@ namespace functionObjects { /*---------------------------------------------------------------------------*\ - Class divide Declaration + Class divide Declaration \*---------------------------------------------------------------------------*/ class divide diff --git a/src/functionObjects/field/fieldValues/volFieldValue/volFieldValue.H b/src/functionObjects/field/fieldValues/volFieldValue/volFieldValue.H index 1865a8108c..e157de137f 100644 --- a/src/functionObjects/field/fieldValues/volFieldValue/volFieldValue.H +++ b/src/functionObjects/field/fieldValues/volFieldValue/volFieldValue.H @@ -324,7 +324,7 @@ void volFieldValue::writeFileHeaderLocation<scalar>(); /*---------------------------------------------------------------------------*\ - Class volFieldValue::Result Declaration + Class volFieldValue::Result Declaration \*---------------------------------------------------------------------------*/ template<class Type> diff --git a/src/functionObjects/field/layerAverage/layerAverage.H b/src/functionObjects/field/layerAverage/layerAverage.H index 3634a961a7..e5915338d8 100644 --- a/src/functionObjects/field/layerAverage/layerAverage.H +++ b/src/functionObjects/field/layerAverage/layerAverage.H @@ -83,7 +83,7 @@ namespace functionObjects { /*---------------------------------------------------------------------------*\ - Class layerAverage Declaration + Class layerAverage Declaration \*---------------------------------------------------------------------------*/ class layerAverage diff --git a/src/functionObjects/field/multiply/multiply.H b/src/functionObjects/field/multiply/multiply.H index 5e93b745b3..b880c39c5e 100644 --- a/src/functionObjects/field/multiply/multiply.H +++ b/src/functionObjects/field/multiply/multiply.H @@ -66,7 +66,7 @@ namespace functionObjects { /*---------------------------------------------------------------------------*\ - Class multiply Declaration + Class multiply Declaration \*---------------------------------------------------------------------------*/ class multiply diff --git a/src/functionObjects/field/patchCutLayerAverage/patchCutLayerAverage.H b/src/functionObjects/field/patchCutLayerAverage/patchCutLayerAverage.H index 7b9ce7f963..83d874bcdd 100644 --- a/src/functionObjects/field/patchCutLayerAverage/patchCutLayerAverage.H +++ b/src/functionObjects/field/patchCutLayerAverage/patchCutLayerAverage.H @@ -87,7 +87,7 @@ namespace functionObjects { /*---------------------------------------------------------------------------*\ - Class patchCutLayerAverage Declaration + Class patchCutLayerAverage Declaration \*---------------------------------------------------------------------------*/ class patchCutLayerAverage diff --git a/src/functionObjects/field/reconstruct/reconstruct.H b/src/functionObjects/field/reconstruct/reconstruct.H index 7e06504a4e..4d31461eb2 100644 --- a/src/functionObjects/field/reconstruct/reconstruct.H +++ b/src/functionObjects/field/reconstruct/reconstruct.H @@ -51,7 +51,7 @@ namespace functionObjects { /*---------------------------------------------------------------------------*\ - Class reconstruct Declaration + Class reconstruct Declaration \*---------------------------------------------------------------------------*/ class reconstruct diff --git a/src/functionObjects/field/streamlines/streamlinesCloud.H b/src/functionObjects/field/streamlines/streamlinesCloud.H index ff952767bf..84c6264a0a 100644 --- a/src/functionObjects/field/streamlines/streamlinesCloud.H +++ b/src/functionObjects/field/streamlines/streamlinesCloud.H @@ -44,7 +44,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class streamlinesCloud Declaration + Class streamlinesCloud Declaration \*---------------------------------------------------------------------------*/ class streamlinesCloud diff --git a/src/functionObjects/field/surfaceInterpolate/surfaceInterpolate.H b/src/functionObjects/field/surfaceInterpolate/surfaceInterpolate.H index cf0740dd8d..5c3ac3c2b2 100644 --- a/src/functionObjects/field/surfaceInterpolate/surfaceInterpolate.H +++ b/src/functionObjects/field/surfaceInterpolate/surfaceInterpolate.H @@ -51,7 +51,7 @@ namespace functionObjects { /*---------------------------------------------------------------------------*\ - Class surfaceInterpolate Declaration + Class surfaceInterpolate Declaration \*---------------------------------------------------------------------------*/ class surfaceInterpolate diff --git a/src/functionObjects/field/uniform/uniform.H b/src/functionObjects/field/uniform/uniform.H index 3f14cbdba0..369ba021c3 100644 --- a/src/functionObjects/field/uniform/uniform.H +++ b/src/functionObjects/field/uniform/uniform.H @@ -50,7 +50,7 @@ namespace functionObjects { /*---------------------------------------------------------------------------*\ - Class uniform Declaration + Class uniform Declaration \*---------------------------------------------------------------------------*/ class uniform diff --git a/src/functionObjects/field/wallHeatTransferCoeff/wallHeatTransferCoeffModels/wallHeatTransferCoeffModel/wallHeatTransferCoeffModel.H b/src/functionObjects/field/wallHeatTransferCoeff/wallHeatTransferCoeffModels/wallHeatTransferCoeffModel/wallHeatTransferCoeffModel.H index 10facc8090..fd41773e91 100644 --- a/src/functionObjects/field/wallHeatTransferCoeff/wallHeatTransferCoeffModels/wallHeatTransferCoeffModel/wallHeatTransferCoeffModel.H +++ b/src/functionObjects/field/wallHeatTransferCoeff/wallHeatTransferCoeffModels/wallHeatTransferCoeffModel/wallHeatTransferCoeffModel.H @@ -44,7 +44,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class wallHeatTransferCoeffModel Declaration + Class wallHeatTransferCoeffModel Declaration \*---------------------------------------------------------------------------*/ class wallHeatTransferCoeffModel diff --git a/src/functionObjects/lagrangian/stopAtEmptyClouds/stopAtEmptyClouds.H b/src/functionObjects/lagrangian/stopAtEmptyClouds/stopAtEmptyClouds.H index 368442a8f5..42555f5f54 100644 --- a/src/functionObjects/lagrangian/stopAtEmptyClouds/stopAtEmptyClouds.H +++ b/src/functionObjects/lagrangian/stopAtEmptyClouds/stopAtEmptyClouds.H @@ -73,7 +73,7 @@ namespace functionObjects { /*---------------------------------------------------------------------------*\ - Class stopAtEmptyClouds Declaration + Class stopAtEmptyClouds Declaration \*---------------------------------------------------------------------------*/ class stopAtEmptyClouds diff --git a/src/functionObjects/utilities/setWriteInterval/setWriteIntervalFunctionObject.H b/src/functionObjects/utilities/setWriteInterval/setWriteIntervalFunctionObject.H index a5aed86306..38c42b5c43 100644 --- a/src/functionObjects/utilities/setWriteInterval/setWriteIntervalFunctionObject.H +++ b/src/functionObjects/utilities/setWriteInterval/setWriteIntervalFunctionObject.H @@ -72,7 +72,7 @@ namespace functionObjects { /*---------------------------------------------------------------------------*\ - Class setWriteIntervalFunctionObject Declaration + Class setWriteIntervalFunctionObject Declaration \*---------------------------------------------------------------------------*/ class setWriteIntervalFunctionObject diff --git a/src/fvConstraints/limitMag/limitMag.H b/src/fvConstraints/limitMag/limitMag.H index ef7c4eca38..99f1ae62bd 100644 --- a/src/fvConstraints/limitMag/limitMag.H +++ b/src/fvConstraints/limitMag/limitMag.H @@ -61,7 +61,7 @@ namespace fv { /*---------------------------------------------------------------------------*\ - Class limitMag Declaration + Class limitMag Declaration \*---------------------------------------------------------------------------*/ class limitMag diff --git a/src/fvConstraints/limitPressure/limitPressure.H b/src/fvConstraints/limitPressure/limitPressure.H index 8f09fbbd39..a0040d038c 100644 --- a/src/fvConstraints/limitPressure/limitPressure.H +++ b/src/fvConstraints/limitPressure/limitPressure.H @@ -61,7 +61,7 @@ namespace fv { /*---------------------------------------------------------------------------*\ - Class limitPressure Declaration + Class limitPressure Declaration \*---------------------------------------------------------------------------*/ class limitPressure diff --git a/src/fvMeshDistributors/distributor/fvMeshDistributorsDistributor.H b/src/fvMeshDistributors/distributor/fvMeshDistributorsDistributor.H index 6fc318db6e..ff10e3c531 100644 --- a/src/fvMeshDistributors/distributor/fvMeshDistributorsDistributor.H +++ b/src/fvMeshDistributors/distributor/fvMeshDistributorsDistributor.H @@ -66,7 +66,7 @@ namespace fvMeshDistributors { /*---------------------------------------------------------------------------*\ - Class distributor Declaration + Class distributor Declaration \*---------------------------------------------------------------------------*/ class distributor diff --git a/src/fvMeshDistributors/loadBalancer/fvMeshDistributorsLoadBalancer.H b/src/fvMeshDistributors/loadBalancer/fvMeshDistributorsLoadBalancer.H index ef060f6400..08856004da 100644 --- a/src/fvMeshDistributors/loadBalancer/fvMeshDistributorsLoadBalancer.H +++ b/src/fvMeshDistributors/loadBalancer/fvMeshDistributorsLoadBalancer.H @@ -65,7 +65,7 @@ namespace fvMeshDistributors { /*---------------------------------------------------------------------------*\ - Class loadBalancer Declaration + Class loadBalancer Declaration \*---------------------------------------------------------------------------*/ class loadBalancer diff --git a/src/fvMeshMovers/engine/engine/fvMeshMoversEngine.H b/src/fvMeshMovers/engine/engine/fvMeshMoversEngine.H index 435fe9fd26..7e3846363f 100644 --- a/src/fvMeshMovers/engine/engine/fvMeshMoversEngine.H +++ b/src/fvMeshMovers/engine/engine/fvMeshMoversEngine.H @@ -45,7 +45,7 @@ namespace fvMeshMovers { /*---------------------------------------------------------------------------*\ - Class fvMeshMovers::engine Declaration + Class fvMeshMovers::engine Declaration \*---------------------------------------------------------------------------*/ class engine diff --git a/src/fvMeshMovers/engine/layered/fvMeshMoversLayeredEngine.H b/src/fvMeshMovers/engine/layered/fvMeshMoversLayeredEngine.H index 13be28d94b..c9297b1708 100644 --- a/src/fvMeshMovers/engine/layered/fvMeshMoversLayeredEngine.H +++ b/src/fvMeshMovers/engine/layered/fvMeshMoversLayeredEngine.H @@ -45,7 +45,7 @@ namespace fvMeshMovers { /*---------------------------------------------------------------------------*\ - Class fvMeshMovers::layeredEngine Declaration + Class fvMeshMovers::layeredEngine Declaration \*---------------------------------------------------------------------------*/ class layeredEngine diff --git a/src/fvMeshMovers/inkJet/fvMeshMoversInkJet.H b/src/fvMeshMovers/inkJet/fvMeshMoversInkJet.H index cfccb53eb1..e083a23566 100644 --- a/src/fvMeshMovers/inkJet/fvMeshMoversInkJet.H +++ b/src/fvMeshMovers/inkJet/fvMeshMoversInkJet.H @@ -52,7 +52,7 @@ namespace fvMeshMovers { /*---------------------------------------------------------------------------*\ - Class inkJet Declaration + Class inkJet Declaration \*---------------------------------------------------------------------------*/ class inkJet diff --git a/src/fvMeshMovers/interpolator/fvMeshMoversInterpolator.H b/src/fvMeshMovers/interpolator/fvMeshMoversInterpolator.H index cd21115fdb..0b7a47fdee 100644 --- a/src/fvMeshMovers/interpolator/fvMeshMoversInterpolator.H +++ b/src/fvMeshMovers/interpolator/fvMeshMoversInterpolator.H @@ -69,7 +69,7 @@ namespace fvMeshMovers { /*---------------------------------------------------------------------------*\ - Class interpolator Declaration + Class interpolator Declaration \*---------------------------------------------------------------------------*/ class interpolator diff --git a/src/fvMeshMovers/motionSolver/fvMeshMoversMotionSolver.H b/src/fvMeshMovers/motionSolver/fvMeshMoversMotionSolver.H index ad27597ba0..c9a0304d36 100644 --- a/src/fvMeshMovers/motionSolver/fvMeshMoversMotionSolver.H +++ b/src/fvMeshMovers/motionSolver/fvMeshMoversMotionSolver.H @@ -47,7 +47,7 @@ namespace fvMeshMovers { /*---------------------------------------------------------------------------*\ - Class motionSolver Declaration + Class motionSolver Declaration \*---------------------------------------------------------------------------*/ class motionSolver diff --git a/src/fvMeshStitchers/moving/fvMeshStitchersMoving.H b/src/fvMeshStitchers/moving/fvMeshStitchersMoving.H index 2003af766d..e06667e8bd 100644 --- a/src/fvMeshStitchers/moving/fvMeshStitchersMoving.H +++ b/src/fvMeshStitchers/moving/fvMeshStitchersMoving.H @@ -45,7 +45,7 @@ namespace fvMeshStitchers { /*---------------------------------------------------------------------------*\ - Class fvMeshStitchers::moving Declaration + Class fvMeshStitchers::moving Declaration \*---------------------------------------------------------------------------*/ class moving diff --git a/src/fvMeshStitchers/moving/meshPhiCorrectInfo.H b/src/fvMeshStitchers/moving/meshPhiCorrectInfo.H index 61b6bfddca..9dca9eabe3 100644 --- a/src/fvMeshStitchers/moving/meshPhiCorrectInfo.H +++ b/src/fvMeshStitchers/moving/meshPhiCorrectInfo.H @@ -50,7 +50,7 @@ Ostream& operator<<(Ostream&, const meshPhiCorrectInfo&); Istream& operator>>(Istream&, meshPhiCorrectInfo&); /*---------------------------------------------------------------------------*\ - Class meshPhiCorrectInfo Declaration + Class meshPhiCorrectInfo Declaration \*---------------------------------------------------------------------------*/ class meshPhiCorrectInfo diff --git a/src/fvMeshStitchers/moving/meshPhiPreCorrectInfo.H b/src/fvMeshStitchers/moving/meshPhiPreCorrectInfo.H index c24b001b25..5db2185659 100644 --- a/src/fvMeshStitchers/moving/meshPhiPreCorrectInfo.H +++ b/src/fvMeshStitchers/moving/meshPhiPreCorrectInfo.H @@ -52,7 +52,7 @@ Ostream& operator<<(Ostream&, const meshPhiPreCorrectInfo&); Istream& operator>>(Istream&, meshPhiPreCorrectInfo&); /*---------------------------------------------------------------------------*\ - Class meshPhiPreCorrectInfo Declaration + Class meshPhiPreCorrectInfo Declaration \*---------------------------------------------------------------------------*/ class meshPhiPreCorrectInfo diff --git a/src/fvMeshTopoChangers/meshToMesh/fvMeshTopoChangersMeshToMesh.H b/src/fvMeshTopoChangers/meshToMesh/fvMeshTopoChangersMeshToMesh.H index 4888543b8b..f7679a71d0 100644 --- a/src/fvMeshTopoChangers/meshToMesh/fvMeshTopoChangersMeshToMesh.H +++ b/src/fvMeshTopoChangers/meshToMesh/fvMeshTopoChangersMeshToMesh.H @@ -45,7 +45,7 @@ namespace fvMeshTopoChangers { /*---------------------------------------------------------------------------*\ - Class fvMeshTopoChangers::meshToMesh Declaration + Class fvMeshTopoChangers::meshToMesh Declaration \*---------------------------------------------------------------------------*/ class meshToMesh diff --git a/src/fvMeshTopoChangers/meshToMesh/meshToMeshAdjustTimeStep/meshToMeshAdjustTimeStepFunctionObject.H b/src/fvMeshTopoChangers/meshToMesh/meshToMeshAdjustTimeStep/meshToMeshAdjustTimeStepFunctionObject.H index 6282bd8932..2b666c7c2e 100644 --- a/src/fvMeshTopoChangers/meshToMesh/meshToMeshAdjustTimeStep/meshToMeshAdjustTimeStepFunctionObject.H +++ b/src/fvMeshTopoChangers/meshToMesh/meshToMeshAdjustTimeStep/meshToMeshAdjustTimeStepFunctionObject.H @@ -46,7 +46,7 @@ namespace functionObjects { /*---------------------------------------------------------------------------*\ - Class meshToMeshAdjustTimeStepFunctionObject Declaration + Class meshToMeshAdjustTimeStepFunctionObject Declaration \*---------------------------------------------------------------------------*/ class meshToMeshAdjustTimeStepFunctionObject diff --git a/src/fvMeshTopoChangers/movingCone/fvMeshTopoChangersMovingCone.H b/src/fvMeshTopoChangers/movingCone/fvMeshTopoChangersMovingCone.H index c114d3ba03..b59b24f7f6 100644 --- a/src/fvMeshTopoChangers/movingCone/fvMeshTopoChangersMovingCone.H +++ b/src/fvMeshTopoChangers/movingCone/fvMeshTopoChangersMovingCone.H @@ -47,7 +47,7 @@ namespace fvMeshTopoChangers { /*---------------------------------------------------------------------------*\ - Class movingCone Declaration + Class movingCone Declaration \*---------------------------------------------------------------------------*/ class movingCone diff --git a/src/fvModels/derived/heatSource/heatSource.H b/src/fvModels/derived/heatSource/heatSource.H index 15bf226fa4..44b1cc9d7a 100644 --- a/src/fvModels/derived/heatSource/heatSource.H +++ b/src/fvModels/derived/heatSource/heatSource.H @@ -59,7 +59,7 @@ namespace fv { /*---------------------------------------------------------------------------*\ - Class heatSource Declaration + Class heatSource Declaration \*---------------------------------------------------------------------------*/ class heatSource diff --git a/src/fvModels/derived/heatTransfer/heatTransfer.H b/src/fvModels/derived/heatTransfer/heatTransfer.H index 9049d7fc60..f2b97ad00f 100644 --- a/src/fvModels/derived/heatTransfer/heatTransfer.H +++ b/src/fvModels/derived/heatTransfer/heatTransfer.H @@ -87,7 +87,7 @@ namespace fv { /*---------------------------------------------------------------------------*\ - Class heatTransfer Declaration + Class heatTransfer Declaration \*---------------------------------------------------------------------------*/ class heatTransfer diff --git a/src/fvModels/derived/heatTransfer/heatTransferModels/constant/constant.H b/src/fvModels/derived/heatTransfer/heatTransferModels/constant/constant.H index 0d7bf18da1..fd2e642204 100644 --- a/src/fvModels/derived/heatTransfer/heatTransferModels/constant/constant.H +++ b/src/fvModels/derived/heatTransfer/heatTransferModels/constant/constant.H @@ -58,7 +58,7 @@ namespace heatTransferModels { /*---------------------------------------------------------------------------*\ - Class constant Declaration + Class constant Declaration \*---------------------------------------------------------------------------*/ class constant diff --git a/src/fvModels/derived/heatTransfer/heatTransferModels/function1/function1.H b/src/fvModels/derived/heatTransfer/heatTransferModels/function1/function1.H index 145a973fcd..9caebe6379 100644 --- a/src/fvModels/derived/heatTransfer/heatTransferModels/function1/function1.H +++ b/src/fvModels/derived/heatTransfer/heatTransferModels/function1/function1.H @@ -62,7 +62,7 @@ namespace heatTransferModels { /*---------------------------------------------------------------------------*\ - Class function1 Declaration + Class function1 Declaration \*---------------------------------------------------------------------------*/ class function1 diff --git a/src/fvModels/derived/heatTransfer/heatTransferModels/function2/function2.H b/src/fvModels/derived/heatTransfer/heatTransferModels/function2/function2.H index f98fe6ccb8..6b54e1e127 100644 --- a/src/fvModels/derived/heatTransfer/heatTransferModels/function2/function2.H +++ b/src/fvModels/derived/heatTransfer/heatTransferModels/function2/function2.H @@ -64,7 +64,7 @@ namespace heatTransferModels { /*---------------------------------------------------------------------------*\ - Class function2 Declaration + Class function2 Declaration \*---------------------------------------------------------------------------*/ class function2 diff --git a/src/fvModels/derived/heatTransfer/heatTransferModels/heatTransferModel/heatTransferModel.H b/src/fvModels/derived/heatTransfer/heatTransferModels/heatTransferModel/heatTransferModel.H index 4b56cf29b7..f0cd16b983 100644 --- a/src/fvModels/derived/heatTransfer/heatTransferModels/heatTransferModel/heatTransferModel.H +++ b/src/fvModels/derived/heatTransfer/heatTransferModels/heatTransferModel/heatTransferModel.H @@ -49,7 +49,7 @@ namespace fv { /*---------------------------------------------------------------------------*\ - Class heatTransferModel Declaration + Class heatTransferModel Declaration \*---------------------------------------------------------------------------*/ class heatTransferModel diff --git a/src/fvModels/derived/heatTransfer/heatTransferModels/variable/variable.H b/src/fvModels/derived/heatTransfer/heatTransferModels/variable/variable.H index 0a053e7268..e847214516 100644 --- a/src/fvModels/derived/heatTransfer/heatTransferModels/variable/variable.H +++ b/src/fvModels/derived/heatTransfer/heatTransferModels/variable/variable.H @@ -78,7 +78,7 @@ namespace heatTransferModels { /*---------------------------------------------------------------------------*\ - Class variable Declaration + Class variable Declaration \*---------------------------------------------------------------------------*/ class variable diff --git a/src/fvModels/derived/massSource/massSource.H b/src/fvModels/derived/massSource/massSource.H index 0c00988c5d..53bddf19dd 100644 --- a/src/fvModels/derived/massSource/massSource.H +++ b/src/fvModels/derived/massSource/massSource.H @@ -76,7 +76,7 @@ namespace fv { /*---------------------------------------------------------------------------*\ - Class massSource Declaration + Class massSource Declaration \*---------------------------------------------------------------------------*/ class massSource diff --git a/src/fvModels/derived/sixDoFAccelerationSource/sixDoFAccelerationSource.H b/src/fvModels/derived/sixDoFAccelerationSource/sixDoFAccelerationSource.H index 37c0e86d27..2c66a0f772 100644 --- a/src/fvModels/derived/sixDoFAccelerationSource/sixDoFAccelerationSource.H +++ b/src/fvModels/derived/sixDoFAccelerationSource/sixDoFAccelerationSource.H @@ -58,7 +58,7 @@ namespace fv { /*---------------------------------------------------------------------------*\ - Class sixDoFAccelerationSource Declaration + Class sixDoFAccelerationSource Declaration \*---------------------------------------------------------------------------*/ class sixDoFAccelerationSource diff --git a/src/fvModels/general/codedFvModel/codedFvModel.H b/src/fvModels/general/codedFvModel/codedFvModel.H index bb6539ed87..666c6fe2ef 100644 --- a/src/fvModels/general/codedFvModel/codedFvModel.H +++ b/src/fvModels/general/codedFvModel/codedFvModel.H @@ -83,7 +83,7 @@ namespace fv { /*---------------------------------------------------------------------------*\ - Class codedFvModel Declaration + Class codedFvModel Declaration \*---------------------------------------------------------------------------*/ class codedFvModel diff --git a/src/fvModels/interRegion/interRegionHeatTransfer/interRegionHeatTransfer.H b/src/fvModels/interRegion/interRegionHeatTransfer/interRegionHeatTransfer.H index 0e4e87858e..0e049e4827 100644 --- a/src/fvModels/interRegion/interRegionHeatTransfer/interRegionHeatTransfer.H +++ b/src/fvModels/interRegion/interRegionHeatTransfer/interRegionHeatTransfer.H @@ -85,7 +85,7 @@ namespace fv { /*---------------------------------------------------------------------------*\ - Class interRegionHeatTransfer Declaration + Class interRegionHeatTransfer Declaration \*---------------------------------------------------------------------------*/ class interRegionHeatTransfer diff --git a/src/lagrangian/parcel/fvModels/clouds/clouds.H b/src/lagrangian/parcel/fvModels/clouds/clouds.H index 65d82f61fb..7cc313ea4f 100644 --- a/src/lagrangian/parcel/fvModels/clouds/clouds.H +++ b/src/lagrangian/parcel/fvModels/clouds/clouds.H @@ -87,7 +87,7 @@ namespace fv { /*---------------------------------------------------------------------------*\ - Class clouds Declaration + Class clouds Declaration \*---------------------------------------------------------------------------*/ class clouds diff --git a/src/lagrangian/parcel/parcelCloud/parcelClouds.H b/src/lagrangian/parcel/parcelCloud/parcelClouds.H index 6323932861..a6b1e33c24 100644 --- a/src/lagrangian/parcel/parcelCloud/parcelClouds.H +++ b/src/lagrangian/parcel/parcelCloud/parcelClouds.H @@ -51,7 +51,7 @@ namespace Foam /*---------------------------------------------------------------------------*\ - Class parcelClouds Declaration + Class parcelClouds Declaration \*---------------------------------------------------------------------------*/ class parcelClouds diff --git a/src/lagrangian/parcel/parcelThermo/parcelThermo.H b/src/lagrangian/parcel/parcelThermo/parcelThermo.H index 568844ac69..cff1013fa1 100644 --- a/src/lagrangian/parcel/parcelThermo/parcelThermo.H +++ b/src/lagrangian/parcel/parcelThermo/parcelThermo.H @@ -53,7 +53,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class parcelThermo Declaration + Class parcelThermo Declaration \*---------------------------------------------------------------------------*/ class parcelThermo diff --git a/src/lagrangian/parcel/submodels/CloudFunctionObjects/Flux/Flux.H b/src/lagrangian/parcel/submodels/CloudFunctionObjects/Flux/Flux.H index 3bf872002d..e206c6269b 100644 --- a/src/lagrangian/parcel/submodels/CloudFunctionObjects/Flux/Flux.H +++ b/src/lagrangian/parcel/submodels/CloudFunctionObjects/Flux/Flux.H @@ -135,7 +135,7 @@ public: /*---------------------------------------------------------------------------*\ - Class NumberFlux Declaration + Class NumberFlux Declaration \*---------------------------------------------------------------------------*/ template<class CloudType> @@ -172,7 +172,7 @@ public: /*---------------------------------------------------------------------------*\ - Class VolumeFlux Declaration + Class VolumeFlux Declaration \*---------------------------------------------------------------------------*/ template<class CloudType> @@ -209,7 +209,7 @@ public: /*---------------------------------------------------------------------------*\ - Class MassFlux Declaration + Class MassFlux Declaration \*---------------------------------------------------------------------------*/ template<class CloudType> diff --git a/src/lagrangian/parcel/submodels/Thermodynamic/SurfaceFilmModel/ThermoSurfaceFilm/ThermoSurfaceFilm.H b/src/lagrangian/parcel/submodels/Thermodynamic/SurfaceFilmModel/ThermoSurfaceFilm/ThermoSurfaceFilm.H index a9e51aaa8d..7dca7e43ce 100644 --- a/src/lagrangian/parcel/submodels/Thermodynamic/SurfaceFilmModel/ThermoSurfaceFilm/ThermoSurfaceFilm.H +++ b/src/lagrangian/parcel/submodels/Thermodynamic/SurfaceFilmModel/ThermoSurfaceFilm/ThermoSurfaceFilm.H @@ -57,7 +57,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class ThermoSurfaceFilmBase Declaration + Class ThermoSurfaceFilmBase Declaration \*---------------------------------------------------------------------------*/ class ThermoSurfaceFilmBase diff --git a/src/mesh/snappyHexMesh/refinementRegions/refinementRegions.H b/src/mesh/snappyHexMesh/refinementRegions/refinementRegions.H index a37b70a794..4ca759fe5e 100644 --- a/src/mesh/snappyHexMesh/refinementRegions/refinementRegions.H +++ b/src/mesh/snappyHexMesh/refinementRegions/refinementRegions.H @@ -48,7 +48,7 @@ namespace Foam class searchableSurfaces; /*---------------------------------------------------------------------------*\ - Class refinementRegions Declaration + Class refinementRegions Declaration \*---------------------------------------------------------------------------*/ class refinementRegions diff --git a/src/meshTools/PrimitiveOldTimePatch/PrimitiveOldTimePatch.H b/src/meshTools/PrimitiveOldTimePatch/PrimitiveOldTimePatch.H index e08271688d..bf95bc4968 100644 --- a/src/meshTools/PrimitiveOldTimePatch/PrimitiveOldTimePatch.H +++ b/src/meshTools/PrimitiveOldTimePatch/PrimitiveOldTimePatch.H @@ -56,7 +56,7 @@ template<class Face> struct UFaceList<IndirectList<Face>> : public UFaceList<UIndirectList<Face>> {}; /*---------------------------------------------------------------------------*\ - Class PrimitiveOldTimePatch Declaration + Class PrimitiveOldTimePatch Declaration \*---------------------------------------------------------------------------*/ template<class FaceList, class PointField> diff --git a/src/meshTools/coordinateSystems/cartesianCS.H b/src/meshTools/coordinateSystems/cartesianCS.H index 43b85fe14f..3b0be42e8c 100644 --- a/src/meshTools/coordinateSystems/cartesianCS.H +++ b/src/meshTools/coordinateSystems/cartesianCS.H @@ -45,7 +45,7 @@ namespace coordinateSystems { /*---------------------------------------------------------------------------*\ - Class cartesian Declaration + Class cartesian Declaration \*---------------------------------------------------------------------------*/ class cartesian diff --git a/src/meshTools/coordinateSystems/cylindricalCS.H b/src/meshTools/coordinateSystems/cylindricalCS.H index c2b2867911..7209e2af9b 100644 --- a/src/meshTools/coordinateSystems/cylindricalCS.H +++ b/src/meshTools/coordinateSystems/cylindricalCS.H @@ -45,7 +45,7 @@ namespace coordinateSystems { /*---------------------------------------------------------------------------*\ - Class cylindrical Declaration + Class cylindrical Declaration \*---------------------------------------------------------------------------*/ class cylindrical diff --git a/src/meshTools/cutPoly/cellEdgeAddressing.H b/src/meshTools/cutPoly/cellEdgeAddressing.H index 55e378b78a..4939d1bb82 100644 --- a/src/meshTools/cutPoly/cellEdgeAddressing.H +++ b/src/meshTools/cutPoly/cellEdgeAddressing.H @@ -50,7 +50,7 @@ class polyTopoChangeMap; class polyMeshMap; /*---------------------------------------------------------------------------*\ - Class cellEdgeAddressing Declaration + Class cellEdgeAddressing Declaration \*---------------------------------------------------------------------------*/ class cellEdgeAddressing @@ -103,7 +103,7 @@ public: /*---------------------------------------------------------------------------*\ - Class cellEdgeAddressingList Declaration + Class cellEdgeAddressingList Declaration \*---------------------------------------------------------------------------*/ class cellEdgeAddressingList diff --git a/src/meshTools/cutPoly/cutPolyIsoSurface.H b/src/meshTools/cutPoly/cutPolyIsoSurface.H index a2bda8a17f..be74b07229 100644 --- a/src/meshTools/cutPoly/cutPolyIsoSurface.H +++ b/src/meshTools/cutPoly/cutPolyIsoSurface.H @@ -44,7 +44,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class cutPolyIsoSurface Declaration + Class cutPolyIsoSurface Declaration \*---------------------------------------------------------------------------*/ class cutPolyIsoSurface diff --git a/src/meshTools/cutPoly/cutPolyValue.H b/src/meshTools/cutPoly/cutPolyValue.H index a16621d841..b024e61c9e 100644 --- a/src/meshTools/cutPoly/cutPolyValue.H +++ b/src/meshTools/cutPoly/cutPolyValue.H @@ -76,7 +76,7 @@ Type edgeCutValue /*---------------------------------------------------------------------------*\ - Class FaceCutValues Declaration + Class FaceCutValues Declaration \*---------------------------------------------------------------------------*/ template<class Type> @@ -203,7 +203,7 @@ public: /*---------------------------------------------------------------------------*\ - Class CellCutValues Declaration + Class CellCutValues Declaration \*---------------------------------------------------------------------------*/ template<class Type> diff --git a/src/meshTools/mappedPatches/mappedInternalPatchBase/mappedInternalPatchBase.H b/src/meshTools/mappedPatches/mappedInternalPatchBase/mappedInternalPatchBase.H index 9e289f0abd..df7970d619 100644 --- a/src/meshTools/mappedPatches/mappedInternalPatchBase/mappedInternalPatchBase.H +++ b/src/meshTools/mappedPatches/mappedInternalPatchBase/mappedInternalPatchBase.H @@ -68,7 +68,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class mappedInternalPatchBase Declaration + Class mappedInternalPatchBase Declaration \*---------------------------------------------------------------------------*/ class mappedInternalPatchBase diff --git a/src/meshTools/mappedPatches/mappedInternalPointPatch/mappedInternalPointPatch.H b/src/meshTools/mappedPatches/mappedInternalPointPatch/mappedInternalPointPatch.H index 6d3cef5d6a..e2516e8b0a 100644 --- a/src/meshTools/mappedPatches/mappedInternalPointPatch/mappedInternalPointPatch.H +++ b/src/meshTools/mappedPatches/mappedInternalPointPatch/mappedInternalPointPatch.H @@ -42,7 +42,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class mappedInternalPointPatch Declaration + Class mappedInternalPointPatch Declaration \*---------------------------------------------------------------------------*/ class mappedInternalPointPatch diff --git a/src/meshTools/mappedPatches/mappedInternalPolyPatch/mappedInternalPolyPatch.H b/src/meshTools/mappedPatches/mappedInternalPolyPatch/mappedInternalPolyPatch.H index 5e581e7d0d..b901f7001b 100644 --- a/src/meshTools/mappedPatches/mappedInternalPolyPatch/mappedInternalPolyPatch.H +++ b/src/meshTools/mappedPatches/mappedInternalPolyPatch/mappedInternalPolyPatch.H @@ -47,7 +47,7 @@ namespace Foam class polyMesh; /*---------------------------------------------------------------------------*\ - Class mappedInternalPolyPatch Declaration + Class mappedInternalPolyPatch Declaration \*---------------------------------------------------------------------------*/ class mappedInternalPolyPatch diff --git a/src/meshTools/mappedPatches/mappedPointPatch/mappedExtrudedWallPointPatch.H b/src/meshTools/mappedPatches/mappedPointPatch/mappedExtrudedWallPointPatch.H index e0b4acfede..fd4edde425 100644 --- a/src/meshTools/mappedPatches/mappedPointPatch/mappedExtrudedWallPointPatch.H +++ b/src/meshTools/mappedPatches/mappedPointPatch/mappedExtrudedWallPointPatch.H @@ -41,7 +41,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class mappedExtrudedWallPointPatch Declaration + Class mappedExtrudedWallPointPatch Declaration \*---------------------------------------------------------------------------*/ class mappedExtrudedWallPointPatch diff --git a/src/meshTools/mappedPatches/mappedPolyPatch/mappedExtrudedWallPolyPatch.H b/src/meshTools/mappedPatches/mappedPolyPatch/mappedExtrudedWallPolyPatch.H index 1ca88f9ba9..24d488cbed 100644 --- a/src/meshTools/mappedPatches/mappedPolyPatch/mappedExtrudedWallPolyPatch.H +++ b/src/meshTools/mappedPatches/mappedPolyPatch/mappedExtrudedWallPolyPatch.H @@ -46,7 +46,7 @@ namespace Foam class polyMesh; /*---------------------------------------------------------------------------*\ - Class mappedExtrudedWallPolyPatch Declaration + Class mappedExtrudedWallPolyPatch Declaration \*---------------------------------------------------------------------------*/ class mappedExtrudedWallPolyPatch diff --git a/src/meshTools/nonConformal/pointPatchFields/nonConformalCyclic/nonConformalCyclicPointPatchField.H b/src/meshTools/nonConformal/pointPatchFields/nonConformalCyclic/nonConformalCyclicPointPatchField.H index 7ae47f83d8..71b1a6e541 100644 --- a/src/meshTools/nonConformal/pointPatchFields/nonConformalCyclic/nonConformalCyclicPointPatchField.H +++ b/src/meshTools/nonConformal/pointPatchFields/nonConformalCyclic/nonConformalCyclicPointPatchField.H @@ -44,7 +44,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class nonConformalCyclicPointPatchField Declaration + Class nonConformalCyclicPointPatchField Declaration \*---------------------------------------------------------------------------*/ template<class Type> diff --git a/src/meshTools/nonConformal/pointPatchFields/nonConformalError/nonConformalErrorPointPatchField.H b/src/meshTools/nonConformal/pointPatchFields/nonConformalError/nonConformalErrorPointPatchField.H index 5f1d68afa9..806d515dc8 100644 --- a/src/meshTools/nonConformal/pointPatchFields/nonConformalError/nonConformalErrorPointPatchField.H +++ b/src/meshTools/nonConformal/pointPatchFields/nonConformalError/nonConformalErrorPointPatchField.H @@ -44,7 +44,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class nonConformalErrorPointPatchField Declaration + Class nonConformalErrorPointPatchField Declaration \*---------------------------------------------------------------------------*/ template<class Type> diff --git a/src/meshTools/nonConformal/pointPatchFields/nonConformalProcessorCyclic/nonConformalProcessorCyclicPointPatchField.H b/src/meshTools/nonConformal/pointPatchFields/nonConformalProcessorCyclic/nonConformalProcessorCyclicPointPatchField.H index 84423c70a9..78517f090a 100644 --- a/src/meshTools/nonConformal/pointPatchFields/nonConformalProcessorCyclic/nonConformalProcessorCyclicPointPatchField.H +++ b/src/meshTools/nonConformal/pointPatchFields/nonConformalProcessorCyclic/nonConformalProcessorCyclicPointPatchField.H @@ -44,7 +44,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class nonConformalProcessorCyclicPointPatchField Declaration + Class nonConformalProcessorCyclicPointPatchField Declaration \*---------------------------------------------------------------------------*/ template<class Type> diff --git a/src/meshTools/nonConformal/pointPatches/nonConformalCyclic/nonConformalCyclicPointPatch.H b/src/meshTools/nonConformal/pointPatches/nonConformalCyclic/nonConformalCyclicPointPatch.H index 297f1f5faa..ed1335d24d 100644 --- a/src/meshTools/nonConformal/pointPatches/nonConformalCyclic/nonConformalCyclicPointPatch.H +++ b/src/meshTools/nonConformal/pointPatches/nonConformalCyclic/nonConformalCyclicPointPatch.H @@ -47,7 +47,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class nonConformalCyclicPointPatch Declaration + Class nonConformalCyclicPointPatch Declaration \*---------------------------------------------------------------------------*/ class nonConformalCyclicPointPatch diff --git a/src/meshTools/nonConformal/pointPatches/nonConformalError/nonConformalErrorPointPatch.H b/src/meshTools/nonConformal/pointPatches/nonConformalError/nonConformalErrorPointPatch.H index 0087e38b9a..de3d89905c 100644 --- a/src/meshTools/nonConformal/pointPatches/nonConformalError/nonConformalErrorPointPatch.H +++ b/src/meshTools/nonConformal/pointPatches/nonConformalError/nonConformalErrorPointPatch.H @@ -47,7 +47,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class nonConformalErrorPointPatch Declaration + Class nonConformalErrorPointPatch Declaration \*---------------------------------------------------------------------------*/ class nonConformalErrorPointPatch diff --git a/src/meshTools/nonConformal/polyPatches/nonConformal/nonConformalPolyPatch.H b/src/meshTools/nonConformal/polyPatches/nonConformal/nonConformalPolyPatch.H index 73382d869f..1af45b5ca5 100644 --- a/src/meshTools/nonConformal/polyPatches/nonConformal/nonConformalPolyPatch.H +++ b/src/meshTools/nonConformal/polyPatches/nonConformal/nonConformalPolyPatch.H @@ -46,7 +46,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class nonConformalPolyPatch Declaration + Class nonConformalPolyPatch Declaration \*---------------------------------------------------------------------------*/ class nonConformalPolyPatch diff --git a/src/meshTools/nonConformal/polyPatches/nonConformalCoupled/nonConformalCoupledPolyPatch.H b/src/meshTools/nonConformal/polyPatches/nonConformalCoupled/nonConformalCoupledPolyPatch.H index 13650b22af..ed4d26caf8 100644 --- a/src/meshTools/nonConformal/polyPatches/nonConformalCoupled/nonConformalCoupledPolyPatch.H +++ b/src/meshTools/nonConformal/polyPatches/nonConformalCoupled/nonConformalCoupledPolyPatch.H @@ -53,7 +53,7 @@ namespace Foam class nonConformalErrorPolyPatch; /*---------------------------------------------------------------------------*\ - Class nonConformalCoupledPolyPatch Declaration + Class nonConformalCoupledPolyPatch Declaration \*---------------------------------------------------------------------------*/ class nonConformalCoupledPolyPatch diff --git a/src/meshTools/nonConformal/polyPatches/nonConformalProcessorCyclic/nonConformalProcessorCyclicPolyPatch.H b/src/meshTools/nonConformal/polyPatches/nonConformalProcessorCyclic/nonConformalProcessorCyclicPolyPatch.H index f5d46efbc5..f51a184d7d 100644 --- a/src/meshTools/nonConformal/polyPatches/nonConformalProcessorCyclic/nonConformalProcessorCyclicPolyPatch.H +++ b/src/meshTools/nonConformal/polyPatches/nonConformalProcessorCyclic/nonConformalProcessorCyclicPolyPatch.H @@ -48,7 +48,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class nonConformalProcessorCyclicPolyPatch Declaration + Class nonConformalProcessorCyclicPolyPatch Declaration \*---------------------------------------------------------------------------*/ class nonConformalProcessorCyclicPolyPatch diff --git a/src/meshTools/nonConformalBoundary/nonConformalBoundary.H b/src/meshTools/nonConformalBoundary/nonConformalBoundary.H index 69dc323e0f..a6eb3bab33 100644 --- a/src/meshTools/nonConformalBoundary/nonConformalBoundary.H +++ b/src/meshTools/nonConformalBoundary/nonConformalBoundary.H @@ -48,7 +48,7 @@ namespace Foam class nonConformalCoupledPolyPatch; /*---------------------------------------------------------------------------*\ - Class nonConformalBoundary Declaration + Class nonConformalBoundary Declaration \*---------------------------------------------------------------------------*/ class nonConformalBoundary diff --git a/src/meshTools/patchDist/wallFace/wallFace.H b/src/meshTools/patchDist/wallFace/wallFace.H index e4473f274b..a218af6b30 100644 --- a/src/meshTools/patchDist/wallFace/wallFace.H +++ b/src/meshTools/patchDist/wallFace/wallFace.H @@ -58,7 +58,7 @@ template<class Derived> Istream& operator>>(Istream&, WallFaceBase<Derived>&); /*---------------------------------------------------------------------------*\ - Class WallFaceBase Declaration + Class WallFaceBase Declaration \*---------------------------------------------------------------------------*/ template<class Derived> diff --git a/src/meshTools/patchDist/wallPoint/wallPoint.H b/src/meshTools/patchDist/wallPoint/wallPoint.H index f2d7ec7325..53a2a96bf8 100644 --- a/src/meshTools/patchDist/wallPoint/wallPoint.H +++ b/src/meshTools/patchDist/wallPoint/wallPoint.H @@ -58,7 +58,7 @@ template<class Derived> Istream& operator>>(Istream&, WallPointBase<Derived>&); /*---------------------------------------------------------------------------*\ - Class WallPointBase Declaration + Class WallPointBase Declaration \*---------------------------------------------------------------------------*/ template<class Derived> diff --git a/src/meshTools/patchToPatch/intersection/intersectionPatchToPatch.H b/src/meshTools/patchToPatch/intersection/intersectionPatchToPatch.H index 5c61eb543f..06ebba84e5 100644 --- a/src/meshTools/patchToPatch/intersection/intersectionPatchToPatch.H +++ b/src/meshTools/patchToPatch/intersection/intersectionPatchToPatch.H @@ -50,7 +50,7 @@ namespace patchToPatches { /*---------------------------------------------------------------------------*\ - Class intersection Declaration + Class intersection Declaration \*---------------------------------------------------------------------------*/ class intersection diff --git a/src/meshTools/patchToPatch/inverseDistance/inverseDistancePatchToPatch.H b/src/meshTools/patchToPatch/inverseDistance/inverseDistancePatchToPatch.H index 5ce25a8483..784cf5bc18 100644 --- a/src/meshTools/patchToPatch/inverseDistance/inverseDistancePatchToPatch.H +++ b/src/meshTools/patchToPatch/inverseDistance/inverseDistancePatchToPatch.H @@ -48,7 +48,7 @@ namespace patchToPatches { /*---------------------------------------------------------------------------*\ - Class inverseDistance Declaration + Class inverseDistance Declaration \*---------------------------------------------------------------------------*/ class inverseDistance diff --git a/src/meshTools/patchToPatch/nearby/nearbyPatchToPatch.H b/src/meshTools/patchToPatch/nearby/nearbyPatchToPatch.H index 3c21c3d99f..2f47b958ef 100644 --- a/src/meshTools/patchToPatch/nearby/nearbyPatchToPatch.H +++ b/src/meshTools/patchToPatch/nearby/nearbyPatchToPatch.H @@ -46,7 +46,7 @@ namespace patchToPatches { /*---------------------------------------------------------------------------*\ - Class nearby Declaration + Class nearby Declaration \*---------------------------------------------------------------------------*/ class nearby diff --git a/src/meshTools/patchToPatch/nearest/nearestPatchToPatch.H b/src/meshTools/patchToPatch/nearest/nearestPatchToPatch.H index 67bdf7039d..a5ee6abe3f 100644 --- a/src/meshTools/patchToPatch/nearest/nearestPatchToPatch.H +++ b/src/meshTools/patchToPatch/nearest/nearestPatchToPatch.H @@ -46,7 +46,7 @@ namespace patchToPatches { /*---------------------------------------------------------------------------*\ - Class nearest Declaration + Class nearest Declaration \*---------------------------------------------------------------------------*/ class nearest diff --git a/src/meshTools/patchToPatch/rays/raysPatchToPatch.H b/src/meshTools/patchToPatch/rays/raysPatchToPatch.H index 5a01b18962..50170596d6 100644 --- a/src/meshTools/patchToPatch/rays/raysPatchToPatch.H +++ b/src/meshTools/patchToPatch/rays/raysPatchToPatch.H @@ -51,7 +51,7 @@ namespace patchToPatches { /*---------------------------------------------------------------------------*\ - Class rays Declaration + Class rays Declaration \*---------------------------------------------------------------------------*/ class rays diff --git a/src/meshTools/sets/cellSources/patchDistanceToCell/patchDistanceToCell.H b/src/meshTools/sets/cellSources/patchDistanceToCell/patchDistanceToCell.H index e7c8be4c21..8ab8bb0454 100644 --- a/src/meshTools/sets/cellSources/patchDistanceToCell/patchDistanceToCell.H +++ b/src/meshTools/sets/cellSources/patchDistanceToCell/patchDistanceToCell.H @@ -44,7 +44,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class patchDistanceToCell Declaration + Class patchDistanceToCell Declaration \*---------------------------------------------------------------------------*/ class patchDistanceToCell diff --git a/src/meshTools/sets/polyCellSet/polyCellSet.H b/src/meshTools/sets/polyCellSet/polyCellSet.H index b5fc52ebd1..912f41e699 100644 --- a/src/meshTools/sets/polyCellSet/polyCellSet.H +++ b/src/meshTools/sets/polyCellSet/polyCellSet.H @@ -77,7 +77,7 @@ class polyMeshMap; class polyDistributionMap; /*---------------------------------------------------------------------------*\ - Class polyCellSet Declaration + Class polyCellSet Declaration \*---------------------------------------------------------------------------*/ class polyCellSet diff --git a/src/multiphaseModels/multiphaseProperties/alphaContactAngle/alphaContactAngleFvPatchScalarField.H b/src/multiphaseModels/multiphaseProperties/alphaContactAngle/alphaContactAngleFvPatchScalarField.H index f9749c4766..e9c4815808 100644 --- a/src/multiphaseModels/multiphaseProperties/alphaContactAngle/alphaContactAngleFvPatchScalarField.H +++ b/src/multiphaseModels/multiphaseProperties/alphaContactAngle/alphaContactAngleFvPatchScalarField.H @@ -44,7 +44,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class alphaContactAngleFvPatchScalarField Declaration + Class alphaContactAngleFvPatchScalarField Declaration \*---------------------------------------------------------------------------*/ class alphaContactAngleFvPatchScalarField diff --git a/src/parallel/decompose/zoltanDecomp/zoltanDecomp.H b/src/parallel/decompose/zoltanDecomp/zoltanDecomp.H index ef2b5216bc..07a72d9360 100644 --- a/src/parallel/decompose/zoltanDecomp/zoltanDecomp.H +++ b/src/parallel/decompose/zoltanDecomp/zoltanDecomp.H @@ -87,7 +87,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class zoltanDecomp Declaration + Class zoltanDecomp Declaration \*---------------------------------------------------------------------------*/ class zoltanDecomp diff --git a/src/parallel/parallel/processorRunTimes.H b/src/parallel/parallel/processorRunTimes.H index 3ceff4f2b7..148ea2360e 100644 --- a/src/parallel/parallel/processorRunTimes.H +++ b/src/parallel/parallel/processorRunTimes.H @@ -43,7 +43,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class processorRunTimes Declaration + Class processorRunTimes Declaration \*---------------------------------------------------------------------------*/ class processorRunTimes diff --git a/src/physicalProperties/physicalProperties/physicalProperties.H b/src/physicalProperties/physicalProperties/physicalProperties.H index 5125804863..18d3c9fd6f 100644 --- a/src/physicalProperties/physicalProperties/physicalProperties.H +++ b/src/physicalProperties/physicalProperties/physicalProperties.H @@ -46,7 +46,7 @@ namespace Foam class fvMesh; /*---------------------------------------------------------------------------*\ - Class physicalProperties Declaration + Class physicalProperties Declaration \*---------------------------------------------------------------------------*/ class physicalProperties diff --git a/src/physicalProperties/viscosity/viscosity.H b/src/physicalProperties/viscosity/viscosity.H index 5399c91300..b0eef7eb6c 100644 --- a/src/physicalProperties/viscosity/viscosity.H +++ b/src/physicalProperties/viscosity/viscosity.H @@ -44,7 +44,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class viscosity Declaration + Class viscosity Declaration \*---------------------------------------------------------------------------*/ class viscosity diff --git a/src/rigidBodyDynamics/joints/rotating/rotating.H b/src/rigidBodyDynamics/joints/rotating/rotating.H index 6d64bcdd4f..97c3e032a9 100644 --- a/src/rigidBodyDynamics/joints/rotating/rotating.H +++ b/src/rigidBodyDynamics/joints/rotating/rotating.H @@ -56,7 +56,7 @@ namespace joints { /*---------------------------------------------------------------------------*\ - Class rotating Declaration + Class rotating Declaration \*---------------------------------------------------------------------------*/ class rotating diff --git a/src/sampling/sampledSet/sampledSet/sampledSetParticle.H b/src/sampling/sampledSet/sampledSet/sampledSetParticle.H index 966e1e2d53..aad9b6f89a 100644 --- a/src/sampling/sampledSet/sampledSet/sampledSetParticle.H +++ b/src/sampling/sampledSet/sampledSet/sampledSetParticle.H @@ -52,7 +52,7 @@ Ostream& operator<<(Ostream&, const sampledSetParticle&); /*---------------------------------------------------------------------------*\ - Class sampledSetParticle Declaration + Class sampledSetParticle Declaration \*---------------------------------------------------------------------------*/ class sampledSetParticle diff --git a/src/sampling/sampledSet/writers/gnuplot/gnuplotSetWriter.H b/src/sampling/sampledSet/writers/gnuplot/gnuplotSetWriter.H index b8e031085d..e516ac9da8 100644 --- a/src/sampling/sampledSet/writers/gnuplot/gnuplotSetWriter.H +++ b/src/sampling/sampledSet/writers/gnuplot/gnuplotSetWriter.H @@ -43,7 +43,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class gnuplotSetWriter Declaration + Class gnuplotSetWriter Declaration \*---------------------------------------------------------------------------*/ class gnuplotSetWriter diff --git a/src/sampling/sampledSet/writers/none/noSetWriter.H b/src/sampling/sampledSet/writers/none/noSetWriter.H index d59b1bbdf9..a895361b65 100644 --- a/src/sampling/sampledSet/writers/none/noSetWriter.H +++ b/src/sampling/sampledSet/writers/none/noSetWriter.H @@ -43,7 +43,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class noSetWriter Declaration + Class noSetWriter Declaration \*---------------------------------------------------------------------------*/ class noSetWriter diff --git a/src/sampling/sampledSet/writers/setWriter.H b/src/sampling/sampledSet/writers/setWriter.H index b5b4daf5c9..2f6e53245a 100644 --- a/src/sampling/sampledSet/writers/setWriter.H +++ b/src/sampling/sampledSet/writers/setWriter.H @@ -58,7 +58,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class setWriter Declaration + Class setWriter Declaration \*---------------------------------------------------------------------------*/ class setWriter diff --git a/src/sampling/sampledSurface/sampledCutPlane/sampledCutPlane.H b/src/sampling/sampledSurface/sampledCutPlane/sampledCutPlane.H index a67905463e..020806f04e 100644 --- a/src/sampling/sampledSurface/sampledCutPlane/sampledCutPlane.H +++ b/src/sampling/sampledSurface/sampledCutPlane/sampledCutPlane.H @@ -66,7 +66,7 @@ namespace sampledSurfaces { /*---------------------------------------------------------------------------*\ - Class cutPlane Declaration + Class cutPlane Declaration \*---------------------------------------------------------------------------*/ class cutPlane diff --git a/src/sampling/sampledSurface/sampledIsoSurfaceSurface/sampledIsoSurfaceSurface.H b/src/sampling/sampledSurface/sampledIsoSurfaceSurface/sampledIsoSurfaceSurface.H index 912fbe3196..f5be4aa685 100644 --- a/src/sampling/sampledSurface/sampledIsoSurfaceSurface/sampledIsoSurfaceSurface.H +++ b/src/sampling/sampledSurface/sampledIsoSurfaceSurface/sampledIsoSurfaceSurface.H @@ -46,7 +46,7 @@ namespace sampledSurfaces { /*---------------------------------------------------------------------------*\ - Class sampledIsoSurfaceSurface Declaration + Class sampledIsoSurfaceSurface Declaration \*---------------------------------------------------------------------------*/ class sampledIsoSurfaceSurface diff --git a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/restraints/axialAngularSpring/axialAngularSpring.H b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/restraints/axialAngularSpring/axialAngularSpring.H index 797ebf8eb5..9ff83bfff5 100644 --- a/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/restraints/axialAngularSpring/axialAngularSpring.H +++ b/src/sixDoFRigidBodyMotion/sixDoFRigidBodyMotion/restraints/axialAngularSpring/axialAngularSpring.H @@ -50,7 +50,7 @@ namespace sixDoFRigidBodyMotionRestraints { /*---------------------------------------------------------------------------*\ - Class axialAngularSpring Declaration + Class axialAngularSpring Declaration \*---------------------------------------------------------------------------*/ class axialAngularSpring diff --git a/src/surfaceFilmModels/fvModels/surfaceFilms/surfaceFilms.H b/src/surfaceFilmModels/fvModels/surfaceFilms/surfaceFilms.H index fa813afd1b..063ea5fb90 100644 --- a/src/surfaceFilmModels/fvModels/surfaceFilms/surfaceFilms.H +++ b/src/surfaceFilmModels/fvModels/surfaceFilms/surfaceFilms.H @@ -56,7 +56,7 @@ namespace fv { /*---------------------------------------------------------------------------*\ - Class surfaceFilms Declaration + Class surfaceFilms Declaration \*---------------------------------------------------------------------------*/ class surfaceFilms diff --git a/src/surfaceFilmModels/momentumSurfaceFilm/momentumSurfaceFilm.H b/src/surfaceFilmModels/momentumSurfaceFilm/momentumSurfaceFilm.H index 3e01e91e7d..5bbfbcff97 100644 --- a/src/surfaceFilmModels/momentumSurfaceFilm/momentumSurfaceFilm.H +++ b/src/surfaceFilmModels/momentumSurfaceFilm/momentumSurfaceFilm.H @@ -56,7 +56,7 @@ namespace surfaceFilmModels } /*---------------------------------------------------------------------------*\ - Class momentumSurfaceFilm Declaration + Class momentumSurfaceFilm Declaration \*---------------------------------------------------------------------------*/ class momentumSurfaceFilm diff --git a/src/surfaceFilmModels/submodels/momentum/ejectionModel/ejectionModel/ejectionModel.H b/src/surfaceFilmModels/submodels/momentum/ejectionModel/ejectionModel/ejectionModel.H index 631b67629a..445138cb2a 100644 --- a/src/surfaceFilmModels/submodels/momentum/ejectionModel/ejectionModel/ejectionModel.H +++ b/src/surfaceFilmModels/submodels/momentum/ejectionModel/ejectionModel/ejectionModel.H @@ -49,7 +49,7 @@ namespace surfaceFilmModels { /*---------------------------------------------------------------------------*\ - Class ejectionModel Declaration + Class ejectionModel Declaration \*---------------------------------------------------------------------------*/ class ejectionModel diff --git a/src/surfaceFilmModels/submodels/momentum/ejectionModel/ejectionModelList/ejectionModelList.H b/src/surfaceFilmModels/submodels/momentum/ejectionModel/ejectionModelList/ejectionModelList.H index 3de62b01af..27e3e70f9b 100644 --- a/src/surfaceFilmModels/submodels/momentum/ejectionModel/ejectionModelList/ejectionModelList.H +++ b/src/surfaceFilmModels/submodels/momentum/ejectionModel/ejectionModelList/ejectionModelList.H @@ -47,7 +47,7 @@ namespace surfaceFilmModels { /*---------------------------------------------------------------------------*\ - Class ejectionModelList Declaration + Class ejectionModelList Declaration \*---------------------------------------------------------------------------*/ class ejectionModelList diff --git a/src/surfaceFilmModels/submodels/momentum/ejectionModel/patchEjection/patchEjection.H b/src/surfaceFilmModels/submodels/momentum/ejectionModel/patchEjection/patchEjection.H index 10f650e615..31ffba69fb 100644 --- a/src/surfaceFilmModels/submodels/momentum/ejectionModel/patchEjection/patchEjection.H +++ b/src/surfaceFilmModels/submodels/momentum/ejectionModel/patchEjection/patchEjection.H @@ -46,7 +46,7 @@ namespace surfaceFilmModels { /*---------------------------------------------------------------------------*\ - Class patchEjection Declaration + Class patchEjection Declaration \*---------------------------------------------------------------------------*/ class patchEjection diff --git a/src/surfaceFilmModels/submodels/momentum/filmMomentumTransportModel/filmMomentumTransportModel/filmMomentumTransportModel.H b/src/surfaceFilmModels/submodels/momentum/filmMomentumTransportModel/filmMomentumTransportModel/filmMomentumTransportModel.H index 7bc0b3ec52..3c79ffd57f 100644 --- a/src/surfaceFilmModels/submodels/momentum/filmMomentumTransportModel/filmMomentumTransportModel/filmMomentumTransportModel.H +++ b/src/surfaceFilmModels/submodels/momentum/filmMomentumTransportModel/filmMomentumTransportModel/filmMomentumTransportModel.H @@ -49,7 +49,7 @@ namespace surfaceFilmModels { /*---------------------------------------------------------------------------*\ - Class momentumTransportModel Declaration + Class momentumTransportModel Declaration \*---------------------------------------------------------------------------*/ class momentumTransportModel diff --git a/src/surfaceFilmModels/submodels/momentum/filmViscosityModel/Newtonian/NewtonianViscosity.H b/src/surfaceFilmModels/submodels/momentum/filmViscosityModel/Newtonian/NewtonianViscosity.H index 7d242c7a65..5844f9c087 100644 --- a/src/surfaceFilmModels/submodels/momentum/filmViscosityModel/Newtonian/NewtonianViscosity.H +++ b/src/surfaceFilmModels/submodels/momentum/filmViscosityModel/Newtonian/NewtonianViscosity.H @@ -46,7 +46,7 @@ namespace surfaceFilmModels { /*---------------------------------------------------------------------------*\ - Class NewtonianViscosity Declaration + Class NewtonianViscosity Declaration \*---------------------------------------------------------------------------*/ class NewtonianViscosity diff --git a/src/surfaceFilmModels/submodels/momentum/filmViscosityModel/filmViscosityModel/filmViscosityModel.H b/src/surfaceFilmModels/submodels/momentum/filmViscosityModel/filmViscosityModel/filmViscosityModel.H index fddfc03ac4..ce88a7337d 100644 --- a/src/surfaceFilmModels/submodels/momentum/filmViscosityModel/filmViscosityModel/filmViscosityModel.H +++ b/src/surfaceFilmModels/submodels/momentum/filmViscosityModel/filmViscosityModel/filmViscosityModel.H @@ -48,7 +48,7 @@ namespace surfaceFilmModels { /*---------------------------------------------------------------------------*\ - Class viscosityModel Declaration + Class viscosityModel Declaration \*---------------------------------------------------------------------------*/ class viscosityModel diff --git a/src/surfaceFilmModels/submodels/thermo/filmRadiationModel/filmRadiationModel/filmRadiationModel.H b/src/surfaceFilmModels/submodels/thermo/filmRadiationModel/filmRadiationModel/filmRadiationModel.H index c1ea02c34c..b8d0f1db62 100644 --- a/src/surfaceFilmModels/submodels/thermo/filmRadiationModel/filmRadiationModel/filmRadiationModel.H +++ b/src/surfaceFilmModels/submodels/thermo/filmRadiationModel/filmRadiationModel/filmRadiationModel.H @@ -47,7 +47,7 @@ namespace surfaceFilmModels { /*---------------------------------------------------------------------------*\ - Class radiationModel Declaration + Class radiationModel Declaration \*---------------------------------------------------------------------------*/ class radiationModel diff --git a/src/surfaceFilmModels/submodels/thermo/phaseChangeModel/speciePhaseChange/speciePhaseChange.H b/src/surfaceFilmModels/submodels/thermo/phaseChangeModel/speciePhaseChange/speciePhaseChange.H index b7ba877384..3b0cbbbae3 100644 --- a/src/surfaceFilmModels/submodels/thermo/phaseChangeModel/speciePhaseChange/speciePhaseChange.H +++ b/src/surfaceFilmModels/submodels/thermo/phaseChangeModel/speciePhaseChange/speciePhaseChange.H @@ -46,7 +46,7 @@ namespace surfaceFilmModels { /*---------------------------------------------------------------------------*\ - Class speciePhaseChange Declaration + Class speciePhaseChange Declaration \*---------------------------------------------------------------------------*/ class speciePhaseChange diff --git a/src/surfaceFilmModels/surfaceFilm/surfaceFilm.H b/src/surfaceFilmModels/surfaceFilm/surfaceFilm.H index 05f3580102..14a1ab31df 100644 --- a/src/surfaceFilmModels/surfaceFilm/surfaceFilm.H +++ b/src/surfaceFilmModels/surfaceFilm/surfaceFilm.H @@ -44,7 +44,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class surfaceFilm Declaration + Class surfaceFilm Declaration \*---------------------------------------------------------------------------*/ class surfaceFilm diff --git a/src/thermophysicalModels/chemistryModel/chemistryModel/chemistryModel.H b/src/thermophysicalModels/chemistryModel/chemistryModel/chemistryModel.H index 64ba05acde..b5790dcc29 100644 --- a/src/thermophysicalModels/chemistryModel/chemistryModel/chemistryModel.H +++ b/src/thermophysicalModels/chemistryModel/chemistryModel/chemistryModel.H @@ -81,7 +81,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class chemistryModel Declaration + Class chemistryModel Declaration \*---------------------------------------------------------------------------*/ template<class ThermoType> diff --git a/src/thermophysicalModels/chemistryModel/chemistryModel/reduction/DRGEP/DRGEP.H b/src/thermophysicalModels/chemistryModel/chemistryModel/reduction/DRGEP/DRGEP.H index 1bafddd53f..4c81f4620e 100644 --- a/src/thermophysicalModels/chemistryModel/chemistryModel/reduction/DRGEP/DRGEP.H +++ b/src/thermophysicalModels/chemistryModel/chemistryModel/reduction/DRGEP/DRGEP.H @@ -113,7 +113,7 @@ namespace chemistryReductionMethods { /*---------------------------------------------------------------------------*\ - Class DRGEP Declaration + Class DRGEP Declaration \*---------------------------------------------------------------------------*/ template<class ThermoType> diff --git a/src/thermophysicalModels/chemistryModel/chemistryModel/reduction/chemistryReductionMethod/chemistryReductionMethod.H b/src/thermophysicalModels/chemistryModel/chemistryModel/reduction/chemistryReductionMethod/chemistryReductionMethod.H index 7f321aedc1..fbffe156bb 100644 --- a/src/thermophysicalModels/chemistryModel/chemistryModel/reduction/chemistryReductionMethod/chemistryReductionMethod.H +++ b/src/thermophysicalModels/chemistryModel/chemistryModel/reduction/chemistryReductionMethod/chemistryReductionMethod.H @@ -53,7 +53,7 @@ template<class ThermoType> class chemistryModel; /*---------------------------------------------------------------------------*\ - Class chemistryReductionMethod Declaration + Class chemistryReductionMethod Declaration \*---------------------------------------------------------------------------*/ template<class ThermoType> diff --git a/src/thermophysicalModels/chemistryModel/chemistryModel/tabulation/ISAT/binaryTree/binaryTree.H b/src/thermophysicalModels/chemistryModel/chemistryModel/tabulation/ISAT/binaryTree/binaryTree.H index 5bbb76a800..0214ffb949 100644 --- a/src/thermophysicalModels/chemistryModel/chemistryModel/tabulation/ISAT/binaryTree/binaryTree.H +++ b/src/thermophysicalModels/chemistryModel/chemistryModel/tabulation/ISAT/binaryTree/binaryTree.H @@ -52,7 +52,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class binaryTree Declaration + Class binaryTree Declaration \*---------------------------------------------------------------------------*/ class binaryTree diff --git a/src/thermophysicalModels/chemistryModel/odeChemistryModel/odeChemistryModel.H b/src/thermophysicalModels/chemistryModel/odeChemistryModel/odeChemistryModel.H index e52c3342b2..c558ace6e2 100644 --- a/src/thermophysicalModels/chemistryModel/odeChemistryModel/odeChemistryModel.H +++ b/src/thermophysicalModels/chemistryModel/odeChemistryModel/odeChemistryModel.H @@ -54,7 +54,7 @@ class chemistryReductionMethod; /*---------------------------------------------------------------------------*\ - Class odeChemistryModel Declaration + Class odeChemistryModel Declaration \*---------------------------------------------------------------------------*/ class odeChemistryModel diff --git a/src/thermophysicalModels/multicomponentThermo/fluidMulticomponentThermo/fluidMulticomponentThermo.H b/src/thermophysicalModels/multicomponentThermo/fluidMulticomponentThermo/fluidMulticomponentThermo.H index bb81cf96ef..97f92989bc 100644 --- a/src/thermophysicalModels/multicomponentThermo/fluidMulticomponentThermo/fluidMulticomponentThermo.H +++ b/src/thermophysicalModels/multicomponentThermo/fluidMulticomponentThermo/fluidMulticomponentThermo.H @@ -47,7 +47,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class fluidMulticomponentThermo Declaration + Class fluidMulticomponentThermo Declaration \*---------------------------------------------------------------------------*/ class fluidMulticomponentThermo @@ -102,7 +102,7 @@ public: /*---------------------------------------------------------------------------*\ - Class fluidMulticomponentThermo Declaration + Class fluidMulticomponentThermo Declaration \*---------------------------------------------------------------------------*/ class fluidMulticomponentThermo::implementation diff --git a/src/thermophysicalModels/multicomponentThermo/psiMulticomponentThermo/psiMulticomponentThermo.H b/src/thermophysicalModels/multicomponentThermo/psiMulticomponentThermo/psiMulticomponentThermo.H index 88dabee0c6..43f82e33e6 100644 --- a/src/thermophysicalModels/multicomponentThermo/psiMulticomponentThermo/psiMulticomponentThermo.H +++ b/src/thermophysicalModels/multicomponentThermo/psiMulticomponentThermo/psiMulticomponentThermo.H @@ -48,7 +48,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class psiMulticomponentThermo Declaration + Class psiMulticomponentThermo Declaration \*---------------------------------------------------------------------------*/ class psiMulticomponentThermo @@ -98,7 +98,7 @@ public: /*---------------------------------------------------------------------------*\ - Class psiMulticomponentThermo::implementation Declaration + Class psiMulticomponentThermo::implementation Declaration \*---------------------------------------------------------------------------*/ class psiMulticomponentThermo::implementation @@ -119,7 +119,7 @@ public: /*---------------------------------------------------------------------------*\ - Class psiMulticomponentThermo::composite Declaration + Class psiMulticomponentThermo::composite Declaration \*---------------------------------------------------------------------------*/ class psiMulticomponentThermo::composite diff --git a/src/thermophysicalModels/multicomponentThermo/psiuMulticomponentThermo/psiuMulticomponentThermo.H b/src/thermophysicalModels/multicomponentThermo/psiuMulticomponentThermo/psiuMulticomponentThermo.H index 4e494b5d29..a98236034d 100644 --- a/src/thermophysicalModels/multicomponentThermo/psiuMulticomponentThermo/psiuMulticomponentThermo.H +++ b/src/thermophysicalModels/multicomponentThermo/psiuMulticomponentThermo/psiuMulticomponentThermo.H @@ -48,7 +48,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class psiuMulticomponentThermo Declaration + Class psiuMulticomponentThermo Declaration \*---------------------------------------------------------------------------*/ class psiuMulticomponentThermo @@ -179,7 +179,7 @@ public: /*---------------------------------------------------------------------------*\ - Class psiuMulticomponentThermo::implementation Declaration + Class psiuMulticomponentThermo::implementation Declaration \*---------------------------------------------------------------------------*/ class psiuMulticomponentThermo::implementation @@ -200,7 +200,7 @@ public: /*---------------------------------------------------------------------------*\ - Class psiuMulticomponentThermo::composite Declaration + Class psiuMulticomponentThermo::composite Declaration \*---------------------------------------------------------------------------*/ class psiuMulticomponentThermo::composite diff --git a/src/thermophysicalModels/multicomponentThermo/rhoMulticomponentThermo/rhoMulticomponentThermo.H b/src/thermophysicalModels/multicomponentThermo/rhoMulticomponentThermo/rhoMulticomponentThermo.H index f43b8c00aa..ba3d144386 100644 --- a/src/thermophysicalModels/multicomponentThermo/rhoMulticomponentThermo/rhoMulticomponentThermo.H +++ b/src/thermophysicalModels/multicomponentThermo/rhoMulticomponentThermo/rhoMulticomponentThermo.H @@ -48,7 +48,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class rhoMulticomponentThermo Declaration + Class rhoMulticomponentThermo Declaration \*---------------------------------------------------------------------------*/ class rhoMulticomponentThermo @@ -98,7 +98,7 @@ public: /*---------------------------------------------------------------------------*\ - Class rhoMulticomponentThermo::implementation Declaration + Class rhoMulticomponentThermo::implementation Declaration \*---------------------------------------------------------------------------*/ class rhoMulticomponentThermo::implementation @@ -120,7 +120,7 @@ public: /*---------------------------------------------------------------------------*\ - Class rhoMulticomponentThermo::composite Declaration + Class rhoMulticomponentThermo::composite Declaration \*---------------------------------------------------------------------------*/ class rhoMulticomponentThermo::composite diff --git a/src/thermophysicalModels/saturationModels/constantPressure/constantPressure.H b/src/thermophysicalModels/saturationModels/constantPressure/constantPressure.H index a8dbf9dc79..4e7526d9d7 100644 --- a/src/thermophysicalModels/saturationModels/constantPressure/constantPressure.H +++ b/src/thermophysicalModels/saturationModels/constantPressure/constantPressure.H @@ -45,7 +45,7 @@ namespace saturationModels { /*---------------------------------------------------------------------------*\ - Class constantPressure Declaration + Class constantPressure Declaration \*---------------------------------------------------------------------------*/ class constantPressure diff --git a/src/thermophysicalModels/saturationModels/constantTemperature/constantTemperature.H b/src/thermophysicalModels/saturationModels/constantTemperature/constantTemperature.H index 18c70ea5e4..a0736a51b9 100644 --- a/src/thermophysicalModels/saturationModels/constantTemperature/constantTemperature.H +++ b/src/thermophysicalModels/saturationModels/constantTemperature/constantTemperature.H @@ -45,7 +45,7 @@ namespace saturationModels { /*---------------------------------------------------------------------------*\ - Class constantTemperature Declaration + Class constantTemperature Declaration \*---------------------------------------------------------------------------*/ class constantTemperature diff --git a/src/thermophysicalModels/saturationModels/function1Temperature/function1Temperature.H b/src/thermophysicalModels/saturationModels/function1Temperature/function1Temperature.H index b19dbaa5d8..6ea0c0c2a0 100644 --- a/src/thermophysicalModels/saturationModels/function1Temperature/function1Temperature.H +++ b/src/thermophysicalModels/saturationModels/function1Temperature/function1Temperature.H @@ -83,7 +83,7 @@ namespace saturationModels { /*---------------------------------------------------------------------------*\ - Class function1Temperature Declaration + Class function1Temperature Declaration \*---------------------------------------------------------------------------*/ class function1Temperature diff --git a/src/thermophysicalModels/saturationModels/polynomialTemperature/polynomialTemperature.H b/src/thermophysicalModels/saturationModels/polynomialTemperature/polynomialTemperature.H index 9f985f76cc..46ea046957 100644 --- a/src/thermophysicalModels/saturationModels/polynomialTemperature/polynomialTemperature.H +++ b/src/thermophysicalModels/saturationModels/polynomialTemperature/polynomialTemperature.H @@ -53,7 +53,7 @@ namespace saturationModels { /*---------------------------------------------------------------------------*\ - Class polynomialTemperature Declaration + Class polynomialTemperature Declaration \*---------------------------------------------------------------------------*/ class polynomialTemperature diff --git a/src/thermophysicalModels/saturationModels/saturationPressureModel/saturationPressureModel.H b/src/thermophysicalModels/saturationModels/saturationPressureModel/saturationPressureModel.H index e38523e890..2f1c4d8f78 100644 --- a/src/thermophysicalModels/saturationModels/saturationPressureModel/saturationPressureModel.H +++ b/src/thermophysicalModels/saturationModels/saturationPressureModel/saturationPressureModel.H @@ -79,7 +79,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class saturationPressureModel Declaration + Class saturationPressureModel Declaration \*---------------------------------------------------------------------------*/ class saturationPressureModel diff --git a/src/thermophysicalModels/saturationModels/saturationTemperatureModel/saturationTemperatureModel.H b/src/thermophysicalModels/saturationModels/saturationTemperatureModel/saturationTemperatureModel.H index e3a6c5831c..fcde4e2a14 100644 --- a/src/thermophysicalModels/saturationModels/saturationTemperatureModel/saturationTemperatureModel.H +++ b/src/thermophysicalModels/saturationModels/saturationTemperatureModel/saturationTemperatureModel.H @@ -63,7 +63,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class saturationTemperatureModel Declaration + Class saturationTemperatureModel Declaration \*---------------------------------------------------------------------------*/ class saturationTemperatureModel diff --git a/src/thermophysicalModels/solidThermo/constAnisoSolidThermo/constAnisoSolidThermo.H b/src/thermophysicalModels/solidThermo/constAnisoSolidThermo/constAnisoSolidThermo.H index 4ee025e0e8..e650176ab6 100644 --- a/src/thermophysicalModels/solidThermo/constAnisoSolidThermo/constAnisoSolidThermo.H +++ b/src/thermophysicalModels/solidThermo/constAnisoSolidThermo/constAnisoSolidThermo.H @@ -125,7 +125,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class constAnisoSolidThermo Declaration + Class constAnisoSolidThermo Declaration \*---------------------------------------------------------------------------*/ class constAnisoSolidThermo diff --git a/src/thermophysicalModels/solidThermo/constSolidThermo/constSolidThermo.H b/src/thermophysicalModels/solidThermo/constSolidThermo/constSolidThermo.H index d8c2445229..eba9ef9d4b 100644 --- a/src/thermophysicalModels/solidThermo/constSolidThermo/constSolidThermo.H +++ b/src/thermophysicalModels/solidThermo/constSolidThermo/constSolidThermo.H @@ -123,7 +123,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class constSolidThermo Declaration + Class constSolidThermo Declaration \*---------------------------------------------------------------------------*/ class constSolidThermo diff --git a/src/thermophysicalModels/solidThermo/solidSpecie/transport/tabulated/tabulatedSolidTransport.H b/src/thermophysicalModels/solidThermo/solidSpecie/transport/tabulated/tabulatedSolidTransport.H index 2086d48fde..69fb9dbbdd 100644 --- a/src/thermophysicalModels/solidThermo/solidSpecie/transport/tabulated/tabulatedSolidTransport.H +++ b/src/thermophysicalModels/solidThermo/solidSpecie/transport/tabulated/tabulatedSolidTransport.H @@ -84,7 +84,7 @@ Ostream& operator<< /*---------------------------------------------------------------------------*\ - Class tabulatedSolidTransport Declaration + Class tabulatedSolidTransport Declaration \*---------------------------------------------------------------------------*/ template<class Thermo> diff --git a/src/thermophysicalModels/specie/reaction/specieExponent/specieExponent.H b/src/thermophysicalModels/specie/reaction/specieExponent/specieExponent.H index 64b64a1023..6a29b7f2d1 100644 --- a/src/thermophysicalModels/specie/reaction/specieExponent/specieExponent.H +++ b/src/thermophysicalModels/specie/reaction/specieExponent/specieExponent.H @@ -56,7 +56,7 @@ Ostream& operator<<(Ostream&, const specieExponent&); /*---------------------------------------------------------------------------*\ - Class specieExponent Declaration + Class specieExponent Declaration \*---------------------------------------------------------------------------*/ class specieExponent diff --git a/src/thermophysicalModels/specie/thermo/eIcoTabulated/eIcoTabulatedThermo.H b/src/thermophysicalModels/specie/thermo/eIcoTabulated/eIcoTabulatedThermo.H index b756d2f242..304995cb34 100644 --- a/src/thermophysicalModels/specie/thermo/eIcoTabulated/eIcoTabulatedThermo.H +++ b/src/thermophysicalModels/specie/thermo/eIcoTabulated/eIcoTabulatedThermo.H @@ -87,7 +87,7 @@ Ostream& operator<< /*---------------------------------------------------------------------------*\ - Class eIcoTabulatedThermo Declaration + Class eIcoTabulatedThermo Declaration \*---------------------------------------------------------------------------*/ template<class EquationOfState> diff --git a/src/thermophysicalModels/specie/thermo/hIcoTabulated/hIcoTabulatedThermo.H b/src/thermophysicalModels/specie/thermo/hIcoTabulated/hIcoTabulatedThermo.H index 6fea844d32..61f9338ff7 100644 --- a/src/thermophysicalModels/specie/thermo/hIcoTabulated/hIcoTabulatedThermo.H +++ b/src/thermophysicalModels/specie/thermo/hIcoTabulated/hIcoTabulatedThermo.H @@ -88,7 +88,7 @@ Ostream& operator<< /*---------------------------------------------------------------------------*\ - Class hIcoTabulatedThermo Declaration + Class hIcoTabulatedThermo Declaration \*---------------------------------------------------------------------------*/ template<class EquationOfState> diff --git a/src/thermophysicalModels/specie/transport/Andrade/AndradeTransport.H b/src/thermophysicalModels/specie/transport/Andrade/AndradeTransport.H index 879f904ede..e1406d4b2e 100644 --- a/src/thermophysicalModels/specie/transport/Andrade/AndradeTransport.H +++ b/src/thermophysicalModels/specie/transport/Andrade/AndradeTransport.H @@ -109,7 +109,7 @@ Ostream& operator<< /*---------------------------------------------------------------------------*\ - Class AndradeTransport Declaration + Class AndradeTransport Declaration \*---------------------------------------------------------------------------*/ template<class Thermo> diff --git a/src/thermophysicalModels/specie/transport/icoTabulated/icoTabulatedTransport.H b/src/thermophysicalModels/specie/transport/icoTabulated/icoTabulatedTransport.H index a808292d6b..7520b13370 100644 --- a/src/thermophysicalModels/specie/transport/icoTabulated/icoTabulatedTransport.H +++ b/src/thermophysicalModels/specie/transport/icoTabulated/icoTabulatedTransport.H @@ -89,7 +89,7 @@ Ostream& operator<<(Ostream&, const icoTabulatedTransport<Thermo>&); /*---------------------------------------------------------------------------*\ - Class icoTabulatedTransport Declaration + Class icoTabulatedTransport Declaration \*---------------------------------------------------------------------------*/ template<class Thermo> diff --git a/src/twoPhaseModels/incompressibleTwoPhases/incompressibleTwoPhases.H b/src/twoPhaseModels/incompressibleTwoPhases/incompressibleTwoPhases.H index ad00e3381b..c79889d6e9 100644 --- a/src/twoPhaseModels/incompressibleTwoPhases/incompressibleTwoPhases.H +++ b/src/twoPhaseModels/incompressibleTwoPhases/incompressibleTwoPhases.H @@ -43,7 +43,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class incompressibleTwoPhases Declaration + Class incompressibleTwoPhases Declaration \*---------------------------------------------------------------------------*/ class incompressibleTwoPhases diff --git a/src/twoPhaseModels/interfaceCompression/noInterfaceCompression/noInterfaceCompression.H b/src/twoPhaseModels/interfaceCompression/noInterfaceCompression/noInterfaceCompression.H index 92bdaf7eef..ebacef07db 100644 --- a/src/twoPhaseModels/interfaceCompression/noInterfaceCompression/noInterfaceCompression.H +++ b/src/twoPhaseModels/interfaceCompression/noInterfaceCompression/noInterfaceCompression.H @@ -61,7 +61,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class noInterfaceCompression Declaration + Class noInterfaceCompression Declaration \*---------------------------------------------------------------------------*/ class noInterfaceCompressionNew diff --git a/src/twoPhaseModels/twoPhaseMixture/twoPhases.H b/src/twoPhaseModels/twoPhaseMixture/twoPhases.H index a1b16add33..316dd50ed3 100644 --- a/src/twoPhaseModels/twoPhaseMixture/twoPhases.H +++ b/src/twoPhaseModels/twoPhaseMixture/twoPhases.H @@ -43,7 +43,7 @@ namespace Foam { /*---------------------------------------------------------------------------*\ - Class twoPhases Declaration + Class twoPhases Declaration \*---------------------------------------------------------------------------*/ class twoPhases diff --git a/src/waves/fvModels/waveForcing/waveForcing.H b/src/waves/fvModels/waveForcing/waveForcing.H index 5b01a595e3..7351060299 100644 --- a/src/waves/fvModels/waveForcing/waveForcing.H +++ b/src/waves/fvModels/waveForcing/waveForcing.H @@ -88,7 +88,7 @@ namespace fv { /*---------------------------------------------------------------------------*\ - Class waveForcing Declaration + Class waveForcing Declaration \*---------------------------------------------------------------------------*/ class waveForcing |
|
resolved by commit 00ca8905a058713ff899015fd2548ea2d3b24539 |
Date Modified | Username | Field | Change |
---|---|---|---|
2023-01-24 12:19 | tniemi | New Issue | |
2023-01-24 12:19 | tniemi | File Added: typos.diff | |
2023-01-24 12:19 | tniemi | File Added: declarations.diff | |
2023-01-24 12:19 | tniemi | File Added: fullDiff.diff | |
2023-01-24 18:28 | henry | Assigned To | => henry |
2023-01-24 18:28 | henry | Status | new => resolved |
2023-01-24 18:28 | henry | Resolution | open => fixed |
2023-01-24 18:28 | henry | Fixed in Version | => dev |
2023-01-24 18:28 | henry | Note Added: 0012936 |