diff --git a/applications/solvers/modules/isothermalFluid/correctBuoyantPressure.C b/applications/solvers/modules/isothermalFluid/correctBuoyantPressure.C index 207dafee8f..4919593c4d 100644 --- a/applications/solvers/modules/isothermalFluid/correctBuoyantPressure.C +++ b/applications/solvers/modules/isothermalFluid/correctBuoyantPressure.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2022 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2022-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -39,7 +39,7 @@ License void Foam::solvers::isothermalFluid::correctBuoyantPressure() { - // Local references to the buoyancy paramaters + // Local references to the buoyancy parameters const volScalarField& gh = buoyancy->gh; const surfaceScalarField& ghf = buoyancy->ghf; const uniformDimensionedScalarField pRef = buoyancy->pRef; diff --git a/applications/solvers/modules/multiphaseEuler/multiphaseThermophysicalTransportModels/derivedFvPatchFields/alphatWallBoilingWallFunction/alphatWallBoilingWallFunctionFvPatchScalarField.C b/applications/solvers/modules/multiphaseEuler/multiphaseThermophysicalTransportModels/derivedFvPatchFields/alphatWallBoilingWallFunction/alphatWallBoilingWallFunctionFvPatchScalarField.C index 9886712f55..aeb380ee89 100644 --- a/applications/solvers/modules/multiphaseEuler/multiphaseThermophysicalTransportModels/derivedFvPatchFields/alphatWallBoilingWallFunction/alphatWallBoilingWallFunctionFvPatchScalarField.C +++ b/applications/solvers/modules/multiphaseEuler/multiphaseThermophysicalTransportModels/derivedFvPatchFields/alphatWallBoilingWallFunction/alphatWallBoilingWallFunctionFvPatchScalarField.C @@ -133,7 +133,7 @@ struct alphatWallBoilingWallFunctionFvPatchScalarField::properties {} - // Member Fuctions + // Member Functions //- Patch inline const fvPatch& patch() const diff --git a/applications/utilities/mesh/conversion/gmshToFoam/gmsh/mesh-1.geo b/applications/utilities/mesh/conversion/gmshToFoam/gmsh/mesh-1.geo index 4248c9b9d9..54545ad73d 100644 --- a/applications/utilities/mesh/conversion/gmshToFoam/gmsh/mesh-1.geo +++ b/applications/utilities/mesh/conversion/gmshToFoam/gmsh/mesh-1.geo @@ -1,4 +1,4 @@ -// Parametres geometriques +// Parameters geometriques r1 = 200*Cos(Pi/4)/1000; r2 = 200*Cos(Pi/4)/1000; @@ -7,7 +7,7 @@ h2 = 360/1000; h3 = 900/1000; h4 = 1900/1000; -// Parametres de maillage +// Parameters de maillage // selon le rayon rCells = 10/2; rRatio = 0.85; // selon S1 diff --git a/applications/utilities/postProcessing/graphics/ensightFoamReader/USERD_set_filenames.H b/applications/utilities/postProcessing/graphics/ensightFoamReader/USERD_set_filenames.H index f70f20ab44..cbc15d66f5 100644 --- a/applications/utilities/postProcessing/graphics/ensightFoamReader/USERD_set_filenames.H +++ b/applications/utilities/postProcessing/graphics/ensightFoamReader/USERD_set_filenames.H @@ -38,7 +38,7 @@ int USERD_set_filenames rootDir = the_path; - // the path is pre-pended to filename_1 + // the path is prepended to filename_1 // 1 is the 'Geometry' : 2 the 'Result' which is null here // since two_field is FALSE for (label i=0; i Foam::globalMeshData::mergePoints // Send back pointSlavesMap.reverseDistribute(cpp.nPoints(), masterToGlobal); - // On slave copy master index into overal map. + // On slave copy master index into overall map. forAll(pointSlaves, pointi) { label meshPointi = cpp.meshPoints()[pointi]; diff --git a/src/OpenFOAM/meshes/polyMesh/polyMesh.H b/src/OpenFOAM/meshes/polyMesh/polyMesh.H index 9152d86637..2ccc91dcd6 100644 --- a/src/OpenFOAM/meshes/polyMesh/polyMesh.H +++ b/src/OpenFOAM/meshes/polyMesh/polyMesh.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2022 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -410,7 +410,7 @@ public: fileName meshDir() const; //- Return the current instance directory for points - // Used in the construction of gemometric mesh data dependent + // Used in the construction of geometric mesh data dependent // on points const fileName& pointsInstance() const; diff --git a/src/OpenFOAM/meshes/primitiveMesh/primitiveMeshCheck/primitiveMeshTools.H b/src/OpenFOAM/meshes/primitiveMesh/primitiveMeshCheck/primitiveMeshTools.H index 76ef328596..45e478c99f 100644 --- a/src/OpenFOAM/meshes/primitiveMesh/primitiveMeshCheck/primitiveMeshTools.H +++ b/src/OpenFOAM/meshes/primitiveMesh/primitiveMeshCheck/primitiveMeshTools.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2012-2020 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2012-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -78,7 +78,7 @@ public: const vectorField& cellCtrs ); - //- Generate cell openness and cell ascpect ratio field + //- Generate cell openness and cell aspect ratio field static void cellClosedness ( const primitiveMesh& mesh, diff --git a/src/ThermophysicalTransportModels/fluid/derivedFvPatchFields/externalCoupledTemperatureMixed/externalCoupledTemperatureMixedFvPatchScalarField.H b/src/ThermophysicalTransportModels/fluid/derivedFvPatchFields/externalCoupledTemperatureMixed/externalCoupledTemperatureMixedFvPatchScalarField.H index d3036ac73a..f527308a5e 100644 --- a/src/ThermophysicalTransportModels/fluid/derivedFvPatchFields/externalCoupledTemperatureMixed/externalCoupledTemperatureMixedFvPatchScalarField.H +++ b/src/ThermophysicalTransportModels/fluid/derivedFvPatchFields/externalCoupledTemperatureMixed/externalCoupledTemperatureMixedFvPatchScalarField.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2013-2022 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2013-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -38,7 +38,7 @@ Description \endverbatim - and received as the constitutent pieces of the `mixed' condition, i.e. + and received as the constituent pieces of the `mixed' condition, i.e. \verbatim # Patch: diff --git a/src/dynamicMesh/motionSolvers/displacement/solidBody/solidBodyMotionFunctions/SDA/SDA.C b/src/dynamicMesh/motionSolvers/displacement/solidBody/solidBodyMotionFunctions/SDA/SDA.C index 6ccef9fee0..b11d33e45e 100644 --- a/src/dynamicMesh/motionSolvers/displacement/solidBody/solidBodyMotionFunctions/SDA/SDA.C +++ b/src/dynamicMesh/motionSolvers/displacement/solidBody/solidBodyMotionFunctions/SDA/SDA.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2018 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -104,7 +104,7 @@ bool Foam::solidBodyMotionFunctions::SDA::read(const dictionary& SBMFCoeffs) solidBodyMotionFunction::read(SBMFCoeffs); SBMFCoeffs_.lookup("CofG") >> CofG_; - SBMFCoeffs_.lookup("lamda") >> lamda_; + SBMFCoeffs_.lookup("lambda") >> lambda_; SBMFCoeffs_.lookup("rollAmax") >> rollAmax_; SBMFCoeffs_.lookup("rollAmin") >> rollAmin_; SBMFCoeffs_.lookup("heaveA") >> heaveA_; @@ -116,14 +116,14 @@ bool Foam::solidBodyMotionFunctions::SDA::read(const dictionary& SBMFCoeffs) SBMFCoeffs_.lookup("dTp") >> dTp_; // Rescale parameters according to the given scale parameter - if (lamda_ > 1 + small) + if (lambda_ > 1 + small) { - heaveA_ /= lamda_; - swayA_ /= lamda_; - Tp_ /= sqrt(lamda_); - Tpn_ /= sqrt(lamda_); - dTi_ /= sqrt(lamda_); - dTp_ /= sqrt(lamda_); + heaveA_ /= lambda_; + swayA_ /= lambda_; + Tp_ /= sqrt(lambda_); + Tpn_ /= sqrt(lambda_); + dTi_ /= sqrt(lambda_); + dTp_ /= sqrt(lambda_); } return true; diff --git a/src/dynamicMesh/motionSolvers/displacement/solidBody/solidBodyMotionFunctions/SDA/SDA.H b/src/dynamicMesh/motionSolvers/displacement/solidBody/solidBodyMotionFunctions/SDA/SDA.H index 23d4550f59..173686c9b3 100644 --- a/src/dynamicMesh/motionSolvers/displacement/solidBody/solidBodyMotionFunctions/SDA/SDA.H +++ b/src/dynamicMesh/motionSolvers/displacement/solidBody/solidBodyMotionFunctions/SDA/SDA.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2020 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -64,7 +64,7 @@ class SDA vector CofG_; //- Model scale ratio - scalar lamda_; + scalar lambda_; //- Max roll amplitude [rad] scalar rollAmax_; diff --git a/src/dynamicMesh/polyTopoChange/polyTopoChange/removePoints.C b/src/dynamicMesh/polyTopoChange/polyTopoChange/removePoints.C index 4295468da0..d8cf8673f8 100644 --- a/src/dynamicMesh/polyTopoChange/polyTopoChange/removePoints.C +++ b/src/dynamicMesh/polyTopoChange/polyTopoChange/removePoints.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2022 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -688,7 +688,7 @@ void Foam::removePoints::getUnrefimentSet // So now if any of the points-to-restore is used by any coupled face // anywhere the corresponding index in faceVertexRestore will be set. - // Now combine the localPointSet and the (sychronised) + // Now combine the localPointSet and the (synchronised) // boundary-points-to-restore. forAll(savedFaces_, saveI) diff --git a/src/finiteVolume/cfdTools/general/porosityModel/DarcyForchheimer/DarcyForchheimer.H b/src/finiteVolume/cfdTools/general/porosityModel/DarcyForchheimer/DarcyForchheimer.H index 7f92d932f8..f4cc42bf1c 100644 --- a/src/finiteVolume/cfdTools/general/porosityModel/DarcyForchheimer/DarcyForchheimer.H +++ b/src/finiteVolume/cfdTools/general/porosityModel/DarcyForchheimer/DarcyForchheimer.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2012-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2012-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -72,10 +72,10 @@ class DarcyForchheimer { // Private Data - //- Darcy coeffient XYZ components (user-supplied) [1/m^2] + //- Darcy coefficient XYZ components (user-supplied) [1/m^2] dimensionedVector dXYZ_; - //- Forchheimer coeffient XYZ components (user-supplied) [1/m] + //- Forchheimer coefficient XYZ components (user-supplied) [1/m] dimensionedVector fXYZ_; //- Darcy coefficient - converted from dXYZ [1/m^2] diff --git a/src/finiteVolume/fvMesh/fvPatches/fvPatch/fvPatch.H b/src/finiteVolume/fvMesh/fvPatches/fvPatch/fvPatch.H index 260fefdaff..204bd0df45 100644 --- a/src/finiteVolume/fvMesh/fvPatches/fvPatch/fvPatch.H +++ b/src/finiteVolume/fvMesh/fvPatches/fvPatch/fvPatch.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2022 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -226,9 +226,9 @@ public: //- Return patch weighting factors const scalarField& weights() const; - //- Return the face - cell distance coeffient + //- Return the face - cell distance coefficient // except for coupled patches for which the cell-centre - // to coupled-cell-centre distance coeffient is returned + // to coupled-cell-centre distance coefficient is returned const scalarField& deltaCoeffs() const; diff --git a/src/functionObjects/field/wallHeatTransferCoeff/wallHeatTransferCoeffModels/kappaEff/kappaEff.H b/src/functionObjects/field/wallHeatTransferCoeff/wallHeatTransferCoeffModels/kappaEff/kappaEff.H index 9dd9e7f03e..ff40eeb168 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 equations bellow. + as the volScalarField field 'kappaEff' using one of equations below. kappaEff model, given by: diff --git a/src/fvAgglomerationMethods/pairPatchAgglomeration/pairPatchAgglomeration.H b/src/fvAgglomerationMethods/pairPatchAgglomeration/pairPatchAgglomeration.H index f30d25f448..a494b78402 100644 --- a/src/fvAgglomerationMethods/pairPatchAgglomeration/pairPatchAgglomeration.H +++ b/src/fvAgglomerationMethods/pairPatchAgglomeration/pairPatchAgglomeration.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2020 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -109,7 +109,7 @@ private: const bPatch& patchLevel ); - //- Combine leves + //- Combine levels void combineLevels(const label curLevel); //- Shrink the number of levels to that specified diff --git a/src/fvMeshDistributors/loadBalancer/fvMeshDistributorsLoadBalancer.H b/src/fvMeshDistributors/loadBalancer/fvMeshDistributorsLoadBalancer.H index a81f4fdc85..459afe2790 100644 --- a/src/fvMeshDistributors/loadBalancer/fvMeshDistributorsLoadBalancer.H +++ b/src/fvMeshDistributors/loadBalancer/fvMeshDistributorsLoadBalancer.H @@ -80,7 +80,7 @@ class loadBalancer //- Enable multi-constraint load-balancing in which separate weights // 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. + // is provided to the distributor. // Defaults to true. Switch multiConstraint_; diff --git a/src/lagrangian/parcel/submodels/Momentum/CollisionModel/PairCollision/PairModel/PairSpringSliderDashpot/PairSpringSliderDashpot.H b/src/lagrangian/parcel/submodels/Momentum/CollisionModel/PairCollision/PairModel/PairSpringSliderDashpot/PairSpringSliderDashpot.H index 65ec0f5993..18e0234c4f 100644 --- a/src/lagrangian/parcel/submodels/Momentum/CollisionModel/PairCollision/PairModel/PairSpringSliderDashpot/PairSpringSliderDashpot.H +++ b/src/lagrangian/parcel/submodels/Momentum/CollisionModel/PairCollision/PairModel/PairSpringSliderDashpot/PairSpringSliderDashpot.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2020 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -86,7 +86,7 @@ class PairSpringSliderDashpot // parcelEquivD = cbrt(volumeFactor*nParticles)*p.d() // + When volumeFactor = 1, the particles are compressed // together so that the equivalent volume of the parcel is - // the sum of the constitutent particles + // the sum of the constituent particles // + When volumeFactor = 3*sqrt(2)/pi, the particles are // close packed, but uncompressed. // + When volumeFactor > 3*sqrt(2)/pi, the particles loosely diff --git a/src/lagrangian/parcel/submodels/Momentum/CollisionModel/PairCollision/WallModel/WallLocalSpringSliderDashpot/WallLocalSpringSliderDashpot.H b/src/lagrangian/parcel/submodels/Momentum/CollisionModel/PairCollision/WallModel/WallLocalSpringSliderDashpot/WallLocalSpringSliderDashpot.H index 46ec2f14da..9cbe79877c 100644 --- a/src/lagrangian/parcel/submodels/Momentum/CollisionModel/PairCollision/WallModel/WallLocalSpringSliderDashpot/WallLocalSpringSliderDashpot.H +++ b/src/lagrangian/parcel/submodels/Momentum/CollisionModel/PairCollision/WallModel/WallLocalSpringSliderDashpot/WallLocalSpringSliderDashpot.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2022 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -91,7 +91,7 @@ class WallLocalSpringSliderDashpot // parcelEquivD = cbrt(volumeFactor*nParticles)*p.d() // + When volumeFactor = 1, the particles are compressed // together so that the equivalent volume of the parcel is - // the sum of the constitutent particles + // the sum of the constituent particles // + When volumeFactor = 3*sqrt(2)/pi, the particles are // close packed, but uncompressed. // + When volumeFactor > 3*sqrt(2)/pi, the particles loosely diff --git a/src/lagrangian/parcel/submodels/Momentum/CollisionModel/PairCollision/WallModel/WallSpringSliderDashpot/WallSpringSliderDashpot.H b/src/lagrangian/parcel/submodels/Momentum/CollisionModel/PairCollision/WallModel/WallSpringSliderDashpot/WallSpringSliderDashpot.H index 9357bb0bef..af34131ff2 100644 --- a/src/lagrangian/parcel/submodels/Momentum/CollisionModel/PairCollision/WallModel/WallSpringSliderDashpot/WallSpringSliderDashpot.H +++ b/src/lagrangian/parcel/submodels/Momentum/CollisionModel/PairCollision/WallModel/WallSpringSliderDashpot/WallSpringSliderDashpot.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2020 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -83,7 +83,7 @@ class WallSpringSliderDashpot // parcelEquivD = cbrt(volumeFactor*nParticles)*p.d() // + When volumeFactor = 1, the particles are compressed // together so that the equivalent volume of the parcel is - // the sum of the constitutent particles + // the sum of the constituent particles // + When volumeFactor = 3*sqrt(2)/pi, the particles are // close packed, but uncompressed. // + When volumeFactor > 3*sqrt(2)/pi, the particles loosely diff --git a/src/mesh/snappyHexMesh/meshRefinement/meshRefinementRefine.C b/src/mesh/snappyHexMesh/meshRefinement/meshRefinementRefine.C index a5a832f826..be8b393aac 100644 --- a/src/mesh/snappyHexMesh/meshRefinement/meshRefinementRefine.C +++ b/src/mesh/snappyHexMesh/meshRefinement/meshRefinementRefine.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2022 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -630,7 +630,7 @@ void Foam::meshRefinement::markFeatureCellLevel // { // Pout<< "Feature went through cell:" << celli // << " coord:" << mesh_.cellCentres()[celli] - // << " leve:" << maxFeatureLevel[celli] + // << " level:" << maxFeatureLevel[celli] // << endl; // } // } diff --git a/src/meshTools/searchableSurfaces/searchableSurfaceCollection/searchableSurfaceCollection.H b/src/meshTools/searchableSurfaces/searchableSurfaceCollection/searchableSurfaceCollection.H index 5a04678485..9744474e01 100644 --- a/src/meshTools/searchableSurfaces/searchableSurfaceCollection/searchableSurfaceCollection.H +++ b/src/meshTools/searchableSurfaces/searchableSurfaceCollection/searchableSurfaceCollection.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2022 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -36,7 +36,7 @@ Usage \c scale parameter and then rotated and translated by the mandatory \c transform. In the example below, two geometries are included named \c buildingB and \c buildingC which are both formed by a translation - of \c buildingA according to the \c origin paramater. No rotation is + of \c buildingA according to the \c origin parameter. No rotation is applied (by setting e1 and e2 to the global x and y axis directions, respectively). diff --git a/src/randomProcesses/graph/curve/curveTools.C b/src/randomProcesses/graph/curve/curveTools.C index 82e6ff7feb..f283b2e1c6 100644 --- a/src/randomProcesses/graph/curve/curveTools.C +++ b/src/randomProcesses/graph/curve/curveTools.C @@ -91,16 +91,16 @@ bool interpolate { scalar srb2m4ac = sqrt(b2m4ac); - scalar lamda = (-b - srb2m4ac)/(2.0*a); + scalar lambda = (-b - srb2m4ac)/(2.0*a); - if (lamda > 1.0+curveSmall || lamda < -curveSmall) + if (lambda > 1.0+curveSmall || lambda < -curveSmall) { - lamda = (-b + srb2m4ac)/(2.0*a); + lambda = (-b + srb2m4ac)/(2.0*a); } - if (lamda < 1.0+curveSmall && lamda > -curveSmall) + if (lambda < 1.0+curveSmall && lambda > -curveSmall) { - n = p2 + lamda*(p1 - p2); + n = p2 + lambda*(p1 - p2); return false; } @@ -168,8 +168,8 @@ bool Xinterpolate } vector D = p2 - p1; - scalar lamda = (n.x() - p1.x())/D.x(); - n.y() = p1.y() + lamda*D.y(); + scalar lambda = (n.x() - p1.x())/D.x(); + n.y() = p1.y() + lambda*D.y(); return false; } diff --git a/tutorials/modules/compressibleVoF/sloshingTank2D/constant/dynamicMeshDict b/tutorials/modules/compressibleVoF/sloshingTank2D/constant/dynamicMeshDict index 501c73546b..f38a472b92 100644 --- a/tutorials/modules/compressibleVoF/sloshingTank2D/constant/dynamicMeshDict +++ b/tutorials/modules/compressibleVoF/sloshingTank2D/constant/dynamicMeshDict @@ -27,7 +27,7 @@ mover solidBodyMotionFunction SDA; CofG (0 0 0); - lamda 50; + lambda 50; rollAmax 0.22654; rollAmin 0.10472; heaveA 3.79; diff --git a/tutorials/modules/incompressibleVoF/sloshingTank2D/constant/dynamicMeshDict b/tutorials/modules/incompressibleVoF/sloshingTank2D/constant/dynamicMeshDict index 501c73546b..f38a472b92 100644 --- a/tutorials/modules/incompressibleVoF/sloshingTank2D/constant/dynamicMeshDict +++ b/tutorials/modules/incompressibleVoF/sloshingTank2D/constant/dynamicMeshDict @@ -27,7 +27,7 @@ mover solidBodyMotionFunction SDA; CofG (0 0 0); - lamda 50; + lambda 50; rollAmax 0.22654; rollAmin 0.10472; heaveA 3.79; diff --git a/tutorials/modules/incompressibleVoF/sloshingTank2D3DoF/constant/dynamicMeshDict b/tutorials/modules/incompressibleVoF/sloshingTank2D3DoF/constant/dynamicMeshDict index 6a029c70bc..0b399d5936 100644 --- a/tutorials/modules/incompressibleVoF/sloshingTank2D3DoF/constant/dynamicMeshDict +++ b/tutorials/modules/incompressibleVoF/sloshingTank2D3DoF/constant/dynamicMeshDict @@ -27,7 +27,7 @@ mover solidBodyMotionFunction SDA; CofG (0 0 0); - lamda 50; + lambda 50; rollAmax 0.2; rollAmin 0.1; heaveA 4; diff --git a/tutorials/modules/incompressibleVoF/sloshingTank3D/constant/dynamicMeshDict b/tutorials/modules/incompressibleVoF/sloshingTank3D/constant/dynamicMeshDict index ed1c3d56cf..0dbba859a4 100644 --- a/tutorials/modules/incompressibleVoF/sloshingTank3D/constant/dynamicMeshDict +++ b/tutorials/modules/incompressibleVoF/sloshingTank3D/constant/dynamicMeshDict @@ -27,7 +27,7 @@ mover solidBodyMotionFunction SDA; CofG (0 0 0); - lamda 50; + lambda 50; rollAmax 0.22654; rollAmin 0.10472; heaveA 3.79; diff --git a/tutorials/modules/incompressibleVoF/sloshingTank3D3DoF/constant/dynamicMeshDict b/tutorials/modules/incompressibleVoF/sloshingTank3D3DoF/constant/dynamicMeshDict index 311e11e992..ecf58c4a1f 100644 --- a/tutorials/modules/incompressibleVoF/sloshingTank3D3DoF/constant/dynamicMeshDict +++ b/tutorials/modules/incompressibleVoF/sloshingTank3D3DoF/constant/dynamicMeshDict @@ -27,7 +27,7 @@ mover solidBodyMotionFunction SDA; CofG (0 0 0); - lamda 50; + lambda 50; rollAmax 0.2; rollAmin 0.1; heaveA 4;