1
0
mirror of https://git.dev.opencascade.org/repos/occt.git synced 2025-04-16 10:08:36 +03:00

0033778: Documentation - Fix various typos found in codebase

This commit is contained in:
luzpaz 2024-07-26 03:51:12 -04:00 committed by GitHub
parent 9fcfec881c
commit 245febe036
No known key found for this signature in database
GPG Key ID: B5690EEEBB952194
62 changed files with 124 additions and 124 deletions

View File

@ -36,7 +36,7 @@
//! The Datum groups together the construction elements such as lines, circles, points, trihedra, plane trihedra, planes and axes. //! The Datum groups together the construction elements such as lines, circles, points, trihedra, plane trihedra, planes and axes.
//! The Relation is made up of constraints on one or more interactive shapes and the corresponding reference geometry. //! The Relation is made up of constraints on one or more interactive shapes and the corresponding reference geometry.
//! For example, you might want to constrain two edges in a parallel relation. //! For example, you might want to constrain two edges in a parallel relation.
//! This contraint is considered as an object in its own right, and is shown as a sensitive primitive. //! This constraint is considered as an object in its own right, and is shown as a sensitive primitive.
//! This takes the graphic form of a perpendicular arrow marked with the || symbol and lying between the two edges. //! This takes the graphic form of a perpendicular arrow marked with the || symbol and lying between the two edges.
//! The Object type includes topological shapes, and connections between shapes. //! The Object type includes topological shapes, and connections between shapes.
//! None, in order not to eliminate the object, tells the application to look further until it finds an object definition in its generation which is accepted. //! None, in order not to eliminate the object, tells the application to look further until it finds an object definition in its generation which is accepted.

View File

@ -42,7 +42,7 @@ DEFINE_STANDARD_HANDLE(AIS_ExclusionFilter, SelectMgr_Filter)
//! except those of the types and signatures stored //! except those of the types and signatures stored
//! in the filter framework //! in the filter framework
//! - Exclusion flag off //! - Exclusion flag off
//! - the funciton IsOk answers true for all objects //! - the function IsOk answers true for all objects
//! which have the same type and signature as the stored ones. //! which have the same type and signature as the stored ones.
class AIS_ExclusionFilter : public SelectMgr_Filter class AIS_ExclusionFilter : public SelectMgr_Filter
{ {

View File

@ -40,7 +40,7 @@ public:
//! @warning It binds this object with Graphic3d_ZLayerId_TopOSD layer. //! @warning It binds this object with Graphic3d_ZLayerId_TopOSD layer.
Standard_EXPORT AIS_RubberBand(); Standard_EXPORT AIS_RubberBand();
//! Consructs the rubber band with empty filling and defined line style. //! Constructs the rubber band with empty filling and defined line style.
//! @param theLineColor [in] color of rubber band lines //! @param theLineColor [in] color of rubber band lines
//! @param theType [in] type of rubber band lines //! @param theType [in] type of rubber band lines
//! @param theLineWidth [in] width of rubber band line. By default it is 1. //! @param theLineWidth [in] width of rubber band line. By default it is 1.

View File

@ -363,7 +363,7 @@ void AdvApp2Var_ApproxAFunc2Var::ComputePatches(const AdvApprox_Cutting& UChoice
throw Standard_ConstructionError("AdvApp2Var_ApproxAFunc2Var : Surface Discretisation Error"); throw Standard_ConstructionError("AdvApp2Var_ApproxAFunc2Var : Surface Discretisation Error");
} }
// calculate the number and the type of autorized cuts // calculate the number and the type of authorized cuts
// depending on the max number of squares and the validity of next cuts. // depending on the max number of squares and the validity of next cuts.
NbU = myResult.NbPatchInU(); NbU = myResult.NbPatchInU();
NbV = myResult.NbPatchInV(); NbV = myResult.NbPatchInV();
@ -457,7 +457,7 @@ void AdvApp2Var_ApproxAFunc2Var::ComputePatches(const AdvApprox_Cutting& UChoice
throw Standard_ConstructionError("AdvApp2Var_ApproxAFunc2Var : Surface Discretisation Error"); throw Standard_ConstructionError("AdvApp2Var_ApproxAFunc2Var : Surface Discretisation Error");
} }
// calculate the number and type of autorized cuts // calculate the number and type of authorized cuts
// depending on the max number of squares and the validity of next cuts // depending on the max number of squares and the validity of next cuts
NbU = myResult.NbPatchInU(); NbU = myResult.NbPatchInU();
NbV = myResult.NbPatchInV(); NbV = myResult.NbPatchInV();

View File

@ -42,13 +42,13 @@ class Geom_BSplineSurface;
//! OneDTol, TwoDTol, ThreeDTol: The tolerance of approximation in each //! OneDTol, TwoDTol, ThreeDTol: The tolerance of approximation in each
//! subspaces //! subspaces
//! OneDTolFr, TwoDTolFr, ThreeDTolFr: The tolerance of approximation on //! OneDTolFr, TwoDTolFr, ThreeDTolFr: The tolerance of approximation on
//! the boundarys in each subspaces //! the boundaries in each subspaces
//! [FirstInU, LastInU]: The Bounds in U of the Approximation //! [FirstInU, LastInU]: The Bounds in U of the Approximation
//! [FirstInV, LastInV]: The Bounds in V of the Approximation //! [FirstInV, LastInV]: The Bounds in V of the Approximation
//! FavorIso : Give preference to extract u-iso or v-iso on F(U,V) //! FavorIso : Give preference to extract u-iso or v-iso on F(U,V)
//! This can be useful to optimize the <Func> method //! This can be useful to optimize the <Func> method
//! ContInU, ContInV : Continuity waiting in u and v //! ContInU, ContInV : Continuity waiting in u and v
//! PrecisCode : Precision on approximation's error mesurement //! PrecisCode : Precision on approximation's error measurement
//! 1 : Fast computation and average precision //! 1 : Fast computation and average precision
//! 2 : Average computation and good precision //! 2 : Average computation and good precision
//! 3 : Slow computation and very good precision //! 3 : Slow computation and very good precision

View File

@ -337,7 +337,7 @@ int mma1cdi_(integer *ndimen,
/* HERMIT: Table of coeff. 2*(IORDRE+1) Hermite polynoms */ /* HERMIT: Table of coeff. 2*(IORDRE+1) Hermite polynoms */
/* of degree 2*IORDRE+1. */ /* of degree 2*IORDRE+1. */
/* IERCOD: Error code, */ /* IERCOD: Error code, */
/* = 0, Everythig is OK */ /* = 0, Everything is OK */
/* = 1, The value of IORDRE is out of (0,2) */ /* = 1, The value of IORDRE is out of (0,2) */
/* COMMON USED : */ /* COMMON USED : */
/* ---------------- */ /* ---------------- */
@ -989,8 +989,8 @@ int mma1fer_(integer *,//ndimen,
/* IORDRE: Order of constraint at the extremities of the border */ /* IORDRE: Order of constraint at the extremities of the border */
/* -1 = no constraints, */ /* -1 = no constraints, */
/* 0 = constraints of passage to limits (i.e. C0), */ /* 0 = constraints of passage to limits (i.e. C0), */
/* 1 = C0 + constraintes of 1st derivatives (i.e. C1), */ /* 1 = C0 + constraints of 1st derivatives (i.e. C1), */
/* 2 = C1 + constraintes of 2nd derivatives (i.e. C2). */ /* 2 = C1 + constraints of 2nd derivatives (i.e. C2). */
/* NDGJAC: Degree of development in series to use for the calculation */ /* NDGJAC: Degree of development in series to use for the calculation */
/* in the base of Jacobi. */ /* in the base of Jacobi. */
/* CRVJAC: Table of coeff. of the curve of approximation in the */ /* CRVJAC: Table of coeff. of the curve of approximation in the */
@ -1131,7 +1131,7 @@ int mma1fer_(integer *,//ndimen,
/* ------------------------------ The end ------------------------------- /* ------------------------------ The end -------------------------------
*/ */
/* --> The order of constraints is not within autorized values. */ /* --> The order of constraints is not within authorized values. */
L9100: L9100:
*iercod = 1; *iercod = 1;
goto L9999; goto L9999;
@ -3520,7 +3520,7 @@ int AdvApp2Var_ApproxF2var::mma2cdi_( integer *ndimen,
goto L9100; goto L9100;
} }
/* ---- Subract discretizations of polynoms of constraints /* ---- Subtract discretizations of polynoms of constraints
---- */ ---- */
mma2cd3_(ndimen, nbpntu, &urootl[1], nbpntv, iordru, &sotbu1[1], mma2cd3_(ndimen, nbpntu, &urootl[1], nbpntv, iordru, &sotbu1[1],
@ -4919,7 +4919,7 @@ int mma2cfv_(integer *ndvjac,
/* MAXDGU: Degree maximum by U of coeff. to calculate. */ /* MAXDGU: Degree maximum by U of coeff. to calculate. */
/* NBPNTV: Degree of the Legendre polynom on the roots which of */ /* NBPNTV: Degree of the Legendre polynom on the roots which of */
/* the coefficients of integration by V are calculated */ /* the coefficients of integration by V are calculated */
/* by Gauss method. It is reqired that NBPNTV = 30, 40, 50 or 61 and NDVJAC < NBPNTV. */ /* by Gauss method. It is required that NBPNTV = 30, 40, 50 or 61 and NDVJAC < NBPNTV. */
/* GSSVTB: Table of coefficients of integration by Gauss method */ /* GSSVTB: Table of coefficients of integration by Gauss method */
/* by V for NDVJAC fixed: j varies from 0 to NBPNTV/2. */ /* by V for NDVJAC fixed: j varies from 0 to NBPNTV/2. */
/* CHPAIR: Table of terms connected to degrees from MINDGU to MAXDGU by U to */ /* CHPAIR: Table of terms connected to degrees from MINDGU to MAXDGU by U to */
@ -7511,7 +7511,7 @@ int mmmapcoe_(integer *ndim,
/* FUNCTION : */ /* FUNCTION : */
/* ---------- */ /* ---------- */
/* Calculate the coefficients of polinomial approximation curve */ /* Calculate the coefficients of polynomial approximation curve */
/* of degree NDGJAC by the method of smallest squares starting from */ /* of degree NDGJAC by the method of smallest squares starting from */
/* the discretization of function on the roots of Legendre polynom */ /* the discretization of function on the roots of Legendre polynom */
/* of degree NBPNTS. */ /* of degree NBPNTS. */
@ -8102,7 +8102,7 @@ int mmjacpt_(const integer *ndimen,
/* OUTPUT ARGUMENTS : */ /* OUTPUT ARGUMENTS : */
/* ------------------- */ /* ------------------- */
/* PTCAUX : Auxilliary space. */ /* PTCAUX : Auxiliary space. */
/* PTCCAN : The square in the canonic base (-1,1) */ /* PTCCAN : The square in the canonic base (-1,1) */
/* COMMONS USED : */ /* COMMONS USED : */

View File

@ -1229,7 +1229,7 @@ int AdvApp2Var_MathBase::mmaperx_(integer *ncofmx,
/* ERRMAX : Precision of the approximation. */ /* ERRMAX : Precision of the approximation. */
/* IERCOD = 0, OK */ /* IERCOD = 0, OK */
/* = 1, order of constraints (IORDRE) is not within the */ /* = 1, order of constraints (IORDRE) is not within the */
/* autorized values. */ /* authorized values. */
/* COMMONS USED : */ /* COMMONS USED : */
/* ---------------- */ /* ---------------- */
@ -2281,7 +2281,7 @@ int AdvApp2Var_MathBase::mmcglc1_(integer *ndimax,
/* length calculation. */ /* length calculation. */
/* TFINAL : Upper limit of the interval of integration for */ /* TFINAL : Upper limit of the interval of integration for */
/* length calculation. */ /* length calculation. */
/* EPSILN : REQIRED precision for length calculation. */ /* EPSILN : REQUIRED precision for length calculation. */
/* OUTPUT ARGUMENTS : */ /* OUTPUT ARGUMENTS : */
/* ------------------- */ /* ------------------- */
@ -2677,14 +2677,14 @@ int AdvApp2Var_MathBase::mmcvctx_(integer *ndimen,
/* 2 --> cas (0)+ (1) + " " 2nd derivatives. */ /* 2 --> cas (0)+ (1) + " " 2nd derivatives. */
/* etc... */ /* etc... */
/* CTRTES : Table of constraints. */ /* CTRTES : Table of constraints. */
/* CTRTES(*,1,*) = contraints at -1. */ /* CTRTES(*,1,*) = constraints at -1. */
/* CTRTES(*,2,*) = contraints at 1. */ /* CTRTES(*,2,*) = constraints at 1. */
/* OUTPUT ARGUMENTS : */ /* OUTPUT ARGUMENTS : */
/* ------------------- */ /* ------------------- */
/* CRVRES : Resulting curve defined on (-1,1). */ /* CRVRES : Resulting curve defined on (-1,1). */
/* TABAUX : Auxilliary matrix. */ /* TABAUX : Auxiliary matrix. */
/* XMATRI : Auxilliary matrix. */ /* XMATRI : Auxiliary matrix. */
/* COMMONS UTILISES : */ /* COMMONS UTILISES : */
/* ---------------- */ /* ---------------- */
@ -3560,7 +3560,7 @@ int AdvApp2Var_MathBase::mmdrvck_(integer *ncoeff,
*/ */
/* Factorials (1 to 21) caculated on VAX in R*16 */ /* Factorials (1 to 21) calculated on VAX in R*16 */
/* ********************************************************************** /* **********************************************************************
@ -3845,7 +3845,7 @@ int mmexthi_(integer *ndegre,
/* within the interval [0,1]. They are ranked for the degrees increasing from */ /* within the interval [0,1]. They are ranked for the degrees increasing from */
/* 2 to 61. */ /* 2 to 61. */
/* HILTAB : Table of Legendre interpolators concerning ROOTAB. */ /* HILTAB : Table of Legendre interpolators concerning ROOTAB. */
/* The adressing is the same. */ /* The addressing is the same. */
/* HI0TAB : Table of Legendre interpolators for root x=0 */ /* HI0TAB : Table of Legendre interpolators for root x=0 */
/* of polynoms of UNEVEN degree. */ /* of polynoms of UNEVEN degree. */
/* RTLTB0 : Table of Li(uk) where uk are the roots of */ /* RTLTB0 : Table of Li(uk) where uk are the roots of */
@ -3990,7 +3990,7 @@ int mmextrl_(integer *ndegre,
/* within the interval [0,1]. They are ranked for the degrees increasing from */ /* within the interval [0,1]. They are ranked for the degrees increasing from */
/* 2 to 61. */ /* 2 to 61. */
/* HILTAB : Table of Legendre interpolators concerning ROOTAB. */ /* HILTAB : Table of Legendre interpolators concerning ROOTAB. */
/* The adressing is the same. */ /* The addressing is the same. */
/* HI0TAB : Table of Legendre interpolators for root x=0 */ /* HI0TAB : Table of Legendre interpolators for root x=0 */
/* of polynoms of UNEVEN degree. */ /* of polynoms of UNEVEN degree. */
/* RTLTB0 : Table of Li(uk) where uk are the roots of */ /* RTLTB0 : Table of Li(uk) where uk are the roots of */
@ -4610,7 +4610,7 @@ int AdvApp2Var_MathBase::mmfmcb5_(integer *isenmsc,
/* FUNCTION : */ /* FUNCTION : */
/* ---------- */ /* ---------- */
/* Reformating (and eventual compression/decompression) of curve */ /* Reformatting (and eventual compression/decompression) of curve */
/* (ndim,.) by (.,ndim) and vice versa. */ /* (ndim,.) by (.,ndim) and vice versa. */
/* KEYWORDS : */ /* KEYWORDS : */
@ -6260,7 +6260,7 @@ L9999:
/* OUTPUT ARGUMENTS : */ /* OUTPUT ARGUMENTS : */
/* ------------------- */ /* ------------------- */
/* POLAUX : Auxilliary space. */ /* POLAUX : Auxiliary space. */
/* CRVCAN : The curve in the canonic base [-1,1] */ /* CRVCAN : The curve in the canonic base [-1,1] */
/* COMMONS USED : */ /* COMMONS USED : */
@ -6297,7 +6297,7 @@ L9999:
i__1 = *ndim; i__1 = *ndim;
for (nd = 1; nd <= i__1; ++nd) { for (nd = 1; nd <= i__1; ++nd) {
/* Loading of the auxilliary table. */ /* Loading of the auxiliary table. */
ii = 0; ii = 0;
i__2 = ndeg / 2; i__2 = ndeg / 2;
for (i__ = 0; i__ <= i__2; ++i__) { for (i__ = 0; i__ <= i__2; ++i__) {
@ -6377,7 +6377,7 @@ int mmloncv_(integer *ndimax,
/* -------------------- */ /* -------------------- */
/* NDIMAX : Max number of lines of tables (max number of polynoms). */ /* NDIMAX : Max number of lines of tables (max number of polynoms). */
/* NDIMEN : Dimension of the polynom (Nomber of polynoms). */ /* NDIMEN : Dimension of the polynom (Number of polynoms). */
/* NCOEFF : Number of coefficients of the polynom (no limitation) */ /* NCOEFF : Number of coefficients of the polynom (no limitation) */
/* This is degree + 1 */ /* This is degree + 1 */
/* COURBE : Coefficients of the polynom ordered by increasing power */ /* COURBE : Coefficients of the polynom ordered by increasing power */
@ -6606,7 +6606,7 @@ L9900:
/* FUNCTION : */ /* FUNCTION : */
/* ---------- */ /* ---------- */
/* Position on the polynoms of base hermit-Jacobi */ /* Position on the polynoms of base hermit-Jacobi */
/* and their succesive derivatives */ /* and their successive derivatives */
/* KEYWORDS : */ /* KEYWORDS : */
/* ----------- */ /* ----------- */
@ -7160,7 +7160,7 @@ int mmpojac_(doublereal *tparam,
*/ */
/* static varaibles */ /* static variables */
@ -7519,12 +7519,12 @@ L9999:
/* INPUT ARGUMENTS : */ /* INPUT ARGUMENTS : */
/* -------------------- */ /* -------------------- */
/* HDIMEN: NOMBER OF LINE (OR COLUMN) OF THE HESSIAN MATRIX */ /* HDIMEN: NUMBER OF LINE (OR COLUMN) OF THE HESSIAN MATRIX */
/* GDIMEN: NOMBER OF LINE OF THE MATRIX OF CONSTRAINTS */ /* GDIMEN: NUMBER OF LINE OF THE MATRIX OF CONSTRAINTS */
/* HNSTOC: NOMBErS OF TERMS IN THE PROFILE OF HESSIAN MATRIX /* HNSTOC: NUMBERS OF TERMS IN THE PROFILE OF HESSIAN MATRIX
*/ */
/* GNSTOC: NOMBERS OF TERMS IN THE PROFILE OF THE MATRIX OF CONSTRAINTS */ /* GNSTOC: NUMBERS OF TERMS IN THE PROFILE OF THE MATRIX OF CONSTRAINTS */
/* MNSTOC: NOMBERS OF TERMS IN THE PROFILE OF THE MATRIX M= G H t(G) */ /* MNSTOC: NUMBERS OF TERMS IN THE PROFILE OF THE MATRIX M= G H t(G) */
/* where H IS THE HESSIAN MATRIX AND G IS THE MATRIX OF CONSTRAINTS */ /* where H IS THE HESSIAN MATRIX AND G IS THE MATRIX OF CONSTRAINTS */
/* MATSYH: TRIANGULAR INFERIOR PART OF THE HESSIAN MATRIX */ /* MATSYH: TRIANGULAR INFERIOR PART OF THE HESSIAN MATRIX */
/* IN FORM OF PROFILE */ /* IN FORM OF PROFILE */
@ -7896,7 +7896,7 @@ int mmrslss_(integer *,//mxcoef,
/* ----------------------------------- */ /* ----------------------------------- */
/* T */ /* T */
/* SS is the decomposition of choleski of a symmetric matrix */ /* SS is the decomposition of choleski of a symmetric matrix */
/* defined postive, that can result from routine MMCHOLE. */ /* defined positive, that can result from routine MMCHOLE. */
/* For a full matrix it is possible to use MRSLMSC */ /* For a full matrix it is possible to use MRSLMSC */
@ -8409,7 +8409,7 @@ L9999:
/* > */ /* > */
/* ********************************************************************** /* **********************************************************************
*/ */
/* Nome of the routine */ /* Name of the routine */
/* Common MLGDRTL: */ /* Common MLGDRTL: */
@ -8675,7 +8675,7 @@ int mmtmave_(integer *nligne,
/* INPUT ARGUMENTS : */ /* INPUT ARGUMENTS : */
/* -------------------- */ /* -------------------- */
/* NLIGNE : NUMBER OF LINE OF THE MATRIX */ /* NLIGNE : NUMBER OF LINE OF THE MATRIX */
/* NCOLON : NOMBER OF COLUMN OF THE MATRIX */ /* NCOLON : NUMBER OF COLUMN OF THE MATRIX */
/* GPOSIT: TABLE OF POSITIONING OF TERMS OF STORAGE */ /* GPOSIT: TABLE OF POSITIONING OF TERMS OF STORAGE */
/* GPOSIT(1,I) CONTAINS THE NUMBER of TERMS-1 ON LINE */ /* GPOSIT(1,I) CONTAINS THE NUMBER of TERMS-1 ON LINE */
/* I IN THE PROFILE OF THE MATRIX */ /* I IN THE PROFILE OF THE MATRIX */
@ -11193,7 +11193,7 @@ L9900:
/* FUNCTION : */ /* FUNCTION : */
/* ---------- */ /* ---------- */
/* SERVES to calculate the euclidian norm of a vector : */ /* SERVES to calculate the euclidean norm of a vector : */
/* ____________________________ */ /* ____________________________ */
/* Z = V V(1)**2 + V(2)**2 + ... */ /* Z = V V(1)**2 + V(2)**2 + ... */
@ -11208,7 +11208,7 @@ L9900:
/* OUTPUT ARGUMENTS : */ /* OUTPUT ARGUMENTS : */
/* ------------------- */ /* ------------------- */
/* MZSNORM : Value of the euclidian norm of vector VECTEU */ /* MZSNORM : Value of the euclidean norm of vector VECTEU */
/* COMMONS USED : */ /* COMMONS USED : */
/* ---------------- */ /* ---------------- */

View File

@ -416,7 +416,7 @@ int AdvApp2Var_SysBase::macrchk_()
/* FONCTION : */ /* FONCTION : */
/* ---------- */ /* ---------- */
/* TABLE OF MANAGEMENT OF DYNAMIC MEMOTY ALLOCATIONS */ /* TABLE OF MANAGEMENT OF DYNAMIC MEMORY ALLOCATIONS */
/* KEYWORDS : */ /* KEYWORDS : */
/* ----------- */ /* ----------- */
@ -2484,7 +2484,7 @@ int mcrfree_(integer *,//ibyte,
/* */ /* */
/* = 0 ==> OK */ /* = 0 ==> OK */
/* = 1 ==> Allocation impossible */ /* = 1 ==> Allocation impossible */
/* = -1 ==> Ofset > 2**31 - 1 */ /* = -1 ==> Offset > 2**31 - 1 */
/* */ /* */
/* */ /* */

View File

@ -32,7 +32,7 @@
class PLib_JacobiPolynomial; class PLib_JacobiPolynomial;
//! Approximate a function on an intervall [First,Last] //! Approximate a function on an interval [First,Last]
//! The result is a simple polynomial whose degree is as low as //! The result is a simple polynomial whose degree is as low as
//! possible to satisfy the required tolerance and the //! possible to satisfy the required tolerance and the
//! maximum degree. The maximum error and the averrage error //! maximum degree. The maximum error and the averrage error

View File

@ -223,7 +223,7 @@ typedef NCollection_Vector<BOPAlgo_VFI> BOPAlgo_VectorOfVFI;
//======================================================================= //=======================================================================
void BOPAlgo_Builder::FillImagesFaces(const Message_ProgressRange& theRange) void BOPAlgo_Builder::FillImagesFaces(const Message_ProgressRange& theRange)
{ {
Message_ProgressScope aPS(theRange, "Filing spligs of faces", 10); Message_ProgressScope aPS(theRange, "Filling splits of faces", 10);
BuildSplitFaces(aPS.Next(9)); BuildSplitFaces(aPS.Next(9));
if (HasErrors()) if (HasErrors())
{ {

View File

@ -1925,7 +1925,7 @@ Standard_Boolean BOPTools_AlgoTools::IsBlockInOnFace
} }
// //
// Treatment intemediate // Treatment intermediate
Standard_Real m1, aTolF, aTolE, aTol, aDist; Standard_Real m1, aTolF, aTolE, aTol, aDist;
m1=IntTools_Tools::IntermediatePoint(f1, l1); m1=IntTools_Tools::IntermediatePoint(f1, l1);
BOPTools_AlgoTools::PointOnEdge(aE1, m1, aP12); BOPTools_AlgoTools::PointOnEdge(aE1, m1, aP12);

View File

@ -182,7 +182,7 @@ public: //! @name Point/Edge/Face classification relatively solid
//! Computes the 3-D state of the point thePoint //! Computes the 3-D state of the point thePoint
//! toward solid theSolid. //! toward solid theSolid.
//! theTol - value of precision of computation //! theTol - value of precision of computation
//! theContext- cahed geometrical tools //! theContext- cached geometrical tools
//! Returns 3-D state. //! Returns 3-D state.
Standard_EXPORT static TopAbs_State ComputeState(const gp_Pnt& thePoint, Standard_EXPORT static TopAbs_State ComputeState(const gp_Pnt& thePoint,
const TopoDS_Solid& theSolid, const TopoDS_Solid& theSolid,
@ -192,7 +192,7 @@ public: //! @name Point/Edge/Face classification relatively solid
//! Computes the 3-D state of the vertex theVertex //! Computes the 3-D state of the vertex theVertex
//! toward solid theSolid. //! toward solid theSolid.
//! theTol - value of precision of computation //! theTol - value of precision of computation
//! theContext- cahed geometrical tools //! theContext- cached geometrical tools
//! Returns 3-D state. //! Returns 3-D state.
Standard_EXPORT static TopAbs_State ComputeState(const TopoDS_Vertex& theVertex, Standard_EXPORT static TopAbs_State ComputeState(const TopoDS_Vertex& theVertex,
const TopoDS_Solid& theSolid, const TopoDS_Solid& theSolid,
@ -202,7 +202,7 @@ public: //! @name Point/Edge/Face classification relatively solid
//! Computes the 3-D state of the edge theEdge //! Computes the 3-D state of the edge theEdge
//! toward solid theSolid. //! toward solid theSolid.
//! theTol - value of precision of computation //! theTol - value of precision of computation
//! theContext- cahed geometrical tools //! theContext- cached geometrical tools
//! Returns 3-D state. //! Returns 3-D state.
Standard_EXPORT static TopAbs_State ComputeState(const TopoDS_Edge& theEdge, Standard_EXPORT static TopAbs_State ComputeState(const TopoDS_Edge& theEdge,
const TopoDS_Solid& theSolid, const TopoDS_Solid& theSolid,
@ -213,7 +213,7 @@ public: //! @name Point/Edge/Face classification relatively solid
//! toward solid theSolid. //! toward solid theSolid.
//! theTol - value of precision of computation //! theTol - value of precision of computation
//! theBounds - set of edges of <theSolid> to avoid //! theBounds - set of edges of <theSolid> to avoid
//! theContext- cahed geometrical tools //! theContext- cached geometrical tools
//! Returns 3-D state. //! Returns 3-D state.
Standard_EXPORT static TopAbs_State ComputeState(const TopoDS_Face& theFace, Standard_EXPORT static TopAbs_State ComputeState(const TopoDS_Face& theFace,
const TopoDS_Solid& theSolid, const TopoDS_Solid& theSolid,
@ -224,7 +224,7 @@ public: //! @name Point/Edge/Face classification relatively solid
//! Computes the 3-D state of the shape theShape //! Computes the 3-D state of the shape theShape
//! toward solid theSolid. //! toward solid theSolid.
//! theTol - value of precision of computation //! theTol - value of precision of computation
//! theContext- cahed geometrical tools //! theContext- cached geometrical tools
//! Returns 3-D state. //! Returns 3-D state.
Standard_EXPORT static TopAbs_State ComputeStateByOnePoint(const TopoDS_Shape& theShape, Standard_EXPORT static TopAbs_State ComputeStateByOnePoint(const TopoDS_Shape& theShape,
const TopoDS_Solid& theSolid, const TopoDS_Solid& theSolid,
@ -274,7 +274,7 @@ public: //! @name Face classification relatively solid
//! solid theSolid. //! solid theSolid.
//! theMEF - Map Edge/Faces for theSolid //! theMEF - Map Edge/Faces for theSolid
//! theTol - value of precision of computation //! theTol - value of precision of computation
//! theContext- cahed geometrical tools //! theContext- cached geometrical tools
Standard_EXPORT static Standard_Boolean IsInternalFace(const TopoDS_Face& theFace, Standard_EXPORT static Standard_Boolean IsInternalFace(const TopoDS_Face& theFace,
const TopoDS_Solid& theSolid, const TopoDS_Solid& theSolid,
TopTools_IndexedDataMapOfShapeListOfShape& theMEF, TopTools_IndexedDataMapOfShapeListOfShape& theMEF,

View File

@ -95,7 +95,7 @@ void BRepExtrema_ProximityDistTool::LoadAdditionalPointsFirstSet (const BVH_Arra
//======================================================================= //=======================================================================
//function : goThroughtSet1 //function : goThroughtSet1
//purpose : Goes throught vertices from the 1st set //purpose : Goes through vertices from the 1st set
//======================================================================= //=======================================================================
void BRepExtrema_ProximityDistTool::goThroughtSet1 (const BVH_Array3d& theVertices1, void BRepExtrema_ProximityDistTool::goThroughtSet1 (const BVH_Array3d& theVertices1,
const Standard_Boolean theIsAdditionalSet) const Standard_Boolean theIsAdditionalSet)

View File

@ -88,7 +88,7 @@ public:
public: public:
//! Creates new unitialized tool. //! Creates new uninitialized tool.
Standard_EXPORT BRepExtrema_ProximityDistTool(); Standard_EXPORT BRepExtrema_ProximityDistTool();
//! Creates new tool for the given element sets. //! Creates new tool for the given element sets.
@ -169,7 +169,7 @@ protected:
private: private:
//! Goes throught vertices from the 1st set. //! Goes through vertices from the 1st set.
void goThroughtSet1 (const BVH_Array3d& aVertices1, void goThroughtSet1 (const BVH_Array3d& aVertices1,
const Standard_Boolean theIsAdditionalSet); const Standard_Boolean theIsAdditionalSet);

View File

@ -27,7 +27,7 @@
//======================================================================= //=======================================================================
//function : BRepExtrema_ProximityValueTool //function : BRepExtrema_ProximityValueTool
//purpose : Creates new unitialized proximity tool //purpose : Creates new uninitialized proximity tool
//======================================================================= //=======================================================================
BRepExtrema_ProximityValueTool::BRepExtrema_ProximityValueTool() BRepExtrema_ProximityValueTool::BRepExtrema_ProximityValueTool()
: myIsRefinementRequired1 (Standard_False), : myIsRefinementRequired1 (Standard_False),
@ -262,8 +262,8 @@ Standard_Boolean BRepExtrema_ProximityValueTool::getEdgeAdditionalVertices (
//======================================================================= //=======================================================================
//function : doRecurTrgSplit //function : doRecurTrgSplit
//purpose : Splits the triangle into two ones recursively, halving the longest side //purpose : Splits the triangle into two ones recursively, halving the longest side
// untill the area of the current triangle > input step // until the area of the current triangle > input step
//! @param theTrg points of the triangle to be splitted //! @param theTrg points of the triangle to be split
//! @param theEdgesStatus status of triangle edges - on the border or middle of the face //! @param theEdgesStatus status of triangle edges - on the border or middle of the face
//! @param theTol telerance used in search of coincidence points //! @param theTol telerance used in search of coincidence points
//! @param theStep minimum area of the resulting triangle //! @param theStep minimum area of the resulting triangle

View File

@ -90,7 +90,7 @@ class BRepExtrema_ProximityValueTool
public: public:
//! Creates new unitialized proximity tool. //! Creates new uninitialized proximity tool.
Standard_EXPORT BRepExtrema_ProximityValueTool(); Standard_EXPORT BRepExtrema_ProximityValueTool();
//! Creates new proximity tool for the given element sets. //! Creates new proximity tool for the given element sets.

View File

@ -194,7 +194,7 @@ private:
//! Reference point of the proximity value on the 1st shape. //! Reference point of the proximity value on the 1st shape.
gp_Pnt myProxPoint1; gp_Pnt myProxPoint1;
//! Reference point of the proximity value on the 2st shape. //! Reference point of the proximity value on the 2nd shape.
gp_Pnt myProxPoint2; gp_Pnt myProxPoint2;
//! Status of reference points of the proximity value. //! Status of reference points of the proximity value.

View File

@ -11,7 +11,7 @@
// Alternatively, this file may be used under the terms of Open CASCADE // Alternatively, this file may be used under the terms of Open CASCADE
// commercial license or contractual agreement. // commercial license or contractual agreement.
// abv 28.04.99 S4137: ading method Apply for work on all types of shapes // abv 28.04.99 S4137: adding method Apply for work on all types of shapes
// sln 29.11.01 Bug24: correction iteration through map in method 'Status' // sln 29.11.01 Bug24: correction iteration through map in method 'Status'
// sln 29.11.01 Bug22: correction of methods Replace and Value for case when mode myConsiderLocation is on // sln 29.11.01 Bug22: correction of methods Replace and Value for case when mode myConsiderLocation is on
@ -362,7 +362,7 @@ TopoDS_Shape BRepTools_ReShape::Apply (const TopoDS_Shape& shape,
if(st == TopAbs_VERTEX || st == TopAbs_SHAPE) if(st == TopAbs_VERTEX || st == TopAbs_SHAPE)
return shape; return shape;
// define allowed types of components // define allowed types of components
//fix for SAMTECH bug OCC322 about abcense internal vertices after sewing. //fix for SAMTECH bug OCC322 about absent internal vertices after sewing.
/* /*
switch ( st ) { switch ( st ) {
case TopAbs_COMPOUND: subt = TopAbs_SHAPE; break; case TopAbs_COMPOUND: subt = TopAbs_SHAPE; break;
@ -402,14 +402,14 @@ TopoDS_Shape BRepTools_ReShape::Apply (const TopoDS_Shape& shape,
if ( isEmpty ) if ( isEmpty )
isEmpty = Standard_False; isEmpty = Standard_False;
locStatus |= EncodeStatus(3);//ShapeExtend::EncodeStatus ( ShapeExtend_DONE3 ); locStatus |= EncodeStatus(3);//ShapeExtend::EncodeStatus ( ShapeExtend_DONE3 );
if ( st == TopAbs_COMPOUND || newsh.ShapeType() == sh.ShapeType()) { //fix for SAMTECH bug OCC322 about abcense internal vertices after sewing. if ( st == TopAbs_COMPOUND || newsh.ShapeType() == sh.ShapeType()) { //fix for SAMTECH bug OCC322 about absent internal vertices after sewing.
B.Add ( result, newsh ); B.Add ( result, newsh );
continue; continue;
} }
Standard_Integer nitems = 0; Standard_Integer nitems = 0;
for ( TopoDS_Iterator subit(newsh); subit.More(); subit.Next(), nitems++ ) { for ( TopoDS_Iterator subit(newsh); subit.More(); subit.Next(), nitems++ ) {
const TopoDS_Shape& subsh = subit.Value(); const TopoDS_Shape& subsh = subit.Value();
if ( subsh.ShapeType() == sh.ShapeType() ) B.Add ( result, subsh );//fix for SAMTECH bug OCC322 about abcense internal vertices after sewing. if ( subsh.ShapeType() == sh.ShapeType() ) B.Add ( result, subsh );//fix for SAMTECH bug OCC322 about absent internal vertices after sewing.
else locStatus |= EncodeStatus(10);//ShapeExtend::EncodeStatus ( ShapeExtend_FAIL1 ); else locStatus |= EncodeStatus(10);//ShapeExtend::EncodeStatus ( ShapeExtend_FAIL1 );
} }
if ( ! nitems ) locStatus |= EncodeStatus(10);//ShapeExtend::EncodeStatus ( ShapeExtend_FAIL1 ); if ( ! nitems ) locStatus |= EncodeStatus(10);//ShapeExtend::EncodeStatus ( ShapeExtend_FAIL1 );

View File

@ -72,7 +72,7 @@ public:
//! Clears the content of the set. //! Clears the content of the set.
Standard_EXPORT virtual void Clear() Standard_OVERRIDE; Standard_EXPORT virtual void Clear() Standard_OVERRIDE;
//! Stores the goemetry of <S>. //! Stores the geometry of <S>.
Standard_EXPORT virtual void AddGeometry (const TopoDS_Shape& S) Standard_OVERRIDE; Standard_EXPORT virtual void AddGeometry (const TopoDS_Shape& S) Standard_OVERRIDE;
//! Dumps the geometry of me on the stream <OS>. //! Dumps the geometry of me on the stream <OS>.

View File

@ -31,7 +31,7 @@ public:
//! \param theDegreeU degree along the first parameter (U) of the surface //! \param theDegreeU degree along the first parameter (U) of the surface
//! \param thePeriodicU identify the surface is periodical along U axis //! \param thePeriodicU identify the surface is periodical along U axis
//! \param theFlatKnotsU knots of the surface (with repetition) along U axis //! \param theFlatKnotsU knots of the surface (with repetition) along U axis
//! \param theDegreeV degree alogn the second parameter (V) of the surface //! \param theDegreeV degree along the second parameter (V) of the surface
//! \param thePeriodicV identify the surface is periodical along V axis //! \param thePeriodicV identify the surface is periodical along V axis
//! \param theFlatKnotsV knots of the surface (with repetition) along V axis //! \param theFlatKnotsV knots of the surface (with repetition) along V axis
//! \param theWeights array of weights of corresponding poles //! \param theWeights array of weights of corresponding poles

View File

@ -215,7 +215,7 @@ static void TreatInfinitePlane(const gp_Pln &aPlane,
// theMinIdx - minimum poles index, that can be used. // theMinIdx - minimum poles index, that can be used.
// theMaxIdx - maximum poles index, that can be used. // theMaxIdx - maximum poles index, that can be used.
// theShiftCoeff - shift between flatknots array and poles array. // theShiftCoeff - shift between flatknots array and poles array.
// This vaule should be equal to 1 in case of non periodic BSpline, // This value should be equal to 1 in case of non periodic BSpline,
// and (degree + 1) - mults(the lowest index). // and (degree + 1) - mults(the lowest index).
void ComputePolesIndexes(const TColStd_Array1OfReal &theKnots, void ComputePolesIndexes(const TColStd_Array1OfReal &theKnots,

View File

@ -451,7 +451,7 @@ void CPnts_AbscissaPoint::Perform(const Standard_Real Abscissa,
} }
else { else {
Standard_Real Ui = U0 + (Abscissa / myL) * (myUMax - myUMin) / 3.; Standard_Real Ui = U0 + (Abscissa / myL) * (myUMax - myUMin) / 3.;
// exercice : why 3 ? // exercise : why 3 ?
Perform(Abscissa,U0,Ui,Resolution); Perform(Abscissa,U0,Ui,Resolution);
} }
} }

View File

@ -157,7 +157,7 @@ static Standard_Boolean SearchFD(TopOpeBRepDS_DataStructure& DStr,
//======================================================================= //=======================================================================
//function : ToricCorner //function : ToricCorner
//purpose : Test if this is a paricular cas of a torus corner //purpose : Test if this is a particular case of a torus corner
// (or spherical limited by isos). // (or spherical limited by isos).
//======================================================================= //=======================================================================
@ -601,7 +601,7 @@ void ChFi3d_FilBuilder::PerformThreeCorner(const Standard_Integer Jndex)
#endif #endif
// the contour to be fillet consists of straight lines uv in beginning and end // the contour to be fillet consists of straight lines uv in beginning and end
// of two pcurves (only one if c1pointu) calculted as possible // of two pcurves (only one if c1pointu) calculated as possible
// on piv and the opposite face. // on piv and the opposite face.
Handle(GeomFill_Boundary) Bdeb,Bfin,Bpiv,Bfac; Handle(GeomFill_Boundary) Bdeb,Bfin,Bpiv,Bfac;
Handle(Geom2d_Curve) PCurveOnFace; Handle(Geom2d_Curve) PCurveOnFace;

View File

@ -51,7 +51,7 @@
//! TrueIntervals : the nth polynomial has to be mapped linearly to be //! TrueIntervals : the nth polynomial has to be mapped linearly to be
//! defined on the following interval : //! defined on the following interval :
//! myTrueIntervals->Value(n) and myTrueIntervals->Value(n+1) //! myTrueIntervals->Value(n) and myTrueIntervals->Value(n+1)
//! so that it represent adequatly the function with the //! so that it adequately represents the function with the
//! required continuity //! required continuity
class Convert_CompPolynomialToPoles class Convert_CompPolynomialToPoles
{ {
@ -85,7 +85,7 @@ public:
//! TrueIntervals[2] = {-1, 1} //! TrueIntervals[2] = {-1, 1}
Standard_EXPORT Convert_CompPolynomialToPoles(const Standard_Integer NumCurves, const Standard_Integer Continuity, const Standard_Integer Dimension, const Standard_Integer MaxDegree, const Handle(TColStd_HArray1OfInteger)& NumCoeffPerCurve, const Handle(TColStd_HArray1OfReal)& Coefficients, const Handle(TColStd_HArray2OfReal)& PolynomialIntervals, const Handle(TColStd_HArray1OfReal)& TrueIntervals); Standard_EXPORT Convert_CompPolynomialToPoles(const Standard_Integer NumCurves, const Standard_Integer Continuity, const Standard_Integer Dimension, const Standard_Integer MaxDegree, const Handle(TColStd_HArray1OfInteger)& NumCoeffPerCurve, const Handle(TColStd_HArray1OfReal)& Coefficients, const Handle(TColStd_HArray2OfReal)& PolynomialIntervals, const Handle(TColStd_HArray1OfReal)& TrueIntervals);
//! To Convert sevral span with different order of Continuity. //! To Convert several span with different order of Continuity.
//! Warning: The Length of Continuity have to be NumCurves-1 //! Warning: The Length of Continuity have to be NumCurves-1
Standard_EXPORT Convert_CompPolynomialToPoles(const Standard_Integer NumCurves, const Standard_Integer Dimension, const Standard_Integer MaxDegree, const TColStd_Array1OfInteger& Continuity, const TColStd_Array1OfInteger& NumCoeffPerCurve, const TColStd_Array1OfReal& Coefficients, const TColStd_Array2OfReal& PolynomialIntervals, const TColStd_Array1OfReal& TrueIntervals); Standard_EXPORT Convert_CompPolynomialToPoles(const Standard_Integer NumCurves, const Standard_Integer Dimension, const Standard_Integer MaxDegree, const TColStd_Array1OfInteger& Continuity, const TColStd_Array1OfInteger& NumCoeffPerCurve, const TColStd_Array1OfReal& Coefficients, const TColStd_Array2OfReal& PolynomialIntervals, const TColStd_Array1OfReal& TrueIntervals);

View File

@ -60,7 +60,7 @@ public:
//! returns true if the geometric system has an axis of symmetry. //! returns true if the geometric system has an axis of symmetry.
//! For comparing moments relative tolerance 1.e-10 is used. //! For comparing moments relative tolerance 1.e-10 is used.
//! Usually it is enough for objects, restricted by faces with //! Usually it is enough for objects, restricted by faces with
//! analitycal geometry. //! analytical geometry.
Standard_EXPORT Standard_Boolean HasSymmetryAxis() const; Standard_EXPORT Standard_Boolean HasSymmetryAxis() const;
@ -73,7 +73,7 @@ public:
//! returns true if the geometric system has a point of symmetry. //! returns true if the geometric system has a point of symmetry.
//! For comparing moments relative tolerance 1.e-10 is used. //! For comparing moments relative tolerance 1.e-10 is used.
//! Usually it is enough for objects, restricted by faces with //! Usually it is enough for objects, restricted by faces with
//! analitycal geometry. //! analytical geometry.
Standard_EXPORT Standard_Boolean HasSymmetryPoint() const; Standard_EXPORT Standard_Boolean HasSymmetryPoint() const;

View File

@ -17,7 +17,7 @@
#ifndef _GProp_ValueType_HeaderFile #ifndef _GProp_ValueType_HeaderFile
#define _GProp_ValueType_HeaderFile #define _GProp_ValueType_HeaderFile
//! Algorithmes : //! Algorithms:
enum GProp_ValueType enum GProp_ValueType
{ {
GProp_Mass, GProp_Mass,

View File

@ -48,7 +48,7 @@ public:
//! defines surface commands. //! defines surface commands.
Standard_EXPORT static void SurfaceCommands (Draw_Interpretor& I); Standard_EXPORT static void SurfaceCommands (Draw_Interpretor& I);
//! defines cosntrained curves commands. //! defines constrained curves commands.
Standard_EXPORT static void ConstraintCommands (Draw_Interpretor& I); Standard_EXPORT static void ConstraintCommands (Draw_Interpretor& I);
//! defines commands to test the GeomAPI //! defines commands to test the GeomAPI

View File

@ -287,7 +287,7 @@ static void PolyTest(const TColStd_Array1OfReal& Herm,
} }
} // end of the loop } // end of the loop
if (!SignDenom(Polesinit)) //invertion of the polynome sign if (!SignDenom(Polesinit)) //inversion of the polynome sign
{ {
for (index=0;index<=3;index++) for (index=0;index<=3;index++)
Polesinit(index).SetCoord(0.0,-Polesinit(index).Y()); Polesinit(index).SetCoord(0.0,-Polesinit(index).Y());
@ -520,7 +520,7 @@ static void PolyTest(const TColStd_Array1OfReal& Herm,
} }
} // end of the loop } // end of the loop
if (!SignDenom(Polesinit)) // invertion of the polynome sign if (!SignDenom(Polesinit)) // inversion of the polynome sign
{ {
for (index=0;index<=3;index++) for (index=0;index<=3;index++)
Polesinit(index).SetCoord(0.0,-Polesinit(index).Y()); Polesinit(index).SetCoord(0.0,-Polesinit(index).Y());

View File

@ -32,7 +32,7 @@ public:
DEFINE_STANDARD_ALLOC DEFINE_STANDARD_ALLOC
//! Prepares dymanic data (Protocol, Modules) for this package //! Prepares dynamic data (Protocol, Modules) for this package
Standard_EXPORT static void Init(); Standard_EXPORT static void Init();
//! Returns the Protocol for this Package //! Returns the Protocol for this Package

View File

@ -38,7 +38,7 @@ DEFINE_STANDARD_HANDLE(IGESGeom_Line, IGESData_IGESEntity)
//! From IGES-5.3, two other Forms are admitted (same params) : //! From IGES-5.3, two other Forms are admitted (same params) :
//! 0 remains for standard limited line (the default) //! 0 remains for standard limited line (the default)
//! 1 for semi-infinite line (End is just a passing point) //! 1 for semi-infinite line (End is just a passing point)
//! 2 for full infinite Line (both Start and End are abitrary) //! 2 for full infinite Line (both Start and End are arbitrary)
class IGESGeom_Line : public IGESData_IGESEntity class IGESGeom_Line : public IGESData_IGESEntity
{ {

View File

@ -51,7 +51,7 @@ public:
//! last parameter or at the first parameter of the domain. //! last parameter or at the first parameter of the domain.
Standard_EXPORT Standard_Boolean IsOpen() const; Standard_EXPORT Standard_Boolean IsOpen() const;
//! Returns the paramatric domain of the curve. //! Returns the parametric domain of the curve.
Standard_EXPORT void Domain(Standard_Real& theFirst, Standard_Real& theLast) const; Standard_EXPORT void Domain(Standard_Real& theFirst, Standard_Real& theLast) const;
//! Returns TRUE if the function is constant. //! Returns TRUE if the function is constant.

View File

@ -44,11 +44,11 @@ public:
//! it's the parameters which start the marching algorithm //! it's the parameters which start the marching algorithm
static void Value2d (const IntSurf_InteriorPoint& PStart, Standard_Real& U, Standard_Real& V); static void Value2d (const IntSurf_InteriorPoint& PStart, Standard_Real& U, Standard_Real& V);
//! returns the tangent at the intersectin in 3d space //! returns the tangent at the intersection in 3d space
//! associated to <P> //! associated to <P>
static gp_Vec Direction3d (const IntSurf_InteriorPoint& PStart); static gp_Vec Direction3d (const IntSurf_InteriorPoint& PStart);
//! returns the tangent at the intersectin in the //! returns the tangent at the intersection in the
//! parametric space of the parametrized surface.This tangent //! parametric space of the parametrized surface.This tangent
//! is associated to the value2d //! is associated to the value2d
static gp_Dir2d Direction2d (const IntSurf_InteriorPoint& PStart); static gp_Dir2d Direction2d (const IntSurf_InteriorPoint& PStart);

View File

@ -844,7 +844,7 @@ Standard_Boolean IntTools_Context::IsVertexOnLine
aFirst=aC3D->FirstParameter(); aFirst=aC3D->FirstParameter();
aLast =aC3D->LastParameter(); aLast =aC3D->LastParameter();
// //
// Checking extermities first // Checking extremities first
// It is necessary to chose the closest bound to the point // It is necessary to chose the closest bound to the point
Standard_Boolean bFirstValid = Standard_False; Standard_Boolean bFirstValid = Standard_False;
Standard_Real aFirstDist = Precision::Infinite(); Standard_Real aFirstDist = Precision::Infinite();

View File

@ -72,7 +72,7 @@ public:
//! Gets array, can be null //! Gets array, can be null
void** GetArray() const { return myArray; } void** GetArray() const { return myArray; }
//! Gets value by index, no acess validation //! Gets value by index, no access validation
void* Value (const size_t theInd) const { return myArray[theInd]; } void* Value (const size_t theInd) const { return myArray[theInd]; }
public: public:

View File

@ -26,10 +26,10 @@
//! to the system. //! to the system.
//! //!
//! This allocator can also be created per each working thread //! This allocator can also be created per each working thread
//! hovewer it real multi-threading performance is dubious. //! however its real multi-threading performance is dubious.
//! //!
//! Notice that this also means that existing pointers will be broken //! Notice that this also means that existing pointers will be broken
//! and you shoould control that allocator is alive along all objects //! and you should control that allocator is alive along all objects
//! allocated with him. //! allocated with him.
class NCollection_WinHeapAllocator : public NCollection_BaseAllocator class NCollection_WinHeapAllocator : public NCollection_BaseAllocator
{ {

View File

@ -23,7 +23,7 @@ public:
DEFINE_STANDARD_ALLOC DEFINE_STANDARD_ALLOC
//! Adds Draw commands to the draw interpretor. //! Adds Draw commands to the draw interpreter.
Standard_EXPORT static void Commands (Draw_Interpretor& theDI); Standard_EXPORT static void Commands (Draw_Interpretor& theDI);
//! Plugin entry point function. //! Plugin entry point function.

View File

@ -50,7 +50,7 @@ DEFINE_STANDARD_HANDLE (Poly_CoherentTriangulation, Standard_Transient)
* *
* This class is useful for algorithms that need to analyse and/or edit a triangulated mesh -- for example for mesh refining. * This class is useful for algorithms that need to analyse and/or edit a triangulated mesh -- for example for mesh refining.
* The connectivity model follows the idea that all Triangles in a mesh should have coherent orientation like on a surface of a solid body. * The connectivity model follows the idea that all Triangles in a mesh should have coherent orientation like on a surface of a solid body.
* Connections between more than 2 triangles are not suppoorted. * Connections between more than 2 triangles are not supported.
* *
* @section Poly_CoherentTriangulation Architecture * @section Poly_CoherentTriangulation Architecture
* The data types used in this structure are: * The data types used in this structure are:

View File

@ -131,7 +131,7 @@ namespace
{ {
return false; return false;
} }
// std::all_of is not used due to VS2008 compilability limitation // std::all_of is not used due to VS2008 compatibility limitation
return std::count_if (theString, theString + theLength, isHexDigit) == static_cast<std::ptrdiff_t> (theLength); return std::count_if (theString, theString + theLength, isHexDigit) == static_cast<std::ptrdiff_t> (theLength);
} }

View File

@ -825,7 +825,7 @@ Standard_Boolean ShapeAnalysis_CanonicalRecognition::GetSurfaceByLS(const TopoDS
Standard_Real aRelDev = 0.2; //Customer can set parameters of sample surface Standard_Real aRelDev = 0.2; //Customer can set parameters of sample surface
// with relative precision about aRelDev. // with relative precision about aRelDev.
// For example, if radius of sample surface is R, // For example, if radius of sample surface is R,
// it means, that "exact" vaue is in interav // it means, that "exact" value is in interav
//[R - aRelDev*R, R + aRelDev*R]. This interval is set //[R - aRelDev*R, R + aRelDev*R]. This interval is set
// for R as boundary values for optimization algo. // for R as boundary values for optimization algo.
FillSolverData(theTarget, thePos, theParams, FillSolverData(theTarget, thePos, theParams,
@ -878,7 +878,7 @@ Standard_Boolean ShapeAnalysis_CanonicalRecognition::GetSurfaceByLS(const TopoDS
if (theTarget == GeomAbs_Cylinder || theTarget == GeomAbs_Cone) if (theTarget == GeomAbs_Cylinder || theTarget == GeomAbs_Cone)
{ {
//Set search direction for location to be perpendicular to axis to avoid //Set search direction for location to be perpendicular to axis to avoid
//seaching along axis //searching along axis
const gp_Dir aDir = thePos.Direction(); const gp_Dir aDir = thePos.Direction();
gp_Pln aPln(thePos.Location(), aDir); gp_Pln aPln(thePos.Location(), aDir);
gp_Dir aUDir = aPln.Position().XDirection(); gp_Dir aUDir = aPln.Position().XDirection();

View File

@ -43,7 +43,7 @@ class Geom_Surface;
//! This class provides operators for analysis surfaces and curves of shapes //! This class provides operators for analysis surfaces and curves of shapes
//! in order to find out more simple geometry entities, which could replace //! in order to find out more simple geometry entities, which could replace
//! existing complex (for exampe, BSpline) geometry objects with given tolerance. //! existing complex (for example, BSpline) geometry objects with given tolerance.
class ShapeAnalysis_CanonicalRecognition class ShapeAnalysis_CanonicalRecognition
{ {
public: public:

View File

@ -97,7 +97,7 @@ public:
//! Returns compound of open wires out of free edges. //! Returns compound of open wires out of free edges.
const TopoDS_Compound& GetOpenWires() const; const TopoDS_Compound& GetOpenWires() const;
//! Builds sequnce of <wires> out of sequence of not sorted //! Builds sequence of <wires> out of sequence of not sorted
//! <edges>. //! <edges>.
//! Tries to build wires of maximum length. Building a wire is //! Tries to build wires of maximum length. Building a wire is
//! stopped when no edges can be connected to it at its head or //! stopped when no edges can be connected to it at its head or
@ -112,7 +112,7 @@ public:
Standard_EXPORT static void ConnectWiresToWires (Handle(TopTools_HSequenceOfShape)& iwires, const Standard_Real toler, const Standard_Boolean shared, Handle(TopTools_HSequenceOfShape)& owires); Standard_EXPORT static void ConnectWiresToWires (Handle(TopTools_HSequenceOfShape)& iwires, const Standard_Real toler, const Standard_Boolean shared, Handle(TopTools_HSequenceOfShape)& owires);
//! Builds sequnce of <owires> out of sequence of not sorted //! Builds sequence of <owires> out of sequence of not sorted
//! <iwires>. //! <iwires>.
//! Tries to build wires of maximum length. Building a wire is //! Tries to build wires of maximum length. Building a wire is
//! stopped when no wires can be connected to it at its head or //! stopped when no wires can be connected to it at its head or

View File

@ -260,7 +260,7 @@ static Standard_Boolean GetShells(TopTools_SequenceOfShape& Lface,
aMapFaceShells.Bind(F1,nshell); aMapFaceShells.Bind(F1,nshell);
Lface.Remove(i); Lface.Remove(i);
// check if closed shell is obtained in multy connex mode and add to sequence of // check if closed shell is obtained in multi connex mode and add to sequence of
// shells and new shell begin to construct. // shells and new shell begin to construct.
// (check is n*2) // (check is n*2)
if(isMultiConnex && BRep_Tool::IsClosed (nshell)) { if(isMultiConnex && BRep_Tool::IsClosed (nshell)) {
@ -300,7 +300,7 @@ static Standard_Boolean GetShells(TopTools_SequenceOfShape& Lface,
numFace++; numFace++;
} }
if(numFace >1) { if(numFace >1) {
// close all closed shells in no multy connex mode // close all closed shells in no multi connex mode
if(!isMultiConnex) if(!isMultiConnex)
nshell.Closed (BRep_Tool::IsClosed (nshell)); nshell.Closed (BRep_Tool::IsClosed (nshell));
aSeqShells.Append(nshell); aSeqShells.Append(nshell);
@ -514,7 +514,7 @@ static Standard_Integer BoxIn(const Bnd_Box& theBox1,const Bnd_Box& theBox2)
//======================================================================= //=======================================================================
// function : GetClosedShells // function : GetClosedShells
// purpose : Check if one shell is a part from other shell. // purpose : Check if one shell is a part from other shell.
// For case of compsolid when afew shells are created from // For case of compsolid when a few shells are created from
// the same set of faces. // the same set of faces.
//======================================================================= //=======================================================================
static void GetClosedShells(TopTools_SequenceOfShape& Shells, TopTools_SequenceOfShape& aRemainShells) static void GetClosedShells(TopTools_SequenceOfShape& Shells, TopTools_SequenceOfShape& aRemainShells)

View File

@ -67,7 +67,7 @@ Standard_Boolean ShapeFix_SplitTool::SplitEdge(const TopoDS_Edge& edge,
sae.PCurve(edge,face,c2d,a,b,Standard_True ); sae.PCurve(edge,face,c2d,a,b,Standard_True );
if( Abs(a-param)<tol2d || Abs(b-param)<tol2d ) if( Abs(a-param)<tol2d || Abs(b-param)<tol2d )
return Standard_False; return Standard_False;
// check distanse between edge and new vertex // check distance between edge and new vertex
gp_Pnt P1; gp_Pnt P1;
TopLoc_Location L; TopLoc_Location L;
if(BRep_Tool::SameParameter(edge)) { if(BRep_Tool::SameParameter(edge)) {

View File

@ -85,11 +85,11 @@ public:
Standard_EXPORT TopAbs_Orientation Orientation() const; Standard_EXPORT TopAbs_Orientation Orientation() const;
//! Returns first vertex of the first edge in the wire //! Returns first vertex of the first edge in the wire
//! (no dependance on Orientation()). //! (no dependence on Orientation()).
Standard_EXPORT TopoDS_Vertex FirstVertex() const; Standard_EXPORT TopoDS_Vertex FirstVertex() const;
//! Returns last vertex of the last edge in the wire //! Returns last vertex of the last edge in the wire
//! (no dependance on Orientation()). //! (no dependence on Orientation()).
Standard_EXPORT TopoDS_Vertex LastVertex() const; Standard_EXPORT TopoDS_Vertex LastVertex() const;
//! Returns True if FirstVertex() == LastVertex() //! Returns True if FirstVertex() == LastVertex()

View File

@ -104,7 +104,7 @@ public:
return (identifiedItem.IsNull() ? 0 : identifiedItem->Length()); return (identifiedItem.IsNull() ? 0 : identifiedItem->Length());
} }
//! Set fiels IdentifiedItem //! Set field IdentifiedItem
inline void SetIdentifiedItem (const Handle(StepRepr_HArray1OfRepresentationItem)& theIdentifiedItem) inline void SetIdentifiedItem (const Handle(StepRepr_HArray1OfRepresentationItem)& theIdentifiedItem)
{ {
identifiedItem = theIdentifiedItem; identifiedItem = theIdentifiedItem;

View File

@ -127,7 +127,7 @@ public:
//! Destructor cleans allocated memory of all fields //! Destructor cleans allocated memory of all fields
~StepFile_ReadData() { ClearRecorder(3); } ~StepFile_ReadData() { ClearRecorder(3); }
//! Preperes the text value for analysis. //! Prepares the text value for analysis.
//! It is the main tool for transferring data from flex to bison //! It is the main tool for transferring data from flex to bison
//! If characters page is full, allocates a new page. //! If characters page is full, allocates a new page.
void CreateNewText(const char* theNewText, int theLenText); void CreateNewText(const char* theNewText, int theLenText);

View File

@ -622,7 +622,7 @@ goto find_rule; \
typedef step::parser::token token; typedef step::parser::token token;
/* skl 31.01.2002 for OCC133(OCC96,97) - uncorrect /* skl 31.01.2002 for OCC133(OCC96,97) - incorrect
long string in files Henri.stp and 401.stp*/ long string in files Henri.stp and 401.stp*/
#include <Standard_Failure.hxx> #include <Standard_Failure.hxx>
#define YY_FATAL_ERROR(msg) Standard_Failure::Raise(msg); #define YY_FATAL_ERROR(msg) Standard_Failure::Raise(msg);

View File

@ -61,7 +61,7 @@
typedef step::parser::token token; typedef step::parser::token token;
/* skl 31.01.2002 for OCC133(OCC96,97) - uncorrect /* skl 31.01.2002 for OCC133(OCC96,97) - incorrect
long string in files Henri.stp and 401.stp*/ long string in files Henri.stp and 401.stp*/
#include <Standard_Failure.hxx> #include <Standard_Failure.hxx>
#define YY_FATAL_ERROR(msg) Standard_Failure::Raise(msg); #define YY_FATAL_ERROR(msg) Standard_Failure::Raise(msg);

View File

@ -82,7 +82,7 @@ public:
return *this; return *this;
} }
//! Returne true if this list is empty //! Return true if this list is empty
Standard_Boolean IsEmpty() const Standard_Boolean IsEmpty() const
{ {
return myNode.IsNull(); return myNode.IsNull();

View File

@ -1587,7 +1587,7 @@ void TopOpeBRepBuild_Builder::FillShape(const TopoDS_Shape& S1,
TopOpeBRepTool_ShapeExplorer ex11(aSubShape,t11); TopOpeBRepTool_ShapeExplorer ex11(aSubShape,t11);
SplitShapes(ex11,ToBuild1,ToBuild2,aSet,RevOri); SplitShapes(ex11,ToBuild1,ToBuild2,aSet,RevOri);
} }
} // exploration ot SubShapes of type <t1> of shape <S1> } // exploration of SubShapes of type <t1> of shape <S1>
} // FillShape } // FillShape

View File

@ -878,7 +878,7 @@ void TopOpeBRepBuild_Builder1::GFillEdgeSameDomWES(const TopoDS_Shape& EOR,
} }
//we should process all same domain edges (ON2D) in the code above //we should process all same domain edges (ON2D) in the code above
//and we can not proceess edges with UNKNOWN state //and we can not process edges with UNKNOWN state
if(aState == TopAbs_ON || aState == TopAbs_UNKNOWN) if(aState == TopAbs_ON || aState == TopAbs_UNKNOWN)
continue; continue;
@ -1586,7 +1586,7 @@ Standard_Integer TopOpeBRepBuild_Builder1::TwoPiecesON (const TopTools_SequenceO
if(!anAd1 || !anAd2) if(!anAd1 || !anAd2)
return 12; return 12;
else else
return 10; //10 doesn't mean anything just to retutn something return 10; //10 doesn't mean anything just to return something
} }
// case c. No==Nt , To==Tt // case c. No==Nt , To==Tt
@ -1640,7 +1640,7 @@ Standard_Integer TopOpeBRepBuild_Builder1::TwoPiecesON (const TopTools_SequenceO
if(!anAd1 || !anAd2) if(!anAd1 || !anAd2)
return 14; return 14;
else else
return 10; //10 doesn't mean anything just to retutn something return 10; //10 doesn't mean anything just to return something
} }
return 10; return 10;
} // end of if (!anAd1 || !anAd2 || !aScPrFlag1 || !aScPrFlag2) } // end of if (!anAd1 || !anAd2 || !aScPrFlag1 || !aScPrFlag2)

View File

@ -497,7 +497,7 @@ void DumpMapOfShapeWithState (const Standard_Integer iP,
} }
} //end of else {// Wire has an interferences } //end of else {// Wire has an interferences
} // next Wire } // next Wire
} // next interferred Face ... for (i=1; i<=nF; i++) ... } // next interfered Face ... for (i=1; i<=nF; i++) ...
} }
//======================================================================= //=======================================================================

View File

@ -1027,8 +1027,8 @@ Standard_Integer TopOpeBRepBuild_Builder::KPiskoletge()
Standard_Boolean se2ONouterw1 = ::sectionedgesON(myDataStructure,outerw2,mape1); Standard_Boolean se2ONouterw1 = ::sectionedgesON(myDataStructure,outerw2,mape1);
if (!se2ONouterw1) return 0; if (!se2ONouterw1) return 0;
// NYI : <fi> interfers with faces of <Sj> on edges different from outerw's edges // NYI : <fi> interferes with faces of <Sj> on edges different from outerw's edges
// ------------------------------------------------------------------------------ // -------=-----------------------------------------------------------------------
Standard_Boolean allI1onseouterw = ::allIonsectionedges(myDataStructure,f1,mape1,mape2); Standard_Boolean allI1onseouterw = ::allIonsectionedges(myDataStructure,f1,mape1,mape2);
if (!allI1onseouterw) return 0; if (!allI1onseouterw) return 0;
Standard_Boolean allI2onseouterw = ::allIonsectionedges(myDataStructure,f2,mape2,mape1); Standard_Boolean allI2onseouterw = ::allIonsectionedges(myDataStructure,f2,mape2,mape1);

View File

@ -334,7 +334,7 @@ void TopOpeBRepBuild_Builder::GFABUMakeFaces(const TopoDS_Shape& FF,TopOpeBRepBu
//--ofv: //--ofv:
// Unfortunately, the function GFillONPartsWES2() from file TopOpeBRepBuild_BuilderON.cxx sets orientation of // Unfortunately, the function GFillONPartsWES2() from file TopOpeBRepBuild_BuilderON.cxx sets orientation of
// some section edges as INTERNAL or EXTERNAL, but they should be FORWARD or REVERSED. It probably makes faces // some section edges as INTERNAL or EXTERNAL, but they should be FORWARD or REVERSED. It probably makes faces
// without closed boundary, for example. So, we must check carefuly edges with orientation INTERNAL(EXTERNAL). // without closed boundary, for example. So, we must check carefully edges with orientation INTERNAL(EXTERNAL).
// Bugs: 60936, 60937, 60938 (cut, fuse, common shapes) // Bugs: 60936, 60937, 60938 (cut, fuse, common shapes)
TopoDS_Compound CmpOfEdges; TopoDS_Compound CmpOfEdges;
BRep_Builder BldCmpOfEdges; BRep_Builder BldCmpOfEdges;

View File

@ -42,8 +42,8 @@ static void FUN_Raise()
// myIsVertex : // myIsVertex :
// ------------ // ------------
// POINT :<Eref> interfers with <E> at a point // POINT :<Eref> interferes with <E> at a point
// <Eref> interfers with <E> at a vertex V, // <Eref> interferes with <E> at a vertex V,
// VERTEXonref : V is on shape of <Eref> // VERTEXonref : V is on shape of <Eref>
// VERTEXonOO : V is on shape of <E> // VERTEXonOO : V is on shape of <E>
// VERTEXonOref : V is on 2 shapes. // VERTEXonOref : V is on 2 shapes.

View File

@ -38,7 +38,7 @@ class TopOpeBRepDS_ShapeShapeInterference : public TopOpeBRepDS_Interference
public: public:
//! a shape interfers on shape <G> with shape <S>. //! a shape interferes on shape <G> with shape <S>.
//! examples : //! examples :
//! create a ShapeShapeInterference describing : //! create a ShapeShapeInterference describing :
//! vertex V of edge E1 found on edge E2 : //! vertex V of edge E1 found on edge E2 :

View File

@ -20,8 +20,8 @@
#include <gp_XYZ.hxx> #include <gp_XYZ.hxx>
/** /**
* Inplementation of the Box node. * Implementation of the Box node.
* This node is defined by Size vector, assumong that the box center is located * This node is defined by Size vector, assuming that the box center is located
* in (0., 0., 0.) and that each corner is 0.5*|Size| distance from the center. * in (0., 0., 0.) and that each corner is 0.5*|Size| distance from the center.
*/ */
class VrmlData_Box : public VrmlData_Geometry class VrmlData_Box : public VrmlData_Geometry

View File

@ -630,7 +630,7 @@ VrmlData_ErrorStatus VrmlData_ArrayVec3d::ReadArray
if (OK(aStatus) && OK(aStatus, VrmlData_Scene::ReadLine(theBuffer))) { if (OK(aStatus) && OK(aStatus, VrmlData_Scene::ReadLine(theBuffer))) {
if (theBuffer.LinePtr[0] != '[') // opening bracket if (theBuffer.LinePtr[0] != '[') // opening bracket
{ {
// Handle case when brackets are ommited for single element of array // Handle case when brackets are omitted for single element of array
gp_XYZ anXYZ; gp_XYZ anXYZ;
// Read three numbers (XYZ value) // Read three numbers (XYZ value)
if (!OK(aStatus, Scene().ReadXYZ(theBuffer, anXYZ, if (!OK(aStatus, Scene().ReadXYZ(theBuffer, anXYZ,

View File

@ -871,7 +871,7 @@ VrmlData_ErrorStatus VrmlData_Scene::ReadArrIndex
if (vecInt.Length() > 2) if (vecInt.Length() > 2)
{ {
// additional check for redundant point: // additional check for redundant point:
// ignore last point which is a dublicate of first point // ignore last point which is a duplicate of first point
if (anIntValue == vecInt[0]) if (anIntValue == vecInt[0])
{ {
continue; continue;

View File

@ -68,7 +68,7 @@ class VrmlData_Scene
* in that node are matched with these directories. * in that node are matched with these directories.
* The last (implicit) search directory is the current process directory * The last (implicit) search directory is the current process directory
* ("."). It takes effect if the list is empty or if there is no match with * ("."). It takes effect if the list is empty or if there is no match with
* exisiting directories. * existing directories.
*/ */
Standard_EXPORT void SetVrmlDir (const TCollection_ExtendedString&); Standard_EXPORT void SetVrmlDir (const TCollection_ExtendedString&);
@ -205,7 +205,7 @@ class VrmlData_Scene
ReadLine (VrmlData_InBuffer& theBuffer); ReadLine (VrmlData_InBuffer& theBuffer);
/** /**
* Read a singel word from the input stream, delimited by whitespace. * Read a single word from the input stream, delimited by whitespace.
*/ */
Standard_EXPORT static VrmlData_ErrorStatus Standard_EXPORT static VrmlData_ErrorStatus
ReadWord (VrmlData_InBuffer& theBuffer, ReadWord (VrmlData_InBuffer& theBuffer,

View File

@ -49,7 +49,7 @@ class VrmlData_Sphere : public VrmlData_Geometry
inline Standard_Real Radius () const { return myRadius; } inline Standard_Real Radius () const { return myRadius; }
/** /**
* Set the spere radius * Set the sphere radius
*/ */
inline void SetRadius (const Standard_Real theRadius) inline void SetRadius (const Standard_Real theRadius)
{ myRadius = theRadius; SetModified(); } { myRadius = theRadius; SetModified(); }

View File

@ -114,7 +114,7 @@ class XSControl_Controller : public Standard_Transient
//! Read from field. Can be redefined //! Read from field. Can be redefined
Standard_EXPORT virtual Handle(Transfer_ActorOfFinderProcess) ActorWrite() const; Standard_EXPORT virtual Handle(Transfer_ActorOfFinderProcess) ActorWrite() const;
//! Sets mininum and maximum values for modetrans (write) //! Sets minimum and maximum values for modetrans (write)
//! Erases formerly recorded bounds and values //! Erases formerly recorded bounds and values
//! Actually only for shape //! Actually only for shape
//! Then, for each value a little help can be attached //! Then, for each value a little help can be attached