Handle(BOPDS_PaveBlock) aPBD;
TColStd_ListIteratorOfListOfInteger aItLI;
//
- // 1. Find degnerated edges
+ // 1. Find degenerated edges
//-----------------------------------------------------scope f
//
aAllocator=
closed_flag = Standard_True ;
} //with the toler value
Handle(TColGeom_HArray1OfBSplineCurve) concatcurve; //array of the concatenated curves
- Handle(TColStd_HArray1OfInteger) ArrayOfIndices; //array of the remining Vertex
+ Handle(TColStd_HArray1OfInteger) ArrayOfIndices; //array of the remaining Vertex
if (Option==GeomAbs_G1)
GeomConvert::ConcatG1(tab,
tabtolvertex,
}
Handle(TColGeom_HArray1OfBSplineCurve) concatcurve; //array of the concatenated curves
- Handle(TColStd_HArray1OfInteger) ArrayOfIndices; //array of the remining Vertex
+ Handle(TColStd_HArray1OfInteger) ArrayOfIndices; //array of the remaining Vertex
GeomConvert::ConcatC1(tab,
tabtolvertex,
ArrayOfIndices,
orf = (TopAbs_Orientation)MapOfShapeOrientation.Find(Fcur);
Fcur.Orientation(orf);
std::cout << " Error : this face has been already examined " << std::endl;
- std::cout << " Imposible to return it ";
+ std::cout << " Impossible to return it ";
PrintShape(Fcur, MapOfShapeOrientation.NbBuckets());
}
#endif
continue;
// for base case prism on mySUntil -> ambivalent direction
-// -> preferrable direction = 1
+// -> preferable direction = 1
if(sens != 1) {
if (ASI2.Point(jj,1).Parameter()*
ASI2.Point(jj,ASI2.NbPoints(jj)).Parameter()<=0)
// Construct a great profile that goes till the bounding box
// -> by tangency with first and last edge of the Wire
// -> by normals to base faces : statistically better
-// Intersect everythin to find the final profile
+// Intersect everything to find the final profile
// ---case of sliding : construction of the face profile
#ifndef _BRepFeat_StatusError_HeaderFile
#define _BRepFeat_StatusError_HeaderFile
-//! Discribes the error.
+//! Describes the error.
enum BRepFeat_StatusError
{
BRepFeat_OK,
//=======================================================================
//function : ToG0
-//purpose : Calculate tranformation T such as T.M2 = M1
+//purpose : Calculate transformation T such as T.M2 = M1
//=======================================================================
static void ToG0(const gp_Mat& M1, const gp_Mat& M2, gp_Mat& T) {
Standard_Boolean isVolume = myType == Vinert;
Standard_Integer i;
- Standard_Integer n1, n2, n3; //node indeces
+ Standard_Integer n1, n2, n3; //node indices
for (i = theTriangles.Lower(); i <= theTriangles.Upper(); ++i)
{
const Poly_Triangle& aTri = theTriangles(i);
// Check conditions for G2 and C2 continuity:
// * calculate principal curvatures on each surface
- // * continuity is C2 if directions of principal curvatures are equal on differenct surfaces
+ // * continuity is C2 if directions of principal curvatures are equal on different surfaces
// * continuity is G2 if directions of principal curvatures are just parallel
// and values of curvatures are the same
aSP1.Curvature(aCrvDir1[0], aCrvLen1[0], aCrvDir1[1], aCrvLen1[1]);
//! radius of -- the cylindrical pipe surface that
//! MinToleranceRequest is the minimum tolerance before it
//! is useful to start testing.
- //! Usually it should be arround 10e-5
+ //! Usually it should be around 10e-5
//! contains all -- the curve representation of the edge
//! returns True if the Edge tolerance had to be updated
Standard_EXPORT static Standard_Boolean UpdateEdgeTol (const TopoDS_Edge& E, const Standard_Real MinToleranceRequest, const Standard_Real MaxToleranceToCheck);
//! Returns True if at least one edge was updated --
//! MinToleranceRequest is the minimum tolerance before
//! -- it -- is useful to start testing.
- //! Usually it should be arround -- 10e-5--
+ //! Usually it should be around -- 10e-5--
//!
//! Warning :The method is very slow as it checks all.
//! Use only in interfaces or processing assimilate batch
//! if <OnlyPlane> is true, the computed surface will be
//! a plane. If it is not possible to find a plane, the
//! flag NotDone will be set.
- //! If <OnlyClosed> is true, then S sould be a wire
+ //! If <OnlyClosed> is true, then S should be a wire
//! and the existing surface, on which wire S is not
//! closed in 2D, will be ignored.
Standard_EXPORT BRepLib_FindSurface(const TopoDS_Shape& S, const Standard_Real Tol = -1, const Standard_Boolean OnlyPlane = Standard_False, const Standard_Boolean OnlyClosed = Standard_False);
//! if <OnlyPlane> is true, the computed surface will be
//! a plane. If it is not possible to find a plane, the
//! flag NotDone will be set.
- //! If <OnlyClosed> is true, then S sould be a wire
+ //! If <OnlyClosed> is true, then S should be a wire
//! and the existing surface, on which wire S is not
//! closed in 2D, will be ignored.
Standard_EXPORT void Init (const TopoDS_Shape& S, const Standard_Real Tol = -1, const Standard_Boolean OnlyPlane = Standard_False, const Standard_Boolean OnlyClosed = Standard_False);
itFac1.Next();
}
- // 3rd condition : same suport
+ // 3rd condition : same support
if (HasConnex) {
HasConnex = SameSupport(TopoDS::Edge(theEdge),TopoDS::Edge(theEdgeConnex));
}
class TopoDS_Shell;
-//! Provides methos to build shells.
+//! Provides methods to build shells.
//!
//! Build a shell from a set of faces.
//! Build untied shell from a non C2 surface
//! - A new wire is created with the edges of the
//! wire + the edge.
//!
-//! - If the edge is not connnected to the wire the
+//! - If the edge is not connected to the wire the
//! flag NotDone is set and the method Wire will
//! raise an error.
//!
{
//map [old vertex => new vertex]
//note that already existing shape (i.e. the original ones)
- //shouldnt be modified on the topological level
+ //shouldn't be modified on the topological level
NCollection_List<NCollection_List<TopoDS_Vertex>>::Iterator itLLV;
NCollection_List<TopoDS_Vertex>::Iterator itLV;
BRep_Builder aBB;
if (aNewV.IsNull())
{
- //vertices from the original shape isnt found in this group
+ //vertices from the original shape isn't found in this group
//create the new vertex
aNewV = BRepLib_MakeVertex(aNewC);
aBB.UpdateVertex(aNewV, aNewTol);
class TopoDS_Wire;
-//! Constucts links between the Wire or the Face of the explorer and
+//! Constructs links between the Wire or the Face of the explorer and
//! the BasicElts contained in the bisecting locus.
class BRepMAT2d_LinkTopoBilo
{
{
Handle(IMeshData::MapOfInteger) anInternalEdges = InternalEdges();
- // Destruction of triancles intersecting internal edges
+ // Destruction of triangles intersecting internal edges
// and their replacement by makeshift triangles
IMeshData::IteratorOfMapOfInteger anInernalEdgesIt( *anInternalEdges );
for ( ; anInernalEdgesIt.More(); anInernalEdgesIt.Next() )
//! Returns number of pcurves assigned to current edge.
Standard_EXPORT virtual Standard_Integer PCurvesNb () const Standard_OVERRIDE;
- //! Adds disrete pcurve for the specifed discrete face.
+ //! Adds discrete pcurve for the specified discrete face.
Standard_EXPORT virtual const IMeshData::IPCurveHandle& AddPCurve (
const IMeshData::IFacePtr& theDFace,
const TopAbs_Orientation theOrientation) Standard_OVERRIDE;
EnLargeFace(TopoDS::Face(ToBuild(E)),StopFace,Standard_False);
TopoDS_Face NullFace;
BRepOffset_Tool::Inter3D (EF,StopFace,LInt1,LInt2,Side,E,NullFace,NullFace);
- // No intersection, it may happen for example for a chosen (non-offseted) planar face and
- // its neighbour offseted cylindrical face, if the offset is directed so that
+ // No intersection, it may happen for example for a chosen (non-offsetted) planar face and
+ // its neighbour offseted cylindrical face, if the offset is directed so that
// the radius of the cylinder becomes smaller.
if (LInt1.IsEmpty())
continue;
//! The two global approaches can also be combined.
//! You can also close the surface later in order to form a solid.
//! Warning: some limitations exist
-//! -- Mode with auxilary spine is incompatible with hometetic laws
-//! -- Mode with auxilary spine and keep contact produce only CO surface.
+//! -- Mode with auxiliary spine is incompatible with hometetic laws
+//! -- Mode with auxiliary spine and keep contact produce only CO surface.
class BRepOffsetAPI_MakePipeShell : public BRepPrimAPI_MakeSweep
{
public:
//=======================================================================
//function : FillProblems
-// purpose : auxilary for StructuralDump
+// purpose : auxiliary for StructuralDump
//=======================================================================
static void FillProblems(const BRepCheck_Status stat,
Handle(TColStd_HArray1OfInteger)& NbProblems)
//=======================================================================
//function : GetProblemSub
-// purpose : auxilary for StructuralDump
+// purpose : auxiliary for StructuralDump
//=======================================================================
static void GetProblemSub(const BRepCheck_Analyzer& Ana,
const TopoDS_Shape& Shape,
//=======================================================================
//function : GetProblemShapes
-// purpose : auxilary for StructuralDump
+// purpose : auxiliary for StructuralDump
//=======================================================================
static void GetProblemShapes(const BRepCheck_Analyzer& Ana,
const TopoDS_Shape& Shape,
theCommands.Add("checksection",
"checks the closure of a section : checksection name [-r <RefVal>]\n"
- "\"-r\" - allowed number of allone vertices.",
+ "\"-r\" - allowed number of alone vertices.",
__FILE__,
checksection,
g);
class TopoDS_Shape;
-//! A Tool to glue faces at common edges and
-//! reconstruct shells.
+//! A Tool to glue faces at common edges and reconstruct shells.
//!
-//! The user designate pairs of common edges using the
-//! method Bind. One edge is designated as the edge to
-//! use in place of the other one (they are supposed
-//! to be geometrically confused, but this not
-//! checked). They can be of opposite directions, this
-//! is specified by the orientations.
+//! The user designate pairs of common edges using the method Bind.
+//! One edge is designated as the edge to use in place of the other one
+//! (they are supposed to be geometrically confused, but this not checked).
+//! They can be of opposite directions, this is specified by the orientations.
//!
-//! The user can add shapes with the Add method, all
-//! the faces are registred and copies of faces and
-//! edges are made to glue at the bound edges.
+//! The user can add shapes with the Add method, all the faces are registered and copies of faces
+//! and edges are made to glue at the bound edges.
//!
-//! The user can call the Shells methods to compute a
-//! compound of shells from the current set of faces.
+//! The user can call the Shells methods to compute a compound of shells from the current set of faces.
//!
-//! If no binding is made this class can be used to
-//! make shell from faces already sharing their edges.
+//! If no binding is made this class can be used to make shell from faces already sharing their edges.
class BRepTools_Quilt
{
public:
//function : LocateParameter
//purpose : Effective computation
// pmn 28-01-97 : Add limits of the period as input argument,
-// as it is imposible to produce them at this level.
+// as it is impossible to produce them at this level.
//=======================================================================
void BSplCLib::LocateParameter
Standard_EXPORT static void Unperiodize (const Standard_Integer Degree, const TColStd_Array1OfInteger& Mults, const TColStd_Array1OfReal& Knots, const TColgp_Array1OfPnt2d& Poles, const TColStd_Array1OfReal* Weights, TColStd_Array1OfInteger& NewMults, TColStd_Array1OfReal& NewKnots, TColgp_Array1OfPnt2d& NewPoles, TColStd_Array1OfReal* NewWeights);
//! Set in <NbKnots> and <NbPoles> the number of Knots and
- //! Poles of the curve resulting of the trimming of the
- //! BSplinecurve definded with <degree>, <knots>, <mults>
+ //! Poles of the curve resulting from the trimming of the
+ //! BSplinecurve defined with <degree>, <knots>, <mults>
Standard_EXPORT static void PrepareTrimming (const Standard_Integer Degree, const Standard_Boolean Periodic, const TColStd_Array1OfReal& Knots, const TColStd_Array1OfInteger& Mults, const Standard_Real U1, const Standard_Real U2, Standard_Integer& NbKnots, Standard_Integer& NbPoles);
Standard_EXPORT static void Trimming (const Standard_Integer Degree, const Standard_Boolean Periodic, const Standard_Integer Dimension, const TColStd_Array1OfReal& Knots, const TColStd_Array1OfInteger& Mults, const TColStd_Array1OfReal& Poles, const Standard_Real U1, const Standard_Real U2, TColStd_Array1OfReal& NewKnots, TColStd_Array1OfInteger& NewMults, TColStd_Array1OfReal& NewPoles);
//! Array[i][p] for each p in
//! 1..ArrayDimension. If HomogeneousFlag ==
//! 0 the Poles are multiplied by the
- //! Weights uppon Entry and once
+ //! Weights upon Entry and once
//! interpolation is carried over the
//! result of the poles are divided by the
//! result of the interpolation of the
//! weights. Otherwise if HomogenousFlag == 1
- //! the Poles and Weigths are treated homogenously
+ //! the Poles and Weigths are treated homogeneously
//! that is that those are interpolated as they
//! are and result is returned without division
//! by the interpolated weigths.
//! B[i] = Array[i][p] for each p in 1..ArrayDimension
//! If HomogeneousFlag ==
//! 0 the Poles are multiplied by the
- //! Weights uppon Entry and once
+ //! Weights upon Entry and once
//! interpolation is carried over the
//! result of the poles are divided by the
//! result of the interpolation of the
//! weights. Otherwise if HomogenousFlag == 1
- //! the Poles and Weigths are treated homogenously
+ //! the Poles and Weigths are treated homogeneously
//! that is that those are interpolated as they
//! are and result is returned without division
//! by the interpolated weigths.
//! the Poles array according to the requests in
//! ContactOrderArray that is : if
//! ContactOrderArray(i) has value d it means that
- //! Poles(i) containes the dth derivative of the
+ //! Poles(i) contains the dth derivative of the
//! function to be interpolated. The length L of the
//! following arrays must be the same :
//! Parameters, ContactOrderArray, Poles,
//! the Poles array according to the requests in
//! ContactOrderArray that is : if
//! ContactOrderArray(i) has value d it means that
- //! Poles(i) containes the dth derivative of the
+ //! Poles(i) contains the dth derivative of the
//! function to be interpolated. The length L of the
//! following arrays must be the same :
//! Parameters, ContactOrderArray, Poles,
//! the Poles array according to the requests in
//! ContactOrderArray that is : if
//! ContactOrderArray(i) has value d it means that
- //! Poles(i) containes the dth derivative of the
+ //! Poles(i) contains the dth derivative of the
//! function to be interpolated. The length L of the
//! following arrays must be the same :
//! Parameters, ContactOrderArray, Poles,
//! the Poles array according to the requests in
//! ContactOrderArray that is : if
//! ContactOrderArray(i) has value d it means that
- //! Poles(i) containes the dth derivative of the
+ //! Poles(i) contains the dth derivative of the
//! function to be interpolated. The length L of the
//! following arrays must be the same :
//! Parameters, ContactOrderArray, Poles,
//! the Poles array according to the requests in
//! ContactOrderArray that is : if
//! ContactOrderArray(i) has value d it means that
- //! Poles(i) containes the dth derivative of the
+ //! Poles(i) contains the dth derivative of the
//! function to be interpolated. The length L of the
//! following arrays must be the same :
//! Parameters, ContactOrderArray
if (conditions) {
//
- // build 2 auxialiary functions
+ // build 2 auxiliary functions
//
TColStd_Array1OfReal schoenberg_points(1,num_poles) ;
TColStd_Array1OfReal first_function (1,num_poles) ;
// Find in the initial Shapel:
// - untouched Faces
// - generated tubes
- // - the faces neighbors of tubes that sould be reconstucted preserving sharing.
+ // - the faces neighbors of tubes that should be reconstructed preserving sharing.
// For Debug : Visualize edges of the initial shape that should be reconstructed.
#ifdef DRAW
}
aDS = aModel->GetLabel().Data();
}
- // reffered label
+ // referred label
TDF_Label aLabel;
if (! theSource.GetLabel (aDS, aLabel)) return Standard_False;
Standard_EXPORT Bnd_Box();
//! Creates a bounding box, it contains:
- //! - minimum/maximum point of bouning box,
+ //! - minimum/maximum point of bounding box,
//! The constructed box is qualified Void. Its gap is null.
Standard_EXPORT Bnd_Box (const gp_Pnt theMin, const gp_Pnt theMax);
- //! Sets this bounding box so that it covers the whole of 3D space.
- //! It is infinitely long in all directions.
+ //! Sets this bounding box so that it covers the whole of 3D space.
+ //! It is infinitely long in all directions.
void SetWhole() { Flags = WholeMask; }
//! Sets this bounding box so that it is empty. All points are outside a void box.
//! Adds to the bounding box B the part of curve C
//! B is then enlarged by the tolerance value Tol.
- //! U1, U2 - the parametric range to comute the bounding box;
+ //! U1, U2 - the parametric range to compute the bounding box;
//! Note: depending on the type of curve, one of the following
//! representations of the curve C is used to include it in the bounding box B:
//! - an exact representation if C is built from a line, a circle or a conic curve,
//! Adds to the bounding box B the part of curve C
//! B is then enlarged by the tolerance value Tol.
- //! U1, U2 - the parametric range to comute the bounding box;
+ //! U1, U2 - the parametric range to compute the bounding box;
//! Note: depending on the type of curve, one of the following
//! algorithms is used to include it in the bounding box B:
//! - an exact analytical if C is built from a line, a circle or a conic curve,
}
//=======================================================================
-//function : SetStorageFormatVerison
+//function : SetStorageFormatVersion
//purpose :
//=======================================================================
static Standard_Integer DDocStd_SetStorageFormatVersion (Draw_Interpretor& ,
}
//=======================================================================
-//function : GetStorageFormatVerison
+//function : GetStorageFormatVersion
//purpose :
//=======================================================================
static Standard_Integer DDocStd_GetStorageFormatVersion (Draw_Interpretor& di,
//! Initialize view by the type.
Standard_Boolean Init(const char* theType);
- //! Transformates view matrix.
+ //! Transform view matrix.
void Transform(const gp_Trsf& theTransformation);
//! Resets frame of current view.
and RealLast() in case of maximums),
- table TbSel(0,NbU+1,0,NbV+1) of selection of points for
calculation of local extremum (0). When a point will selected,
- it will not be selectable, as well as the ajacent points
+ it will not be selectable, as well as the adjacent points
(8 at least). The corresponding addresses will be set to 1.
b.b- Calculation of minimums (or maximums):
All distances from table TbDist are parsed in a loop:
else if (aPcurve->IsKind(STANDARD_TYPE(Geom2d_Parabola))) {
#ifdef OCCT_DEBUG
std::cout << "PCURVE of Parabola type" << std::endl;
- std::cout << "Parameters Not Yet transformed according to LenghtUnit" << std::endl;
+ std::cout << "Parameters Not Yet transformed according to LengthUnit" << std::endl;
#endif
return aPcurve;
}
else if (aPcurve->IsKind(STANDARD_TYPE(Geom2d_Hyperbola))) {
#ifdef OCCT_DEBUG
std::cout << "PCURVE of Hyperbola type" << std::endl;
- std::cout << "Parameters Not Yet transformed according to LenghtUnit" << std::endl;
+ std::cout << "Parameters Not Yet transformed according to LengthUnit" << std::endl;
#endif
return aPcurve;
}
const Standard_Real theC,
const Standard_Real theD);
- //! Display the plane representation in the choosen view.
+ //! Display the plane representation in the chosen view.
Standard_EXPORT virtual void Display (const Handle(V3d_View)& theView,
const Quantity_Color& theColor = Quantity_NOC_GRAY);
private:
- //! Updates the the plane representation.
+ //! Updates the plane representation.
Standard_EXPORT void Update();
protected:
Standard_EXPORT void SetCenter (const Standard_Integer theXp, const Standard_Integer theYp);
//! Defines the view projection size in its maximum dimension,
- //! keeping the inital height/width ratio unchanged.
+ //! keeping the initial height/width ratio unchanged.
Standard_EXPORT void SetSize (const Standard_Real theSize);
//! Defines the Depth size of the view
}
else if (theObj->Type() == AIS_KindOfInteractive_Relation)
{
- // PrsDim_Dimention and AIS_Relation
+ // PrsDim_Dimension and AIS_Relation
Handle(PrsDim_Relation) aRelation = Handle(PrsDim_Relation)::DownCast (theObj);
switch (aRelation->KindOfDimension())
{
"\nSets selection shape type filter in context or remove all filters."
"\n : Option -contextfilter : To define a selection filter for two or more types of entity,"
"\n use value AND (OR by default)."
- "\n : Option -type set type of selection filter. Filters are applyed with Or combination."
+ "\n : Option -type set type of selection filter. Filters are applied with Or combination."
"\n : Option -clear remove all filters in context",
__FILE__,VSelFilter,group);
//=======================================================================
//function : VPointCloud
-//purpose : Create interactive object for arbitary set of points.
+//purpose : Create interactive object for arbitrary set of points.
//=======================================================================
static Standard_Integer VPointCloud (Draw_Interpretor& theDI,
Standard_Integer theArgNum,
theCommands.Add ("vpointcloud",
"vpointcloud name shape [-randColor] [-normals] [-noNormals] [-uv]"
- "\n\t\t: Create an interactive object for arbitary set of points"
+ "\n\t\t: Create an interactive object for arbitrary set of points"
"\n\t\t: from triangulated shape."
"\n"
"vpointcloud name x y z r npts {surface|volume}\n"
// -hideunits
//
// Warning! flyout is not an aspect value, it is for dimension parameter
-// likewise text position, but text position override other paramaters.
+// likewise text position, but text position override other parameters.
// For text position changing use 'vmovedim'.
//=======================================================================
static int ParseDimensionParams (Standard_Integer theArgNum,
TCollection_AsciiString aValue (theArgVec[++anIt]);
if (!aValue.IsRealValue (Standard_True))
{
- Message::SendFail() << "Error: arrow lenght should be float degree value.";
+ Message::SendFail() << "Error: arrow length should be float degree value.";
return 1;
}
theAspect->ArrowAspect()->SetLength (Draw::Atof (aValue.ToCString()));
//==============================================================================
//function : RemoveView
-//purpose : Close and remove view from display, clear maps if neccessary
+//purpose : Close and remove view from display, clear maps if necessary
//==============================================================================
void ViewerTest::RemoveView (const TCollection_AsciiString& theViewName, const Standard_Boolean isContextRemoved)
{
const Standard_Integer aPbrEnvBakingDiffNbSamples = Draw::Atoi (theArgVec[anArgIter]);
if (aPbrEnvBakingDiffNbSamples < 1)
{
- Message::SendFail ("Syntax error: 'BakingDiffSamplesNumber' of PBR Environtment has to be greater or equal 1");
+ Message::SendFail ("Syntax error: 'BakingDiffSamplesNumber' of PBR Environment has to be greater or equal 1");
return 1;
}
aParams.PbrEnvBakingDiffNbSamples = aPbrEnvBakingDiffNbSamples;
const Standard_Integer aPbrEnvBakingSpecNbSamples = Draw::Atoi(theArgVec[anArgIter]);
if (aPbrEnvBakingSpecNbSamples < 1)
{
- Message::SendFail ("Syntax error: 'BakingSpecSamplesNumber' of PBR Environtment has to be greater or equal 1");
+ Message::SendFail ("Syntax error: 'BakingSpecSamplesNumber' of PBR Environment has to be greater or equal 1");
return 1;
}
aParams.PbrEnvBakingSpecNbSamples = aPbrEnvBakingSpecNbSamples;
if (aPbrEnvBakingProbability < 0.f
|| aPbrEnvBakingProbability > 1.f)
{
- Message::SendFail ("Syntax error: 'BakingProbability' of PBR Environtment has to be in range of [0, 1]");
+ Message::SendFail ("Syntax error: 'BakingProbability' of PBR Environment has to be in range of [0, 1]");
return 1;
}
aParams.PbrEnvBakingProbability = aPbrEnvBakingProbability;
}
//===============================================================================================
-//function : VBVHPrebuid
+//function : VSelBvhBuild
//purpose :
//===============================================================================================
static int VSelBvhBuild (Draw_Interpretor& /*theDI*/, Standard_Integer theNbArgs, const char** theArgVec)
"\n\t\t: Display name will be used within creation of graphic driver, when specified."
#endif
"\n\t\t: -left, -top pixel position of left top corner of the window."
- "\n\t\t: -width, -height width and heigth of window respectively."
+ "\n\t\t: -width, -height width and height of window respectively."
"\n\t\t: -cloneActive floag to copy camera and dimensions of active view."
"\n\t\t: -exitOnClose when specified, closing the view will exit application."
"\n\t\t: -closeOnEscape when specified, view will be closed on pressing Escape."
" -imageMode (-imgMode, -imageMd, -imgMd): sets image fill type\n"
" -gradient (-grad, -gr): sets background gradient starting and ending colors\n"
" -gradientMode (-gradMode, -gradMd, -grMode, -grMd): sets gradient fill method\n"
- " -cubemap (-cmap, -cm): sets environmet cubemap as background\n"
+ " -cubemap (-cmap, -cm): sets environment cubemap as background\n"
" -invertedz (-invz, -iz): sets inversion of Z axis for background cubemap rendering\n"
" -order (-o): defines order of tiles in one image cubemap\n"
" (has no effect in case of multi image cubemaps)\n"
"\n\t\t: window - convert to window coordinates, pixels"
"\n\t\t: view - convert to view projection plane"
"\n\t\t: grid - convert to model coordinates, given on grid"
- "\n\t\t: ray - convert projection ray to model coordiantes"
+ "\n\t\t: ray - convert projection ray to model coordinates"
"\n\t\t: - vconvert v window : convert view to window;"
"\n\t\t: - vconvert v view : convert window to view;"
"\n\t\t: - vconvert x y window : convert view to window;"
"\n\t\t: [-fov2d [Angle]] [-lockZup {0|1}]"
"\n\t\t: [-xrPose base|head=base]"
"\n\t\t: Manages camera parameters."
- "\n\t\t: Displays frustum when presntation name PrsName is specified."
+ "\n\t\t: Displays frustum when presentation name PrsName is specified."
"\n\t\t: Prints current value when option called without argument."
"\n\t\t: Orthographic camera:"
"\n\t\t: -ortho activate orthographic projection"
//! defines a directional light node of VRML specifying
//! properties of lights.
//! This node defines a directional light source that illuminates
-//! along rays parallel to a given 3-dimentional vector
+//! along rays parallel to a given 3-dimensional vector
//! Color is written as an RGB triple.
//! Light intensity must be in the range 0.0 to 1.0, inclusive.
class Vrml_DirectionalLight
//=======================================================================
//function : makeTShapeNode
-//purpose : auxilary
+//purpose : auxiliary
//=======================================================================
Handle(VrmlData_Geometry) VrmlData_ShapeConvert::makeTShapeNode(const TopoDS_Shape& theShape,
const TopAbs_ShapeEnum theShapeType,
/**
* Convert all accumulated shapes and store them in myScene.
- * The internal data structures are cleared in the end of convertion.
+ * The internal data structures are cleared in the end of conversion.
* @param theExtractFaces
* If True, converter extracst faces from the shapes.
* @param theExtractEdges
Standard_EXPORT Standard_Real Get() const;
- //! Returns volume of area as argument and succes status
+ //! Returns volume of area as argument and success status
//! returns false if no such attribute at the <label>
Standard_EXPORT static Standard_Boolean Get (const TDF_Label& label, Standard_Real& area);
//=======================================================================
//function : ReverseTreeNodes
-//purpose : auxilary
+//purpose : auxiliary
//=======================================================================
static void ReverseTreeNodes(Handle(TDataStd_TreeNode)& mainNode)
{
Standard_EXPORT void GetDimTolLabels (TDF_LabelSequence& Labels) const;
//! Finds a dimension tolerance definition in the GD&T table
- //! sutisfying the specified kind, values, name and description
+ //! satisfying the specified kind, values, name and description
//! and returns its label if found.
//! Returns False if dimension tolerance is not found in DGTtable.
Standard_EXPORT Standard_Boolean FindDimTol (const Standard_Integer theKind,
TDF_Label& lab) const;
//! Finds a dimension tolerance in the GD&T table
- //! sutisfying the specified kind, values, name and description
+ //! satisfying the specified kind, values, name and description
//! and returns its label if found (or Null label else).
Standard_EXPORT TDF_Label FindDimTol (const Standard_Integer theKind,
const Handle(TColStd_HArray1OfReal)& theVal,
const Handle(TCollection_HAsciiString)& theName,
const Handle(TCollection_HAsciiString)& theDescription) const;
- //! Adds a a dimension tolerance definition with the specified
+ //! Adds a dimension tolerance definition with the specified
//! kind, value, name and description to the GD&T table and returns its label.
Standard_EXPORT TDF_Label AddDimTol (const Standard_Integer theKind,
const Handle(TColStd_HArray1OfReal)& theVal,
const Handle(TCollection_HAsciiString)& theName,
const Handle(TCollection_HAsciiString)& theDescription) const;
- //! Gets all shape labels reffered by theL label of the GD&T table.
+ //! Gets all shape labels referred by theL label of the GD&T table.
//! Returns False if there are no shape labels added to the sequences.
Standard_EXPORT Standard_Boolean GetRefShapeLabel (const TDF_Label& theL,
TDF_LabelSequence& theShapeLFirst,
//! in the GD&T table.
Standard_EXPORT void GetDatumLabels (TDF_LabelSequence& Labels) const;
- //! Finds a datum sutisfying the specified name, description and
+ //! Finds a datum satisfying the specified name, description and
//! identification and returns its label if found.
Standard_EXPORT Standard_Boolean FindDatum (const Handle(TCollection_HAsciiString)& theName,
const Handle(TCollection_HAsciiString)& theDescription,
//! This attribute allow user multirelation tree of labels.
//! This GraphNode is experimental Graph that not control looping and redundance.
-//! Attribute containg sequence of father's and child's labels.
+//! Attribute containing sequence of father's and child's labels.
//! Provide create and work with Graph in XCAFDocument.
class XCAFDoc_GraphNode : public TDF_Attribute
{
Standard_EXPORT Standard_Integer NbChildren() const;
//! Returns the Graph ID (default or explicit one depending
- //! onthe Set method used).
+ //! on the Set method used).
Standard_EXPORT const Standard_GUID& ID() const Standard_OVERRIDE;
Standard_EXPORT virtual void Restore (const Handle(TDF_Attribute)& with) Standard_OVERRIDE;
//! Sets a link from label <L> to Layer
//! defined by <LayerL>
- //! optional parametr <shapeInOneLayer> show could shape be
+ //! optional parameter <shapeInOneLayer> show could shape be
//! in number of layers or only in one.
Standard_EXPORT void SetLayer (const TDF_Label& L, const TDF_Label& LayerL, const Standard_Boolean shapeInOneLayer = Standard_False) const;
//! Sets a link from label <L> to Layer <aLayer>
//! in the Layertable
//! Adds a Layer as necessary
- //! optional parametr <shapeInOneLayer> show could shape be
+ //! optional parameter <shapeInOneLayer> show could shape be
//! in number of layers or only in one.
Standard_EXPORT void SetLayer (const TDF_Label& L, const TCollection_ExtendedString& aLayer, const Standard_Boolean shapeInOneLayer = Standard_False) const;
//! returns FALSE if <aLayerL> is not a layer label.
Standard_EXPORT Standard_Boolean UnSetOneLayer (const TDF_Label& L, const TDF_Label& aLayerL) const;
- //! Returns True if label <L> has a Layer assosiated
+ //! Returns True if label <L> has a Layer associated
//! with the <aLayer>.
Standard_EXPORT Standard_Boolean IsSet (const TDF_Label& L, const TCollection_ExtendedString& aLayer) const;
- //! Returns True if label <L> has a Layer assosiated
+ //! Returns True if label <L> has a Layer associated
//! with the <aLayerL> label.
Standard_EXPORT Standard_Boolean IsSet (const TDF_Label& L, const TDF_Label& aLayerL) const;
- //! Return sequence of strings <aLayerS> that assosiated with label <L>.
+ //! Return sequence of strings <aLayerS> that associated with label <L>.
Standard_EXPORT Standard_Boolean GetLayers (const TDF_Label& L, Handle(TColStd_HSequenceOfExtendedString)& aLayerS);
- //! Return sequence of labels <aLayerSL> that assosiated with label <L>.
+ //! Return sequence of labels <aLayerSL> that associated with label <L>.
Standard_EXPORT Standard_Boolean GetLayers (const TDF_Label& L, TDF_LabelSequence& aLayerLS);
- //! Return sequence of strings that assosiated with label <L>.
+ //! Return sequence of strings that associated with label <L>.
Standard_EXPORT Handle(TColStd_HSequenceOfExtendedString) GetLayers (const TDF_Label& L);
//! Return sequanese of shape labels that assigned with layers to <ShLabels>.
//! will set UAttribute with corresponding GUID.
Standard_EXPORT void SetVisibility (const TDF_Label& layerL, const Standard_Boolean isvisible = Standard_True) const;
- //! Sets a link from label that containig shape <Sh>
+ //! Sets a link from label that containing shape <Sh>
//! with layer that situated at label <LayerL>.
- //! optional parametr <shapeInOneLayer> show could shape be
+ //! optional parameter <shapeInOneLayer> show could shape be
//! in number of layers or only in one.
//! return FALSE if no such shape <Sh> or label <LayerL>
Standard_EXPORT Standard_Boolean SetLayer (const TopoDS_Shape& Sh, const TDF_Label& LayerL, const Standard_Boolean shapeInOneLayer = Standard_False);
- //! Sets a link from label that containig shape <Sh>
+ //! Sets a link from label that containing shape <Sh>
//! with layer <aLayer>. Add <aLayer> to LayerTable if nessesery.
- //! optional parametr <shapeInOneLayer> show could shape be
+ //! optional parameter <shapeInOneLayer> show could shape be
//! in number of layers or only in one.
//! return FALSE if no such shape <Sh>.
Standard_EXPORT Standard_Boolean SetLayer (const TopoDS_Shape& Sh, const TCollection_ExtendedString& aLayer, const Standard_Boolean shapeInOneLayer = Standard_False);
//! returns FALSE if no such layer <aLayerL> or shape <Sh>.
Standard_EXPORT Standard_Boolean UnSetOneLayer (const TopoDS_Shape& Sh, const TDF_Label& aLayerL);
- //! Returns True if shape <Sh> has a Layer assosiated
+ //! Returns True if shape <Sh> has a Layer associated
//! with the <aLayer>.
Standard_EXPORT Standard_Boolean IsSet (const TopoDS_Shape& Sh, const TCollection_ExtendedString& aLayer);
- //! Returns True if shape <Sh> has a Layer assosiated
+ //! Returns True if shape <Sh> has a Layer associated
//! with the <aLayerL>.
Standard_EXPORT Standard_Boolean IsSet (const TopoDS_Shape& Sh, const TDF_Label& aLayerL);
- //! Return sequence of strings <aLayerS> that assosiated with shape <Sh>.
+ //! Return sequence of strings <aLayerS> that associated with shape <Sh>.
Standard_EXPORT Standard_Boolean GetLayers (const TopoDS_Shape& Sh, Handle(TColStd_HSequenceOfExtendedString)& aLayerS);
- //! Return sequence of labels <aLayerLS> that assosiated with shape <Sh>.
+ //! Return sequence of labels <aLayerLS> that associated with shape <Sh>.
Standard_EXPORT Standard_Boolean GetLayers (const TopoDS_Shape& Sh, TDF_LabelSequence& aLayerLS);
- //! Return sequence of strings that assosiated with shape <Sh>.
+ //! Return sequence of strings that associated with shape <Sh>.
Standard_EXPORT Handle(TColStd_HSequenceOfExtendedString) GetLayers (const TopoDS_Shape& Sh);
Standard_EXPORT const Standard_GUID& ID() const Standard_OVERRIDE;
if(!MatL.FindAttribute(XCAFDoc_Material::GetID(),MatAttr)) {
return Dens;
}
- // defaul dimension fo density - gram/sm^3
+ // default dimension fo density - gram/sm^3
// we transfer "sm" into "mm"
Dens = MatAttr->GetDensity()*0.001;
return Dens;
//=======================================================================
//function : SetShape
-//purpose : auxilary
+//purpose : auxiliary
//=======================================================================
static void AddSubShape(const TopoDS_Shape& S,
TopTools_IndexedMapOfShape& myMap)
//=======================================================================
//function : prepareAssembly
-//purpose : auxilary
+//purpose : auxiliary
//=======================================================================
static Standard_Boolean prepareAssembly (const TopoDS_Shape& theShape,
TopoDS_Shape& theOUTShape)
}
}
-// API: API work with SHUO (Specified Higher Usage Occurrance) structure
+// API: API work with SHUO (Specified Higher Usage Occurrence) structure
//=======================================================================
//function : GetSHUO
//=======================================================================
//function : checkForShape
-//purpose : auxilary
+//purpose : auxiliary
//=======================================================================
static Standard_Boolean checkForShape (const TopoDS_Shape& theShape,
theLabels.Prepend( theUserL );
return Standard_True;
}
- // try to search deeply (upper by assmebly structure)
+ // try to search deeply (upper by assembly structure)
TDF_LabelSequence aNewLabels;
for (Standard_Integer j = 1; j <= theLabels.Length(); j++)
aNewLabels.Append( theLabels.Value( j ) );
//=======================================================================
//function : getShapesOfSHUO
-//purpose : auxilary
+//purpose : auxiliary
//=======================================================================
static Standard_Boolean getShapesOfSHUO (TopLoc_IndexedMapOfLocation& theaPrevLocMap,
// get location of the component
TopLoc_Location compLoc = XCAFDoc_ShapeTool::GetLocation ( aSHUOlab.Father() );
TopLoc_IndexedMapOfLocation aPrevLocMap;
- // get previous setted location
+ // get previous set location
if ( !loc.IsIdentity() )
aPrevLocMap.Add( loc );
aPrevLocMap.Add( compLoc );
//=======================================================================
//function : getUsersShapesOfSHUO
-//purpose : auxilary
+//purpose : auxiliary
//=======================================================================
static Standard_Boolean getUsersShapesOfSHUO (TopLoc_IndexedMapOfLocation& aPrevLocMap,
TopLoc_Location loc = XCAFDoc_ShapeTool::GetLocation ( theUserL.Father() );
// get location of the component
TopLoc_Location compLoc = XCAFDoc_ShapeTool::GetLocation ( theUserL );
- // get previous setted location
+ // get previous set location
aNewPrevLocMap.Add( loc );
aNewPrevLocMap.Add( compLoc );
Standard_Integer i;
//=======================================================================
//function : GetAllSHUOInstances
-//purpose : auxilary
+//purpose : auxiliary
//=======================================================================
Standard_Boolean XCAFDoc_ShapeTool::GetAllSHUOInstances (const Handle(XCAFDoc_GraphNode)& theSHUO,
TopLoc_Location loc = XCAFDoc_ShapeTool::GetLocation ( aSHUOlab.Father().Father() );
// get location of the component
TopLoc_Location compLoc = XCAFDoc_ShapeTool::GetLocation ( aSHUOlab.Father() );
- // get previous setted location
+ // get previous set location
if ( !loc.IsIdentity() )
aPrevLocMap.Add( loc );
aPrevLocMap.Add( compLoc );
//! Returns the label corresponding to shape S
//! (searches among top-level shapes, not including subcomponents
//! of assemblies and subshapes)
- //! If findInstance is False (default), seach for the
+ //! If findInstance is False (default), search for the
//! input shape without location
//! If findInstance is True, searches for the
//! input shape as is.
//! If makeAssembly is True, treats TopAbs_COMPOUND shapes
//! as assemblies (creates assembly structure).
//! NOTE: <makePrepare> replace components without location
- //! in assmebly by located components to avoid some problems.
+ //! in assembly by located components to avoid some problems.
//! If AutoNaming() is True then automatically attaches names.
Standard_EXPORT TDF_Label AddShape (const TopoDS_Shape& S, const Standard_Boolean makeAssembly = Standard_True, const Standard_Boolean makePrepare = Standard_True);
//! NOTE: remove any styles that associated with this SHUO.
Standard_EXPORT Standard_Boolean RemoveSHUO (const TDF_Label& SHUOLabel) const;
- //! Serach the path of labels in the document,
+ //! Search the path of labels in the document,
//! that corresponds the component from any assembly
//! Try to search the sequence of labels with location that
//! produce this shape as component of any assembly
//! Returns null attribute if no component in any assembly found.
Standard_EXPORT Handle(XCAFDoc_GraphNode) SetInstanceSHUO (const TopoDS_Shape& theShape) const;
- //! Seaching for component shapes that styled by shuo
+ //! Searching for component shapes that styled by shuo
//! Returns empty sequence of shape if no any shape is found.
Standard_EXPORT Standard_Boolean GetAllSHUOInstances (const Handle(XCAFDoc_GraphNode)& theSHUO, TopTools_SequenceOfShape& theSHUOShapeSeq) const;
- //! Searchs the SHUO by labels of components
- //! from upper_usage componet to next_usage
+ //! Searches the SHUO by labels of components
+ //! from upper_usage component to next_usage
//! Returns null attribute if no SHUO found
Standard_EXPORT static Standard_Boolean FindSHUO (const TDF_LabelSequence& Labels, Handle(XCAFDoc_GraphNode)& theSHUOAttr);
//! Sets the text position
Standard_EXPORT void SetPointText (const gp_Pnt& thePnt);
- //! Returns a tesselated annotation if specified
+ //! Returns a tessellated annotation if specified
const TopoDS_Shape& GetPresentation() const { return myPresentation; }
- //! Sets a tesselated annotation
+ //! Sets a tessellated annotation
Standard_EXPORT void SetPresentation (const TopoDS_Shape& thePresentation);
//! Resets data to the state after calling the default constructor
TDF_LabelSequence seq;
- // attibutes of subshapes
+ // attributes of subshapes
if (XCAFDoc_ShapeTool::GetSubShapes (aLabel, seq)) {
Standard_Integer i = 1;
for (i = 1; i <= seq.Length(); i++) {
}
}
- // attibutes of components
+ // attributes of components
seq.Clear();
if (XCAFDoc_ShapeTool::GetComponents (aLabel, seq)) {
Standard_Integer i = 1;
DisplayText (aL, aPrs, anAspect, aLocation);
TDF_Label aRefLabel;
- // attributes of referrences
+ // attributes of references
TopLoc_Location aLoc = XCAFDoc_ShapeTool::GetLocation (aL);
if (XCAFDoc_ShapeTool::GetReferredShape (aL, aRefLabel)) {
DisplayText (aRefLabel, aPrs, anAspect, aLoc);
//=======================================================================
//function : getviewName
-//purpose : auxilary
+//purpose : auxiliary
//=======================================================================
static Standard_Integer getviewName (Draw_Interpretor& di, Standard_Integer /*argc*/, const char** /*argv*/)
case '3' : mode = STEPControl_ManifoldSolidBrep; break;
case 'w' :
case '4' : mode = STEPControl_GeometricCurveSet; break;
- default : di<<"3st arg = mode, incorrect [give fsmw]\n"; return 1;
+ default : di<<"3rd arg = mode, incorrect [give fsmw]\n"; return 1;
}
Standard_Boolean wrmode = Standard_True;
for ( Standard_Integer i = 0; argv[k][i] ; i++ )
__FILE__, ReadStep, g);
di.Add("WriteStep" , "Doc filename [mode=a [multifile_prefix] [label]]: Write DECAF document to STEP file" ,__FILE__, WriteStep, g);
- di.Add("XFileList","Print list of files that was transfered by the last transfer" ,__FILE__, GetDicWSList , g);
+ di.Add("XFileList","Print list of files that was transferred by the last transfer" ,__FILE__, GetDicWSList , g);
di.Add("XFileCur", ": returns name of file which is set as current",__FILE__, GetCurWS, g);
di.Add("XFileSet", "filename: Set the specified file to be the current one",__FILE__, SetCurWS, g);
di.Add("XFromShape", "shape: do fromshape command for all the files",__FILE__, FromShape, g);
// --------------------- VolumeFix Begin ---
//=======================================================================
//function : TetraVol
-//purpose : auxilary
+//purpose : auxiliary
//=======================================================================
static double TetraVol(gp_Pnt RefPoint, gp_Pnt Som1, gp_Pnt Som2, gp_Pnt Som3)
{
//=======================================================================
//function : TetraCen
-//purpose : auxilary
+//purpose : auxiliary
//=======================================================================
static gp_XYZ TetraCen(gp_Pnt RefPoint, gp_Pnt Som1, gp_Pnt Som2, gp_Pnt Som3)
{
//=======================================================================
//function : CalculVolume
-//purpose : auxilary
+//purpose : auxiliary
//=======================================================================
static Standard_Real CalculVolume(const TopoDS_Shape& So,
gp_Pnt& aRefPoint,
//=======================================================================
//function : GetMassProps
-//purpose : auxilary for ShapeMassProps
+//purpose : auxiliary for ShapeMassProps
//=======================================================================
static Standard_Boolean GetMassProps(const TDF_Label& aLabel, gp_XYZ& theCenterGravity,
Standard_CString g = "XDE property's commands";
- di.Add ("XSetVolume","DocName {Label|Shape} volume \t: Seting volume to shape",
+ di.Add ("XSetVolume","DocName {Label|Shape} volume \t: Setting volume to shape",
__FILE__, SetVolume, g);
di.Add ("XGetVolume","DocName {Shape|Label} \t: Getting volume of shape",
__FILE__, GetVolume, g);
- di.Add ("XSetArea","DocName {Label|Shape} area \t: Seting area to shape",
+ di.Add ("XSetArea","DocName {Label|Shape} area \t: Setting area to shape",
__FILE__, SetArea, g);
di.Add ("XGetArea","DocName {Shape|Label} \t: Getting area of shape",
__FILE__, GetArea, g);
- di.Add ("XSetCentroid","DocName {Label|Shape} x y z \t: Seting centroid to shape",
+ di.Add ("XSetCentroid","DocName {Label|Shape} x y z \t: Setting centroid to shape",
__FILE__, SetCentroid, g);
di.Add ("XGetCentroid","DocName {Shape|Label} \t: Getting centroid of shape ",
di.Add ("XGetFreeShapes","Doc [shape_prefix]\t: Print labels or create DRAW shapes for all free shapes in the Doc",
__FILE__, getFreeShapes, g);
- di.Add ("XGetOneShape","shape Doc \t: Put all free shapes of the Doc into signle DRAW shape",
+ di.Add ("XGetOneShape","shape Doc \t: Put all free shapes of the Doc into single DRAW shape",
__FILE__, getOneShape, g);
di.Add ("XDumpLocation","Doc Label \t: Dump Transformation() of XCAFDoc_Location attribute",
if ( DU/8. > (UL/6. - UF/6.) || DV/8. > (VL/6. - VF/6.) ) {
ShapeBuild_Edge().RemovePCurve(E,face);
#ifdef OCCT_DEBUG
- std::cout<<"Removing pcuve periodic"<<std::endl;
+ std::cout<<"Removing pcurve periodic"<<std::endl;
#endif
return Standard_False;
}
if (resBinder.IsNull()) {
resBinder = new TransferBRep_ShapeBinder(res);
- //if <orig> shape was splitted, put entities corresponding to new shapes
+ //if <orig> shape was split, put entities corresponding to new shapes
// into Transfer_TransientListBinder.
if ( orig.ShapeType() > res.ShapeType() ) {
TopoDS_Shape sub;
resBinder->AddResult(TransientListBinder);
// resBinder->SetNext(TransientListBinder, Standard_True);
#ifdef OCCT_DEBUG
- std::cout<<"Info: TransientListBinder created for splitted shape"<<std::endl;
+ std::cout<<"Info: TransientListBinder created for split shape"<<std::endl;
}
else {
std::cout<<"Warning: XSAlgo_AlgoContainer::MergeTransferInfo() "
- <<"No results were found for splitted shape. "<<std::endl;
+ <<"No results were found for split shape. "<<std::endl;
//<<"Transfer_FinderProcess->NbMapped() = "<<FP->NbMapped()<<std::endl;
#endif
}
//! instance).
//!
//! Finally, Controller can be gathered in a general dictionary then
-//! retreived later by a general call (method Recorded)
+//! retrieved later by a general call (method Recorded)
//!
//! It does not manage the produced data, but the Actors make the
//! link between the norm and the application
//! Returns a name, as given when initializing :
//! rsc = False (D) : True Name attached to the Norm (long name)
- //! rsc = True : Name of the ressource set (i.e. short name)
+ //! rsc = True : Name of the resource set (i.e. short name)
Standard_CString Name (const Standard_Boolean rsc = Standard_False) const
{ return (rsc ? myShortName.ToCString() : myLongName.ToCString()); }
if ( silent ) sout << " in file " << XSControl::Session(pilot)->LoadedFile();
sout<<std::endl;
}
- // abv 31.08.00: treat case of splitted shape (several results)
+ // abv 31.08.00: treat case of split shape (several results)
// it is supposed that results are of the same type and lie in one-level comp
else {
Handle(Transfer_Binder) bnd = FP->Find ( fnd );
class TCollection_AsciiString;
-//! Defines additionnal commands for XSControl to :
+//! Defines additional commands for XSControl to :
//! - control of initialisation (xinit, xnorm, newmodel)
//! - analyse of the result of a transfer (recorded in a
//! TransientProcess for Read, FinderProcess for Write) :
Standard_EXPORT Handle(TColStd_HSequenceOfTransient) GiveList (const Standard_CString first = "", const Standard_CString second = "");
//! Computes a List of entities from the model as follows
- //! <first> beeing a Selection, <ent> beeing an entity or a list
+ //! <first> being a Selection, <ent> being an entity or a list
//! of entities (as a HSequenceOfTransient) :
//! the standard result of this selection applied to this list
//! if <first> is erroneous, a null handle is returned
//! Clears the whole current Context (nullifies it)
Standard_EXPORT void ClearContext();
- //! Prints the transfer status of a transferred item, as beeing
+ //! Prints the transfer status of a transferred item, as being
//! the Mapped n0 <num>, from MapWriter if <wri> is True, or
//! from MapReader if <wri> is False
//! Returns True when done, False else (i.e. num out of range)
//! No cumulation with former calls to TransferReadOne
Standard_EXPORT Standard_Integer TransferReadRoots(const Message_ProgressRange& theProgress = Message_ProgressRange());
- //! produces and returns a new Model well conditionned
+ //! produces and returns a new Model well conditioned
//! It is produced by the Norm Controller
//! It can be Null (if this function is not implemented)
Standard_EXPORT Handle(Interface_InterfaceModel) NewModel();
Standard_EXPORT static Handle(IFSelect_SessionPilot) Pilot();
//! Returns the WorkSession defined in AddDraw (through Pilot)
- //! It is from XSControl, it brings functionnalities for Transfers
+ //! It is from XSControl, it brings functionalities for Transfers
Standard_EXPORT static Handle(XSControl_WorkSession) Session();
//! Defines a Controller for the command "xinit" and applies it
Standard_EXPORT static Handle(XSControl_TransferReader) TransferReader();
//! Takes the name of an entity, either as argument, or (if <name>
- //! is empty) on keybord, and returns the entity
+ //! is empty) on keyboard, and returns the entity
//! name can be a label or a number (in alphanumeric), it is
//! searched by NumberFromLabel from WorkSession.
//! If <name> doesn't match en entity, a Null Handle is returned
#include <Standard.hxx>
-//! Defines additionnal commands for XSDRAW to :
+//! Defines additional commands for XSDRAW to :
//! - control of initialisation (xinit, xnorm, newmodel)
//! - analyse of the result of a transfer (recorded in a
//! TransientProcess for Read, FinderProcess for Write) :
Interface_Static::IVal("write.iges.brep.mode"));
di<<"unit (write) : "<<Interface_Static::CVal("write.iges.unit")<<"\n";
di<<"mode write : "<<Interface_Static::CVal("write.iges.brep.mode")<<"\n";
- di<<" To modifiy : command param\n";
+ di<<" To modify : command param\n";
// Mode d emploi (K4B ->) : brepiges shape [+shape][ +shape] nomfic
// c a d tant qu il y a des + on ajoute ce qui suit
Standard_Integer i =1;
di<<"=====================================================\n";
- di<<"LENTH Unit\n";
+ di<<"LENGTH Unit\n";
for( ; i <= anUnitLengthNames.Length() ; i++)
di<<anUnitLengthNames(i).ToCString()<<"\n";
//! Constructor
Standard_EXPORT XSDRAWSTLVRML_DataSource(const Handle(Poly_Triangulation)& aMesh);
- //! Returns geometry information about node ( if IsElement is False ) or element ( IsElement is True )
- //! by co-ordinates. For element this method must return all its nodes co-ordinates in the strict order: X, Y, Z and
+ //! Returns geometry information about node (if IsElement is False) or element (IsElement is True) by coordinates.
+ //! For element this method must return all its nodes coordinates in the strict order: X, Y, Z and
//! with nodes order is the same as in wire bounding the face or link. NbNodes is number of nodes of element.
//! It is recommended to return 1 for node. Type is an element type.
Standard_EXPORT Standard_Boolean GetGeom (const Standard_Integer ID, const Standard_Boolean IsElement, TColStd_Array1OfReal& Coords, Standard_Integer& NbNodes, MeshVS_EntityType& Type) const Standard_OVERRIDE;
//! Constructor
Standard_EXPORT XSDRAWSTLVRML_DataSource3D();
- //! Returns geometry information about node ( if IsElement is False ) or element ( IsElement is True )
- //! by co-ordinates. For element this method must return all its nodes co-ordinates in the strict order: X, Y, Z and
+ //! Returns geometry information about node (if IsElement is False) or element (IsElement is True) by coordinates.
+ //! For element this method must return all its nodes coordinates in the strict order: X, Y, Z and
//! with nodes order is the same as in wire bounding the face or link. NbNodes is number of nodes of element.
//! It is recommended to return 1 for node. Type is an element type.
Standard_EXPORT Standard_Boolean GetGeom (const Standard_Integer theID, const Standard_Boolean theIsElement, TColStd_Array1OfReal& theCoords, Standard_Integer& theNbNodes, MeshVS_EntityType& theType) const Standard_OVERRIDE;
"Parameter Data : parameter 3 (Number of Boundary entities) is incorrect.\n"
"!Type 143\n"
".XSTEP_168\n"
- "Parameter Data : parameter %d (Boudary entity) is incorrect.\n"
+ "Parameter Data : parameter %d (Boundary entity) is incorrect.\n"
"!Type 144\n"
".XSTEP_169\n"
"Parameter Data : parameter 1 (Surface to be trimmed) is incorrect.\n"
" Transfer error on basic curve : entity skipped.\n"
"!\n"
".IGES_1115\n"
- " With C0 continuity can not be splitted into Geom_BSplineCurve C1 lower than Precision::Confusion().\n"
+ " With C0 continuity can not be split into Geom_BSplineCurve C1 lower than Precision::Confusion().\n"
"!\n"
".IGES_1120\n"
- " With C0 continuity was splitted into C1 continuity Geom_BSplineCurve.\n"
+ " With C0 continuity was split into C1 continuity Geom_BSplineCurve.\n"
"!\n"
".IGES_1125\n"
" Parameter data : parameter 1 (Type of Bounded Surface Representation = 0) : case not implemented. \n"
" Basis surface is C0-continuous but was corrected to C1-continuous.\n"
"!\n"
".IGES_1270\n"
- " Basis surface is C0-continuous and is transferred into a TopoDS_Shell. Only first face was offseted.\n"
+ " Basis surface is C0-continuous and is transferred into a TopoDS_Shell. Only first face was offsetted.\n"
"!\n"
".IGES_1275\n"
" Model Space Representation 0 case not implemented : result is a basis surface.\n"
Parameter Data : parameter 3 (Number of Boundary entities) is incorrect.
!Type 143
.XSTEP_168
-Parameter Data : parameter %d (Boudary entity) is incorrect.
+Parameter Data : parameter %d (Boundary entity) is incorrect.
!Type 144
.XSTEP_169
Parameter Data : parameter 1 (Surface to be trimmed) is incorrect.
Transfer error on basic curve : entity skipped.
!
.IGES_1115
- With C0 continuity can not be splitted into Geom_BSplineCurve C1 lower than Precision::Confusion().
+ With C0 continuity can not be split into Geom_BSplineCurve C1 lower than Precision::Confusion().
!
.IGES_1120
- With C0 continuity was splitted into C1 continuity Geom_BSplineCurve.
+ With C0 continuity was split into C1 continuity Geom_BSplineCurve.
!
.IGES_1125
Parameter data : parameter 1 (Type of Bounded Surface Representation = 0) : case not implemented.
Basis surface is C0-continuous but was corrected to C1-continuous.
!
.IGES_1270
- Basis surface is C0-continuous and is transferred into a TopoDS_Shell. Only first face was offseted.
+ Basis surface is C0-continuous and is transferred into a TopoDS_Shell. Only first face was offsetted.
!
.IGES_1275
Model Space Representation 0 case not implemented : result is a basis surface.
}
}
- // oan: OCC22305 - check a document verison and if it's greater than
+ // oan: OCC22305 - check a document version and if it's greater than
// current version of storage driver set an error status and return
if( aCurDocVersion > TDocStd_Document::CurrentStorageFormatVersion() )
{
TDocStd_FormatVersion aFormatVersion = TDocStd_Document::CurrentStorageFormatVersion(); // the last version of the format
if (TDocStd_Document::CurrentStorageFormatVersion() < aDoc->StorageFormatVersion())
{
- TCollection_ExtendedString anErrorString("Unacceptable storage format version, the last verson is used");
+ TCollection_ExtendedString anErrorString("Unacceptable storage format version, the last version is used");
aMessageDriver->Send (anErrorString.ToExtString(), Message_Warning);
}
else
for(i = 1; i <= aRefs.Length(); i++)
aUserInfo.Append(aRefs.Value(i));
- // Keep fomat version in Reloc. table
+ // Keep format version in Reloc. table
Handle(Storage_HeaderData) aHeaderData = theData->HeaderData();
aHeaderData->SetStorageVersion(aFormatVersion);
myRelocTable.Clear();
// Retrieve from DOM_Document
XmlMDF::FromTo (aTDF, theElement, myRelocTable, myDrivers, theRange);
#ifdef OCCT_DEBUGXML
- aMessage = "First step successfull";
+ aMessage = "First step successful";
aMessageDriver -> Send (aMessage.ToExtString(), Message_Warning);
#endif
return myRelocTable.Extent();
const Handle(TColStd_HArray1OfByte)& hArr = aByteArray->InternalArray();
if (!hArr.IsNull() && hArr->Length())
{
- // Access to data through an internal reprsentation of the array is faster.
+ // Access to data through an internal representation of the array is faster.
const TColStd_Array1OfByte& arr = hArr->Array1();
// Allocate 4 characters (including a space ' ') for each byte (unsigned char) from the array.
Standard_Character c = '-';
if (theRelocTable.GetHeaderData()->StorageVersion().IntegerValue() >= TDocStd_FormatVersion_VERSION_8)
{
- // Preferrable symbols for the separator: - _ . : ^ ~
+ // Preferable symbols for the separator: - _ . : ^ ~
// Don't use a space as a separator: XML low-level parser sometimes "eats" it.
static Standard_Character aPreferable[] = "-_.:^~";
for (i = 0; found && aPreferable[i]; i++)
c = aPreferable[i];
found = Contains(aExtStringArray, TCollection_ExtendedString(c));
}
- // If all prefferable symbols exist in the array,
+ // If all preferable symbols exist in the array,
// try to use any other simple symbols.
if (found)
{
char * aTargetPtr = aTarget + (sizeof (aRefPrefix) - 1);
for(;;) {
- // Check for the end-of-string; find the delimeter ':'
+ // Check for the end-of-string; find the delimiter ':'
aPtr = strchr (aTagEntry, ':');
if (aPtr == NULL) break;
aTagEntry = aPtr + 1;
#include <XmlObjMgt_DOMString.hxx>
-//! The class Array1 represents unidimensionnal
+//! The class Array1 represents unidimensional
//! array of fixed size known at run time.
//! The range of the index is user defined.
-//! Warning: Programs clients of such class must be independant
+//! Warning: Programs clients of such class must be independent
//! of the range of the first element. Then, a C++ for
//! loop must be written like this
//! for (i = A->Lower(); i <= A->Upper(); i++)
<element ref="ocaf:AbstractList3RealAtt"/>
</choice>
<element name="label" type="ocaf:LabelType" minOccurs="0" maxOccurs="unbounded">
-<!-- This type of uniqueness does not alow recursive structures
+<!-- This type of uniqueness does not allow recursive structures
<unique name="LabelUniqueness">
<selector xpath="ocaf:label"/>
<field xpath="@tag"/>
{
const XmlObjMgt_Element& anElement = Source;
- // get co-ordinates
+ // get coordinates
TCollection_AsciiString CoordX = anElement.getAttribute(::CoordX());
TCollection_AsciiString CoordY = anElement.getAttribute(::CoordY());
TCollection_AsciiString CoordZ = anElement.getAttribute(::CoordZ());
TCollection_AsciiString aCoord;
- // co-ordinate X
+ // coordinate X
aCoord = TCollection_AsciiString( aXYZ.X() );
Target.Element().setAttribute(::CoordX(), aCoord.ToCString());
- // co-ordinate Y
+ // coordinate Y
aCoord = TCollection_AsciiString( aXYZ.Y() );
Target.Element().setAttribute(::CoordY(), aCoord.ToCString());
- // co-ordinate Z
+ // coordinate Z
aCoord = TCollection_AsciiString( aXYZ.Z() );
Target.Element().setAttribute(::CoordZ(), aCoord.ToCString());
}
puts "================"
puts ""
#######################################################################################
-# Improve comman sewing in DRAW
+# Improve command sewing in DRAW
######################################################################################
set BugNumber OCC22770
puts "================"
puts ""
#######################################################################################
-# Improve comman sewing in DRAW
+# Improve command sewing in DRAW
######################################################################################
set BugNumber OCC22770
puts "================"
puts ""
#######################################################################################
-# Improve comman sewing in DRAW
+# Improve command sewing in DRAW
######################################################################################
set BugNumber OCC22770
puts "================"
puts ""
#######################################################################################
-# Improve comman sewing in DRAW
+# Improve command sewing in DRAW
######################################################################################
set BugNumber OCC22770
puts "================"
puts ""
#######################################################################################
-# Improve comman sewing in DRAW
+# Improve command sewing in DRAW
######################################################################################
set BugNumber OCC22770
puts "================"
puts ""
#######################################################################################
-# Improve comman sewing in DRAW
+# Improve command sewing in DRAW
######################################################################################
set BugNumber OCC22770
puts "================"
puts ""
#######################################################################################
-# Improve comman sewing in DRAW
+# Improve command sewing in DRAW
######################################################################################
set BugNumber OCC22770
puts "================"
puts ""
#######################################################################################
-# Improve comman sewing in DRAW
+# Improve command sewing in DRAW
######################################################################################
set BugNumber OCC22770
puts "================"
puts ""
#######################################################################################
-# Improve comman sewing in DRAW
+# Improve command sewing in DRAW
######################################################################################
set BugNumber OCC22770
puts "================"
puts ""
#######################################################################################
-# Improve comman sewing in DRAW
+# Improve command sewing in DRAW
######################################################################################
set BugNumber OCC22770
puts "================"
puts ""
#######################################################################################
-# Improve comman sewing in DRAW
+# Improve command sewing in DRAW
######################################################################################
set BugNumber OCC22770
puts "================"
puts ""
#######################################################################################
-# Improve comman sewing in DRAW
+# Improve command sewing in DRAW
######################################################################################
set BugNumber OCC22770
puts "================"
puts ""
#######################################################################################
-# Improve comman sewing in DRAW
+# Improve command sewing in DRAW
######################################################################################
set BugNumber OCC22770
puts "================"
puts ""
#######################################################################################
-# Improve comman sewing in DRAW
+# Improve command sewing in DRAW
######################################################################################
set BugNumber OCC22770
puts "================"
puts ""
#######################################################################################
-# Improve comman sewing in DRAW
+# Improve command sewing in DRAW
######################################################################################
set BugNumber OCC22770
puts "================"
puts ""
#######################################################################################
-# Improve comman sewing in DRAW
+# Improve command sewing in DRAW
######################################################################################
set BugNumber OCC22770
puts "================"
puts ""
#######################################################################################
-# Improve comman sewing in DRAW
+# Improve command sewing in DRAW
######################################################################################
set BugNumber OCC22770
puts "================"
puts ""
#######################################################################################
-# Improve comman sewing in DRAW
+# Improve command sewing in DRAW
######################################################################################
set BugNumber OCC22770
puts "================"
puts ""
#######################################################################################
-# Improve comman sewing in DRAW
+# Improve command sewing in DRAW
######################################################################################
set BugNumber OCC22770
puts "================"
puts ""
#######################################################################################
-# Improve comman sewing in DRAW
+# Improve command sewing in DRAW
######################################################################################
set BugNumber OCC22770
puts "================"
puts ""
#######################################################################################
-# Improve comman sewing in DRAW
+# Improve command sewing in DRAW
######################################################################################
set BugNumber OCC22770
puts "================"
puts ""
#######################################################################################
-# Improve comman sewing in DRAW
+# Improve command sewing in DRAW
######################################################################################
set BugNumber OCC22770
puts "================"
puts ""
#######################################################################################
-# Improve comman sewing in DRAW
+# Improve command sewing in DRAW
######################################################################################
set BugNumber OCC22770
puts "================"
puts ""
#######################################################################################
-# Improve comman sewing in DRAW
+# Improve command sewing in DRAW
######################################################################################
set BugNumber OCC22770
puts "================"
puts ""
#######################################################################################
-# Improve comman sewing in DRAW
+# Improve command sewing in DRAW
######################################################################################
set BugNumber OCC22770
puts "================"
puts ""
#######################################################################################
-# Improve comman sewing in DRAW
+# Improve command sewing in DRAW
######################################################################################
set BugNumber OCC22770
puts "================"
puts ""
#######################################################################################
-# Improve comman sewing in DRAW
+# Improve command sewing in DRAW
######################################################################################
set BugNumber OCC22770
puts "================"
puts ""
#######################################################################################
-# Improve comman sewing in DRAW
+# Improve command sewing in DRAW
######################################################################################
set BugNumber OCC22770
puts "================"
puts ""
#######################################################################################
-# Improve comman sewing in DRAW
+# Improve command sewing in DRAW
######################################################################################
set BugNumber OCC22770
puts "================"
puts ""
#######################################################################################
-# Improve comman sewing in DRAW
+# Improve command sewing in DRAW
######################################################################################
set BugNumber OCC22770
if {[validrange $e] == "edge has no valid range"} {
regexp {Mass : *([0-9\-+.eE]+)} [lprops $e] dummy len
regexp {Tolerance MAX=([0-9\-+.eE]+)} [tolerance $e] dummy tol
- puts "Error: edge $e (lenth=$len, tolerance=$tol) is too small"
+ puts "Error: edge $e (length=$len, tolerance=$tol) is too small"
}
}