STYLE: Correcting typos

This commit is contained in:
Andrew Heather 2018-03-28 17:14:16 +01:00
parent 3a569c9fd5
commit a230e8d408
486 changed files with 740 additions and 758 deletions

View File

@ -103,7 +103,7 @@ int main(int argc, char *argv[])
#include "setDeltaT.H"
// Indicators for refinement. Note: before runTime++
// only for postprocessing reasons.
// only for post-processing reasons.
tmp<volScalarField> tmagGradP = mag(fvc::grad(p));
volScalarField normalisedGradP
(

View File

@ -25,7 +25,7 @@ Class
Foam::XiEqModels::basicSubGrid
Description
Basic sub-grid obstacle flame-wrinking enhancement factor model.
Basic sub-grid obstacle flame-wrinkling enhancement factor model.
Details supplied by J Puttock 2/7/06.
<b> Sub-grid flame area generation </b>
@ -125,7 +125,7 @@ public:
// Member Functions
//- Return the flame-wrinking XiEq
//- Return the flame-wrinkling XiEq
virtual tmp<volScalarField> XiEq() const;
//- Update properties from given dictionary

View File

@ -26,7 +26,7 @@ Class
Description
Basic sub-grid obstacle flame-wrinking generation rate coefficient model.
Basic sub-grid obstacle flame-wrinkling generation rate coefficient model.
Details supplied by J Puttock 2/7/06.
\f$ G_{sub} \f$ denotes the generation coefficient and it is given by
@ -113,7 +113,7 @@ public:
// Member Functions
//- Return the flame-wrinking generation rate
//- Return the flame-wrinkling generation rate
virtual tmp<volScalarField> G() const;
//- Return the flame diffusivity

View File

@ -129,7 +129,7 @@ void PDRkEpsilon::correct()
volScalarField G(GName(), rho_*nut_*(tgradU() && dev(twoSymm(tgradU()))));
tgradU.clear();
// Update espsilon and G at the wall
// Update epsilon and G at the wall
epsilon_.boundaryFieldRef().updateCoeffs();
// Add the blockage generation term so that it is included consistently

View File

@ -101,7 +101,7 @@ public:
// Member Functions
//- Return the flame-wrinking XiEq
//- Return the flame-wrinkling XiEq
virtual tmp<volScalarField> XiEq() const;
//- Update properties from given dictionary

View File

@ -97,7 +97,7 @@ public:
// Member Functions
//- Return the flame-wrinking XiEq
//- Return the flame-wrinkling XiEq
virtual tmp<volScalarField> XiEq() const;
//- Update properties from given dictionary

View File

@ -115,7 +115,7 @@ public:
// Member Functions
//- Return the flame-wrinking XiEq
//- Return the flame-wrinkling XiEq
virtual tmp<volScalarField> XiEq() const;
//- Update properties from given dictionary

View File

@ -144,7 +144,7 @@ public:
// Member Functions
//- Return the flame-wrinking XiEq
//- Return the flame-wrinkling XiEq
virtual tmp<volScalarField> XiEq() const
{
return turbulence_.muEff();

View File

@ -96,7 +96,7 @@ public:
// Member Functions
//- Return the flame-wrinking XiEq
//- Return the flame-wrinkling XiEq
virtual tmp<volScalarField> XiEq() const;
//- Update properties from given dictionary

View File

@ -91,7 +91,7 @@ public:
// Member Functions
//- Return the flame-wrinking generation rate
//- Return the flame-wrinkling generation rate
virtual tmp<volScalarField> G() const;
//- Update properties from given dictionary

View File

@ -135,7 +135,7 @@ public:
// Member Functions
//- Return the flame-wrinking genration rate
//- Return the flame-wrinkling generation rate
virtual tmp<volScalarField> G() const = 0;
//- Return the flame diffusivity

View File

@ -25,7 +25,7 @@ Class
Foam::XiGModels::instabilityG
Description
Flame-surface instabilityG flame-wrinking generation rate coefficient model
Flame-surface instabilityG flame-wrinkling generation rate coefficient model
used in \link XiModel.H \endlink.
See Technical Report SH/RE/01R for details on the PDR modelling.
@ -57,7 +57,7 @@ class instabilityG
{
// Private data
//- Flame instabilityG wrinling generation rate coefficient
//- Flame instabilityG wrinkling generation rate coefficient
dimensionedScalar GIn_;
//- InstabilityG length-scale
@ -100,7 +100,7 @@ public:
// Member Functions
//- Return the flame-wrinking generation rate
//- Return the flame-wrinkling generation rate
virtual tmp<volScalarField> G() const;
//- Return the flame diffusivity

View File

@ -122,7 +122,7 @@ protected:
const volScalarField& b_;
const surfaceScalarField& phi_;
//- Flame wrinking field
//- Flame wrinkling field
volScalarField Xi_;
@ -207,7 +207,7 @@ public:
// Member Functions
//- Return the flame-wrinking Xi
//- Return the flame-wrinkling Xi
virtual const volScalarField& Xi() const
{
return Xi_;
@ -227,10 +227,10 @@ public:
)
{}
//- Correct the flame-wrinking Xi
//- Correct the flame-wrinkling Xi
virtual void correct() = 0;
//- Correct the flame-wrinking Xi using the given convection scheme
//- Correct the flame-wrinkling Xi using the given convection scheme
virtual void correct(const fv::convectionScheme<scalar>&)
{
correct();

View File

@ -104,7 +104,7 @@ public:
//- Return the flame diffusivity
virtual tmp<volScalarField> Db() const;
//- Correct the flame-wrinking Xi
//- Correct the flame-wrinkling Xi
virtual void correct();
//- Update properties from given dictionary

View File

@ -89,7 +89,7 @@ public:
// Member Functions
//- Correct the flame-wrinking Xi
//- Correct the flame-wrinkling Xi
virtual void correct()
{}

View File

@ -113,13 +113,13 @@ public:
fields.add(Xi_);
}
//- Correct the flame-wrinking Xi
//- Correct the flame-wrinkling Xi
virtual void correct()
{
NotImplemented;
}
//- Correct the flame-wrinking Xi using the given convection scheme
//- Correct the flame-wrinkling Xi using the given convection scheme
virtual void correct(const fv::convectionScheme<scalar>& mvConvection);
//- Update properties from given dictionary

View File

@ -82,8 +82,8 @@ Foam::laminarFlameSpeedModels::SCOPE::SCOPE
)()
).optionalSubDict(typeName + "Coeffs")
),
LFL_(readScalar(coeffsDict_.lookup("lowerFlamabilityLimit"))),
UFL_(readScalar(coeffsDict_.lookup("upperFlamabilityLimit"))),
LFL_(readScalar(coeffsDict_.lookup("lowerFlammabilityLimit"))),
UFL_(readScalar(coeffsDict_.lookup("upperFlammabilityLimit"))),
SuPolyL_(coeffsDict_.subDict("lowerSuPolynomial")),
SuPolyU_(coeffsDict_.subDict("upperSuPolynomial")),
Texp_(readScalar(coeffsDict_.lookup("Texp"))),
@ -145,19 +145,19 @@ inline Foam::scalar Foam::laminarFlameSpeedModels::SCOPE::SuRef
{
if (phi < LFL_ || phi > UFL_)
{
// Return 0 beyond the flamibility limits
// Return 0 beyond the flammability limits
return scalar(0);
}
else if (phi < SuPolyL_.ll)
{
// Use linear interpolation between the low end of the
// lower polynomial and the lower flamibility limit
// lower polynomial and the lower flammability limit
return SuPolyL_.llv*(phi - LFL_)/(SuPolyL_.ll - LFL_);
}
else if (phi > SuPolyU_.ul)
{
// Use linear interpolation between the upper end of the
// upper polynomial and the upper flamibility limit
// upper polynomial and the upper flammability limit
return SuPolyU_.ulv*(UFL_ - phi)/(UFL_ - SuPolyU_.ul);
}
else if (phi < SuPolyL_.lu)

View File

@ -109,10 +109,10 @@ class SCOPE
dictionary coeffsDict_;
//- Lower flamability limit
//- Lower flammability limit
scalar LFL_;
//- Upper flamability limit
//- Upper flammability limit
scalar UFL_;
//- Lower Su polynomial

View File

@ -89,7 +89,7 @@ else
}
}
// The incompressibe form of the continuity error check is appropriate for
// The incompressible form of the continuity error check is appropriate for
// steady-state compressible also.
#include "incompressible/continuityErrs.H"

View File

@ -63,7 +63,7 @@ else
<< endl;
}
// store local id of near-walll cell to process
// store local id of near-wall cell to process
label cellId = patches[patchId].faceCells()[faceId];
// create position array for graph generation

View File

@ -13,7 +13,7 @@ scalarListList weightCellCells(mesh.nInternalFaces());
// Interpolated HbyA faces
vectorField UIntFaces(mesh.nInternalFaces(), vector::zero);
// Determine receptor neighbourd cells
// Determine receptor neighbour cells
labelList receptorNeigCell(mesh.nInternalFaces(), -1);
{

View File

@ -45,7 +45,7 @@ namespace Foam
{
/*---------------------------------------------------------------------------*\
Class alphaContactAngleFvPatch Declaration
Class alphaContactAngleFvPatch Declaration
\*---------------------------------------------------------------------------*/
class alphaContactAngleFvPatchScalarField
@ -65,7 +65,7 @@ public:
//- Limiting advancing contact angle
scalar thetaA_;
//- Limiting receeding contact angle
//- Limiting receding contact angle
scalar thetaR_;
@ -100,7 +100,7 @@ public:
else return 180.0 - thetaA_;
}
//- Return the limiting receeding contact angle
//- Return the limiting receding contact angle
scalar thetaR(bool matched=true) const
{
if (matched) return thetaR_;

View File

@ -100,20 +100,20 @@ public:
// Member Functions
//- Return access to the inernal energy field [J/Kg]
//- Return access to the internal energy field [J/Kg]
virtual volScalarField& he()
{
return e_;
}
//- Return access to the inernal energy field [J/Kg]
//- Return access to the internal energy field [J/Kg]
virtual const volScalarField& he() const
{
return e_;
}
//- Enthalpy/Internal energy
// for given pressure and temperature [J/kg]
//- for given pressure and temperature [J/kg]
virtual tmp<volScalarField> he
(
const volScalarField& p,
@ -159,14 +159,14 @@ public:
//- Return true if the equation of state is incompressible
// i.e. rho != f(p)
//- i.e. rho != f(p)
bool incompressible() const
{
return (true);
}
//- Return true if the equation of state is isochoric
// i.e. rho = const
//- i.e. rho = const
bool isochoric() const
{
return (false);
@ -189,7 +189,7 @@ public:
const label patchi
) const;
//- Return Cv of the mixture
//- Return Cv of the mixture
virtual tmp<volScalarField> Cv() const;
//- Heat capacity at constant volume for patch [J/kg/K]
@ -237,21 +237,21 @@ public:
virtual tmp<volScalarField> kappa() const;
//- Thermal diffusivity for temperature
// of mixture for patch [J/m/s/K]
//- of mixture for patch [J/m/s/K]
virtual tmp<scalarField> kappa
(
const label patchi
) const;
//- Effective thermal diffusivity for temperature
// of mixture [J/m/s/K]
//- of mixture [J/m/s/K]
virtual tmp<volScalarField> kappaEff
(
const volScalarField&
) const;
//- Effective thermal diffusivity for temperature
// of mixture for patch [J/m/s/K]
//- of mixture for patch [J/m/s/K]
virtual tmp<scalarField> kappaEff
(
const scalarField& alphat,
@ -272,7 +272,7 @@ public:
) const;
//- Correct the thermo fields
//- Correct the thermo fields
virtual void correct();
//- Read properties
@ -298,7 +298,6 @@ public:
{
return pDivU_;
}
};

View File

@ -128,13 +128,13 @@ public:
return residualSlip_;
}
//- The dragfunction K used in the momentum eq.
//- The drag function K used in the momentum eq.
// ddt(alpha1*rho1*U1) + ... = ... alpha1*alpha2*K*(U1-U2)
// ddt(alpha2*rho2*U2) + ... = ... alpha1*alpha2*K*(U2-U1)
// ********************************** NB! *****************************
// for numerical reasons alpha1 and alpha2 has been
// extracted from the dragFunction K,
// so you MUST divide K by alpha1*alpha2 when implemnting the drag
// so you MUST divide K by alpha1*alpha2 when implementing the drag
// function
// ********************************** NB! *****************************
virtual tmp<volScalarField> K(const volScalarField& Ur) const = 0;

View File

@ -45,7 +45,7 @@ namespace Foam
{
/*---------------------------------------------------------------------------*\
Class alphaContactAngleFvPatch Declaration
Class alphaContactAngleFvPatch Declaration
\*---------------------------------------------------------------------------*/
class alphaContactAngleFvPatchScalarField
@ -65,7 +65,7 @@ public:
//- Limiting advancing contact angle
scalar thetaA_;
//- Limiting receeding contact angle
//- Limiting receding contact angle
scalar thetaR_;
@ -100,7 +100,7 @@ public:
else return 180.0 - thetaA_;
}
//- Return the limiting receeding contact angle
//- Return the limiting receding contact angle
scalar thetaR(bool matched=true) const
{
if (matched) return thetaR_;

View File

@ -45,7 +45,7 @@ namespace Foam
{
/*---------------------------------------------------------------------------*\
Class alphaContactAngleFvPatch Declaration
Class alphaContactAngleFvPatch Declaration
\*---------------------------------------------------------------------------*/
class alphaContactAngleFvPatchScalarField
@ -65,7 +65,7 @@ public:
//- Limiting advancing contact angle
scalar thetaA_;
//- Limiting receeding contact angle
//- Limiting receding contact angle
scalar thetaR_;
@ -100,7 +100,7 @@ public:
else return 180.0 - thetaA_;
}
//- Return the limiting receeding contact angle
//- Return the limiting receding contact angle
scalar thetaR(bool matched=true) const
{
if (matched) return thetaR_;

View File

@ -54,7 +54,7 @@ namespace interfaceCompositionModels
{
/*---------------------------------------------------------------------------*\
Class NonRandomTwoLiquid Declaration
Class NonRandomTwoLiquid Declaration
\*---------------------------------------------------------------------------*/
template<class Thermo, class OtherThermo>
@ -76,10 +76,10 @@ class NonRandomTwoLiquid
//- Name of species 2
word species2Name_;
//- Indiex of species 1 within this thermo
//- Index of species 1 within this thermo
label species1Index_;
//- Indiex of species 2 within this thermo
//- Index of species 2 within this thermo
label species2Index_;
//- Non-randomness constant parameter for species 1
@ -88,10 +88,10 @@ class NonRandomTwoLiquid
//- Non-randomness constant parameter for species 2
dimensionedScalar alpha21_;
//- Non-randomness linear paramater for species 1
//- Non-randomness linear parameter for species 1
dimensionedScalar beta12_;
//- Non-randomness linear paramater for species 2
//- Non-randomness linear parameter for species 2
dimensionedScalar beta21_;
//- Interaction parameter model for species 1

View File

@ -74,8 +74,8 @@ protected:
// Private Member Functions
//- Constant of propotionality between partial pressure and mass
// fraction
//- Constant of proportionality between partial pressure and mass
//- fraction
tmp<volScalarField> wRatioByP() const;

View File

@ -93,7 +93,7 @@ public:
//- Saturation pressure
virtual tmp<volScalarField> pSat(const volScalarField& T) const;
//- Saturation pressure derivetive w.r.t. temperature
//- Saturation pressure derivative w.r.t. temperature
virtual tmp<volScalarField> pSatPrime(const volScalarField& T) const;
//- Natural log of the saturation pressure

View File

@ -93,7 +93,7 @@ public:
//- Saturation pressure
virtual tmp<volScalarField> pSat(const volScalarField& T) const;
//- Saturation pressure derivetive w.r.t. temperature
//- Saturation pressure derivative w.r.t. temperature
virtual tmp<volScalarField> pSatPrime(const volScalarField& T) const;
//- Natural log of the saturation pressure

View File

@ -78,7 +78,7 @@ public:
//- Saturation pressure
virtual tmp<volScalarField> pSat(const volScalarField& T) const;
//- Saturation pressure derivetive w.r.t. temperature
//- Saturation pressure derivative w.r.t. temperature
virtual tmp<volScalarField> pSatPrime(const volScalarField& T) const;
//- Natural log of the saturation pressure

View File

@ -83,7 +83,7 @@ public:
//- Saturation pressure
virtual tmp<volScalarField> pSat(const volScalarField& T) const;
//- Saturation pressure derivetive w.r.t. temperature
//- Saturation pressure derivative w.r.t. temperature
virtual tmp<volScalarField> pSatPrime(const volScalarField& T) const;
//- Natural log of the saturation pressure

View File

@ -119,7 +119,7 @@ public:
//- Saturation pressure
virtual tmp<volScalarField> pSat(const volScalarField& T) const;
//- Saturation pressure derivetive w.r.t. temperature
//- Saturation pressure derivative w.r.t. temperature
virtual tmp<volScalarField> pSatPrime(const volScalarField& T) const;
//- Natural log of the saturation pressure

View File

@ -89,7 +89,7 @@ public:
//- Saturation pressure
virtual tmp<volScalarField> pSat(const volScalarField& T) const;
//- Saturation pressure derivetive w.r.t. temperature
//- Saturation pressure derivative w.r.t. temperature
virtual tmp<volScalarField> pSatPrime(const volScalarField& T) const;
//- Natural log of the saturation pressure

View File

@ -102,7 +102,7 @@ public:
const volScalarField& T
) const = 0;
//- Saturation pressure derivetive w.r.t. temperature
//- Saturation pressure derivative w.r.t. temperature
virtual tmp<volScalarField> pSatPrime
(
const volScalarField& T

View File

@ -68,7 +68,7 @@ HeatAndMassTransferPhaseSystem
continue;
}
// Initialy assume no mass transfer
// Initially assume no mass transfer
dmdt_.insert
(
@ -228,7 +228,7 @@ Foam::HeatAndMassTransferPhaseSystem<BasePhaseSystem>::momentumTransfer() const
phaseSystem::momentumTransferTable& eqns = eqnsPtr();
// Source term due to mass trasfer
// Source term due to mass transfer
forAllConstIters(this->phasePairs_, phasePairIter)
{
const phasePair& pair = *(phasePairIter.object());

View File

@ -45,7 +45,7 @@ namespace Foam
{
/*---------------------------------------------------------------------------*\
Class alphaContactAngleFvPatch Declaration
Class alphaContactAngleFvPatch Declaration
\*---------------------------------------------------------------------------*/
class alphaContactAngleFvPatchScalarField
@ -65,7 +65,7 @@ public:
//- Limiting advancing contact angle
scalar thetaA_;
//- Limiting receeding contact angle
//- Limiting receding contact angle
scalar thetaR_;
@ -100,7 +100,7 @@ public:
else return 180.0 - thetaA_;
}
//- Return the limiting receeding contact angle
//- Return the limiting receding contact angle
scalar thetaR(bool matched=true) const
{
if (matched) return thetaR_;

View File

@ -91,7 +91,7 @@ public:
// Member Functions
//- Calculate and return the wall heat-flux partioning
//- Calculate and return the wall heat-flux partitioning
virtual tmp<scalarField> fLiquid(const scalarField& alphaLiquid) const;
virtual void write(Ostream& os) const;

View File

@ -92,7 +92,7 @@ public:
// Member Functions
//- Calculate and return the wall heat-flux partioning
//- Calculate and return the wall heat-flux partitioning
virtual tmp<scalarField> fLiquid(const scalarField& alphaLiquid) const;
virtual void write(Ostream& os) const;

View File

@ -73,7 +73,7 @@ public:
// Member Functions
//- Calculate and return the wall heat-flux partioning
//- Calculate and return the wall heat-flux partitioning
virtual tmp<scalarField> fLiquid(const scalarField& alphaLiquid) const;
};

View File

@ -183,7 +183,7 @@ Foam::twoPhaseSystem::twoPhaseSystem
*pair_,
*pair1In2_,
*pair2In1_,
false // Do not zero drag coefficent at fixed-flux BCs
false // Do not zero drag coefficient at fixed-flux BCs
)
);

View File

@ -212,7 +212,7 @@ public:
//- Return the mixture flux
inline const surfaceScalarField& phi() const;
//- Return non-const access to the the mixture flux
//- Return non-const access to the mixture flux
inline surfaceScalarField& phi();
//- Return the dilatation term

View File

@ -26,7 +26,7 @@ sortCoupledFaceCells false;
// blockCoeffs dictionary to construct a decompositionMethod to do
// a block subdivision) and then applies the renumberMethod to each
// block in turn. This can be used in large cases to keep the blocks
// fitting in cache with all the the cache misses bunched at the end.
// fitting in cache with all the cache misses bunched at the end.
// This number is the approximate size of the blocks - this gets converted
// to a number of blocks that is the input to the decomposition method.
//blockSize 1000;

View File

@ -127,7 +127,7 @@ void Foam::router::fixWeights
{
WarningInFunction
<< "Cannot route from node " << nodeI
<< " since all neigbours of node "
<< " since all neighbours of node "
<< "already allocated:" << endl;
forAll(myNeighbours, neighbourI)

View File

@ -631,7 +631,7 @@ int main(int argc, char *argv[])
#include "createTime.H"
#include "createPolyMesh.H"
// If nessecary add oldInternalFaces patch
// If necessary add oldInternalFaces patch
label newPatchi = addPatch(mesh, "oldInternalFaces");

View File

@ -311,7 +311,7 @@ mtype {space}"MTYPE:"{space}
scalar y = readScalar(nodeStream);
scalar z = readScalar(nodeStream);
// add mapping and scalced node to the list
// add mapping and scaled node to the list
pointMap[curNumberOfNodes] = nodeI;
points[curNumberOfNodes] = point(x, y, z);
curNumberOfNodes++;

View File

@ -718,7 +718,7 @@ void countExtrudePatches
}
}
}
// Synchronise decistion. Actual numbers are not important, just make
// Synchronise decision. Actual numbers are not important, just make
// sure that they're > 0 on all processors.
Pstream::listCombineGather(zoneSidePatch, plusEqOp<label>());
Pstream::listCombineScatter(zoneSidePatch);
@ -2428,7 +2428,7 @@ int main(int argc, char *argv[])
meshMod
);
// Enforce actual point posititions according to extrudeModel (model)
// Enforce actual point positions according to extrudeModel (model)
// (extruder.setRefinement only does fixed expansionRatio)
// The regionPoints and nLayers are looped in the same way as in
// createShellMesh

View File

@ -81,15 +81,15 @@ public:
// Controls
//- Minimum cell size below which protusions through the surface are
// not split
//- Minimum cell size below which protrusions through the surface
//- are not split
scalar minCellSize_;
//- Square of minCellSize
scalar minCellSize2_;
//- Maximum quadrant angle allowed at a concave corner before
// additional "mitering" lines are added
//- additional "mitering" lines are added
scalar maxQuadAngle_;
//- Near-wall region where cells are aligned with the wall
@ -126,22 +126,22 @@ public:
//- Square of span
scalar span2_;
//- Minumum edge-length of the cell size below which protusions
// through the surface are not split
//- Minimum edge-length of the cell size below which protrusions
//- through the surface are not split
scalar minEdgeLen_;
//- Square of minEdgeLen
scalar minEdgeLen2_;
//- Maximum notch size below which protusions into the surface are
// not filled
//- not filled
scalar maxNotchLen_;
//- Square of maxNotchLen
scalar maxNotchLen2_;
//- The minimum distance alowed between a dual-cell vertex
// and the surface before a point-pair is introduced
//- The minimum distance allowed between a dual-cell vertex
//- and the surface before a point-pair is introduced
scalar minNearPointDist_;
//- Square of minNearPoint

View File

@ -439,7 +439,7 @@ private:
) const;
//- Check to see if dual cell specified by given vertex iterator
// intersects the boundary and hence reqires a point-pair
// intersects the boundary and hence requires a point-pair
bool dualCellSurfaceAnyIntersection
(
const Delaunay::Finite_vertices_iterator& vit
@ -726,7 +726,7 @@ private:
label classifyBoundaryPoint(Cell_handle cit) const;
//- Index all of the the Delaunay cells and calculate their dual points
//- Index all of the Delaunay cells and calculate their dual points
void indexDualVertices
(
pointField& pts,

View File

@ -513,7 +513,7 @@ void Foam::conformalVoronoiMesh::createExternalEdgePointGroup
// Convex. So refPt will be inside domain and hence a master point
Foam::point refPt = edgePt - ppDist*refVec;
// Insert the master point pairing the the first slave
// Insert the master point pairing the first slave
if (!geometryToConformTo_.inside(refPt))
{
@ -532,7 +532,7 @@ void Foam::conformalVoronoiMesh::createExternalEdgePointGroup
);
// Insert the slave points by reflecting refPt in both faces.
// with each slave refering to the master
// with each slave referring to the master
Foam::point reflectedA = refPt + 2*ppDist*nA;
pts.append

View File

@ -636,7 +636,7 @@ bool Foam::autoDensity::fillBox
}
// Using the sampledPoints as the first test locations as they are
// randomly shuffled, but unfiormly sampling space and have wellInside
// randomly shuffled, but uniformly sampling space and have wellInside
// and size data already
maxDensity = 1/pow3(max(minCellSize, SMALL));

View File

@ -422,7 +422,7 @@ polyMeshFiltering
// Maximum number of times an to allow an equal faceSet to be
// returned from the face quality assessment before stopping iterations
// to break an infinitie loop.
// to break an infinite loop.
maxConsecutiveEqualFaceSets 5;
// Remove little steps (almost perp to surface) by collapsing face.
surfaceStepFaceAngle 80;

View File

@ -590,7 +590,7 @@ void Foam::CV2D::newPoints()
0.5*(sizes[vA->index()] + sizes[vB->index()]);
// Test for changing aspect ratio on second alignment (first
// alignment is neartest surface normal)
// alignment is nearest surface normal)
// if (aD == 1)
// {
// targetFaceSize *= 2.0;
@ -773,7 +773,7 @@ void Foam::CV2D::newPoints()
if (!is_infinite(ec)) break;
} while (++ec != ecStart);
// Store the start-end of the first non-infinte edge
// Store the start-end of the first non-infinite edge
point2D de0 = toPoint2D(circumcenter(ec->first));
// Keep track of the maximum edge length^2

View File

@ -33,10 +33,10 @@ Description
// Min cell size used in tolerances when inserting points for
// boundary conforming.
// Also used to as the grid spacing usind in insertGrid.
// Also used to as the grid spacing using in insertGrid.
minCellSize 0.05;
// Feature angle used to inser feature points
// Feature angle used to insert feature points
// 0 = all features, 180 = no features
featureAngle 45;
@ -185,7 +185,7 @@ private:
//- Keep track of the boundary conform point-pairs
// stored after the insertion of the surface point-pairs in case
// the boundary conform function is called more than once without
// removing and insertin the surface point-pairs
// removing and inserting the surface point-pairs
label startOfBoundaryConformPointPairs_;
//- Store the feature points
@ -268,7 +268,7 @@ private:
);
//- Check to see if dual cell specified by given vertex iterator
// intersects the boundary and hence reqires a point-pair.
// intersects the boundary and hence requires a point-pair.
bool dualCellSurfaceIntersection
(
const Triangulation::Finite_vertices_iterator& vit
@ -311,7 +311,7 @@ private:
void markNearBoundaryPoints();
//- Restore the Delaunay contraint
//- Restore the Delaunay constraint
void fast_restore_Delaunay(Vertex_handle vh);
// Flip operations used by fast_restore_Delaunay

View File

@ -169,14 +169,14 @@ public:
// Friend Functions
//- Do the two given vertices consitute a boundary point-pair
//- Do the two given vertices constitute a boundary point-pair
friend bool pointPair <Gt, Vb>
(
const indexedVertex<Gt, Vb>& v0,
const indexedVertex<Gt, Vb>& v1
);
//- Do the three given vertices consitute a boundary triangle
//- Do the three given vertices constitute a boundary triangle
friend bool boundaryTriangle <Gt, Vb>
(
const indexedVertex<Gt, Vb>& v0,
@ -184,7 +184,7 @@ public:
const indexedVertex<Gt, Vb>& v2
);
//- Do the three given vertices consitute an outside triangle
//- Do the three given vertices constitute an outside triangle
friend bool outsideTriangle <Gt, Vb>
(
const indexedVertex<Gt, Vb>& v0,

View File

@ -49,7 +49,7 @@ bool Foam::CV2D::dualCellSurfaceIntersection
point e1 = toPoint3D(circumcenter(ec->first->neighbor(ec->second)));
// If other edge end is ouside bounding box then edge cuts boundary
// If other edge end is outside bounding box then edge cuts boundary
if (!qSurf_.globalBounds().contains(e1))
{
return true;

View File

@ -1319,7 +1319,7 @@ int main(int argc, char *argv[])
}
// For now: have single faceZone per surface. Use first
// region in surface for patch for zoneing
// region in surface for patch for zoning
if (regNames.size())
{
label globalRegioni = surfaces.globalRegion(surfi, 0);

View File

@ -277,7 +277,7 @@ castellatedMeshControls
// in a given geometric region. The syntax is exactly the same as for the
// refinementRegions; the cell level now specifies the upper limit
// for any cell. Note that it does not override the refinement constraints
// given by the nCellsBetweenLevels settting.
// given by the nCellsBetweenLevels setting.
limitRegions
{
}

View File

@ -464,7 +464,7 @@ void syncPoints
}
//- Note: hasTransformation is only used for warning messages so
// reduction not strictly nessecary.
// reduction not strictly necessary.
//reduce(hasTransformation, orOp<bool>());
// Synchronize multiple shared points.

View File

@ -244,7 +244,7 @@ labelList findBaffles(const polyMesh& mesh, const labelList& boundaryFaces)
}
// Write to faceSet for ease of postprocessing.
// Write to faceSet for ease of post-processing.
{
faceSet duplicateSet
(

View File

@ -112,7 +112,7 @@ Foam::mirrorFvMesh::mirrorFvMesh(const IOobject& io)
// Algorithm:
// During mirroring, the faces that were previously boundary faces
// in the mirror plane may become ineternal faces. In order to
// in the mirror plane may become internal faces. In order to
// deal with the ordering of the faces, the algorithm is split
// into two parts. For original faces, the internal faces are
// distributed to their owner cells. Once all internal faces are

View File

@ -278,7 +278,7 @@ Foam::label Foam::meshDualiser::addInternalFace
// << " points:" << UIndirectList<point>(meshMod.points(), newFace)
// << " n:" << n
// << " between dualowner:" << dualCell0
// << " dualneigbour:" << dualCell1
// << " dualneighbour:" << dualCell1
// << endl;
}
else
@ -305,7 +305,7 @@ Foam::label Foam::meshDualiser::addInternalFace
// << " points:" << UIndirectList<point>(meshMod.points(), newFace)
// << " n:" << n
// << " between dualowner:" << dualCell1
// << " dualneigbour:" << dualCell0
// << " dualneighbour:" << dualCell0
// << endl;
}
return dualFacei;
@ -1139,7 +1139,7 @@ void Foam::meshDualiser::setRefinement
);
}
// Detect whether different dual cells on either side of a face. This
// would neccesitate having a dual face built from the face and thus a
// would necessitate having a dual face built from the face and thus a
// dual point at the face centre.
for (label facei = 0; facei < mesh_.nInternalFaces(); facei++)
{

View File

@ -63,7 +63,7 @@ Description
using namespace Foam;
// Create named field from labelList for postprocessing
// Create named field from labelList for post-processing
tmp<volScalarField> createScalarField
(
const fvMesh& mesh,

View File

@ -26,7 +26,7 @@ sortCoupledFaceCells false;
// blockCoeffs dictionary to construct a decompositionMethod to do
// a block subdivision) and then applies the renumberMethod to each
// block in turn. This can be used in large cases to keep the blocks
// fitting in cache with all the the cache misses bunched at the end.
// fitting in cache with all the cache misses bunched at the end.
// This number is the approximate size of the blocks - this gets converted
// to a number of blocks that is the input to the decomposition method.
//blockSize 1000;

View File

@ -470,7 +470,7 @@ int main(int argc, char *argv[])
for (const word& name : sprayFields)
{
// Note: try the various field types. Make sure to
// exit once sucessful conversion to avoid re-read
// exit once successful conversion to avoid re-read
// converted file.
if

View File

@ -174,7 +174,7 @@ Foam::doxygenXmlParser::doxygenXmlParser
}
}
// Skip remanining entries
// Skip remaining entries
skipBlock(is, blockName);
}
else

View File

@ -105,7 +105,7 @@ multiLevelCoeffs
// Other example coefficents
// Other example coefficients
simpleCoeffs
{

View File

@ -75,7 +75,7 @@ Foam::faFieldReconstructor::reconstructFaAreaField
PtrList<faPatchField<Type> > patchFields(mesh_.boundary().size());
// Create global mesh patchs starts
// Create global mesh patches starts
labelList gStarts(mesh_.boundary().size(), -1);

View File

@ -194,7 +194,7 @@ Foam::processorFaMeshes::processorFaMeshes
// || stat == fvMesh::TOPO_PATCH_CHANGE
// )
// {
// // Reread all meshes and addresssing
// // Reread all meshes and addressing
// read();
// }
// return stat;

View File

@ -193,7 +193,7 @@ void pqFoamReaderControls::fireCommand
{
vtkSMProxy* pxy = this->proxy();
prop->SetElement(0, val); // Set int value, toogle bool, etc
prop->SetElement(0, val); // Set int value, toggle bool, etc
// Fire off command
prop->Modified();

View File

@ -287,7 +287,7 @@ Foam::solverTemplate::solverTemplate
fieldTypes_.setSize(nRegion);
fieldDimensions_.setSize(nRegion);
// read templates for solver lists of avaliable
// read templates for solver lists of available
// - fields and dimensions required for the solver
// - models
label regionI = 0;
@ -328,7 +328,7 @@ Foam::solverTemplate::solverTemplate
fieldTypes_.setSize(1);
fieldDimensions_.setSize(1);
// read templates for solver lists of avaliable
// read templates for solver lists of available
// - fields and dimensions required for the solver
// - models
const dictionary fieldDict

View File

@ -56,7 +56,7 @@ class tabulatedWallFunction
{
protected:
// Proteced data
// Protected data
//- Main dictionary
const dictionary dict_;

View File

@ -246,7 +246,7 @@ label markBorderPoints
}
// Get minumum length of edges connected to pointi
// Get minimum length of edges connected to pointi
// Serves to get some local length scale.
scalar minEdgeLen(const triSurface& surf, const label pointi)
{

View File

@ -58,7 +58,7 @@ class adaptiveSolver
//- Cache for dydx at the initial time
mutable scalarField dydx0_;
//- Temprorary for the test-step solution
//- Temporary for the test-step solution
mutable scalarField yTemp_;

View File

@ -128,7 +128,7 @@ private:
// Static data
//- Relative peturbation tolerance. Determines when point is
//- Relative perturbation tolerance. Determines when point is
// considered to be close to face/edge of bb of node.
// The tolerance is relative to the bounding box of the smallest
// node.

View File

@ -306,7 +306,7 @@ public:
//- Iterator to last item in list with const access
// Note that this is not a const_reverse_iterator, this is the
// responsibilty of any derived classes.
// responsibility of any derived classes.
inline const_iterator crbegin() const;
//- End of list for iterators

View File

@ -39,7 +39,7 @@ Note
In a non-const context, the '[]' operator returns a reference to an
existing value. Some caution with out-of-range elements to ensure
that the const version of the [] operator is being called.
The get() method is functionally identical the the '[]' operator, but
The get() method is functionally identical to the '[]' operator, but
is always const access.
The set() and unset() methods return a bool if the value changed.

View File

@ -605,7 +605,7 @@ inline bool Foam::PackedList<nBits>::set
return false;
}
// Lazy evaluation - increase size on assigment
// Lazy evaluation - increase size on assignment
resize(i + 1);
}

View File

@ -146,14 +146,14 @@ public:
// Search
//- Find index of the first occurence of the value.
//- Find index of the first occurrence of the value.
// When start is specified, any occurences before start are ignored.
// Linear search.
// \return -1 if not found.
label find(const T& val, const label start=0) const;
//- Find index of the last occurence of the value.
// When pos is specified, any occurences after pos are ignored.
//- Find index of the last occurrence of the value.
// When pos is specified, any occurrences after pos are ignored.
// Linear search.
// \return -1 if not found.
label rfind(const T& val, const label pos=-1) const;

View File

@ -291,14 +291,14 @@ public:
// Search
//- Find index of the first occurence of the value.
// When start is specified, any occurences before start are ignored.
//- Find index of the first occurrence of the value.
// When start is specified, any occurrences before start are ignored.
// Linear search.
// \return position in list or -1 if not found.
label find(const T& val, const label start=0) const;
//- Find index of the last occurence of the value.
// When pos is specified, any occurences after pos are ignored.
//- Find index of the last occurrence of the value.
// When pos is specified, any occurrences after pos are ignored.
// Linear search.
// \return position in list or -1 if not found.
label rfind(const T& val, const label pos=-1) const;

View File

@ -106,7 +106,7 @@ public:
//- Lookup a given name and return IOobject ptr if found else nullptr
IOobject* lookup(const word& name) const;
//- The list of all IOobects with matching names
//- The list of all IOobjects with matching names
IOobjectList lookup(const wordRe& matcher) const;
//- The list of all IOobjects with matching names

View File

@ -189,7 +189,7 @@ void Foam::Pstream::combineScatter
// Get my communication order
const UPstream::commsStruct& myComm = comms[UPstream::myProcNo(comm)];
// Reveive from up
// Receive from up
if (myComm.above() != -1)
{
if (contiguous<T>())
@ -438,7 +438,7 @@ void Foam::Pstream::listCombineScatter
// Get my communication order
const UPstream::commsStruct& myComm = comms[UPstream::myProcNo(comm)];
// Reveive from up
// Receive from up
if (myComm.above() != -1)
{
if (contiguous<T>())
@ -672,7 +672,7 @@ void Foam::Pstream::mapCombineScatter
// Get my communication order
const UPstream::commsStruct& myComm = comms[UPstream::myProcNo(comm)];
// Reveive from up
// Receive from up
if (myComm.above() != -1)
{
IPstream fromAbove

View File

@ -156,7 +156,7 @@ void Pstream::scatter
// Get my communication order
const commsStruct& myComm = comms[UPstream::myProcNo(comm)];
// Reveive from up
// Receive from up
if (myComm.above() != -1)
{
if (contiguous<T>())

View File

@ -230,7 +230,7 @@ void Pstream::scatterList
// Get my communication order
const commsStruct& myComm = comms[UPstream::myProcNo(comm)];
// Reveive from up
// Receive from up
if (myComm.above() != -1)
{
const labelList& notBelowLeaves = myComm.allNotBelow();

View File

@ -83,7 +83,7 @@ public:
// Enquiry
//- Return the sream prefix
//- Return the stream prefix
const string& prefix() const
{
return prefix_;

View File

@ -130,7 +130,7 @@ public:
BEGIN_STRING = '"',
END_STRING = BEGIN_STRING,
ASSIGN = '=', //!< Assigment/equals [#isseparator]
ASSIGN = '=', //!< Assignment/equals [#isseparator]
ADD = '+', //!< Addition [#isseparator]
SUBTRACT = '-', //!< Substract or start of negative number
MULTIPLY = '*', //!< Multiply [#isseparator]

View File

@ -356,7 +356,7 @@ private:
// The value "a.b.c.d" could be a first-level entry, a second-level
// entry (eg, "a" with "b.c.d", "a.b" with "c.d" etc),
// or just about any other combination.
// The heuristic tries sucessively longer top-level entries
// The heuristic tries successively longer top-level entries
// until there is a suitable match.
//
// \param recursive search parent dictionaries

View File

@ -142,7 +142,7 @@ public:
// if registerCopy is true
regIOobject(const regIOobject&, bool registerCopy);
//- Construct as copy with new name, transfering registry registration
//- Construct as copy with new name, transferring registry registration
// to copy as specified
regIOobject(const word& newName, const regIOobject&, bool registerCopy);
@ -281,7 +281,7 @@ public:
// Writing
//- Pure virtual writaData function.
//- Pure virtual writeData function.
// Must be defined in derived types
virtual bool writeData(Ostream&) const = 0;

View File

@ -410,7 +410,7 @@ Foam::Istream& Foam::dimensionSet::read
{
multiplier = 1.0;
// Read begining of dimensionSet
// Read beginning of dimensionSet
token startToken(is);
if (startToken != token::BEGIN_SQR)
@ -504,7 +504,7 @@ Foam::Istream& Foam::dimensionSet::read
{
multiplier = 1.0;
// Read begining of dimensionSet
// Read beginning of dimensionSet
token startToken(is);
if (startToken != token::BEGIN_SQR)

View File

@ -206,9 +206,9 @@ public:
};
// This function is added to overide the hack in pointPatchField.H
// which enables simple backward compatability with verions using
// referenceLevel in GeometicField
// This function is added to override the hack in pointPatchField.H
// which enables simple backward compatibility with versions using
// referenceLevel in GeometricField
template<class Type>
tmp<Field<Type>> operator+
(

View File

@ -137,7 +137,7 @@ public:
//- Cyclic coupled interface functions
//- Does the patch field perform the transfromation
//- Does the patch field perform the transformation
virtual bool doTransform() const
{
return !(cyclicPatch_.parallel() || pTraits<Type>::rank == 0);

View File

@ -150,7 +150,7 @@ public:
}
}
//- Does the patch field perform the transfromation
//- Does the patch field perform the transformation
virtual bool doTransform() const
{
return

View File

@ -478,8 +478,8 @@ public:
};
// This function is added as a hack to enable simple backward compatability
// with verions using referenceLevel in GeometicField
// This function is added as a hack to enable simple backward compatibility
// with versions using referenceLevel in GeometricField
template<class Type>
const pointPatchField<Type>& operator+
(

View File

@ -138,7 +138,7 @@ Foam::autoPtr<Foam::pointPatchField<Type>> Foam::pointPatchField<Type>::New
}
}
// Construct (but not necesarily returned)
// Construct (but not necessarily returned)
autoPtr<pointPatchField<Type>> pfPtr(cstrIter()(p, iF, dict));
if

View File

@ -259,7 +259,7 @@ public:
//- Remove a file, returning true if successful otherwise false
virtual bool rm(const fileName&) const = 0;
//- Remove a dirctory and its contents
//- Remove a directory and its contents
// \param silent do not report missing directory
virtual bool rmDir
(
@ -276,7 +276,7 @@ public:
// ) const = 0;
// (reg)IOobject functinality
// (reg)IOobject functionality
//- Generate disk file name for object. Opposite of filePath.
// Optional wanted typeName.

View File

@ -1324,7 +1324,7 @@ bool Foam::fileOperations::masterUncollatedFileOperation::read
);
const Pstream::commsStruct& myComm = comms[Pstream::myProcNo()];
// Reveive from up
// Receive from up
if (myComm.above() != -1)
{
IPstream fromAbove

View File

@ -416,7 +416,7 @@ public:
//- Max size of parallel communications. Switches from non-blocking
// to scheduled when reading/writing files. Read as float to enable
// easy specificiation of large sizes.
// easy specification of large sizes.
static float maxMasterFileBufferSize;
@ -541,7 +541,7 @@ public:
//- Remove a file, returning true if successful otherwise false
virtual bool rm(const fileName&) const;
//- Remove a dirctory and its contents
//- Remove a directory and its contents
// \param silent do not report missing directory
virtual bool rmDir
(

View File

@ -608,7 +608,7 @@ bool Foam::fileOperations::uncollatedFileOperation::read
);
const Pstream::commsStruct& myComm = comms[Pstream::myProcNo()];
// Reveive from up
// Receive from up
if (myComm.above() != -1)
{
IPstream fromAbove

View File

@ -191,7 +191,7 @@ public:
//- Remove a file, returning true if successful otherwise false
virtual bool rm(const fileName&) const;
//- Remove a dirctory and its contents
//- Remove a directory and its contents
virtual bool rmDir
(
const fileName& dir,
@ -207,7 +207,7 @@ public:
// ) const;
// (reg)IOobject functinality
// (reg)IOobject functionality
//- Search for an object. checkGlobal : also check undecomposed case
virtual fileName filePath

View File

@ -144,7 +144,7 @@ public:
const tmp<Field<Type>>& tff
) const;
//- Do what is neccessary if the mesh has moved
//- Do what is necessary if the mesh has moved
bool movePoints();
};

Some files were not shown because too many files have changed in this diff Show More