ENH: Corrected spelling mistakes

This commit is contained in:
andy 2012-12-03 11:04:54 +00:00
parent af13fd66ed
commit 09141f30d7
25 changed files with 58 additions and 58 deletions

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
\\ / A nd | Copyright (C) 2011 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -55,10 +55,10 @@ Description
- find most unique face shape (e.g. triangle for prism)
- walk (following either vertices in face or jumping from face to other
face) to other faces and checking face sizes.
- if nessecary try other rotations of this face
(only nessecary for wedge, tet-wedge)
- if nessecary try other faces which most unique face shape
(never nessecary for hex degenerates)
- if necessary try other rotations of this face
(only necessary for wedge, tet-wedge)
- if necessary try other faces which most unique face shape
(never necessary for hex degenerates)
The whole calculation is done such that no lists are allocated during
cell checking. E.g. localFaces_ are always sized to hold max. number

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
\\ / A nd | Copyright (C) 2011 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -47,7 +47,7 @@ Description
cell out of face, edge or point.
- can be appended: added 'out of nothing'.
All this information is nessecary to correctly map fields.
All this information is necessary to correctly map fields.
\par points

View File

@ -673,7 +673,7 @@ void Foam::syncTools::syncEdgeMap
// Now sharedEdgeValues will contain per potential sharedEdge the value.
// (potential since an edge having two shared points is not nessecary a
// (potential since an edge having two shared points is not necessary a
// shared edge).
// Reduce this on the master.

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
\\ / A nd | Copyright (C) 2011 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -151,7 +151,7 @@ static void handler(void)
// Save the pointer (that gamma knows about) so we can safely
// gamma_switch_to_buffer with a valid pointer.
// Not sure if nessecary but do anyway.
// Not sure if necessary but do anyway.
savedBuf.transfer(buf);
// Resize all the buffers

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
\\ / A nd | Copyright (C) 2011 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -424,7 +424,7 @@ void Foam::polyDualMesh::collectPatchInternalFace
{
featEdgeIndices2[i] = dualFace2.size() -1 - featEdgeIndices2[i];
}
// Reverse indices (might not be nessecary but do anyway)
// Reverse indices (might not be necessary but do anyway)
reverse(featEdgeIndices2);
}
}

View File

@ -146,7 +146,7 @@ class fvMeshDistribute
// patchI.
autoPtr<mapPolyMesh> deleteProcPatches(const label patchI);
//- Repatch the mesh. This is only nessecary for the proc
//- Repatch the mesh. This is only necessary for the proc
// boundary faces. newPatchID is over all boundary faces: -1 or
// new patchID. constructFaceMap is being adapted for the
// possible new face position (since proc faces get automatically

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
\\ / A nd | Copyright (C) 2011 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -2720,7 +2720,7 @@ Foam::cellCuts::cellCuts
calcLoopsAndAddressing(cutCells);
// Calculate planes and flip cellLoops if nessecary
// Calculate planes and flip cellLoops if necessary
orientPlanesAndLoops();
if (debug)
@ -2765,7 +2765,7 @@ Foam::cellCuts::cellCuts
calcLoopsAndAddressing(identity(mesh.nCells()));
// Calculate planes and flip cellLoops if nessecary
// Calculate planes and flip cellLoops if necessary
orientPlanesAndLoops();
if (debug)
@ -2811,7 +2811,7 @@ Foam::cellCuts::cellCuts
// Makes sure cuts are consistent
setFromCellLoops(cellLabels, cellLoops, cellEdgeWeights);
// Calculate planes and flip cellLoops if nessecary
// Calculate planes and flip cellLoops if necessary
orientPlanesAndLoops();
if (debug)
@ -2855,7 +2855,7 @@ Foam::cellCuts::cellCuts
// Makes sure cuts are consistent
setFromCellCutter(cellCutter, refCells);
// Calculate planes and flip cellLoops if nessecary
// Calculate planes and flip cellLoops if necessary
orientPlanesAndLoops();
if (debug)
@ -2901,7 +2901,7 @@ Foam::cellCuts::cellCuts
// Makes sure cuts are consistent
setFromCellCutter(cellCutter, cellLabels, cutPlanes);
// Calculate planes and flip cellLoops if nessecary
// Calculate planes and flip cellLoops if necessary
orientPlanesAndLoops();
if (debug)

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
\\ / A nd | Copyright (C) 2011 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -29,7 +29,7 @@ Description
Does
- move boundary points
- split boundary edges (multiple per edge if nessecary)
- split boundary edges (multiple per edge if necessary)
- face-centre decomposes boundary faces
- diagonal split of boundary faces

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
\\ / A nd | Copyright (C) 2011 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -28,7 +28,7 @@ Description
Cuts (splits) cells.
Description of cut is given as a loop of 'cuts' per cell (see cellCuts).
setRefinement() takes this cut description and inserts the nessecary
setRefinement() takes this cut description and inserts the necessary
topoActions (add points/faces/cells) into the polyTopoChange.
Stores added cells/faces/points.

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
\\ / A nd | Copyright (C) 2011 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -192,7 +192,7 @@ public:
//- Remove some refinement. Needs to be supplied subset of
// getSplitFaces() output. Returns list of faces removed
// (can be more or equal but never less than splitFaces - since
// removeFaces might decide to take down unnessecary faces)
// removeFaces might decide to take down unnecessary faces)
// Only call if undoable set.
labelList removeSplitFaces
(

View File

@ -278,7 +278,7 @@ void Foam::perfectInterface::setRefinement
{
affectedFaces.erase(pp1.addressing()[i]);
}
// Remove patch0 from renumbered faces. Should not be nessecary since
// Remove patch0 from renumbered faces. Should not be necessary since
// patch0 and 1 should not share any point (if created by mergeMeshing)
// so affectedFaces should not contain any patch0 faces but you can
// never be sure what the user is doing.
@ -373,7 +373,7 @@ void Foam::perfectInterface::setRefinement
}
// 5. Modify patch0 faces for new points (not really nessecary; see
// 5. Modify patch0 faces for new points (not really necessary; see
// comment above about patch1 and patch0 never sharing points) and
// becoming internal.
const boolList& mfFlip =

View File

@ -713,7 +713,7 @@ void Foam::polyMeshAdder::mergePrimitives
}
// Copy cut face (since cutPoints are copied first no renumbering
// nessecary)
// necessary)
allFaces[allFaceI] = cutFaces[i];
allOwner[allFaceI] = mesh0.faceOwner()[mesh0FaceI];
allNeighbour[allFaceI] = mesh1.faceOwner()[mesh1FaceI] + mesh0.nCells();

View File

@ -1022,7 +1022,7 @@ Foam::label Foam::hexRef8::storeMidPointInfo
}
// Check if this call of storeMidPointInfo is the one that completed all
// the nessecary information.
// the necessary information.
if (changed && haveTwoAnchors && haveTwoFaceMids)
{

View File

@ -114,7 +114,7 @@ class hexRef8
label& zoneFlip
) const;
//- Adds a face on top of existing faceI. Reverses if nessecary.
//- Adds a face on top of existing faceI. Reverses if necessary.
label addFace
(
polyTopoChange& meshMod,
@ -136,7 +136,7 @@ class hexRef8
) const;
//- Modifies existing faceI for either new owner/neighbour or new face
// points. Reverses if nessecary.
// points. Reverses if necessary.
void modFace
(
polyTopoChange& meshMod,

View File

@ -825,7 +825,7 @@ void Foam::fvMeshSubset::setLargeCellSubset
// 3: face coupled and used by one cell only (so should become normal,
// non-coupled patch face)
//
// Note that this is not really nessecary - but means we can size things
// Note that this is not really necessary - but means we can size things
// correctly. Also makes handling coupled faces much easier.
labelList nCellsUsingFace(oldFaces.size(), 0);

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
\\ / A nd | Copyright (C) 2011 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -241,7 +241,7 @@ public:
//- Set the subset from all cells with region == currentRegion.
// Create "oldInternalFaces" patch for exposed
// internal faces (patchID==-1) or use supplied patch.
// Handles coupled patches by if nessecary making coupled patch
// Handles coupled patches by if necessary making coupled patch
// face part of patchID (so uncoupled)
void setLargeCellSubset
(

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
\\ / A nd | Copyright (C) 2011 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -233,7 +233,7 @@ tmp<GeometricField<Type, fvsPatchField, surfaceMesh> > fvMeshSubset::interpolate
}
// Map exposed internal faces. Note: Only nessecary if exposed faces added
// Map exposed internal faces. Note: Only necessary if exposed faces added
// into existing patch but since we don't know that at this point...
forAll(patchFields, patchI)
{

View File

@ -637,7 +637,7 @@ void Foam::autoLayerDriver::setNumLayers
Info<< nl << "Handling points with inconsistent layer specification ..."
<< endl;
// Get for every point (really only nessecary on patch external points)
// Get for every point (really only necessary on patch external points)
// the max and min of any patch faces using it.
labelList maxLayers(patchNLayers.size(), labelMin);
labelList minLayers(patchNLayers.size(), labelMax);

View File

@ -235,7 +235,7 @@ Foam::label Foam::autoRefineDriver::surfaceOnlyRefine
<< " cells (out of " << mesh.globalData().nTotalCells()
<< ')' << endl;
// Stop when no cells to refine or have done minimum nessecary
// Stop when no cells to refine or have done minimum necessary
// iterations and not enough cells to refine.
if
(
@ -438,7 +438,7 @@ Foam::label Foam::autoRefineDriver::shellRefine
<< " cells (out of " << mesh.globalData().nTotalCells()
<< ')' << endl;
// Stop when no cells to refine or have done minimum nessecary
// Stop when no cells to refine or have done minimum necessary
// iterations and not enough cells to refine.
if
(

View File

@ -1108,7 +1108,7 @@ Foam::autoPtr<Foam::mapPolyMesh> Foam::meshRefinement::mergeBaffles
mesh_.setInstance(timeName());
// Update intersections. Recalculate intersections on merged faces since
// this seems to give problems? Note: should not be nessecary since
// this seems to give problems? Note: should not be necessary since
// baffles preserve intersections from when they were created.
labelList newExposedFaces(2*couples.size());
label newI = 0;

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
\\ / A nd | Copyright (C) 2011 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -589,7 +589,7 @@ Foam::label Foam::edgeIntersections::removeDegenerates
// If edge not already marked for retesting
if (!affectedEdges[edgeI])
{
// 1. Check edges close to endpoint and perturb if nessecary.
// 1. Check edges close to endpoint and perturb if necessary.
bool shiftedEdgeEndPoints =
inlinePerturb

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
\\ / A nd | Copyright (C) 2011 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -204,7 +204,7 @@ void Foam::orientedSurface::propagateOrientation
if (side == triSurfaceTools::UNKNOWN)
{
// Non-closed surface. Do what? For now behave as if no flipping
// nessecary
// necessary
flipState[nearestFaceI] = NOFLIP;
}
else if ((side == triSurfaceTools::OUTSIDE) == orientOutside)

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
\\ / A nd | Copyright (C) 2011 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -101,7 +101,7 @@ class orientedSurface
);
//- Given nearest point and face check orientation to nearest face
// and flip if nessecary (only marked in flipState) and propagate.
// and flip if necessary (only marked in flipState) and propagate.
static void propagateOrientation
(
const triSurface&,

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
\\ / A nd | Copyright (C) 2011 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -451,7 +451,7 @@ Foam::meshTriangulation::meshTriangulation
}
}
// Shrink if nessecary (because of invalid triangulations)
// Shrink if necessary (because of invalid triangulations)
triangles.setSize(triI);
faceMap_.setSize(triI);

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
\\ / A nd | Copyright (C) 2011 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2012 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -62,7 +62,7 @@ public:
// Private Member Functions
//- Update. Gets information from neighbouring face/cell and
// uses this to update itself (if nessecary) and return true.
// uses this to update itself (if necessary) and return true.
template<class TrackingData>
inline bool update
(