1
0
mirror of https://git.dev.opencascade.org/repos/occt.git synced 2025-04-04 18:06:22 +03:00

Documentation - Fix various typos found in codebase #361

Found via `codespell -q 3 -S "*.fr" -L aadd,abnd,abord,acount,adn,afile,aline,alo,alocation,alog,als,anc,ane,anid,anormal,anout,ans,anumber,aother,aparent,apoints,aprogram,asender,asign,asnd,ba,bbuild,bloc,bord,bu,caf,cas,childrens,childs,classe,clen,commun,cylindre,don,dout,dum,ede,entites,fo,fonction,guid,hist,identic,ii,indx,inout,invalide,ist,iterm,llength,lod,mape,modeling,methode,mye,myu,nam,nd,nin,normale,normales,ons,parametre,parametres,periode,pres,reste,resul,secont,serie,shs,slin,som,somme,syntaxe,sur,te,thei,theis,ther,theres,thes,thev,thex,thet,tol,transfert,va,vas,verifie,vertexes,weight`
This commit is contained in:
luzpaz 2025-02-11 07:38:56 -05:00 committed by GitHub
parent 87c04f1833
commit f423143109
No known key found for this signature in database
GPG Key ID: B5690EEEBB952194
100 changed files with 178 additions and 176 deletions

View File

@ -6480,7 +6480,7 @@ blend b b 2 .
==fleche : 0.001 ==fleche : 0.001
==tolblend 0.01 0.0001 1e-05 0.001 ==tolblend 0.01 0.0001 1e-05 0.001
==Pick an object ==Pick an object
# click on the edge you want ot fillet # click on the edge you want to fillet
==COMPUTE: temps total 0.1s dont : ==COMPUTE: temps total 0.1s dont :
==- Init + ExtentAnalyse 0s ==- Init + ExtentAnalyse 0s

View File

@ -2782,7 +2782,7 @@ The *TObj* sources are distributed in the following packages:
* **External links** -- references from one data structure to another data structure in another document. * **External links** -- references from one data structure to another data structure in another document.
To store these references properly, a label must also contain an external link attribute. To store these references properly, a label must also contain an external link attribute.
* **Father** -- a label, from which other labels have been created. The other labels are, by definition, the children of this label. * **Father** -- a label, from which other labels have been created. The other labels are, by definition, the children of this label.
* **Framework** -- a group of co-operating classes which enable a design to be re-used for a given category of problem. The framework guides the architecture of the application by breaking it up into abstract classes, each of which has different responsibilities and collaborates in a predefined way. Application developer creates a specialized framework by: * **Framework** -- a group of co-operating classes which enable a design to be reused for a given category of problem. The framework guides the architecture of the application by breaking it up into abstract classes, each of which has different responsibilities and collaborates in a predefined way. Application developer creates a specialized framework by:
* defining new classes which inherit from these abstract classes * defining new classes which inherit from these abstract classes
* composing framework class instances * composing framework class instances
* implementing the services required by the framework. * implementing the services required by the framework.

View File

@ -459,7 +459,7 @@ Boolean flag regulating translation of entities that define tessellated geometry
* TRIANGULATED_FACE * TRIANGULATED_FACE
* COMPLEX_TRIANGULATED_FACE * COMPLEX_TRIANGULATED_FACE
Tesselated geometry is attached to shapes as objects of <i>Poly_Triangulation</i> type using STEP links. Tessellated geometry is attached to shapes as objects of <i>Poly_Triangulation</i> type using STEP links.
* 0 (Off) -- do not translate * 0 (Off) -- do not translate
* 1 (On) -- translate * 1 (On) -- translate
@ -1020,7 +1020,7 @@ Boolean flag regulating writing of entities that define tessellated geometry:
* TESSELLATED_SOLID * TESSELLATED_SOLID
* TRIANGULATED_FACE * TRIANGULATED_FACE
Tesselated geometry is taken as objects of <i>Poly_Triangulation type</i> from the active <i>TopoDS_Face</i> triangulation. Tessellated geometry is taken as objects of <i>Poly_Triangulation type</i> from the active <i>TopoDS_Face</i> triangulation.
* 0 (Off) -- do not write * 0 (Off) -- do not write
* 1 (On) -- write * 1 (On) -- write

View File

@ -18,7 +18,7 @@
#include <AdvApp2Var_Context.hxx> #include <AdvApp2Var_Context.hxx>
#include <Standard_ConstructionError.hxx> #include <Standard_ConstructionError.hxx>
// Calculaton of parameters // Calculation of parameters
static Standard_Boolean lesparam(const Standard_Integer iordre, static Standard_Boolean lesparam(const Standard_Integer iordre,
const Standard_Integer ncflim, const Standard_Integer ncflim,
const Standard_Integer icodeo, const Standard_Integer icodeo,

View File

@ -17,8 +17,10 @@
#ifndef _AdvApp2Var_CriterionType_HeaderFile #ifndef _AdvApp2Var_CriterionType_HeaderFile
#define _AdvApp2Var_CriterionType_HeaderFile #define _AdvApp2Var_CriterionType_HeaderFile
//! influency of the criterion on cutting process//! cutting when criterion is not satisfied //! influence of the criterion on cutting process
//! desactivation of the compute of the error max//! cutting when error max is not good or if error //! cutting when criterion is not satisfied
//! deactivation of the compute of the error max
//! cutting when error max is not good or if error
//! max is good and criterion is not satisfied //! max is good and criterion is not satisfied
enum AdvApp2Var_CriterionType enum AdvApp2Var_CriterionType
{ {

View File

@ -5339,7 +5339,7 @@ int mmherm1_(doublereal* debfin,
/* INPUT ARGUMENTS : */ /* INPUT ARGUMENTS : */
/* -------------------- */ /* -------------------- */
/* DEBFIN : PARAMETES DEFINING THE CONSTRAINTS */ /* DEBFIN : PARAMETERS DEFINING THE CONSTRAINTS */
/* DEBFIN(1) : FIRST PARAMETER */ /* DEBFIN(1) : FIRST PARAMETER */
/* DEBFIN(2) : SECOND PARAMETER */ /* DEBFIN(2) : SECOND PARAMETER */

View File

@ -459,7 +459,7 @@ Standard_Boolean Approx_SweepApproximation::D0(const Standard_Real Param,
AAffin->Value(ii).Transforms(myPoles2d->ChangeValue(ii).ChangeCoord()); AAffin->Value(ii).Transforms(myPoles2d->ChangeValue(ii).ChangeCoord());
} }
// Update variables of controle and return // Update variables of control and return
first = First; first = First;
last = Last; last = Last;
myOrder = 0; myOrder = 0;

View File

@ -4733,7 +4733,7 @@ void BRepBuilderAPI_Sewing::CreateOutputInformations()
} }
} }
// Fill maps of Free, Contigous and Multiple edges // Fill maps of Free, Contiguous and Multiple edges
TopTools_IndexedDataMapOfShapeListOfShape::Iterator anIter(edgeSections); TopTools_IndexedDataMapOfShapeListOfShape::Iterator anIter(edgeSections);
for (; anIter.More(); anIter.Next()) for (; anIter.More(); anIter.Next())
{ {

View File

@ -154,7 +154,7 @@ Standard_Boolean BRepGProp_UFunction::CenterMassValue(const Standard_Real X, Sta
//======================================================================= //=======================================================================
// function : InertiaValue // function : InertiaValue
// purpose : Compute the value of intertia. // purpose : Compute the value of inertia.
//======================================================================= //=======================================================================
Standard_Boolean BRepGProp_UFunction::InertiaValue(const Standard_Real X, Standard_Real& F) Standard_Boolean BRepGProp_UFunction::InertiaValue(const Standard_Real X, Standard_Real& F)

View File

@ -83,7 +83,7 @@ private:
//! Private method. Returns the value for volume computation. //! Private method. Returns the value for volume computation.
//! Other returned values are: //! Other returned values are:
//! - thePMP0 - PSurf(X,Y) minus Location. //! - thePMP0 - PSurf(X,Y) minus Location.
//! - theS and theD1 coeffitients that are computed and used //! - theS and theD1 coefficients that are computed and used
//! for computation of center of mass and inertia values //! for computation of center of mass and inertia values
//! by plane. //! by plane.
Standard_EXPORT Standard_Real VolumeValue(const Standard_Real X, Standard_EXPORT Standard_Real VolumeValue(const Standard_Real X,
@ -98,7 +98,7 @@ private:
//! computation of a value. //! computation of a value.
Standard_EXPORT Standard_Boolean CenterMassValue(const Standard_Real X, Standard_Real& F); Standard_EXPORT Standard_Boolean CenterMassValue(const Standard_Real X, Standard_Real& F);
//! Private method. Computes the value of intertia. The type of //! Private method. Computes the value of inertia. The type of
//! a value returned is defined by the value type. If it is //! a value returned is defined by the value type. If it is
//! other then GProp_InertiaXX, GProp_InertiaYY, //! other then GProp_InertiaXX, GProp_InertiaYY,
//! GProp_InertiaZZ, GProp_InertiaXY, GProp_InertiaXZ or //! GProp_InertiaZZ, GProp_InertiaXY, GProp_InertiaXZ or

View File

@ -115,7 +115,7 @@ protected:
//! Internal function //! Internal function
Standard_EXPORT void Find(); Standard_EXPORT void Find();
//! Method chec found intersection point //! Method check found intersection point
Standard_EXPORT Standard_Boolean FindPoint(); Standard_EXPORT Standard_Boolean FindPoint();
//! Method to clear fields of class //! Method to clear fields of class

View File

@ -62,7 +62,7 @@ public:
const IMeshTools_Parameters& theParameters) const; const IMeshTools_Parameters& theParameters) const;
//! Returns point in 3d space corresponded to the given //! Returns point in 3d space corresponded to the given
//! point defined in parameteric space of surface. //! point defined in parametric space of surface.
gp_Pnt Point(const gp_Pnt2d& thePoint2d) const gp_Pnt Point(const gp_Pnt2d& thePoint2d) const
{ {
return GetSurface()->Value(thePoint2d.X(), thePoint2d.Y()); return GetSurface()->Value(thePoint2d.X(), thePoint2d.Y());

View File

@ -21,7 +21,7 @@
#include <GeomLib.hxx> #include <GeomLib.hxx>
//! Extends node insertion Delaunay meshing algo in order to control //! Extends node insertion Delaunay meshing algo in order to control
//! deflection of generated trianges. Splits triangles failing the check. //! deflection of generated triangles. Splits triangles failing the check.
template <class RangeSplitter, class BaseAlgo> template <class RangeSplitter, class BaseAlgo>
class BRepMesh_DelaunayDeflectionControlMeshAlgo class BRepMesh_DelaunayDeflectionControlMeshAlgo
: public BRepMesh_DelaunayNodeInsertionMeshAlgo<RangeSplitter, BaseAlgo> : public BRepMesh_DelaunayNodeInsertionMeshAlgo<RangeSplitter, BaseAlgo>

View File

@ -1356,7 +1356,7 @@ void BRepOffset_Inter3d::ContextIntByArc(const TopTools_IndexedMapOfShape& Conte
if (InitOffsetFace.HasImage(EV)) if (InitOffsetFace.HasImage(EV))
{ {
//------------------------------------------------- //-------------------------------------------------
// OF1 parallel face generated by an ancester edge of V[i]. // OF1 parallel face generated by an ancestor edge of V[i].
//------------------------------------------------- //-------------------------------------------------
OF1 = TopoDS::Face(InitOffsetFace.Image(EV).First()); OF1 = TopoDS::Face(InitOffsetFace.Image(EV).First());
OE = TopoDS::Edge(InitOffsetEdge.Image(V[i]).First()); OE = TopoDS::Edge(InitOffsetEdge.Image(V[i]).First());

View File

@ -3132,10 +3132,10 @@ void BRepOffset_MakeOffset::MakeMissingWalls(const Message_ProgressRange& theRan
// Then edge is trimmed by intersection line between // Then edge is trimmed by intersection line between
// two adjacent extended offset faces and get vertices. // two adjacent extended offset faces and get vertices.
// When intersection lines are invalid for any reason, // When intersection lines are invalid for any reason,
// (one of reson is mixed connectivity of faces) // (one reason is mixed connectivity of faces)
// algoritm of cutting offset edge by intersection line // algorithm of cutting offset edge by intersection line
// can fail and offset edge cannot get vertices. // can fail and offset edge cannot get vertices.
// Follwing workaround is only to avoid exception if V3 and V4 are Null // Following workaround is only to avoid exception if V3 and V4 are Null
// Vertex points are invalid. // Vertex points are invalid.
Standard_Real anOEF, anOEL; Standard_Real anOEF, anOEL;
TopAbs_Orientation anOEOri = OE.Orientation(); TopAbs_Orientation anOEOri = OE.Orientation();

View File

@ -137,7 +137,7 @@ public: //! @name History methods
protected: protected:
//! Analyze progress steps of the whole operation. //! Analyze progress steps of the whole operation.
//! @param theWhole - sum of progress of all operations. //! @param theWhole - sum of progress of all operations.
//! @oaram theSteps - steps of the operations supported by PI //! @param theSteps - steps of the operations supported by PI
Standard_EXPORT void analyzeProgress(const Standard_Real theWhole, Standard_EXPORT void analyzeProgress(const Standard_Real theWhole,
TColStd_Array1OfReal& theSteps) const; TColStd_Array1OfReal& theSteps) const;

View File

@ -1298,7 +1298,7 @@ void BRepOffset_BuildOffsetFaces::BuildSplitsOfFaces(const Message_ProgressRange
Standard_Boolean bAllInv = Standard_True; Standard_Boolean bAllInv = Standard_True;
// Additional check for artificial case // Additional check for artificial case
// if current image face consist only of edges from aMapEInv and aMENInv // if current image face consist only of edges from aMapEInv and aMENInv
// then recheck current face for the futher processing // then recheck current face for the further processing
Standard_Boolean aToReCheckFace = bArtificialCase; Standard_Boolean aToReCheckFace = bArtificialCase;
const TopoDS_Shape& aFIm = aItLFIm.Value(); const TopoDS_Shape& aFIm = aItLFIm.Value();
TopExp_Explorer aExpE(aFIm, TopAbs_EDGE); TopExp_Explorer aExpE(aFIm, TopAbs_EDGE);
@ -1321,7 +1321,7 @@ void BRepOffset_BuildOffsetFaces::BuildSplitsOfFaces(const Message_ProgressRange
{ {
aToReCheckFace = checkConnectionsOfFace(aFIm, aLFImages1); aToReCheckFace = checkConnectionsOfFace(aFIm, aLFImages1);
} }
// do not delete image face from futher processing if aToReCheckFace is true // do not delete image face from further processing if aToReCheckFace is true
if (!aExpE.More() && !aToReCheckFace) if (!aExpE.More() && !aToReCheckFace)
{ {
if (bAllInv) if (bAllInv)
@ -5474,7 +5474,7 @@ namespace
{ {
//======================================================================= //=======================================================================
// function : mapShapes // function : mapShapes
// purpose : Collect theVecShapes into theMap with setted theType // purpose : Collect theVecShapes into theMap with theType set
//======================================================================= //=======================================================================
template <class Container> template <class Container>
static void mapShapes(const Container& theVecShapes, static void mapShapes(const Container& theVecShapes,

View File

@ -68,7 +68,7 @@ public:
Standard_EXPORT BRepOffset_MakeSimpleOffset(const TopoDS_Shape& theInputShape, Standard_EXPORT BRepOffset_MakeSimpleOffset(const TopoDS_Shape& theInputShape,
const Standard_Real theOffsetValue); const Standard_Real theOffsetValue);
//! Initialies shape for modifications. //! Initialise shape for modifications.
Standard_EXPORT void Initialize(const TopoDS_Shape& theInputShape, Standard_EXPORT void Initialize(const TopoDS_Shape& theInputShape,
const Standard_Real theOffsetValue); const Standard_Real theOffsetValue);

View File

@ -150,11 +150,11 @@ public:
Standard_EXPORT Standard_Real GetX2Max() const; Standard_EXPORT Standard_Real GetX2Max() const;
//! Opens <me> in <d1> direction. A face and its edges //! Opens <me> in <d1> direction. A face and its edges
//! or vertices are said nonexistant. //! or vertices are said nonexistent.
Standard_EXPORT void Open(const BRepPrim_Direction d1); Standard_EXPORT void Open(const BRepPrim_Direction d1);
//! Closes <me> in <d1> direction. A face and its //! Closes <me> in <d1> direction. A face and its
//! edges or vertices are said existant. //! edges or vertices are said existent.
Standard_EXPORT void Close(const BRepPrim_Direction d1); Standard_EXPORT void Close(const BRepPrim_Direction d1);
//! Returns True if <me> is open in <d1> direction. //! Returns True if <me> is open in <d1> direction.

View File

@ -116,7 +116,7 @@ static Standard_Boolean getNormalFromVertex(const TopoDS_Shape& theShape,
//======================================================================= //=======================================================================
// function : FindExtrema // function : FindExtrema
// purpose : This finction is called to find the nearest normal projection // purpose : This function is called to find the nearest normal projection
// of a point <aPnt> on a shape <aShape>. // of a point <aPnt> on a shape <aShape>.
// 1) return true if extrema is found. // 1) return true if extrema is found.
// 2) Set in: // 2) Set in:

View File

@ -64,7 +64,7 @@
//! //!
//! The method Has... is given because in some special //! The method Has... is given because in some special
//! cases, a vertex, an edge or a face may be //! cases, a vertex, an edge or a face may be
//! geometricaly nonexistant or not useful. //! geometricaly nonexistent or not useful.
class BRepSweep_NumLinearRegularSweep class BRepSweep_NumLinearRegularSweep
{ {
public: public:

View File

@ -1213,7 +1213,7 @@ Standard_Integer offsetparameter(Draw_Interpretor& di, Standard_Integer n, const
di << " --> TheInter : "; di << " --> TheInter : ";
if (TheInter) if (TheInter)
{ {
di << "Complet"; di << "Complete";
} }
else else
{ {

View File

@ -1639,7 +1639,7 @@ public:
//! WeightsResult one has the result of the evaluation of //! WeightsResult one has the result of the evaluation of
//! the denominator //! the denominator
//! //!
//! Warning: <PolesResult> and <WeightsResult> must be dimensionned //! Warning: <PolesResult> and <WeightsResult> must be dimensioned
//! properly. //! properly.
Standard_EXPORT static void Eval(const Standard_Real U, Standard_EXPORT static void Eval(const Standard_Real U,
const Standard_Boolean PeriodicFlag, const Standard_Boolean PeriodicFlag,
@ -1686,7 +1686,7 @@ public:
//! <Continuity> must be equal to 1, 2 or 3. //! <Continuity> must be equal to 1, 2 or 3.
//! <Degree> must be greater or equal than <Continuity> + 1. //! <Degree> must be greater or equal than <Continuity> + 1.
//! //!
//! Warning: <KnotsResult> and <PolesResult> must be dimensionned //! Warning: <KnotsResult> and <PolesResult> must be dimensioned
//! properly. //! properly.
Standard_EXPORT static void TangExtendToConstraint(const TColStd_Array1OfReal& FlatKnots, Standard_EXPORT static void TangExtendToConstraint(const TColStd_Array1OfReal& FlatKnots,
const Standard_Real C1Coefficient, const Standard_Real C1Coefficient,

View File

@ -170,7 +170,7 @@ public:
//! //!
//! x(1)/w , x(2)/w , ... derivated <N,0> times //! x(1)/w , x(2)/w , ... derivated <N,0> times
//! .... //! ....
//! Warning: <RDers> must be dimensionned properly. //! Warning: <RDers> must be dimensioned properly.
Standard_EXPORT static void RationalDerivative(const Standard_Integer UDeg, Standard_EXPORT static void RationalDerivative(const Standard_Integer UDeg,
const Standard_Integer VDeg, const Standard_Integer VDeg,
const Standard_Integer N, const Standard_Integer N,

View File

@ -34,7 +34,7 @@ public:
//! Returns parallel flag. //! Returns parallel flag.
inline Standard_Boolean IsParallel() const { return myIsParallel; } inline Standard_Boolean IsParallel() const { return myIsParallel; }
//! Set parallel flag contolling possibility of parallel execution. //! Set parallel flag controlling possibility of parallel execution.
inline void SetParallel(const Standard_Boolean isParallel) { myIsParallel = isParallel; } inline void SetParallel(const Standard_Boolean isParallel) { myIsParallel = isParallel; }
protected: protected:

View File

@ -47,7 +47,7 @@ public:
//! Returns parallel flag. //! Returns parallel flag.
inline Standard_Boolean IsParallel() const { return myIsParallel; } inline Standard_Boolean IsParallel() const { return myIsParallel; }
//! Set parallel flag contolling possibility of parallel execution. //! Set parallel flag controlling possibility of parallel execution.
inline void SetParallel(const Standard_Boolean isParallel) { myIsParallel = isParallel; } inline void SetParallel(const Standard_Boolean isParallel) { myIsParallel = isParallel; }
public: public:

View File

@ -43,7 +43,7 @@ public:
//! Returns parallel flag. //! Returns parallel flag.
inline Standard_Boolean IsParallel() const { return myIsParallel; } inline Standard_Boolean IsParallel() const { return myIsParallel; }
//! Set parallel flag contolling possibility of parallel execution. //! Set parallel flag controlling possibility of parallel execution.
inline void SetParallel(const Standard_Boolean isParallel) { myIsParallel = isParallel; } inline void SetParallel(const Standard_Boolean isParallel) { myIsParallel = isParallel; }
private: private:

View File

@ -3306,7 +3306,7 @@ Standard_Real ChFi3d_ConvTol2dToTol3d(const Handle(Adaptor3d_Surface)& S, const
//======================================================================= //=======================================================================
// function : EvalTolReached // function : EvalTolReached
// purpose : The function above is too hard because // purpose : The function above is too hard because
// parametrization of surfaces is not homogenous. // parametrization of surfaces is not homogeneous.
//======================================================================= //=======================================================================
Standard_Real ChFi3d_EvalTolReached(const Handle(Adaptor3d_Surface)& S1, Standard_Real ChFi3d_EvalTolReached(const Handle(Adaptor3d_Surface)& S1,

View File

@ -946,7 +946,7 @@ Standard_Boolean ChFi3d_Builder::PerformElement(const Handle(ChFiDS_Spine)& Spin
{ {
// there is no need of tolerance // there is no need of tolerance
// to make a decision (PRO9486) the regularity is enough. // to make a decision (PRO9486) the regularity is enough.
// However, the abcense of turn-back is checked (PRO9810) // However, the absence of turn-back is checked (PRO9810)
OnAjoute = ((!rev && av1v2 < M_PI / 2) || (rev && av1v2 > M_PI / 2)); OnAjoute = ((!rev && av1v2 < M_PI / 2) || (rev && av1v2 > M_PI / 2));
// mate attention to the single case (cf CTS21610_1) // mate attention to the single case (cf CTS21610_1)
if (OnAjoute && (degeneOnEc || TangentOnVertex(LVEc, Ev, myEFMap, ta))) if (OnAjoute && (degeneOnEc || TangentOnVertex(LVEc, Ev, myEFMap, ta)))

View File

@ -4397,7 +4397,7 @@ void ChFi3d_Builder::IntersectMoreCorner(const Standard_Integer Index)
} }
// Fopbis is the face containing the trace of fillet CP.Arc() which of does not contain Vtx. // Fopbis is the face containing the trace of fillet CP.Arc() which of does not contain Vtx.
// Normallly Fobis is either the same as Fop (cylinder), or Fobis is G1 with Fop. // Normally Fobis is either the same as Fop (cylinder), or Fobis is G1 with Fop.
Fopbis.Orientation(TopAbs_FORWARD); Fopbis.Orientation(TopAbs_FORWARD);
// Fop calls the 4th face non-used for the vertex // Fop calls the 4th face non-used for the vertex

View File

@ -143,7 +143,7 @@ Standard_Boolean ChFi3d_Builder::PerformTwoCornerbyInter(const Standard_Integer
ChFiDS_SequenceOfSurfData& SeqFil2 = Corner2->ChangeSetOfSurfData()->ChangeSequence(); ChFiDS_SequenceOfSurfData& SeqFil2 = Corner2->ChangeSetOfSurfData()->ChangeSequence();
Handle(ChFiDS_SurfData)& Fd2 = SeqFil2.ChangeValue(IFd2); Handle(ChFiDS_SurfData)& Fd2 = SeqFil2.ChangeValue(IFd2);
// The concavities are analysed in case of differents concavities, // The concavities are analysed in case of different concavities,
// preview an evolutionary connection of type ThreeCorner of R to 0. // preview an evolutionary connection of type ThreeCorner of R to 0.
// Otherwise the opposite face // Otherwise the opposite face
// and the eventual intersection of 2 pcurves on this face are found. // and the eventual intersection of 2 pcurves on this face are found.

View File

@ -2403,7 +2403,7 @@ void ChFi3d_Builder::PerformMoreThreeCorner(const Standard_Integer Jndex,
// nbiter - number of iterations, when surface from previous iteration uses as initial surface for // nbiter - number of iterations, when surface from previous iteration uses as initial surface for
// next one practically this process does not converge, using "bad" initial surface leads to much // next one practically this process does not converge, using "bad" initial surface leads to much
// more "bad" solution. constr is order of constraint: 0 - G0, 1 - G1 ... Using constraint order > // more "bad" solution. constr is order of constraint: 0 - G0, 1 - G1 ... Using constraint order >
// 0 very often causes unpredicable undulations of solution // 0 very often causes unpredictable undulations of solution
Standard_Integer degree = 3, nbcurvpnt = 10, nbiter = 1; Standard_Integer degree = 3, nbcurvpnt = 10, nbiter = 1;
Standard_Integer constr = 1; // G1 Standard_Integer constr = 1; // G1
GeomPlate_BuildPlateSurface PSurf(degree, nbcurvpnt, nbiter, tol2d, tolapp3d, angular); GeomPlate_BuildPlateSurface PSurf(degree, nbcurvpnt, nbiter, tol2d, tolapp3d, angular);

View File

@ -123,7 +123,7 @@ static Handle(GeomAdaptor_Surface) BoundSurf(const Handle(Geom_Surface)& S,
// the SurfData of the corner <SDCoin>. Here we know the // the SurfData of the corner <SDCoin>. Here we know the
// extremities of the intersection <pdeb> and <pfin>, and // extremities of the intersection <pdeb> and <pfin>, and
// their parameters <p2dfin>, <p2ddeb> on <SD>. // their parameters <p2dfin>, <p2ddeb> on <SD>.
// <ptcoindeb> cointains the intersection 2d point on the corner // <ptcoindeb> contains the intersection 2d point on the corner
// which corresponds to the point <pdeb> // which corresponds to the point <pdeb>
// <derudeb> and <dervdeb> are the derivative vectors on the // <derudeb> and <dervdeb> are the derivative vectors on the
// SurfData <SD> at the point <ptdeb> // SurfData <SD> at the point <ptdeb>

View File

@ -223,8 +223,8 @@ static Standard_Integer hlr(Draw_Interpretor& di, Standard_Integer n, const char
} }
else if (!strcasecmp(a[1], "ang")) else if (!strcasecmp(a[1], "ang"))
{ {
di << "Angle de discretisation : "; di << "Angle of discretization : ";
di << aParams.HLRAngle * 180 / M_PI << " degres\n"; di << aParams.HLRAngle * 180 / M_PI << " degrees\n";
} }
else else
return 1; return 1;
@ -733,7 +733,7 @@ static Standard_Integer nexplode(Draw_Interpretor& di, Standard_Integer n, const
} }
} }
} }
// Check of equality of MidXYZ // Check equality of MidXYZ
for (Index = 1; Index < MaxShapes; Index++) for (Index = 1; Index < MaxShapes; Index++)
{ {
if (MidXYZ(OrderInd(Index + 1)) == MidXYZ(OrderInd(Index))) if (MidXYZ(OrderInd(Index + 1)) == MidXYZ(OrderInd(Index)))

View File

@ -345,7 +345,7 @@ Function:
Method: Method:
Let Pp be the projection of point P in plane XOY of the torus; Let Pp be the projection of point P in plane XOY of the torus;
2 cases are consideres: 2 cases are considered:
1- distance(Pp,O) < Tol: 1- distance(Pp,O) < Tol:
There is an infinite number of solutions; IsDone() = Standard_False. There is an infinite number of solutions; IsDone() = Standard_False.
2- distance(Pp,O) > Tol: 2- distance(Pp,O) > Tol:

View File

@ -687,7 +687,7 @@ void Extrema_GenExtCS::GlobMinCQuadric(const Adaptor3d_Curve& theC,
// //
// Increase numbers of curve samples to improve searching global minimum // Increase numbers of curve samples to improve searching global minimum
// because dimension of optimisation task is redused // because dimension of optimisation task is reduced
const Standard_Integer aMaxNbNodes = 50; const Standard_Integer aMaxNbNodes = 50;
Standard_Integer aNewCsample = mytsample; Standard_Integer aNewCsample = mytsample;
Standard_Integer anAddsample = Max(myusample / 2, 3); Standard_Integer anAddsample = Max(myusample / 2, 3);

View File

@ -171,7 +171,7 @@ Method:
- F: Extrema_FuncExtPS created from P and S, - F: Extrema_FuncExtPS created from P and S,
- UV: math_Vector the components which of are parameters of the extremum on the - UV: math_Vector the components which of are parameters of the extremum on the
grid, grid,
- Tol: Min(TolU,TolV), (Prov.:math_FunctionSetRoot does not autorize a vector) - Tol: Min(TolU,TolV), (Prov.:math_FunctionSetRoot does not authorize a vector)
- UVinf: math_Vector the components which of are lower limits of u and v, - UVinf: math_Vector the components which of are lower limits of u and v,
- UVsup: math_Vector the components which of are upper limits of u and v. - UVsup: math_Vector the components which of are upper limits of u and v.

View File

@ -247,7 +247,7 @@ public:
//! . UDegree is greater than MaxDegree. //! . UDegree is greater than MaxDegree.
//! . the Length of CPoles is not equal to NbVPoles //! . the Length of CPoles is not equal to NbVPoles
//! . a weight value is lower or equal to Resolution from //! . a weight value is lower or equal to Resolution from
//! pacakage gp //! package gp
Standard_EXPORT void InsertPoleRowBefore(const Standard_Integer UIndex, Standard_EXPORT void InsertPoleRowBefore(const Standard_Integer UIndex,
const TColgp_Array1OfPnt& CPoles, const TColgp_Array1OfPnt& CPoles,
const TColStd_Array1OfReal& CPoleWeights); const TColStd_Array1OfReal& CPoleWeights);

View File

@ -2211,7 +2211,7 @@ void GeomPlate_BuildPlateSurface::Discretise(
{ {
if (((!mySurfInitIsGive) if (((!mySurfInitIsGive)
&& (Geom2dAdaptor_Curve(LinCont->Curve2dOnSurf()).GetType() != GeomAbs_Circle)) && (Geom2dAdaptor_Curve(LinCont->Curve2dOnSurf()).GetType() != GeomAbs_Circle))
|| ((j > 1) && (j < NbPnt_i))) // exclude extremeties || ((j > 1) && (j < NbPnt_i))) // exclude extremities
myPlateCont->ChangeValue(i).Append(Inter); // add the point myPlateCont->ChangeValue(i).Append(Inter); // add the point
} }
} }

View File

@ -23,7 +23,7 @@
#include <Standard_Integer.hxx> #include <Standard_Integer.hxx>
#include <TopAbs_State.hxx> #include <TopAbs_State.hxx>
//! The Coincidence class is used in an Inteference to //! The Coincidence class is used in an Interference to
//! store information on the "hiding" edge. //! store information on the "hiding" edge.
//! //!
//! 2D Data: The tangent and the curvature of the //! 2D Data: The tangent and the curvature of the

View File

@ -50,7 +50,7 @@ public:
//! <TC> allows to run additional copies as required //! <TC> allows to run additional copies as required
//! //!
//! In case of Error, use methods CCheck from the ContextModif //! In case of Error, use methods CCheck from the ContextModif
//! to aknowledge an entity Check or a Global Check with messages //! to acknowledge an entity Check or a Global Check with messages
Standard_EXPORT virtual void Perform(IFSelect_ContextModif& ctx, Standard_EXPORT virtual void Perform(IFSelect_ContextModif& ctx,
const Handle(Interface_InterfaceModel)& target, const Handle(Interface_InterfaceModel)& target,
const Handle(Interface_Protocol)& protocol, const Handle(Interface_Protocol)& protocol,

View File

@ -38,7 +38,7 @@ DEFINE_STANDARD_HANDLE(IFSelect_SelectSignature, IFSelect_SelectExtract)
//! contains (the Type's Name must contain the criterium Text) //! contains (the Type's Name must contain the criterium Text)
//! //!
//! Remark that no more interpretation is done, it is an //! Remark that no more interpretation is done, it is an
//! alpha-numeric signature : for instance, DynamicType is matched //! alphanumeric signature : for instance, DynamicType is matched
//! as such, super-types are not considered //! as such, super-types are not considered
//! //!
//! Also, numeric (integer) comparisons are supported : an item //! Also, numeric (integer) comparisons are supported : an item

View File

@ -35,7 +35,7 @@ class Standard_Transient;
//! WorkSession and an Ascii Form, to be considered as a Dump. //! WorkSession and an Ascii Form, to be considered as a Dump.
//! It allows to write the File from the WorkSession, and later //! It allows to write the File from the WorkSession, and later
//! read the File to the WorkSession, by keeping required //! read the File to the WorkSession, by keeping required
//! descriptions (such as dependances). //! descriptions (such as dependences).
//! //!
//! The produced File is under an Ascii Form, then it may be //! The produced File is under an Ascii Form, then it may be
//! easily consulted. //! easily consulted.
@ -75,7 +75,7 @@ public:
//! Creates a SessionFile which Writes the content of a WorkSession //! Creates a SessionFile which Writes the content of a WorkSession
//! to a File (directly calls Write) //! to a File (directly calls Write)
//! Then, IsDone aknowledges on the result of the Operation. //! Then, IsDone acknowledges on the result of the Operation.
//! But such a SessionFile may not Read a File to a WorkSession. //! But such a SessionFile may not Read a File to a WorkSession.
Standard_EXPORT IFSelect_SessionFile(const Handle(IFSelect_WorkSession)& WS, Standard_EXPORT IFSelect_SessionFile(const Handle(IFSelect_WorkSession)& WS,
const Standard_CString filename); const Standard_CString filename);

View File

@ -642,7 +642,7 @@ public:
//! undefined), positive if OK, negative else : //! undefined), positive if OK, negative else :
//! 0 : Nothing done //! 0 : Nothing done
//! 1 : OK, edition on the spot with no change to the graph //! 1 : OK, edition on the spot with no change to the graph
//! of dependances (purely local) //! of dependencies (purely local)
//! 2 : OK, model edited on the spot (graph recomputed, may //! 2 : OK, model edited on the spot (graph recomputed, may
//! have changed), protocol unchanged //! have changed), protocol unchanged
//! 3 : OK, new model produced, same protocol //! 3 : OK, new model produced, same protocol
@ -654,7 +654,7 @@ public:
//! -2 : Error on edition the spot, data may be corrupted //! -2 : Error on edition the spot, data may be corrupted
//! (checking them is recommended) //! (checking them is recommended)
//! -3 : Error with a new data set, transformation ignored //! -3 : Error with a new data set, transformation ignored
//! -4 : OK as 4, but graph of dependances count not be recomputed //! -4 : OK as 4, but graph of dependences count not be recomputed
//! (the former one is kept) : check the protocol //! (the former one is kept) : check the protocol
Standard_EXPORT Standard_Integer RunTransformer(const Handle(IFSelect_Transformer)& transf); Standard_EXPORT Standard_Integer RunTransformer(const Handle(IFSelect_Transformer)& transf);
@ -795,7 +795,7 @@ public:
//! See the class PacketList for more details. //! See the class PacketList for more details.
Standard_EXPORT Handle(IFSelect_PacketList) EvalSplit() const; Standard_EXPORT Handle(IFSelect_PacketList) EvalSplit() const;
//! Returns the list of Entities sent in files, accourding the //! Returns the list of Entities sent in files, according to the
//! count of files each one has been sent (these counts are reset //! count of files each one has been sent (these counts are reset
//! by SetModel or SetRemaining(Forget) ) stored in Graph Status //! by SetModel or SetRemaining(Forget) ) stored in Graph Status
//! <count> = -1 (default) is for ENtities sent at least once //! <count> = -1 (default) is for ENtities sent at least once

View File

@ -354,7 +354,7 @@ void IGESCAFControl_Writer::MakeColors(const TopoDS_Shape&
} }
else else
{ {
// may be S was splited during shape process // may be S was split during shape process
Handle(Transfer_Binder) bnd = FP->Find(mapper); Handle(Transfer_Binder) bnd = FP->Find(mapper);
if (!bnd.IsNull()) if (!bnd.IsNull())
{ {

View File

@ -57,7 +57,7 @@ public:
//! <modetrans> is to be interpreted by each kind of XstepAdaptor //! <modetrans> is to be interpreted by each kind of XstepAdaptor
//! Returns a status : 0 OK 1 No result 2 Fail -1 bad modeshape //! Returns a status : 0 OK 1 No result 2 Fail -1 bad modeshape
//! -2 bad model (requires an IGESModel) //! -2 bad model (requires an IGESModel)
//! modeshape : 0 groupe of face (version < 5.1) //! modeshape : 0 group of face (version < 5.1)
//! 1 BREP-version 5.1 of IGES //! 1 BREP-version 5.1 of IGES
Standard_EXPORT virtual IFSelect_ReturnStatus TransferWriteShape( Standard_EXPORT virtual IFSelect_ReturnStatus TransferWriteShape(
const TopoDS_Shape& shape, const TopoDS_Shape& shape,

View File

@ -267,7 +267,7 @@ Standard_Integer IGESConvGeom::SplineSurfaceFromIGES(const Handle(IGESGeom_Splin
if ((NbUSeg < 1) || (NbVSeg < 1)) if ((NbUSeg < 1) || (NbVSeg < 1))
return 5; return 5;
// Output BSpline knots & multiplicities arraies for U & V : // Output BSpline knots & multiplicities arrays for U & V :
// ========================================================= // =========================================================
TColStd_Array1OfReal UKnot(1, NbUSeg + 1); TColStd_Array1OfReal UKnot(1, NbUSeg + 1);

View File

@ -185,7 +185,7 @@ public:
//! Warning 0 is returned if no subscript number is defined for this IGES entity. //! Warning 0 is returned if no subscript number is defined for this IGES entity.
Standard_EXPORT Standard_Integer SubScriptNumber() const; Standard_EXPORT Standard_Integer SubScriptNumber() const;
//! Initializes a directory field as an Entiy of any kind //! Initializes a directory field as an Entity of any kind
//! See DirFieldEntity for more details //! See DirFieldEntity for more details
Standard_EXPORT void InitDirFieldEntity(const Standard_Integer fieldnum, Standard_EXPORT void InitDirFieldEntity(const Standard_Integer fieldnum,
const Handle(IGESData_IGESEntity)& ent); const Handle(IGESData_IGESEntity)& ent);

View File

@ -46,7 +46,7 @@ class IGESData_IGESReaderData : public Interface_FileReaderData
{ {
public: public:
//! creates IGESReaderData correctly dimensionned (for arrays) //! creates IGESReaderData correctly dimensioned (for arrays)
//! <nbe> count of entities, that is, half nb of directory lines //! <nbe> count of entities, that is, half nb of directory lines
//! <nbp> : count of parameters //! <nbp> : count of parameters
Standard_EXPORT IGESData_IGESReaderData(const Standard_Integer nbe, const Standard_Integer nbp); Standard_EXPORT IGESData_IGESReaderData(const Standard_Integer nbe, const Standard_Integer nbp);

View File

@ -70,7 +70,7 @@ public:
//! Sends an additional Starting Line : this is the way used to //! Sends an additional Starting Line : this is the way used to
//! send comments in an IGES File (at beginning of the file). //! send comments in an IGES File (at beginning of the file).
//! If the line is more than 72 char.s long, it is splited into //! If the line is more than 72 chars long, it is split into
//! as many lines as required to send it completely //! as many lines as required to send it completely
Standard_EXPORT void SendStartLine(const Standard_CString startline); Standard_EXPORT void SendStartLine(const Standard_CString startline);
@ -143,7 +143,7 @@ public:
const Standard_Boolean negative = Standard_False); const Standard_Boolean negative = Standard_False);
//! Helper method to avoid ambiguity of calls to above methods Send() for //! Helper method to avoid ambiguity of calls to above methods Send() for
//! classes derived from IGESData_IGESEntity, for VC++ 10 and 11 compillers //! classes derived from IGESData_IGESEntity, for VC++ 10 and 11 compilers
template <class T> template <class T>
void Send(const Handle(T)& val, void Send(const Handle(T)& val,
Standard_Boolean negative = Standard_False, Standard_Boolean negative = Standard_False,

View File

@ -50,7 +50,7 @@ public:
const Handle(IGESData_HArray1OfIGESEntity)& allGeoms, const Handle(IGESData_HArray1OfIGESEntity)& allGeoms,
const Handle(IGESDimen_HArray1OfLeaderArrow)& allLeaders); const Handle(IGESDimen_HArray1OfLeaderArrow)& allLeaders);
//! Changes FormNumber (indicates the Nature of the Symbole) //! Changes FormNumber (indicates the Nature of the Symbol)
//! Error if not in ranges [0-3] or [> 5000] //! Error if not in ranges [0-3] or [> 5000]
Standard_EXPORT void SetFormNumber(const Standard_Integer form); Standard_EXPORT void SetFormNumber(const Standard_Integer form);

View File

@ -964,7 +964,7 @@ Handle(Geom_Curve) IGESToBRep_BasicCurve::TransferBSplineCurve(
for (i = 0; i <= start->UpperIndex(); i++) for (i = 0; i <= start->UpperIndex(); i++)
Pole.SetValue(PoleIndex++, start->Pole(i)); Pole.SetValue(PoleIndex++, start->Pole(i));
// Filling knots & multiplicities arraies : // Filling knots & multiplicities arrays :
// ======================================== // ========================================
Standard_Integer NbKnots = start->NbKnots(); Standard_Integer NbKnots = start->NbKnots();
@ -992,7 +992,7 @@ Handle(Geom_Curve) IGESToBRep_BasicCurve::TransferBSplineCurve(
TempKnot.SetValue(++KnotIndex, Knot1); TempKnot.SetValue(++KnotIndex, Knot1);
} }
// Final knots & multiplicities arraies are dimensionned so as to be fully // Final knots & multiplicities arrays are dimensioned so as to be fully
// filled // filled
// ======================================================================= // =======================================================================

View File

@ -673,7 +673,7 @@ Handle(Geom_BSplineSurface) IGESToBRep_BasicSurface::TransferBSplineSurface(
TempUKnot.SetValue(++UIndex, UKnot1); TempUKnot.SetValue(++UIndex, UKnot1);
} }
// Final knots & multiplicities arraies are dimensionned so as to be fully // Final knots & multiplicities arrays are dimensioned so as to be fully
// filled : // filled :
// ======================================================================= // =======================================================================
@ -745,7 +745,7 @@ Handle(Geom_BSplineSurface) IGESToBRep_BasicSurface::TransferBSplineSurface(
TempVKnot.SetValue(++VIndex, VKnot1); TempVKnot.SetValue(++VIndex, VKnot1);
} }
// Final knots & multiplicities arraies are dimensionned so as to be fully // Final knots & multiplicities arrays are dimensioned so as to be fully
// filled : // filled :
// ======================================================================= // =======================================================================

View File

@ -116,7 +116,7 @@ public:
void SetSurfaceCurve(const Standard_Integer ival); void SetSurfaceCurve(const Standard_Integer ival);
//! Returns the value of "mySurfaceCurve" 0 = value in //! Returns the value of "mySurfaceCurve" 0 = value in
//! file , 2 = kepp 2d and compute 3d 3 = keep 3d and //! file, 2 = keep 2d and compute 3d, 3 = keep 3d and
//! compute 2d //! compute 2d
Standard_Integer GetSurfaceCurve() const; Standard_Integer GetSurfaceCurve() const;

View File

@ -90,7 +90,7 @@ IVtkDraw_HighlightAndSelectionPipeline::IVtkDraw_HighlightAndSelectionPipeline(
IVtkTools_SubPolyDataFilter* aSUBFilterH = IVtkTools_SubPolyDataFilter* aSUBFilterH =
IVtkTools_SubPolyDataFilter::SafeDownCast(myFilterMap.Find(Filter_SUB_Hili)); IVtkTools_SubPolyDataFilter::SafeDownCast(myFilterMap.Find(Filter_SUB_Hili));
// No highligthing exists initially // No highlighting exists initially
aSUBFilterH->SetInputConnection(aDataSource->GetOutputPort()); aSUBFilterH->SetInputConnection(aDataSource->GetOutputPort());
aDMFilterH->SetInputConnection(aSUBFilterH->GetOutputPort()); aDMFilterH->SetInputConnection(aSUBFilterH->GetOutputPort());
@ -119,7 +119,7 @@ IVtkDraw_HighlightAndSelectionPipeline::IVtkDraw_HighlightAndSelectionPipeline(
IVtkTools_SubPolyDataFilter* aSUBFilterS = IVtkTools_SubPolyDataFilter* aSUBFilterS =
IVtkTools_SubPolyDataFilter::SafeDownCast(myFilterMap.Find(Filter_SUB_Sel)); IVtkTools_SubPolyDataFilter::SafeDownCast(myFilterMap.Find(Filter_SUB_Sel));
// No highligthing exists initially // No highlighting exists initially
aSUBFilterS->SetInputConnection(aDataSource->GetOutputPort()); aSUBFilterS->SetInputConnection(aDataSource->GetOutputPort());
aDMFilterS->SetInputConnection(aSUBFilterS->GetOutputPort()); aDMFilterS->SetInputConnection(aSUBFilterS->GetOutputPort());

View File

@ -57,7 +57,7 @@ public:
//! Deactivate the given selection //! Deactivate the given selection
void Deactivate(const Handle(SelectMgr_Selection)& theSelection); void Deactivate(const Handle(SelectMgr_Selection)& theSelection);
//! Converts VTK camera defiened for input view to OCC camera //! Converts VTK camera defined for input view to OCC camera
static Handle(Graphic3d_Camera) ConvertVtkToOccCamera(const IVtk_IView::Handle& theView); static Handle(Graphic3d_Camera) ConvertVtkToOccCamera(const IVtk_IView::Handle& theView);
DEFINE_STANDARD_RTTIEXT(IVtkOCC_ViewerSelector, SelectMgr_ViewerSelector) DEFINE_STANDARD_RTTIEXT(IVtkOCC_ViewerSelector, SelectMgr_ViewerSelector)

View File

@ -766,7 +766,7 @@ void IntPatch_ALineToWLine::MakeWLine(const Handle(IntPatch_ALine)& theALine,
if (aPrePointExist == IntPatch_SPntPole || aPrePointExist == IntPatch_SPntPoleSeamU) if (aPrePointExist == IntPatch_SPntPole || aPrePointExist == IntPatch_SPntPoleSeamU)
{ {
// set correxponding status: to be corrected later // set corresponding status: to be corrected later
if (aLinOn2S->NbPoints() == 1) if (aLinOn2S->NbPoints() == 1)
anIsFirstDegenerated = Standard_True; anIsFirstDegenerated = Standard_True;
else else
@ -778,7 +778,7 @@ void IntPatch_ALineToWLine::MakeWLine(const Handle(IntPatch_ALine)& theALine,
{ {
if (aNbPointsPrev == aLinOn2S->NbPoints()) if (aNbPointsPrev == aLinOn2S->NbPoints())
{ {
// Vertex coinsides any point of line and was not added into line // Vertex coincides any point of line and was not added into line
aNewVertexParam = aNbPointsPrev; aNewVertexParam = aNbPointsPrev;
} }
aPrevParam = aParameter = aCurVertParam; aPrevParam = aParameter = aCurVertParam;

View File

@ -4014,7 +4014,7 @@ public:
Standard_Boolean& theIsIncreasing); Standard_Boolean& theIsIncreasing);
//! Computes U2 (U-parameter of the 2nd cylinder) and, if theDelta != 0, //! Computes U2 (U-parameter of the 2nd cylinder) and, if theDelta != 0,
//! esimates the tolerance of U2-computing (estimation result is //! estimates the tolerance of U2-computing (estimation result is
//! assigned to *theDelta value). //! assigned to *theDelta value).
static Standard_Boolean CylCylComputeParameters(const Standard_Real theU1par, static Standard_Boolean CylCylComputeParameters(const Standard_Real theU1par,
const Standard_Integer theWLIndex, const Standard_Integer theWLIndex,
@ -6974,9 +6974,9 @@ static IntPatch_ImpImpIntersection::IntStatus CyCyNoGeometric(
&& ((aVSurf2l - aV2[i]) * (aVSurf2l - aV2Prev[i]) < RealSmall())); && ((aVSurf2l - aV2[i]) * (aVSurf2l - aV2Prev[i]) < RealSmall()));
// isFound1 == TRUE if intersection line intersects V-bounds // isFound1 == TRUE if intersection line intersects V-bounds
// (First or Last - no matter) of the 1st cylynder // (First or Last - no matter) of the 1st cylinder
// isFound2 == TRUE if intersection line intersects V-bounds // isFound2 == TRUE if intersection line intersects V-bounds
// (First or Last - no matter) of the 2nd cylynder // (First or Last - no matter) of the 2nd cylinder
Standard_Boolean isFound1 = Standard_False, isFound2 = Standard_False; Standard_Boolean isFound1 = Standard_False, isFound2 = Standard_False;
Standard_Boolean isForce = Standard_False; Standard_Boolean isForce = Standard_False;

View File

@ -1807,7 +1807,7 @@ void IntPatch_WLineTool::ExtendTwoWLines(IntPatch_SequenceOfLine& theSli
continue; continue;
} }
// Enable/Disable of some ckeck. Bit-mask is used for it. // Enable/Disable of some check. Bit-mask is used for it.
// E.g. if 1st point of aWLine1 matches with // E.g. if 1st point of aWLine1 matches with
// 1st point of aWLine2 then we do not need in check // 1st point of aWLine2 then we do not need in check
// 1st point of aWLine1 and last point of aWLine2 etc. // 1st point of aWLine1 and last point of aWLine2 etc.

View File

@ -136,7 +136,7 @@ public:
//! Clears LastFlags only. This allows to know what Entities are //! Clears LastFlags only. This allows to know what Entities are
//! copied after its call (see method LastCopiedAfter). It can be //! copied after its call (see method LastCopiedAfter). It can be
//! used when copies are done by increments, which must be //! used when copies are done by increments, which must be
//! distinghished. ClearLastFlags is also called by Clear. //! distinguished. ClearLastFlags is also called by Clear.
Standard_EXPORT void ClearLastFlags(); Standard_EXPORT void ClearLastFlags();
//! Returns an copied Entity and its Result which were operated //! Returns an copied Entity and its Result which were operated

View File

@ -58,13 +58,13 @@ public:
//! Returns the other Node extremity of <me>. //! Returns the other Node extremity of <me>.
Standard_EXPORT Handle(MAT_Node) SecondNode() const; Standard_EXPORT Handle(MAT_Node) SecondNode() const;
//! an Arc has two Node, if <aNode> egal one //! An Arc has two Node, if <aNode> equals one
//! Returns the other. //! Returns the other.
//! //!
//! if <aNode> is not oh <me> //! if <aNode> is not oh <me>
Standard_EXPORT Handle(MAT_Node) TheOtherNode(const Handle(MAT_Node)& aNode) const; Standard_EXPORT Handle(MAT_Node) TheOtherNode(const Handle(MAT_Node)& aNode) const;
//! Returnst True is there is an arc linked to //! Returns True if there is an arc linked to
//! the Node <aNode> located on the side <aSide> of <me>; //! the Node <aNode> located on the side <aSide> of <me>;
//! if <aNode> is not on <me> //! if <aNode> is not on <me>
Standard_EXPORT Standard_Boolean HasNeighbour(const Handle(MAT_Node)& aNode, Standard_EXPORT Standard_Boolean HasNeighbour(const Handle(MAT_Node)& aNode,

View File

@ -69,7 +69,7 @@ MeshVS_Mesh::MeshVS_Mesh(const Standard_Boolean theIsAllowOverlapped)
SetAutoHilight(Standard_False); SetAutoHilight(Standard_False);
SetDisplayMode(MeshVS_DMF_WireFrame); // Mode as defaut SetDisplayMode(MeshVS_DMF_WireFrame); // Mode as default
SetHilightMode(MeshVS_DMF_WireFrame); // Wireframe as default hilight mode SetHilightMode(MeshVS_DMF_WireFrame); // Wireframe as default hilight mode
SetColor(Quantity_NOC_WHITE); SetColor(Quantity_NOC_WHITE);

View File

@ -59,7 +59,7 @@ public:
//! (std::ios_base::in will be implicitly added) //! (std::ios_base::in will be implicitly added)
//! @param[in] theOffset expected stream position from the beginning of the file (beginning of //! @param[in] theOffset expected stream position from the beginning of the file (beginning of
//! the stream by default); //! the stream by default);
//! -1 would keep seek position undefined (in case of re-using //! -1 would keep seek position undefined (in case of reusing
//! theOldStream) //! theOldStream)
//! @param[in] theOldStream a pointer to existing stream pointing to theUrl to be reused (without //! @param[in] theOldStream a pointer to existing stream pointing to theUrl to be reused (without
//! re-opening) //! re-opening)

View File

@ -112,7 +112,7 @@ public:
//! ... //! ...
//! x(1)/w , x(2)/w , ... derivated <N> times //! x(1)/w , x(2)/w , ... derivated <N> times
//! //!
//! Warning: <RDers> must be dimensionned properly. //! Warning: <RDers> must be dimensioned properly.
Standard_EXPORT static void RationalDerivative(const Standard_Integer Degree, Standard_EXPORT static void RationalDerivative(const Standard_Integer Degree,
const Standard_Integer N, const Standard_Integer N,
const Standard_Integer Dimension, const Standard_Integer Dimension,
@ -148,7 +148,7 @@ public:
//! can be same since the overwrite is non destructive within //! can be same since the overwrite is non destructive within
//! the algorithm //! the algorithm
//! //!
//! Warning: <RationalDerivates> must be dimensionned properly. //! Warning: <RationalDerivates> must be dimensioned properly.
Standard_EXPORT static void RationalDerivatives(const Standard_Integer DerivativesRequest, Standard_EXPORT static void RationalDerivatives(const Standard_Integer DerivativesRequest,
const Standard_Integer Dimension, const Standard_Integer Dimension,
Standard_Real& PolesDerivatives, Standard_Real& PolesDerivatives,

View File

@ -42,7 +42,7 @@ class gp_XYZ;
class gp_XY; class gp_XY;
class math_Matrix; class math_Matrix;
//! This class implement a variationnal spline algorithm able //! This class implement a variational spline algorithm able
//! to define a two variable function satisfying some constraints //! to define a two variable function satisfying some constraints
//! and minimizing an energy like criterion. //! and minimizing an energy like criterion.
class Plate_Plate class Plate_Plate

View File

@ -367,7 +367,7 @@ static Standard_Boolean ExactBound(gp_Pnt& Sol,
LastV = Surface->LastVParameter(); LastV = Surface->LastVParameter();
// Here we have to compute the boundary that projection is going to intersect // Here we have to compute the boundary that projection is going to intersect
gp_Vec2d D2d; gp_Vec2d D2d;
// these variables are to estimate which boundary has more apportunity // these variables are to estimate which boundary has more opportunity
// to be intersected // to be intersected
Standard_Real RU1, RU2, RV1, RV2; Standard_Real RU1, RU2, RV1, RV2;
d1(Sol.X(), U0, V0, D2d, Curve, Surface); d1(Sol.X(), U0, V0, D2d, Curve, Surface);

View File

@ -119,7 +119,7 @@ public:
protected: protected:
//! Override this method to change logic of anchor point computation. //! Override this method to change logic of anchor point computation.
//! Computes anchor point. Its computation is based on the current //! Computes anchor point. Its computation is based on the current
//! dimension plane. Therfore, anchor point is an intersection of plane //! dimension plane. Therefore, anchor point is an intersection of plane
//! and circle. //! and circle.
//! ATTENTION! //! ATTENTION!
//! 1) The plane should be set or computed before. //! 1) The plane should be set or computed before.

View File

@ -91,7 +91,7 @@ DEFINE_STANDARD_HANDLE(PrsDim_Dimension, AIS_InteractiveObject)
//! Being a 2D drawings, the dimensions are created on imaginary plane, called "dimension plane", //! Being a 2D drawings, the dimensions are created on imaginary plane, called "dimension plane",
//! which can be thought of as reference system of axes (X,Y,N) for constructing the presentation. //! which can be thought of as reference system of axes (X,Y,N) for constructing the presentation.
//! //!
//! The role of axes of the dimension plane is to guide you through the encapsualted automations //! The role of axes of the dimension plane is to guide you through the encapsulated automations
//! of presentation building to help you understand how is the presentation will look and how it //! of presentation building to help you understand how is the presentation will look and how it
//! will be oriented in model space during construction. //! will be oriented in model space during construction.
//! //!
@ -515,7 +515,7 @@ protected:
gp_Pln& thePlane, gp_Pln& thePlane,
Standard_Boolean& theIsPlaneOld) const; Standard_Boolean& theIsPlaneOld) const;
protected: //! @name Static auxilliary methods for geometry extraction protected: //! @name Static auxiliary methods for geometry extraction
//! If it is possible extracts circle from planar face. //! If it is possible extracts circle from planar face.
//! @param[in] theFace the planar face //! @param[in] theFace the planar face
//! @param[out] theCurve the circular curve //! @param[out] theCurve the circular curve

View File

@ -263,7 +263,7 @@ void PrsDim_EqualDistanceRelation::ComputeSelection(const Handle(SelectMgr_Selec
BRepAdaptor_Curve aCurve(TopoDS::Edge(mySShape)); BRepAdaptor_Curve aCurve(TopoDS::Edge(mySShape));
if (aCurve.GetType() == GeomAbs_Line) if (aCurve.GetType() == GeomAbs_Line)
{ {
// add sensetive element - line // add sensitive element - line
seg = new Select3D_SensitiveSegment(own, myAttachPoint2, myPoint2); seg = new Select3D_SensitiveSegment(own, myAttachPoint2, myPoint2);
aSelection->Add(seg); aSelection->Add(seg);
} }
@ -290,7 +290,7 @@ void PrsDim_EqualDistanceRelation::ComputeSelection(const Handle(SelectMgr_Selec
BRepAdaptor_Curve aCurve(TopoDS::Edge(myShape3)); BRepAdaptor_Curve aCurve(TopoDS::Edge(myShape3));
if (aCurve.GetType() == GeomAbs_Line) if (aCurve.GetType() == GeomAbs_Line)
{ {
// add sensetive element - line // add sensitive element - line
seg = new Select3D_SensitiveSegment(own, myAttachPoint3, myPoint3); seg = new Select3D_SensitiveSegment(own, myAttachPoint3, myPoint3);
aSelection->Add(seg); aSelection->Add(seg);
} }
@ -322,7 +322,7 @@ void PrsDim_EqualDistanceRelation::ComputeSelection(const Handle(SelectMgr_Selec
BRepAdaptor_Curve aCurve(TopoDS::Edge(myShape4)); BRepAdaptor_Curve aCurve(TopoDS::Edge(myShape4));
if (aCurve.GetType() == GeomAbs_Line) if (aCurve.GetType() == GeomAbs_Line)
{ {
// add sensetive element - line // add sensitive element - line
seg = new Select3D_SensitiveSegment(own, myAttachPoint4, myPoint4); seg = new Select3D_SensitiveSegment(own, myAttachPoint4, myPoint4);
aSelection->Add(seg); aSelection->Add(seg);
} }

View File

@ -67,7 +67,7 @@ public:
//! Sets flag to skip data loading. //! Sets flag to skip data loading.
void SetToSkipLateDataLoading(bool theToSkip) { myToSkipLateDataLoading = theToSkip; } void SetToSkipLateDataLoading(bool theToSkip) { myToSkipLateDataLoading = theToSkip; }
//! Returns TRUE if data should be loaded into itself without its transfering to new structure. //! Returns TRUE if data should be loaded into itself without its transferring to new structure.
//! It allows to keep information about deferred storage to load/unload this data later. //! It allows to keep information about deferred storage to load/unload this data later.
//! TRUE by default. //! TRUE by default.
bool ToKeepLateData() { return myToKeepLateData; } bool ToKeepLateData() { return myToKeepLateData; }

View File

@ -306,7 +306,7 @@ bool RWGltf_ExtrasParser::parseArray(const RWGltf_JsonValue& theValue,
return true; return true;
} }
// Unsupported type of array. Print waring and return. // Unsupported type of array. Print warning and return.
Message::SendWarning() << "Warning: Extras owner \"" << myParentID << "\", Value \"" Message::SendWarning() << "Warning: Extras owner \"" << myParentID << "\", Value \""
<< theValueName << "\" - " << theValueName << "\" - "
<< "Array of unsupported type is detected. It will be skipped."; << "Array of unsupported type is detected. It will be skipped.";

View File

@ -76,7 +76,7 @@ void RWStepShape_RWAngularLocation::ReadStep(const Handle(StepData_StepReaderDat
// Own fields of AngularLocation // Own fields of AngularLocation
// PTV 16.09.2000 // PTV 16.09.2000
// default value set as StepShape_Small, cause there wasn`t default value, but may be situation // default value set as StepShape_Small, cause there wasn't default value, but may be situation
// when value will not be initialized and returned in ent->Init. // when value will not be initialized and returned in ent->Init.
StepShape_AngleRelator aAngleSelection = StepShape_Small; StepShape_AngleRelator aAngleSelection = StepShape_Small;
if (data->ParamType(num, 5) == Interface_ParamEnum) if (data->ParamType(num, 5) == Interface_ParamEnum)

View File

@ -109,7 +109,7 @@ Standard_Integer CountNormals(const Handle(Poly_Triangulation)& theTriangulation
//======================================================================= //=======================================================================
// function : GenerateNormalsArray // function : GenerateNormalsArray
// purpose : Generates array of normals from theTriangulation. Normals // purpose : Generates array of normals from theTriangulation. Normals
// wiil be transformed with theTransformation. // will be transformed with theTransformation.
// IMPORTANT: Output will be nullptr if theTriangulation has // IMPORTANT: Output will be nullptr if theTriangulation has
// no normals. // no normals.
//======================================================================= //=======================================================================
@ -1567,7 +1567,7 @@ Handle(StepVisual_TessellatedGeometricSet) STEPCAFControl_GDTProperty::GetTessel
// Build tesselated_curve_set. // Build tesselated_curve_set.
Handle(StepVisual_TessellatedCurveSet) aTCS = GenerateTessellatedCurveSet(theShape); Handle(StepVisual_TessellatedCurveSet) aTCS = GenerateTessellatedCurveSet(theShape);
// Fill the container of tesselated items. // Fill the container of tessellated items.
NCollection_Handle<StepVisual_Array1OfTessellatedItem> aTesselatedItems = NCollection_Handle<StepVisual_Array1OfTessellatedItem> aTesselatedItems =
new StepVisual_Array1OfTessellatedItem(1, static_cast<Standard_Integer>(aCTSSs.size()) + 1); new StepVisual_Array1OfTessellatedItem(1, static_cast<Standard_Integer>(aCTSSs.size()) + 1);
aTesselatedItems->SetValue(1, aTCS); aTesselatedItems->SetValue(1, aTCS);

View File

@ -1005,7 +1005,7 @@ static Standard_Integer FindEntities(const Handle(Transfer_FinderProcess)& theFP
return 1; return 1;
} }
// may be S was splited during shape processing // may be S was split during shape processing
Handle(TransferBRep_ShapeMapper) aMapper = TransferBRep::ShapeMapper(theFP, theShape); Handle(TransferBRep_ShapeMapper) aMapper = TransferBRep::ShapeMapper(theFP, theShape);
Handle(Transfer_Binder) aBinder = theFP->Find(aMapper); Handle(Transfer_Binder) aBinder = theFP->Find(aMapper);
if (aBinder.IsNull()) if (aBinder.IsNull())

View File

@ -1799,7 +1799,7 @@ void SWDRAW_ShapeUpgrade::InitCommands(Draw_Interpretor& theCommands)
// theCommands.Add("DT_SplitFace", "DT_SplitFace Result Face Tol", // theCommands.Add("DT_SplitFace", "DT_SplitFace Result Face Tol",
// __FILE__, DT_SplitFace,g); // __FILE__, DT_SplitFace,g);
// theCommands.Add("DT_Debug", "DT_Debug 0/1 : activation/desactivation of the debug messages", // theCommands.Add("DT_Debug", "DT_Debug 0/1 : activation/deactivation of the debug messages",
// __FILE__, DT_Debug,g); // __FILE__, DT_Debug,g);
// theCommands.Add ("shellsolid","option[a-b-c-f] shape result", // theCommands.Add ("shellsolid","option[a-b-c-f] shape result",
// __FILE__,shellsolid,g); // __FILE__,shellsolid,g);

View File

@ -227,7 +227,7 @@ public:
//! also says this. Otherwise additional analysis is performed, //! also says this. Otherwise additional analysis is performed,
//! comparing given precision with the following distances: //! comparing given precision with the following distances:
//! - periodic B-Splines are closed, //! - periodic B-Splines are closed,
//! - polinomial B-Spline with boundary multiplicities degree+1 //! - polynomial B-Spline with boundary multiplicities degree+1
//! and Bezier - maximum distance between poles, //! and Bezier - maximum distance between poles,
//! - rational B-Spline or one with boundary multiplicities not //! - rational B-Spline or one with boundary multiplicities not
//! degree+1 - maximum distance computed at knots and their //! degree+1 - maximum distance computed at knots and their
@ -244,7 +244,7 @@ public:
//! also says this. Otherwise additional analysis is performed, //! also says this. Otherwise additional analysis is performed,
//! comparing given precision with the following distances: //! comparing given precision with the following distances:
//! - periodic B-Splines are closed, //! - periodic B-Splines are closed,
//! - polinomial B-Spline with boundary multiplicities degree+1 //! - polynomial B-Spline with boundary multiplicities degree+1
//! and Bezier - maximum distance between poles, //! and Bezier - maximum distance between poles,
//! - rational B-Spline or one with boundary multiplicities not //! - rational B-Spline or one with boundary multiplicities not
//! degree+1 - maximum distance computed at knots and their //! degree+1 - maximum distance computed at knots and their

View File

@ -379,7 +379,7 @@ void ShapeAnalysis_WireOrder::Perform(const Standard_Boolean /*closed*/)
{ {
aJointMask2D |= (1 << 3); aJointMask2D |= (1 << 3);
} }
// new approche for detecting best edge connection, for all other cases used old 3D // new approch for detecting best edge connection, for all other cases used old 3D
// algorithm // algorithm
Standard_Integer aFullMask = aJointMask3D & aJointMask2D; Standard_Integer aFullMask = aJointMask3D & aJointMask2D;
if (aFullMask != 0) if (aFullMask != 0)

View File

@ -1642,7 +1642,7 @@ Standard_Boolean ShapeCustom_BSplineRestriction::ConvertCurve2d(const Handle(Geo
catch (Standard_Failure const& anException) catch (Standard_Failure const& anException)
{ {
#ifdef OCCT_DEBUG #ifdef OCCT_DEBUG
std::cout << "Warning: Geom2dConvert_ApproxCurve Exception: Wrong Cofficient :Decrease " std::cout << "Warning: Geom2dConvert_ApproxCurve Exception: Wrong Coefficient :Decrease "
"Continuity "; "Continuity ";
anException.Print(std::cout); anException.Print(std::cout);
std::cout << std::endl; std::cout << std::endl;

View File

@ -26,7 +26,7 @@ class Geom2d_Curve;
class Geom2d_BSplineCurve; class Geom2d_BSplineCurve;
//! Converts curve2d to analytical form with given //! Converts curve2d to analytical form with given
//! precision or simpify curve2d. //! precision or simplify curve2d.
class ShapeCustom_Curve2d class ShapeCustom_Curve2d
{ {
public: public:

View File

@ -53,7 +53,7 @@ class StepData_StepReaderData : public Interface_FileReaderData
{ {
public: public:
//! creates StepReaderData correctly dimensionned (necessary at //! creates StepReaderData correctly dimensioned (necessary at
//! creation time, because it contains arrays) //! creation time, because it contains arrays)
//! nbheader is nb of records for Header, nbtotal for Header+Data //! nbheader is nb of records for Header, nbtotal for Header+Data
//! and nbpar gives the total count of parameters //! and nbpar gives the total count of parameters

View File

@ -92,7 +92,7 @@ void TDF_CopyTool::Copy(const Handle(TDF_DataSet)& aSourceDataSet,
// except for the label unattached attributes, // except for the label unattached attributes,
// but everybody can update the relocation table... // but everybody can update the relocation table...
// Now: the paste phasis! // Now: the paste phase!
TDF_DataMapIteratorOfAttributeDataMap attItr2(theAttMap); TDF_DataMapIteratorOfAttributeDataMap attItr2(theAttMap);
for (; attItr2.More(); attItr2.Next()) for (; attItr2.More(); attItr2.Next())
{ {

View File

@ -57,7 +57,7 @@ class TCollection_AsciiString;
return TDF_DERIVED_##Class(); \ return TDF_DERIVED_##Class(); \
} }
//! Class provides global access (through static methods) to all derived attributres information. //! Class provides global access (through static methods) to all derived attributes information.
//! It is used internally by macros for registration of derived attributes and driver-tables //! It is used internally by macros for registration of derived attributes and driver-tables
//! for getting this data. //! for getting this data.
class TDF_DerivedAttribute class TDF_DerivedAttribute

View File

@ -402,7 +402,7 @@ public:
* Method for updating object after restoring * Method for updating object after restoring
*/ */
//! Performs updating the links and dependances of the object which are not //! Performs updating the links and dependences of the object which are not
//! stored in persistence. Should be redefined if necessary. //! stored in persistence. Should be redefined if necessary.
virtual Standard_EXPORT void AfterRetrieval(); virtual Standard_EXPORT void AfterRetrieval();

View File

@ -1338,7 +1338,7 @@ void TopOpeBRepBuild_BuilderON::GFillONPartsWES2(const Handle(TopOpeBRepDS_Inter
Standard_Boolean reverse = (!samegeom); Standard_Boolean reverse = (!samegeom);
#ifdef OCCT_DEBUG #ifdef OCCT_DEBUG
if (TopOpeBRepBuild_GetcontextNOSG()) if (TopOpeBRepBuild_GetcontextNOSG())
// MSV 21.03.2002: restore the genaral behaviour, since the function // MSV 21.03.2002: restore the general behaviour, since the function
// FUN_UNKFstasta was corrected. // FUN_UNKFstasta was corrected.
reverse = Standard_False; // we exclude this line from #ifdef OCCT_DEBUG because reverse = Standard_False; // we exclude this line from #ifdef OCCT_DEBUG because
// in optimised mode this line will never be included , and that // in optimised mode this line will never be included , and that
@ -2143,7 +2143,7 @@ void TopOpeBRepBuild_BuilderON::GFillONPartsWES2(const Handle(TopOpeBRepDS_Inter
if (nfor < 1) if (nfor < 1)
b = shareG; // Esd is FOR's closing edge b = shareG; // Esd is FOR's closing edge
else if (nfor > 1) else if (nfor > 1)
return; // NYIRaise (unvalid shape) return; // NYIRaise (invalid shape)
else else
{ {
const TopoDS_Face& FF = TopoDS::Face(lfor.First()); const TopoDS_Face& FF = TopoDS::Face(lfor.First());

View File

@ -35,7 +35,7 @@ class TopOpeBRepDS_HDataStructure;
class TopOpeBRepDS_Check; class TopOpeBRepDS_Check;
DEFINE_STANDARD_HANDLE(TopOpeBRepDS_Check, Standard_Transient) DEFINE_STANDARD_HANDLE(TopOpeBRepDS_Check, Standard_Transient)
//! a tool verifing integrity and structure of DS //! a tool verifying integrity and structure of DS
class TopOpeBRepDS_Check : public Standard_Transient class TopOpeBRepDS_Check : public Standard_Transient
{ {

View File

@ -1465,7 +1465,7 @@ static Standard_Integer VPlaneBuilder(Draw_Interpretor& /*di*/,
if (aShapes.Extent() < 1 || aShapes.Extent() > 3) if (aShapes.Extent() < 1 || aShapes.Extent() > 3)
{ {
Message::SendFail() Message::SendFail()
<< "Error: Wront number of selected shapes.\n" << "Error: Wrong number of selected shapes.\n"
<< "\tYou should one of variant: face, edge and vertex or three vertices."; << "\tYou should one of variant: face, edge and vertex or three vertices.";
return 1; return 1;
} }
@ -3878,7 +3878,7 @@ static int VDrawPArray(Draw_Interpretor& di, Standard_Integer argc, const char**
if (!hasVertex) if (!hasVertex)
{ {
di << "You should pass any verticies in the list of array elements\n"; di << "You should pass any vertices in the list of array elements\n";
return 1; return 1;
} }

View File

@ -169,7 +169,7 @@ static Standard_Boolean Get3DPointAtMousePosition(const gp_Pnt& theFirstPoint,
//======================================================================= //=======================================================================
// function : ParseDimensionParams // function : ParseDimensionParams
// purpose : Auxilliary function: sets aspect parameters for // purpose : Auxiliary function: sets aspect parameters for
// length, angle, radius and diameter dimension. // length, angle, radius and diameter dimension.
// //
// draw args: -text [3d|2d] [wf|sh|wireframe|shading] [Size] // draw args: -text [3d|2d] [wf|sh|wireframe|shading] [Size]
@ -560,7 +560,7 @@ static void SetDimensionParams(
//======================================================================= //=======================================================================
// function : ParseAngleDimensionParams // function : ParseAngleDimensionParams
// purpose : Auxilliary function: sets custom parameters for angle dimension. // purpose : Auxiliary function: sets custom parameters for angle dimension.
// //
// draw args: -type [interior|exterior] // draw args: -type [interior|exterior]
// -showarrow [first|second|both|none] // -showarrow [first|second|both|none]
@ -999,7 +999,7 @@ Standard_Boolean IsParallel(const TopoDS_Shape& theShape1, const TopoDS_Shape& t
//======================================================================= //=======================================================================
// function : VRelationBuilder // function : VRelationBuilder
// purpose : Command for building realation presentation // purpose : Command for building relation presentation
//======================================================================= //=======================================================================
static int VRelationBuilder(Draw_Interpretor& /*theDi*/, static int VRelationBuilder(Draw_Interpretor& /*theDi*/,
Standard_Integer theArgsNb, Standard_Integer theArgsNb,

View File

@ -430,7 +430,7 @@ Handle(AIS_InteractiveContext) FindContextByView(const Handle(V3d_View)& theView
//============================================================================== //==============================================================================
// function : IsWindowOverlapped // function : IsWindowOverlapped
// purpose : Check if theWindow overlapp another view // purpose : Check if theWindow overlap another view
//============================================================================== //==============================================================================
Standard_Boolean IsWindowOverlapped(const Standard_Integer thePxLeft, Standard_Boolean IsWindowOverlapped(const Standard_Integer thePxLeft,
@ -5691,7 +5691,7 @@ static int VReadPixel(Draw_Interpretor& theDI, Standard_Integer theArgNb, const
} }
// redirect possible warning messages that could have been added by ToPixMap // redirect possible warning messages that could have been added by ToPixMap
// into the Tcl interpretor (via DefaultMessenger) to cout, so that they do not // into the Tcl interpreter (via DefaultMessenger) to cout, so that they do not
// contaminate result of the command // contaminate result of the command
Standard_CString aWarnLog = theDI.Result(); Standard_CString aWarnLog = theDI.Result();
if (aWarnLog != NULL && aWarnLog[0] != '\0') if (aWarnLog != NULL && aWarnLog[0] != '\0')
@ -13996,7 +13996,7 @@ vgrid [off] [-type {rect|circ}] [-mode {line|point}] [-origin X Y] [-rotAngle An
addCmd("vpriviledgedplane", VPriviledgedPlane, /* [vpriviledgedplane] */ R"( addCmd("vpriviledgedplane", VPriviledgedPlane, /* [vpriviledgedplane] */ R"(
vpriviledgedplane [Ox Oy Oz Nx Ny Nz [Xx Xy Xz]] vpriviledgedplane [Ox Oy Oz Nx Ny Nz [Xx Xy Xz]]
Sets or prints viewer's priviledged plane geometry: Sets or prints viewer's privileged plane geometry:
Ox, Oy, Oz - plane origin; Ox, Oy, Oz - plane origin;
Nx, Ny, Nz - plane normal direction; Nx, Ny, Nz - plane normal direction;
Xx, Xy, Xz - plane x-reference axis direction. Xx, Xy, Xz - plane x-reference axis direction.

View File

@ -308,7 +308,7 @@ Standard_Boolean VrmlAPI_Writer::write_v1(const TopoDS_Shape& aShape,
TopTools_Array1OfShape Shapes(1, 1); TopTools_Array1OfShape Shapes(1, 1);
Shapes.SetValue(1, aShape); Shapes.SetValue(1, aShape);
// Check shape tesselation // Check shape tessellation
TopExp_Explorer anExp(aShape, TopAbs_FACE); TopExp_Explorer anExp(aShape, TopAbs_FACE);
TopLoc_Location aLoc; TopLoc_Location aLoc;
Standard_Boolean hasTriangles = Standard_False; Standard_Boolean hasTriangles = Standard_False;

View File

@ -53,7 +53,7 @@ void VrmlConverter_ShadedShape::Add(Standard_OStream& anOStrea
gp_Pnt p; gp_Pnt p;
TopExp_Explorer ex; TopExp_Explorer ex;
// counting phasis. This phasis will count the valid triangle // counting phase. This phase will count the valid triangle
// and the vertices to allocate the correct size for the arrays: // and the vertices to allocate the correct size for the arrays:
Standard_Integer nbTriangles = 0, nbVertices = 0; Standard_Integer nbTriangles = 0, nbVertices = 0;

View File

@ -88,7 +88,7 @@ public:
const Standard_Real theDeflection = 0.01, const Standard_Real theDeflection = 0.01,
const Standard_Real theDeflAngle = 20. * M_PI / 180.); const Standard_Real theDeflAngle = 20. * M_PI / 180.);
// this value of theDeflAngle is used by default // this value of theDeflAngle is used by default
// for tesselation while shading (Drawer->HLRAngle()) // for tessellation while shading (Drawer->HLRAngle())
/** /**
* Add all shapes start from given document with colors and names to the internal structure * Add all shapes start from given document with colors and names to the internal structure

View File

@ -762,7 +762,7 @@ static IFSelect_ReturnStatus XSControl_trimport(const Handle(IFSelect_SessionPil
if (argc < 4) if (argc < 4)
{ {
sout << "Give : filename or . for current model; varname or . to take fileroot\n GiveList, * " sout << "Give : filename or . for current model; varname or . to take fileroot\n GiveList, * "
"for all transferrable roots" "for all transferable roots"
<< std::endl; << std::endl;
return IFSelect_RetError; return IFSelect_RetError;
} }
@ -807,7 +807,7 @@ static IFSelect_ReturnStatus XSControl_trimport(const Handle(IFSelect_SessionPil
if (arg3[0] == '*' && arg3[1] == '\0') if (arg3[0] == '*' && arg3[1] == '\0')
{ {
list = WS->GiveList("xst-transferrable-roots"); list = WS->GiveList("xst-transferrable-roots");
sout << "All Transferrable Roots : "; sout << "All Transferable Roots : ";
} }
else else
{ {

View File

@ -103,7 +103,7 @@ public:
Standard_EXPORT Handle(XSControl_WorkSession) WS() const; Standard_EXPORT Handle(XSControl_WorkSession) WS() const;
//! Loads a file and returns the read status //! Loads a file and returns the read status
//! Zero for a Model which compies with the Controller //! Zero for a Model which complies with the Controller
Standard_EXPORT virtual IFSelect_ReturnStatus ReadFile(const Standard_CString filename); Standard_EXPORT virtual IFSelect_ReturnStatus ReadFile(const Standard_CString filename);
//! Loads a file from stream and returns the read status //! Loads a file from stream and returns the read status

View File

@ -223,7 +223,7 @@ public:
Standard_EXPORT static Standard_Real GetLengthUnit( Standard_EXPORT static Standard_Real GetLengthUnit(
const Handle(TDocStd_Document)& theDoc = nullptr); const Handle(TDocStd_Document)& theDoc = nullptr);
//! Returns avaliable work sessions with their associated files. //! Returns available work sessions with their associated files.
Standard_EXPORT static XSControl_WorkSessionMap& WorkSessionList(); Standard_EXPORT static XSControl_WorkSessionMap& WorkSessionList();
//! Binds session and name into map recursively. //! Binds session and name into map recursively.

View File

@ -73,7 +73,7 @@ public:
//! Prints on the stream o information on the current state //! Prints on the stream o information on the current state
//! of the object. //! of the object.
//! Is used to redifine the operator <<. //! Is used to redefine the operator <<.
Standard_EXPORT void Dump(Standard_OStream& o) const; Standard_EXPORT void Dump(Standard_OStream& o) const;
//! Destructor //! Destructor

View File

@ -18,7 +18,7 @@ regexp {([-0-9.+eE]+)$} [dump d_val] full dist
regexp { +Vertex +: +Min +[-0-9.+eE]+ +Max +([-0-9.+eE]+)} [ maxtolerance d ] full toler regexp { +Vertex +: +Min +[-0-9.+eE]+ +Max +([-0-9.+eE]+)} [ maxtolerance d ] full toler
set good_dist 0 set good_dist 0
if { [expr abs( ${dist} - ${good_dist} )] > ${toler} } { if { [expr abs( ${dist} - ${good_dist} )] > ${toler} } {
puts "Faulty : the distanse is ${dist}. It is bad value" puts "Faulty : the distance is ${dist}. It is bad value"
} }
regexp { +Point 3D : +([-0-9.+eE]+), +([-0-9.+eE]+), +([-0-9.+eE]+)} [ dump d ] full x y z regexp { +Point 3D : +([-0-9.+eE]+), +([-0-9.+eE]+), +([-0-9.+eE]+)} [ dump d ] full x y z

View File

@ -21,17 +21,17 @@ set GOOD_DIST_1 2.0175535360778957e-14
set log_1 [projponf f p_1 -min -t] set log_1 [projponf f p_1 -min -t]
regexp {proj dist = ([-0-9.+eE]+)} ${log_1} full distmax_1 regexp {proj dist = ([-0-9.+eE]+)} ${log_1} full distmax_1
if { [expr abs(${distmax_1} - ${GOOD_DIST_1})] > ${CMP_TOL} } { if { [expr abs(${distmax_1} - ${GOOD_DIST_1})] > ${CMP_TOL} } {
puts "Error: Wrong distanse (# 1)" puts "Error: Wrong distance (# 1)"
} else { } else {
puts "OK: Good distanse (# 1)" puts "OK: Good distance (# 1)"
} }
distmini d_1 v_1 f distmini d_1 v_1 f
set distmin_1 [dval d_1_val] set distmin_1 [dval d_1_val]
if { [expr abs(${distmin_1} - ${GOOD_DIST_1})] > ${CMP_TOL} } { if { [expr abs(${distmin_1} - ${GOOD_DIST_1})] > ${CMP_TOL} } {
puts "Error: Wrong minidistanse (# 1)" puts "Error: Wrong minidistance (# 1)"
} else { } else {
puts "OK: Good minidistanse (# 1)" puts "OK: Good minidistance (# 1)"
} }
# 2 # 2
@ -42,17 +42,17 @@ set GOOD_DIST_2 9.9491842071163076e-14
set log_2 [projponf f p_2 -min -t] set log_2 [projponf f p_2 -min -t]
regexp {proj dist = ([-0-9.+eE]+)} ${log_2} full distmax_2 regexp {proj dist = ([-0-9.+eE]+)} ${log_2} full distmax_2
if { [expr abs(${distmax_2} - ${GOOD_DIST_2})] > ${CMP_TOL} } { if { [expr abs(${distmax_2} - ${GOOD_DIST_2})] > ${CMP_TOL} } {
puts "Error: Wrong distanse (# 2)" puts "Error: Wrong distance (# 2)"
} else { } else {
puts "OK: Good distanse (# 2)" puts "OK: Good distance (# 2)"
} }
distmini d_2 v_2 f distmini d_2 v_2 f
set distmin_2 [dval d_2_val] set distmin_2 [dval d_2_val]
if { [expr abs(${distmin_2} - ${GOOD_DIST_2})] > ${CMP_TOL} } { if { [expr abs(${distmin_2} - ${GOOD_DIST_2})] > ${CMP_TOL} } {
puts "Error: Wrong minidistanse (# 2)" puts "Error: Wrong minidistance (# 2)"
} else { } else {
puts "OK: Good minidistanse (# 2)" puts "OK: Good minidistance (# 2)"
} }
# 3 # 3
@ -63,15 +63,15 @@ set GOOD_DIST_3 2.8421709430404007e-14
set log_3 [projponf f p_3 -min -t] set log_3 [projponf f p_3 -min -t]
regexp {proj dist = ([-0-9.+eE]+)} ${log_3} full distmax_3 regexp {proj dist = ([-0-9.+eE]+)} ${log_3} full distmax_3
if { [expr abs(${distmax_3} - ${GOOD_DIST_3})] > ${CMP_TOL} } { if { [expr abs(${distmax_3} - ${GOOD_DIST_3})] > ${CMP_TOL} } {
puts "Error: Wrong distanse (# 3)" puts "Error: Wrong distance (# 3)"
} else { } else {
puts "OK: Good distanse (# 3)" puts "OK: Good distance (# 3)"
} }
distmini d_3 v_3 f distmini d_3 v_3 f
set distmin_3 [dval d_3_val] set distmin_3 [dval d_3_val]
if { [expr abs(${distmin_3} - ${GOOD_DIST_3})] > ${CMP_TOL} } { if { [expr abs(${distmin_3} - ${GOOD_DIST_3})] > ${CMP_TOL} } {
puts "Error: Wrong minidistanse (# 3)" puts "Error: Wrong minidistance (# 3)"
} else { } else {
puts "OK: Good minidistanse (# 3)" puts "OK: Good minidistance (# 3)"
} }

View File

@ -11,7 +11,7 @@ void main() {
gl_Position = occVertex; gl_Position = occVertex;
}" }"
# define a Geometry shader drawing shrinked triangles # define a Geometry shader drawing shrunken triangles
set aShaderGeom " set aShaderGeom "
layout(triangles) in; layout(triangles) in;
layout(triangle_strip, max_vertices=3) out; layout(triangle_strip, max_vertices=3) out;

View File

@ -256,7 +256,7 @@ public:
return QVariant(); return QVariant();
} }
//! Returns number of tree level line items = colums in table view //! Returns number of tree level line items = columns in table view
virtual int columnCount(const QModelIndex& theParent = QModelIndex()) const Standard_OVERRIDE virtual int columnCount(const QModelIndex& theParent = QModelIndex()) const Standard_OVERRIDE
{ {
(void)theParent; (void)theParent;

View File

@ -31,7 +31,7 @@
//! \class ViewControl_TableModel //! \class ViewControl_TableModel
//! \brief This is an extension of table model to visualize a container of values //! \brief This is an extension of table model to visualize a container of values
//! It is possible to: //! It is possible to:
//! - set orientation to interpretate the values. //! - set orientation to interpret the values.
//! - set table view header values. //! - set table view header values.
//! Items of the view are enabled and selectable. //! Items of the view are enabled and selectable.
class ViewControl_TableModel : public QAbstractTableModel class ViewControl_TableModel : public QAbstractTableModel