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`
==fleche : 0.001
==tolblend 0.01 0.0001 1e-05 0.001
==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 :
==- Init + ExtentAnalyse 0s
* **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.
* **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
* composing framework class instances
* implementing the services required by the framework.
* 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
* 1 (On) -- translate
* TESSELLATED_SOLID
* 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
* 1 (On) -- write
#include <AdvApp2Var_Context.hxx>
#include <Standard_ConstructionError.hxx>
-// Calculaton of parameters
+// Calculation of parameters
static Standard_Boolean lesparam(const Standard_Integer iordre,
const Standard_Integer ncflim,
const Standard_Integer icodeo,
#ifndef _AdvApp2Var_CriterionType_HeaderFile
#define _AdvApp2Var_CriterionType_HeaderFile
-//! influency of the criterion on cutting process//! cutting when criterion is not satisfied
-//! desactivation of the compute of the error max//! cutting when error max is not good or if error
+//! influence of the criterion on cutting process
+//! 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
enum AdvApp2Var_CriterionType
{
/* INPUT ARGUMENTS : */
/* -------------------- */
- /* DEBFIN : PARAMETES DEFINING THE CONSTRAINTS */
+ /* DEBFIN : PARAMETERS DEFINING THE CONSTRAINTS */
/* DEBFIN(1) : FIRST PARAMETER */
/* DEBFIN(2) : SECOND PARAMETER */
AAffin->Value(ii).Transforms(myPoles2d->ChangeValue(ii).ChangeCoord());
}
- // Update variables of controle and return
+ // Update variables of control and return
first = First;
last = Last;
myOrder = 0;
}
}
- // Fill maps of Free, Contigous and Multiple edges
+ // Fill maps of Free, Contiguous and Multiple edges
TopTools_IndexedDataMapOfShapeListOfShape::Iterator anIter(edgeSections);
for (; anIter.More(); anIter.Next())
{
//=======================================================================
// 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)
//! Private method. Returns the value for volume computation.
//! Other returned values are:
//! - 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
//! by plane.
Standard_EXPORT Standard_Real VolumeValue(const Standard_Real X,
//! computation of a value.
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
//! other then GProp_InertiaXX, GProp_InertiaYY,
//! GProp_InertiaZZ, GProp_InertiaXY, GProp_InertiaXZ or
//! Computes the intersection between a face and a
//! curve. To intersect one curve with shape method
-//! Init(Shape, curve, tTol) should be used. To
+//! Init(Shape, curve, tTol) should be used. To
//! intersect a few curves with specified shape it is
//! necessary to load shape one time using method
//! Load(shape, tol) and find intersection points for
-//! each curve using method Init(curve). For
+//! each curve using method Init(curve). For
//! iteration by intersection points method More() and
//! Next() should be used.
//!
//! Empty constructor;
Standard_EXPORT BRepIntCurveSurface_Inter();
- //! Load the Shape, the curve and initialize the
+ //! Load the Shape, the curve and initialize the
//! tolerance used for the classification.
Standard_EXPORT void Init(const TopoDS_Shape& theShape,
const GeomAdaptor_Curve& theCurve,
const Standard_Real theTol);
- //! Load the Shape, the curve and initialize the
+ //! Load the Shape, the curve and initialize the
//! tolerance used for the classification.
Standard_EXPORT void Init(const TopoDS_Shape& theShape,
const gp_Lin& theLine,
const Standard_Real theTol);
- //! Load the Shape, and initialize the
+ //! Load the Shape, and initialize the
//! tolerance used for the classification.
Standard_EXPORT void Load(const TopoDS_Shape& theShape, const Standard_Real theTol);
//! on the current face.
Standard_EXPORT Standard_Real V() const;
- //! returns the parameter of the current point
+ //! returns the parameter of the current point
//! on the curve.
Standard_EXPORT Standard_Real W() const;
- //! returns the current state (IN or ON)
+ //! returns the current state (IN or ON)
Standard_EXPORT TopAbs_State State() const;
//! returns the transition of the line on the surface (IN or OUT or UNKNOWN)
//! Internal function
Standard_EXPORT void Find();
- //! Method chec found intersection point
+ //! Method check found intersection point
Standard_EXPORT Standard_Boolean FindPoint();
//! Method to clear fields of class
const IMeshTools_Parameters& theParameters) const;
//! 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
{
return GetSurface()->Value(thePoint2d.X(), thePoint2d.Y());
#include <GeomLib.hxx>
//! 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>
class BRepMesh_DelaunayDeflectionControlMeshAlgo
: public BRepMesh_DelaunayNodeInsertionMeshAlgo<RangeSplitter, BaseAlgo>
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());
OE = TopoDS::Edge(InitOffsetEdge.Image(V[i]).First());
// Then edge is trimmed by intersection line between
// two adjacent extended offset faces and get vertices.
// When intersection lines are invalid for any reason,
- // (one of reson is mixed connectivity of faces)
- // algoritm of cutting offset edge by intersection line
+ // (one reason is mixed connectivity of faces)
+ // algorithm of cutting offset edge by intersection line
// 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.
Standard_Real anOEF, anOEL;
TopAbs_Orientation anOEOri = OE.Orientation();
protected:
//! Analyze progress steps of the whole operation.
//! @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,
TColStd_Array1OfReal& theSteps) const;
Standard_Boolean bAllInv = Standard_True;
// Additional check for artificial case
// 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;
const TopoDS_Shape& aFIm = aItLFIm.Value();
TopExp_Explorer aExpE(aFIm, TopAbs_EDGE);
{
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 (bAllInv)
{
//=======================================================================
// function : mapShapes
-// purpose : Collect theVecShapes into theMap with setted theType
+// purpose : Collect theVecShapes into theMap with theType set
//=======================================================================
template <class Container>
static void mapShapes(const Container& theVecShapes,
Standard_EXPORT BRepOffset_MakeSimpleOffset(const TopoDS_Shape& theInputShape,
const Standard_Real theOffsetValue);
- //! Initialies shape for modifications.
+ //! Initialise shape for modifications.
Standard_EXPORT void Initialize(const TopoDS_Shape& theInputShape,
const Standard_Real theOffsetValue);
class gp_Lin;
class gp_Pnt;
-//! A wedge is defined by :
+//! A wedge is defined by:
//!
-//! Axes : an Axis2 (coordinate system)
+//! Axes: an Axis2 (coordinate system)
//!
-//! YMin, YMax the coordinates of the ymin and ymax
+//! YMin, YMax the coordinates of the ymin and ymax
//! rectangular faces parallel to the ZX plane (of the
//! coordinate systems)
//!
//! Default constructor
Standard_EXPORT BRepPrim_GWedge();
- //! Creates a GWedge algorithm. <Axes> is the axis
+ //! Creates a GWedge algorithm. <Axes> is the axis
//! system for the primitive.
//!
//! XMin, YMin, ZMin are set to 0
const Standard_Real dy,
const Standard_Real dz);
- //! Creates a GWedge primitive. <Axes> is the axis
+ //! Creates a GWedge primitive. <Axes> is the axis
//! system for the primitive.
//!
//! XMin, YMin, ZMin are set to 0
const Standard_Real dz,
const Standard_Real ltx);
- //! Create a GWedge primitive. <Axes> is the axis
+ //! Create a GWedge primitive. <Axes> is the axis
//! system for the primitive.
//!
//! all the fields are set to the corresponding value
Standard_EXPORT Standard_Real GetX2Max() const;
//! 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);
- //! Closes <me> in <d1> direction. A face and its
- //! edges or vertices are said existant.
+ //! Closes <me> in <d1> direction. A face and its
+ //! edges or vertices are said existent.
Standard_EXPORT void Close(const BRepPrim_Direction d1);
//! Returns True if <me> is open in <d1> direction.
//! Returns the Face of <me> located in <d1> direction.
Standard_EXPORT const TopoDS_Face& Face(const BRepPrim_Direction d1);
- //! Returns the plane of the Face of <me> located in
+ //! Returns the plane of the Face of <me> located in
//! <d1> direction.
Standard_EXPORT gp_Pln Plane(const BRepPrim_Direction d1);
//! Returns the Edge of <me> located in <d1><d2> direction.
Standard_EXPORT const TopoDS_Edge& Edge(const BRepPrim_Direction d1, const BRepPrim_Direction d2);
- //! Returns the line of the Edge of <me> located in
+ //! Returns the line of the Edge of <me> located in
//! <d1><d2> direction.
Standard_EXPORT gp_Lin Line(const BRepPrim_Direction d1, const BRepPrim_Direction d2);
- //! Returns True if <me> has a Vertex in <d1><d2><d3>
+ //! Returns True if <me> has a Vertex in <d1><d2><d3>
//! direction.
Standard_EXPORT Standard_Boolean HasVertex(const BRepPrim_Direction d1,
const BRepPrim_Direction d2,
//=======================================================================
// 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>.
// 1) return true if extrema is found.
// 2) Set in:
//! ...
//!
//! "GenObject" is used to identify an object from the
-//! Generating Shape, and "DirObject" from the
-//! Directing Shape. So may they be from different
+//! Generating Shape, and "DirObject" from the
+//! Directing Shape. So may they be from different
//! types.
//!
//! The method Has... is given because in some special
-//! cases, a vertex, an edge or a face may be
-//! geometricaly nonexistant or not useful.
+//! cases, a vertex, an edge or a face may be
+//! geometricaly nonexistent or not useful.
class BRepSweep_NumLinearRegularSweep
{
public:
di << " --> TheInter : ";
if (TheInter)
{
- di << "Complet";
+ di << "Complete";
}
else
{
//! WeightsResult one has the result of the evaluation of
//! the denominator
//!
- //! Warning: <PolesResult> and <WeightsResult> must be dimensionned
+ //! Warning: <PolesResult> and <WeightsResult> must be dimensioned
//! properly.
Standard_EXPORT static void Eval(const Standard_Real U,
const Standard_Boolean PeriodicFlag,
//! <Continuity> must be equal to 1, 2 or 3.
//! <Degree> must be greater or equal than <Continuity> + 1.
//!
- //! Warning: <KnotsResult> and <PolesResult> must be dimensionned
+ //! Warning: <KnotsResult> and <PolesResult> must be dimensioned
//! properly.
Standard_EXPORT static void TangExtendToConstraint(const TColStd_Array1OfReal& FlatKnots,
const Standard_Real C1Coefficient,
//!
//! 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,
const Standard_Integer VDeg,
const Standard_Integer N,
//! Returns parallel flag.
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; }
protected:
//! Returns parallel flag.
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; }
public:
//! Returns parallel flag.
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; }
private:
//=======================================================================
// function : EvalTolReached
// 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,
{
// there is no need of tolerance
// 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));
// mate attention to the single case (cf CTS21610_1)
if (OnAjoute && (degeneOnEc || TangentOnVertex(LVEc, Ev, myEFMap, ta)))
}
// 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);
// Fop calls the 4th face non-used for the vertex
ChFiDS_SequenceOfSurfData& SeqFil2 = Corner2->ChangeSetOfSurfData()->ChangeSequence();
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.
// Otherwise the opposite face
// and the eventual intersection of 2 pcurves on this face are found.
// 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
// 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 constr = 1; // G1
GeomPlate_BuildPlateSurface PSurf(degree, nbcurvpnt, nbiter, tol2d, tolapp3d, angular);
// the SurfData of the corner <SDCoin>. Here we know the
// extremities of the intersection <pdeb> and <pfin>, and
// 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>
// <derudeb> and <dervdeb> are the derivative vectors on the
// SurfData <SD> at the point <ptdeb>
}
else if (!strcasecmp(a[1], "ang"))
{
- di << "Angle de discretisation : ";
- di << aParams.HLRAngle * 180 / M_PI << " degres\n";
+ di << "Angle of discretization : ";
+ di << aParams.HLRAngle * 180 / M_PI << " degrees\n";
}
else
return 1;
}
}
}
- // Check of equality of MidXYZ
+ // Check equality of MidXYZ
for (Index = 1; Index < MaxShapes; Index++)
{
if (MidXYZ(OrderInd(Index + 1)) == MidXYZ(OrderInd(Index)))
Method:
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:
There is an infinite number of solutions; IsDone() = Standard_False.
2- distance(Pp,O) > Tol:
//
// 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;
Standard_Integer aNewCsample = mytsample;
Standard_Integer anAddsample = Max(myusample / 2, 3);
- F: Extrema_FuncExtPS created from P and S,
- UV: math_Vector the components which of are parameters of the extremum on the
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,
- UVsup: math_Vector the components which of are upper limits of u and v.
//! . UDegree is greater than MaxDegree.
//! . the Length of CPoles is not equal to NbVPoles
//! . a weight value is lower or equal to Resolution from
- //! pacakage gp
+ //! package gp
Standard_EXPORT void InsertPoleRowBefore(const Standard_Integer UIndex,
const TColgp_Array1OfPnt& CPoles,
const TColStd_Array1OfReal& CPoleWeights);
{
if (((!mySurfInitIsGive)
&& (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
}
}
#include <Standard_Integer.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.
//!
-//! 2D Data : The tangent and the curvature of the
-//! projection of the edge at the intersection point.
-//! This is necesserary when the intersection is at
+//! 2D Data: The tangent and the curvature of the
+//! projection of the edge at the intersection point.
+//! This is necesserary when the intersection is at
//! the extremity of the edge.
//!
-//! 3D Data : The state of the edge near the
-//! intersection with the face (before and after).
-//! This is necessary when the intersection is "ON"
+//! 3D Data: The state of the edge near the
+//! intersection with the face (before and after).
+//! This is necessary when the intersection is "ON"
//! the face.
class HLRAlgo_Coincidence
{
//! <TC> allows to run additional copies as required
//!
//! 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,
const Handle(Interface_InterfaceModel)& target,
const Handle(Interface_Protocol)& protocol,
//! contains (the Type's Name must contain the criterium Text)
//!
//! 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
//!
//! Also, numeric (integer) comparisons are supported : an item
//! WorkSession and an Ascii Form, to be considered as a Dump.
//! It allows to write the File from the WorkSession, and later
//! 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
//! easily consulted.
//! Creates a SessionFile which Writes the content of a WorkSession
//! 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.
Standard_EXPORT IFSelect_SessionFile(const Handle(IFSelect_WorkSession)& WS,
const Standard_CString filename);
//! undefined), positive if OK, negative else :
//! 0 : Nothing done
//! 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
//! have changed), protocol unchanged
//! 3 : OK, new model produced, same protocol
//! -2 : Error on edition the spot, data may be corrupted
//! (checking them is recommended)
//! -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
Standard_EXPORT Standard_Integer RunTransformer(const Handle(IFSelect_Transformer)& transf);
//! See the class PacketList for more details.
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
//! by SetModel or SetRemaining(Forget) ) stored in Graph Status
//! <count> = -1 (default) is for ENtities sent at least once
}
else
{
- // may be S was splited during shape process
+ // may be S was split during shape process
Handle(Transfer_Binder) bnd = FP->Find(mapper);
if (!bnd.IsNull())
{
//! <modetrans> is to be interpreted by each kind of XstepAdaptor
//! Returns a status : 0 OK 1 No result 2 Fail -1 bad modeshape
//! -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
Standard_EXPORT virtual IFSelect_ReturnStatus TransferWriteShape(
const TopoDS_Shape& shape,
if ((NbUSeg < 1) || (NbVSeg < 1))
return 5;
- // Output BSpline knots & multiplicities arraies for U & V :
+ // Output BSpline knots & multiplicities arrays for U & V :
// =========================================================
TColStd_Array1OfReal UKnot(1, NbUSeg + 1);
//! Warning 0 is returned if no subscript number is defined for this IGES entity.
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
Standard_EXPORT void InitDirFieldEntity(const Standard_Integer fieldnum,
const Handle(IGESData_IGESEntity)& ent);
{
public:
- //! creates IGESReaderData correctly dimensionned (for arrays)
+ //! creates IGESReaderData correctly dimensioned (for arrays)
//! <nbe> count of entities, that is, half nb of directory lines
//! <nbp> : count of parameters
Standard_EXPORT IGESData_IGESReaderData(const Standard_Integer nbe, const Standard_Integer nbp);
//! Sends an additional Starting Line : this is the way used to
//! 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
Standard_EXPORT void SendStartLine(const Standard_CString startline);
const Standard_Boolean negative = Standard_False);
//! 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>
void Send(const Handle(T)& val,
Standard_Boolean negative = Standard_False,
const Handle(IGESData_HArray1OfIGESEntity)& allGeoms,
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]
Standard_EXPORT void SetFormNumber(const Standard_Integer form);
for (i = 0; i <= start->UpperIndex(); i++)
Pole.SetValue(PoleIndex++, start->Pole(i));
- // Filling knots & multiplicities arraies :
+ // Filling knots & multiplicities arrays :
// ========================================
Standard_Integer NbKnots = start->NbKnots();
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
// =======================================================================
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 :
// =======================================================================
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 :
// =======================================================================
//! Sets values of "myMinTol" and "myMaxTol" as follows
//! myMaxTol = Max ("read.maxprecision.val", myEpsGeom * myUnitFactor)
//! myMinTol = Precision::Confusion()
- //! Remark: This method is automatically invoked each time the values
+ //! Remark: This method is automatically invoked each time the values
//! of "myEpsGeom" or "myUnitFactor" are changed
Standard_EXPORT void UpdateMinMaxTol();
//! Changes the value of "mySurfaceCurve"
void SetSurfaceCurve(const Standard_Integer ival);
- //! Returns the value of " mySurfaceCurve" 0 = value in
- //! file , 2 = kepp 2d and compute 3d 3 = keep 3d and
+ //! Returns the value of "mySurfaceCurve" 0 = value in
+ //! file, 2 = keep 2d and compute 3d, 3 = keep 3d and
//! compute 2d
Standard_Integer GetSurfaceCurve() const;
IVtkTools_SubPolyDataFilter* aSUBFilterH =
IVtkTools_SubPolyDataFilter::SafeDownCast(myFilterMap.Find(Filter_SUB_Hili));
- // No highligthing exists initially
+ // No highlighting exists initially
aSUBFilterH->SetInputConnection(aDataSource->GetOutputPort());
aDMFilterH->SetInputConnection(aSUBFilterH->GetOutputPort());
IVtkTools_SubPolyDataFilter* aSUBFilterS =
IVtkTools_SubPolyDataFilter::SafeDownCast(myFilterMap.Find(Filter_SUB_Sel));
- // No highligthing exists initially
+ // No highlighting exists initially
aSUBFilterS->SetInputConnection(aDataSource->GetOutputPort());
aDMFilterS->SetInputConnection(aSUBFilterS->GetOutputPort());
//! Deactivate the given selection
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);
DEFINE_STANDARD_RTTIEXT(IVtkOCC_ViewerSelector, SelectMgr_ViewerSelector)
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)
anIsFirstDegenerated = Standard_True;
else
{
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;
}
aPrevParam = aParameter = aCurVertParam;
Standard_Boolean& theIsIncreasing);
//! 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).
static Standard_Boolean CylCylComputeParameters(const Standard_Real theU1par,
const Standard_Integer theWLIndex,
&& ((aVSurf2l - aV2[i]) * (aVSurf2l - aV2Prev[i]) < RealSmall()));
// 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
- // (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 isForce = Standard_False;
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
// 1st point of aWLine2 then we do not need in check
// 1st point of aWLine1 and last point of aWLine2 etc.
//! Clears LastFlags only. This allows to know what Entities are
//! copied after its call (see method LastCopiedAfter). It can 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();
//! Returns an copied Entity and its Result which were operated
//! Returns the index of <me> in Graph.theArcs.
Standard_EXPORT Standard_Integer Index() const;
- //! Returns the index associated of the geometric
+ //! Returns the index associated of the geometric
//! representation of <me>.
Standard_EXPORT Standard_Integer GeomIndex() const;
//! Returns the other Node extremity of <me>.
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.
//!
//! if <aNode> is not oh <me>
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>;
//! if <aNode> is not on <me>
Standard_EXPORT Standard_Boolean HasNeighbour(const Handle(MAT_Node)& aNode,
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
SetColor(Quantity_NOC_WHITE);
//! (std::ios_base::in will be implicitly added)
//! @param[in] theOffset expected stream position from the beginning of the file (beginning of
//! 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)
//! @param[in] theOldStream a pointer to existing stream pointing to theUrl to be reused (without
//! re-opening)
//! ...
//! 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,
const Standard_Integer N,
const Standard_Integer Dimension,
//! can be same since the overwrite is non destructive within
//! the algorithm
//!
- //! Warning: <RationalDerivates> must be dimensionned properly.
+ //! Warning: <RationalDerivates> must be dimensioned properly.
Standard_EXPORT static void RationalDerivatives(const Standard_Integer DerivativesRequest,
const Standard_Integer Dimension,
Standard_Real& PolesDerivatives,
class gp_XY;
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
//! and minimizing an energy like criterion.
class Plate_Plate
LastV = Surface->LastVParameter();
// Here we have to compute the boundary that projection is going to intersect
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
Standard_Real RU1, RU2, RV1, RV2;
d1(Sol.X(), U0, V0, D2d, Curve, Surface);
protected:
//! Override this method to change logic of anchor point computation.
//! 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.
//! ATTENTION!
//! 1) The plane should be set or computed before.
//! 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.
//!
-//! 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
//! will be oriented in model space during construction.
//!
gp_Pln& thePlane,
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.
//! @param[in] theFace the planar face
//! @param[out] theCurve the circular curve
BRepAdaptor_Curve aCurve(TopoDS::Edge(mySShape));
if (aCurve.GetType() == GeomAbs_Line)
{
- // add sensetive element - line
+ // add sensitive element - line
seg = new Select3D_SensitiveSegment(own, myAttachPoint2, myPoint2);
aSelection->Add(seg);
}
BRepAdaptor_Curve aCurve(TopoDS::Edge(myShape3));
if (aCurve.GetType() == GeomAbs_Line)
{
- // add sensetive element - line
+ // add sensitive element - line
seg = new Select3D_SensitiveSegment(own, myAttachPoint3, myPoint3);
aSelection->Add(seg);
}
BRepAdaptor_Curve aCurve(TopoDS::Edge(myShape4));
if (aCurve.GetType() == GeomAbs_Line)
{
- // add sensetive element - line
+ // add sensitive element - line
seg = new Select3D_SensitiveSegment(own, myAttachPoint4, myPoint4);
aSelection->Add(seg);
}
//! Sets flag to skip data loading.
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.
//! TRUE by default.
bool ToKeepLateData() { return myToKeepLateData; }
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 \""
<< theValueName << "\" - "
<< "Array of unsupported type is detected. It will be skipped.";
// Own fields of AngularLocation
// 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.
StepShape_AngleRelator aAngleSelection = StepShape_Small;
if (data->ParamType(num, 5) == Interface_ParamEnum)
//=======================================================================
// function : GenerateNormalsArray
// 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
// no normals.
//=======================================================================
// Build tesselated_curve_set.
Handle(StepVisual_TessellatedCurveSet) aTCS = GenerateTessellatedCurveSet(theShape);
- // Fill the container of tesselated items.
+ // Fill the container of tessellated items.
NCollection_Handle<StepVisual_Array1OfTessellatedItem> aTesselatedItems =
new StepVisual_Array1OfTessellatedItem(1, static_cast<Standard_Integer>(aCTSSs.size()) + 1);
aTesselatedItems->SetValue(1, aTCS);
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(Transfer_Binder) aBinder = theFP->Find(aMapper);
if (aBinder.IsNull())
// theCommands.Add("DT_SplitFace", "DT_SplitFace Result Face Tol",
// __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);
// theCommands.Add ("shellsolid","option[a-b-c-f] shape result",
// __FILE__,shellsolid,g);
//! also says this. Otherwise additional analysis is performed,
//! comparing given precision with the following distances:
//! - 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,
//! - rational B-Spline or one with boundary multiplicities not
//! degree+1 - maximum distance computed at knots and their
//! also says this. Otherwise additional analysis is performed,
//! comparing given precision with the following distances:
//! - 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,
//! - rational B-Spline or one with boundary multiplicities not
//! degree+1 - maximum distance computed at knots and their
{
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
Standard_Integer aFullMask = aJointMask3D & aJointMask2D;
if (aFullMask != 0)
catch (Standard_Failure const& anException)
{
#ifdef OCCT_DEBUG
- std::cout << "Warning: Geom2dConvert_ApproxCurve Exception: Wrong Cofficient :Decrease "
+ std::cout << "Warning: Geom2dConvert_ApproxCurve Exception: Wrong Coefficient :Decrease "
"Continuity ";
anException.Print(std::cout);
std::cout << std::endl;
class Geom2d_BSplineCurve;
//! Converts curve2d to analytical form with given
-//! precision or simpify curve2d.
+//! precision or simplify curve2d.
class ShapeCustom_Curve2d
{
public:
{
public:
- //! creates StepReaderData correctly dimensionned (necessary at
+ //! creates StepReaderData correctly dimensioned (necessary at
//! creation time, because it contains arrays)
//! nbheader is nb of records for Header, nbtotal for Header+Data
//! and nbpar gives the total count of parameters
// except for the label unattached attributes,
// but everybody can update the relocation table...
- // Now: the paste phasis!
+ // Now: the paste phase!
TDF_DataMapIteratorOfAttributeDataMap attItr2(theAttMap);
for (; attItr2.More(); attItr2.Next())
{
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
//! for getting this data.
class TDF_DerivedAttribute
* 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.
virtual Standard_EXPORT void AfterRetrieval();
Standard_Boolean reverse = (!samegeom);
#ifdef OCCT_DEBUG
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.
reverse = Standard_False; // we exclude this line from #ifdef OCCT_DEBUG because
// in optimised mode this line will never be included , and that
if (nfor < 1)
b = shareG; // Esd is FOR's closing edge
else if (nfor > 1)
- return; // NYIRaise (unvalid shape)
+ return; // NYIRaise (invalid shape)
else
{
const TopoDS_Face& FF = TopoDS::Face(lfor.First());
class TopOpeBRepDS_Check;
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
{
if (aShapes.Extent() < 1 || aShapes.Extent() > 3)
{
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.";
return 1;
}
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;
}
//=======================================================================
// function : ParseDimensionParams
-// purpose : Auxilliary function: sets aspect parameters for
+// purpose : Auxiliary function: sets aspect parameters for
// length, angle, radius and diameter dimension.
//
// draw args: -text [3d|2d] [wf|sh|wireframe|shading] [Size]
//=======================================================================
// 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]
// -showarrow [first|second|both|none]
//=======================================================================
// function : VRelationBuilder
-// purpose : Command for building realation presentation
+// purpose : Command for building relation presentation
//=======================================================================
static int VRelationBuilder(Draw_Interpretor& /*theDi*/,
Standard_Integer theArgsNb,
//==============================================================================
// function : IsWindowOverlapped
-// purpose : Check if theWindow overlapp another view
+// purpose : Check if theWindow overlap another view
//==============================================================================
Standard_Boolean IsWindowOverlapped(const Standard_Integer thePxLeft,
}
// 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
Standard_CString aWarnLog = theDI.Result();
if (aWarnLog != NULL && aWarnLog[0] != '\0')
-uniform generate colors with the same lightness
-textpos horizontal label position relative to color scale bar
-labelAtBorder vertical label position relative to color interval;
- at border means the value inbetween neighbor intervals,
+ at border means the value in between neighbor intervals,
at center means the center value within current interval
-labels set labels for all intervals
-freeLabels same as -labels but does not require
addCmd("vpriviledgedplane", VPriviledgedPlane, /* [vpriviledgedplane] */ R"(
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;
Nx, Ny, Nz - plane normal direction;
Xx, Xy, Xz - plane x-reference axis direction.
TopTools_Array1OfShape Shapes(1, 1);
Shapes.SetValue(1, aShape);
- // Check shape tesselation
+ // Check shape tessellation
TopExp_Explorer anExp(aShape, TopAbs_FACE);
TopLoc_Location aLoc;
Standard_Boolean hasTriangles = Standard_False;
gp_Pnt p;
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:
Standard_Integer nbTriangles = 0, nbVertices = 0;
const Standard_Real theDeflection = 0.01,
const Standard_Real theDeflAngle = 20. * M_PI / 180.);
// 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
if (argc < 4)
{
sout << "Give : filename or . for current model; varname or . to take fileroot\n GiveList, * "
- "for all transferrable roots"
+ "for all transferable roots"
<< std::endl;
return IFSelect_RetError;
}
if (arg3[0] == '*' && arg3[1] == '\0')
{
list = WS->GiveList("xst-transferrable-roots");
- sout << "All Transferrable Roots : ";
+ sout << "All Transferable Roots : ";
}
else
{
Standard_EXPORT Handle(XSControl_WorkSession) WS() const;
//! 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);
//! Loads a file from stream and returns the read status
Standard_EXPORT static Standard_Real GetLengthUnit(
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();
//! Binds session and name into map recursively.
//! Prints on the stream o information on the current state
//! of the object.
- //! Is used to redifine the operator <<.
+ //! Is used to redefine the operator <<.
Standard_EXPORT void Dump(Standard_OStream& o) const;
//! Destructor
regexp { +Vertex +: +Min +[-0-9.+eE]+ +Max +([-0-9.+eE]+)} [ maxtolerance d ] full toler
set good_dist 0
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
set log_1 [projponf f p_1 -min -t]
regexp {proj dist = ([-0-9.+eE]+)} ${log_1} full distmax_1
if { [expr abs(${distmax_1} - ${GOOD_DIST_1})] > ${CMP_TOL} } {
- puts "Error: Wrong distanse (# 1)"
+ puts "Error: Wrong distance (# 1)"
} else {
- puts "OK: Good distanse (# 1)"
+ puts "OK: Good distance (# 1)"
}
distmini d_1 v_1 f
set distmin_1 [dval d_1_val]
if { [expr abs(${distmin_1} - ${GOOD_DIST_1})] > ${CMP_TOL} } {
- puts "Error: Wrong minidistanse (# 1)"
+ puts "Error: Wrong minidistance (# 1)"
} else {
- puts "OK: Good minidistanse (# 1)"
+ puts "OK: Good minidistance (# 1)"
}
# 2
set log_2 [projponf f p_2 -min -t]
regexp {proj dist = ([-0-9.+eE]+)} ${log_2} full distmax_2
if { [expr abs(${distmax_2} - ${GOOD_DIST_2})] > ${CMP_TOL} } {
- puts "Error: Wrong distanse (# 2)"
+ puts "Error: Wrong distance (# 2)"
} else {
- puts "OK: Good distanse (# 2)"
+ puts "OK: Good distance (# 2)"
}
distmini d_2 v_2 f
set distmin_2 [dval d_2_val]
if { [expr abs(${distmin_2} - ${GOOD_DIST_2})] > ${CMP_TOL} } {
- puts "Error: Wrong minidistanse (# 2)"
+ puts "Error: Wrong minidistance (# 2)"
} else {
- puts "OK: Good minidistanse (# 2)"
+ puts "OK: Good minidistance (# 2)"
}
# 3
set log_3 [projponf f p_3 -min -t]
regexp {proj dist = ([-0-9.+eE]+)} ${log_3} full distmax_3
if { [expr abs(${distmax_3} - ${GOOD_DIST_3})] > ${CMP_TOL} } {
- puts "Error: Wrong distanse (# 3)"
+ puts "Error: Wrong distance (# 3)"
} else {
- puts "OK: Good distanse (# 3)"
+ puts "OK: Good distance (# 3)"
}
distmini d_3 v_3 f
set distmin_3 [dval d_3_val]
if { [expr abs(${distmin_3} - ${GOOD_DIST_3})] > ${CMP_TOL} } {
- puts "Error: Wrong minidistanse (# 3)"
+ puts "Error: Wrong minidistance (# 3)"
} else {
- puts "OK: Good minidistanse (# 3)"
+ puts "OK: Good minidistance (# 3)"
}
gl_Position = occVertex;
}"
-# define a Geometry shader drawing shrinked triangles
+# define a Geometry shader drawing shrunken triangles
set aShaderGeom "
layout(triangles) in;
layout(triangle_strip, max_vertices=3) out;
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
{
(void)theParent;
//! \class ViewControl_TableModel
//! \brief This is an extension of table model to visualize a container of values
//! It is possible to:
-//! - set orientation to interpretate the values.
+//! - set orientation to interpret the values.
//! - set table view header values.
//! Items of the view are enabled and selectable.
class ViewControl_TableModel : public QAbstractTableModel