diff --git a/src/AIS/AIS_Circle.cxx b/src/AIS/AIS_Circle.cxx index 55b1d33d64..c8eb14aec0 100644 --- a/src/AIS/AIS_Circle.cxx +++ b/src/AIS/AIS_Circle.cxx @@ -197,7 +197,7 @@ void AIS_Circle::UnsetColor() } else { - Quantity_Color CC = Quantity_NOC_YELLOW;; + Quantity_Color CC = Quantity_NOC_YELLOW; if( HasColor() ) CC = myDrawer->Color(); else if (myDrawer->HasLink()) AIS_GraphicTool::GetLineColor(myDrawer->Link(),AIS_TOA_Line,CC); myDrawer->LineAspect()->SetColor(CC); diff --git a/src/AIS/AIS_FixRelation.cxx b/src/AIS/AIS_FixRelation.cxx index 647f209b35..a0c2aca81b 100644 --- a/src/AIS/AIS_FixRelation.cxx +++ b/src/AIS/AIS_FixRelation.cxx @@ -300,7 +300,7 @@ void AIS_FixRelation::ComputeVertex(const TopoDS_Vertex& /*FixVertex*/, gp_Pln pln(myPlane->Pln()); gp_Dir dir(pln.XAxis().Direction()); gp_Vec transvec = gp_Vec(dir)*myArrowSize; - curpos = myPntAttach.Translated(transvec);; + curpos = myPntAttach.Translated(transvec); myPosition = curpos; myAutomaticPosition = Standard_True; } diff --git a/src/AIS/AIS_GraphicTool.cxx b/src/AIS/AIS_GraphicTool.cxx index c42c482952..0c339be9f5 100644 --- a/src/AIS/AIS_GraphicTool.cxx +++ b/src/AIS/AIS_GraphicTool.cxx @@ -92,7 +92,7 @@ Aspect_TypeOfLine AIS_GraphicTool::GetLineType (const Handle(Prs3d_Drawer)& Dr, const AIS_TypeOfAttribute Att) { Handle(Prs3d_LineAspect) LA = GetLineAspect(Dr,Att); - return LA->Aspect()->Type();; + return LA->Aspect()->Type(); } diff --git a/src/AIS/AIS_IdenticRelation.cxx b/src/AIS/AIS_IdenticRelation.cxx index b8cc46c569..68d469fec0 100644 --- a/src/AIS/AIS_IdenticRelation.cxx +++ b/src/AIS/AIS_IdenticRelation.cxx @@ -560,7 +560,7 @@ void AIS_IdenticRelation::ComputeTwoLinesPresentation(const Handle(Prs3d_Present gp_Pln pln(myPlane->Pln()); gp_Dir dir(pln.XAxis().Direction()); gp_Vec transvec = gp_Vec(dir)*myArrowSize; - curpos = myFAttach.Translated(transvec);; + curpos = myFAttach.Translated(transvec); myPosition = curpos; myAutomaticPosition = Standard_True; } diff --git a/src/AIS/AIS_Manipulator.hxx b/src/AIS/AIS_Manipulator.hxx index 11999798fd..f53dc9df1d 100644 --- a/src/AIS/AIS_Manipulator.hxx +++ b/src/AIS/AIS_Manipulator.hxx @@ -30,7 +30,8 @@ #include #include #include -NCOLLECTION_HSEQUENCE(AIS_ManipulatorObjectSequence, Handle(AIS_InteractiveObject)); + +NCOLLECTION_HSEQUENCE(AIS_ManipulatorObjectSequence, Handle(AIS_InteractiveObject)) DEFINE_STANDARD_HANDLE (AIS_Manipulator, AIS_InteractiveObject) diff --git a/src/AIS/AIS_OffsetDimension.cxx b/src/AIS/AIS_OffsetDimension.cxx index de74f89345..ed0f42498d 100644 --- a/src/AIS/AIS_OffsetDimension.cxx +++ b/src/AIS/AIS_OffsetDimension.cxx @@ -168,7 +168,7 @@ void AIS_OffsetDimension::ComputeSelection(const Handle(SelectMgr_Selection)& aS gp_Pnt myTSAttach = mySAttach.Transformed (myRelativePos); gp_Dir myTDirAttach = myDirAttach.Transformed (myRelativePos); gp_Dir myTDirAttach2 = myDirAttach2.Transformed (myRelativePos); - gp_Pnt Tcurpos = myPosition.Transformed (myRelativePos);; + gp_Pnt Tcurpos = myPosition.Transformed (myRelativePos); gp_Lin L1 (myTFAttach,myTDirAttach); gp_Lin L2 (myTSAttach,myTDirAttach2); diff --git a/src/Adaptor2d/Adaptor2d_OffsetCurve.cxx b/src/Adaptor2d/Adaptor2d_OffsetCurve.cxx index 16e5dc412f..f5251eea7f 100644 --- a/src/Adaptor2d/Adaptor2d_OffsetCurve.cxx +++ b/src/Adaptor2d/Adaptor2d_OffsetCurve.cxx @@ -530,7 +530,7 @@ gp_Circ2d Adaptor2d_OffsetCurve::Circle() const gp_Elips2d Adaptor2d_OffsetCurve::Ellipse() const { if (myCurve->GetType() == GeomAbs_Ellipse && myOffset == 0.) { - return myCurve->Ellipse();; + return myCurve->Ellipse(); } else { throw Standard_NoSuchObject("Adaptor2d_OffsetCurve:Ellipse"); diff --git a/src/Adaptor3d/Adaptor3d_TopolTool.cxx b/src/Adaptor3d/Adaptor3d_TopolTool.cxx index c22fc52711..81319ac31b 100644 --- a/src/Adaptor3d/Adaptor3d_TopolTool.cxx +++ b/src/Adaptor3d/Adaptor3d_TopolTool.cxx @@ -540,7 +540,7 @@ Standard_Boolean Adaptor3d_TopolTool::IsThePointOn(const gp_Pnt2d& P, if (surumin || survmin || surumax || survmax) { return(Standard_True); } - return(Standard_False);; + return Standard_False; } } diff --git a/src/AppBlend/AppBlend_AppSurf.gxx b/src/AppBlend/AppBlend_AppSurf.gxx index 591a063487..e9926b4b34 100644 --- a/src/AppBlend/AppBlend_AppSurf.gxx +++ b/src/AppBlend/AppBlend_AppSurf.gxx @@ -374,7 +374,7 @@ void AppBlend_AppSurf::InternalPerform(const Handle(TheLine)& Lin, Standard_Real Uf = F.Parameter(Lin->Point(1)); Standard_Real Ul = F.Parameter(Lin->Point(NbPoint))-Uf; for (i=2; iPoint(i))-Uf)/Ul;; + theParams(i) = (F.Parameter(Lin->Point(i))-Uf)/Ul; } AppDef_Compute theAppDef(theParams,dmin,dmax,tol3d,tol2d,nbit, Standard_True, Standard_True); @@ -426,7 +426,7 @@ void AppBlend_AppSurf::InternalPerform(const Handle(TheLine)& Lin, Standard_Real Uf = F.Parameter(Lin->Point(1)); Standard_Real Ul = F.Parameter(Lin->Point(NbPoint))-Uf; for (i=2; iPoint(i))-Uf)/Ul;; + theParams(i) = (F.Parameter(Lin->Point(i))-Uf)/Ul; } theapprox.Init(dmin,dmax,tol3d,tol2d,nbit,Standard_True, diff --git a/src/AppCont/AppCont_LeastSquare.cxx b/src/AppCont/AppCont_LeastSquare.cxx index d44d555591..a69cb65402 100644 --- a/src/AppCont/AppCont_LeastSquare.cxx +++ b/src/AppCont/AppCont_LeastSquare.cxx @@ -452,7 +452,7 @@ AppCont_LeastSquare::AppCont_LeastSquare(const AppCont_Function& SSP, myDone = Standard_True; for (i = bdeb; i <= bfin; i++) { for (j = bdeb; j <= bfin; j++) { - IBPij = IBP(i, j);; + IBPij = IBP(i, j); for (k = 1; k<= nbcol; k++) { myPoles(i, k) += IBPij * B2(j, k); } diff --git a/src/AppParCurves/AppParCurves.cxx b/src/AppParCurves/AppParCurves.cxx index 1987547084..f60c640e3a 100644 --- a/src/AppParCurves/AppParCurves.cxx +++ b/src/AppParCurves/AppParCurves.cxx @@ -65,7 +65,7 @@ void AppParCurves::Bernstein(const Standard_Integer NbPoles, math_Matrix& DA) { Standard_Integer i, j, id, Ndeg = NbPoles-1; - Standard_Real u0, u1, y0, y1, xs, bj, bj1;; + Standard_Real u0, u1, y0, y1, xs, bj, bj1; Standard_Integer first = U.Lower(), last = U.Upper(); math_Vector B(1, NbPoles-1); diff --git a/src/AppParCurves/AppParCurves_LeastSquare.gxx b/src/AppParCurves/AppParCurves_LeastSquare.gxx index 38ccd4e2fd..ac24dfcf95 100644 --- a/src/AppParCurves/AppParCurves_LeastSquare.gxx +++ b/src/AppParCurves/AppParCurves_LeastSquare.gxx @@ -1272,7 +1272,7 @@ const AppParCurves_MultiBSpCurve& AppParCurves_LeastSquare::BSplineValue() { if (!done) {throw StdFail_NotDone();} - Standard_Integer i, j, j2, npoints = nbP+nbP2d;; + Standard_Integer i, j, j2, npoints = nbP+nbP2d; gp_Pnt Pt; gp_Pnt2d Pt2d; Standard_Integer ideb = resinit, ifin = resfin; diff --git a/src/Approx/Approx_SameParameter.cxx b/src/Approx/Approx_SameParameter.cxx index f5b080c848..54a8b569e2 100644 --- a/src/Approx/Approx_SameParameter.cxx +++ b/src/Approx/Approx_SameParameter.cxx @@ -462,7 +462,7 @@ void Approx_SameParameter::Build(const Standard_Real Tolerance) myC3d->D0(pc3d[ii],Pc3d); dist2 = Pcons.SquareDistance(Pc3d); use_parameter = (dist2 <= Tol2 && (pc3d[ii] > pc3d[count-1] + deltamin)) ; - Standard_Real aDistMin = RealLast();; + Standard_Real aDistMin = RealLast(); if(use_parameter) { if(dist2 > dmax2) dmax2 = dist2; diff --git a/src/BOPTools/BOPTools_AlgoTools_1.cxx b/src/BOPTools/BOPTools_AlgoTools_1.cxx index 803f8ba2f8..6b92221f4a 100644 --- a/src/BOPTools/BOPTools_AlgoTools_1.cxx +++ b/src/BOPTools/BOPTools_AlgoTools_1.cxx @@ -813,7 +813,7 @@ void CorrectEdgeTolerance (const TopoDS_Edge& myShape, { if (myCref.IsNull()) return; - Standard_Boolean ok=Standard_True;; + Standard_Boolean ok = Standard_True; Handle(BRep_TEdge)& TE = *((Handle(BRep_TEdge)*)&myShape.TShape()); Standard_Real Tol = BRep_Tool::Tolerance(TopoDS::Edge(myShape)); diff --git a/src/BRepAlgo/BRepAlgo_FaceRestrictor.cxx b/src/BRepAlgo/BRepAlgo_FaceRestrictor.cxx index f01b28b219..c12f410090 100644 --- a/src/BRepAlgo/BRepAlgo_FaceRestrictor.cxx +++ b/src/BRepAlgo/BRepAlgo_FaceRestrictor.cxx @@ -361,7 +361,7 @@ static void BuildFaceIn( TopoDS_Face& F, else { TopoDS_Shape aLocalShape = Faces.First().EmptyCopied(); TopoDS_Face NF = TopoDS::Face(aLocalShape); - // TopoDS_Face NF = TopoDS::Face(Faces.First().EmptyCopied());; + // TopoDS_Face NF = TopoDS::Face(Faces.First().EmptyCopied()); B.Add (NF,WI); Faces.Append (NF); BuildFaceIn (NF, WI, KeyContains, KeyIsIn, TopAbs_FORWARD,Faces); diff --git a/src/BRepAlgoAPI/BRepAlgoAPI_BooleanOperation.cxx b/src/BRepAlgoAPI/BRepAlgoAPI_BooleanOperation.cxx index 9d86a61ae3..969b9be10d 100644 --- a/src/BRepAlgoAPI/BRepAlgoAPI_BooleanOperation.cxx +++ b/src/BRepAlgoAPI/BRepAlgoAPI_BooleanOperation.cxx @@ -280,7 +280,7 @@ void BRepAlgoAPI_DumpOper::Dump(const TopoDS_Shape& theShape1, fprintf(afile,"%s\n","# Result is Null "); fprintf(afile, "%s %s %s\n","restore", aName1.ToCString(), "arg1"); - fprintf(afile, "%s %s %s\n","restore", aName2.ToCString(), "arg2");; + fprintf(afile, "%s %s %s\n","restore", aName2.ToCString(), "arg2"); TCollection_AsciiString aBopString; switch (theOperation) { diff --git a/src/BRepBlend/BRepBlend_SurfRstConstRad.cxx b/src/BRepBlend/BRepBlend_SurfRstConstRad.cxx index c80e52dcd8..e20f37621d 100644 --- a/src/BRepBlend/BRepBlend_SurfRstConstRad.cxx +++ b/src/BRepBlend/BRepBlend_SurfRstConstRad.cxx @@ -878,7 +878,7 @@ Standard_Boolean BRepBlend_SurfRstConstRad::Section gp_Vec d1u1,d1v1,d2u1,d2v1,d2uv1,d1; gp_Vec ns,ns2,dnplan,dnw,dn2w; //,np2,dnp2; - gp_Vec ncrossns;; + gp_Vec ncrossns; gp_Vec resulu,resulv,temp,tgct,resul; gp_Vec d1urst,d1vrst; gp_Pnt Center,bid; diff --git a/src/BRepBlend/BRepBlend_SurfRstEvolRad.cxx b/src/BRepBlend/BRepBlend_SurfRstEvolRad.cxx index e91a0b571f..ed7a94c0f3 100644 --- a/src/BRepBlend/BRepBlend_SurfRstEvolRad.cxx +++ b/src/BRepBlend/BRepBlend_SurfRstEvolRad.cxx @@ -887,7 +887,7 @@ TColStd_Array1OfReal& DWeigths) gp_Vec d1u1,d1v1,d2u1,d2v1,d2uv1,d1; gp_Vec ns,ns2,dnplan,dnw,dn2w;//,np2,dnp2; - gp_Vec ncrossns;; + gp_Vec ncrossns; gp_Vec resulu,resulv,temp,tgct,resul; gp_Vec d1urst,d1vrst; gp_Pnt Center,bid; diff --git a/src/BRepBndLib/BRepBndLib.cxx b/src/BRepBndLib/BRepBndLib.cxx index 6aa8c2dd49..1809948617 100644 --- a/src/BRepBndLib/BRepBndLib.cxx +++ b/src/BRepBndLib/BRepBndLib.cxx @@ -653,7 +653,7 @@ Standard_Boolean IsModifySize(const BRepAdaptor_Surface& theBS, { if(anExtr.NbExt() > 0) { - Standard_Integer i, imin = 0;; + Standard_Integer i, imin = 0; Standard_Real dmin = RealLast(); Standard_Real uextr = 0., vextr = 0.; Extrema_POnSurf P1, P2; diff --git a/src/BRepFeat/BRepFeat.cxx b/src/BRepFeat/BRepFeat.cxx index 09e7ec8858..7f3d843b0f 100644 --- a/src/BRepFeat/BRepFeat.cxx +++ b/src/BRepFeat/BRepFeat.cxx @@ -676,7 +676,7 @@ Standard_OStream& BRepFeat::Print(const BRepFeat_StatusError se, break; case BRepFeat_EmptyCutResult : s << "Failure in Cut : Empty resulting shape"; - break;; + break; case BRepFeat_FalseSide : s << "Verify plane and wire orientation"; break; diff --git a/src/BRepFill/BRepFill_Pipe.cxx b/src/BRepFill/BRepFill_Pipe.cxx index c5563e74a8..2d7f74b36f 100644 --- a/src/BRepFill/BRepFill_Pipe.cxx +++ b/src/BRepFill/BRepFill_Pipe.cxx @@ -434,7 +434,7 @@ TopoDS_Face BRepFill_Pipe::Face(const TopoDS_Edge& ESpine, TopoDS_Edge BRepFill_Pipe::Edge(const TopoDS_Edge& ESpine, const TopoDS_Vertex& VProfile) { - Standard_Integer ii, ispin = 0, iprof = 0, count = 0;; + Standard_Integer ii, ispin = 0, iprof = 0, count = 0; // ************************************************* // Search if VProfile is a Vertex of myProfile diff --git a/src/BRepFill/BRepFill_Sweep.cxx b/src/BRepFill/BRepFill_Sweep.cxx index 0169c813f9..61fb51c77e 100644 --- a/src/BRepFill/BRepFill_Sweep.cxx +++ b/src/BRepFill/BRepFill_Sweep.cxx @@ -1619,7 +1619,7 @@ static void UpdateEdge(TopoDS_Edge& E, // Control direction & Range Standard_Real R, First, Last, Tol=1.e-4; - Standard_Boolean reverse = Standard_False;; + Standard_Boolean reverse = Standard_False; // Class BRep_Tool without fields and without Constructor : diff --git a/src/BRepLib/BRepLib_MakeFace.cxx b/src/BRepLib/BRepLib_MakeFace.cxx index 8046062ce5..fdbd362013 100644 --- a/src/BRepLib/BRepLib_MakeFace.cxx +++ b/src/BRepLib/BRepLib_MakeFace.cxx @@ -468,7 +468,7 @@ Standard_Boolean BRepLib_MakeFace::IsDegenerated( else if (Type == GeomAbs_BezierCurve) { Handle(Geom_BezierCurve) BZ = AC.Bezier(); Standard_Integer NbPoles = BZ->NbPoles(); - Standard_Real aMaxPoleDist2 = 0.0, aMaxTol2 = theMaxTol*theMaxTol;; + Standard_Real aMaxPoleDist2 = 0.0, aMaxTol2 = theMaxTol*theMaxTol; gp_Pnt P1,P2; P1 = BZ->Pole(1); for (Standard_Integer i = 2; i <= NbPoles; i++) { diff --git a/src/BRepMesh/BRepMesh_Delaun.cxx b/src/BRepMesh/BRepMesh_Delaun.cxx index 761dabdcf2..44b1a8b027 100644 --- a/src/BRepMesh/BRepMesh_Delaun.cxx +++ b/src/BRepMesh/BRepMesh_Delaun.cxx @@ -610,7 +610,7 @@ void BRepMesh_Delaun::createTrianglesOnNewVertices( //======================================================================= void BRepMesh_Delaun::insertInternalEdges() { - Handle(IMeshData::MapOfInteger) anInternalEdges = InternalEdges();; + Handle(IMeshData::MapOfInteger) anInternalEdges = InternalEdges(); // Destruction of triancles intersecting internal edges // and their replacement by makeshift triangles diff --git a/src/BRepOffset/BRepOffset_Inter3d.cxx b/src/BRepOffset/BRepOffset_Inter3d.cxx index 2441b581ad..e5c4877411 100644 --- a/src/BRepOffset/BRepOffset_Inter3d.cxx +++ b/src/BRepOffset/BRepOffset_Inter3d.cxx @@ -296,7 +296,7 @@ void BRepOffset_Inter3d::ConnexIntByArc(const TopTools_ListOfShape& /*SetOfFaces //--------------------------- // E1 generated a tube. //--------------------------- - F1 = TopoDS::Face(InitOffsetFace.Image(E1).First());; + F1 = TopoDS::Face(InitOffsetFace.Image(E1).First()); TopExp::Vertices(E1,V[0],V[1]); const TopTools_ListOfShape& AncE1 = Analyse.Ancestors(E1); diff --git a/src/BRepTest/BRepTest_SweepCommands.cxx b/src/BRepTest/BRepTest_SweepCommands.cxx index e8e528f5ad..0593cdff01 100644 --- a/src/BRepTest/BRepTest_SweepCommands.cxx +++ b/src/BRepTest/BRepTest_SweepCommands.cxx @@ -609,7 +609,7 @@ static Standard_Integer setsweep(Draw_Interpretor& di, return 1; } gp_Dir D(Draw::Atof(a[2]), Draw::Atof(a[3]), Draw::Atof(a[4])); - Sweep->SetMode(D);; + Sweep->SetMode(D); } else if (!strcmp(a[1], "-FX")) { if ((n != 5) && (n != 8)) { diff --git a/src/BiTgte/BiTgte_Blend.cxx b/src/BiTgte/BiTgte_Blend.cxx index bae0791307..acc44d02af 100644 --- a/src/BiTgte/BiTgte_Blend.cxx +++ b/src/BiTgte/BiTgte_Blend.cxx @@ -2216,7 +2216,7 @@ void BiTgte_Blend::ComputeSurfaces() if (OF2isEdge) { // Update CutEdges. exp.Next(); const TopoDS_Edge& EOnF2 = TopoDS::Edge(exp.Current()); - TopExp::Vertices(EOnF2,V1,V2);; + TopExp::Vertices(EOnF2,V1,V2); gp_Pnt P1 = BRep_Tool::Pnt(V1); Projector.Init(P1,GC2); diff --git a/src/BinTools/BinTools.cxx b/src/BinTools/BinTools.cxx index a02f71717e..9530abc5c2 100644 --- a/src/BinTools/BinTools.cxx +++ b/src/BinTools/BinTools.cxx @@ -136,7 +136,7 @@ Standard_IStream& BinTools::GetShortReal (Standard_IStream& theIS, Standard_IStream& BinTools::GetInteger(Standard_IStream& IS, Standard_Integer& aValue) { if(!IS.read ((char*)&aValue, sizeof(Standard_Integer))) - throw Storage_StreamTypeMismatchError();; + throw Storage_StreamTypeMismatchError(); #if DO_INVERSE aValue = InverseInt (aValue); #endif @@ -151,7 +151,7 @@ Standard_IStream& BinTools::GetInteger(Standard_IStream& IS, Standard_Integer& a Standard_IStream& BinTools::GetExtChar(Standard_IStream& IS, Standard_ExtCharacter& theValue) { if(!IS.read ((char*)&theValue, sizeof(Standard_ExtCharacter))) - throw Storage_StreamTypeMismatchError();; + throw Storage_StreamTypeMismatchError(); #if DO_INVERSE theValue = InverseExtChar (theValue); #endif diff --git a/src/Bisector/Bisector_Bisec.cxx b/src/Bisector/Bisector_Bisec.cxx index 79dab49777..cb63dc7683 100644 --- a/src/Bisector/Bisector_Bisec.cxx +++ b/src/Bisector/Bisector_Bisec.cxx @@ -677,12 +677,12 @@ static Standard_Boolean IsMaxRC (const Handle(Geom2d_Curve)& C, Standard_Real Norm2; C->D2(US,P,D1,D2); - Norm2 = D1.SquareMagnitude();; + Norm2 = D1.SquareMagnitude(); if (Norm2 < gp::Resolution()) { KF = 0.0;} else { KF = Abs(D1^D2)/(Norm2*sqrt(Norm2));} C->D2(UL,P,D1,D2); - Norm2 = D1.SquareMagnitude();; + Norm2 = D1.SquareMagnitude(); if (Norm2 < gp::Resolution()) { KL = 0.0;} else { KL = Abs(D1^D2)/(Norm2*sqrt(Norm2));} diff --git a/src/Bisector/Bisector_BisecCC.cxx b/src/Bisector/Bisector_BisecCC.cxx index f437963d58..e940e9b10a 100644 --- a/src/Bisector/Bisector_BisecCC.cxx +++ b/src/Bisector/Bisector_BisecCC.cxx @@ -558,7 +558,7 @@ static Standard_Real Curvature (const Handle(Geom2d_Curve)& C, gp_Vec2d D1,D2; gp_Pnt2d P; C->D2(U,P,D1,D2); - Standard_Real Norm2 = D1.SquareMagnitude();; + Standard_Real Norm2 = D1.SquareMagnitude(); if (Norm2 < Tol) { K1 = 0.0; } diff --git a/src/Bisector/Bisector_BisecPC.cxx b/src/Bisector/Bisector_BisecPC.cxx index 3b746cc138..fa0c7f0c4c 100644 --- a/src/Bisector/Bisector_BisecPC.cxx +++ b/src/Bisector/Bisector_BisecPC.cxx @@ -452,7 +452,7 @@ static Standard_Real Curvature (const Handle(Geom2d_Curve)& C, gp_Vec2d D1,D2; gp_Pnt2d P; C->D2(U,P,D1,D2); - Standard_Real Norm2 = D1.SquareMagnitude();; + Standard_Real Norm2 = D1.SquareMagnitude(); if (Norm2 < Tol) { K1 = 0.0; } diff --git a/src/Blend/Blend_Walking_4.gxx b/src/Blend/Blend_Walking_4.gxx index 5241213ceb..a83a177d3c 100644 --- a/src/Blend/Blend_Walking_4.gxx +++ b/src/Blend/Blend_Walking_4.gxx @@ -730,7 +730,7 @@ void Blend_Walking::InternalPerform(Blend_Function& Func, previousP.Parameter(),tolesp); Ext2.SetValue(previousP.PointOnS2(), sol(3),sol(4), - previousP.Parameter(),tolesp);; + previousP.Parameter(),tolesp); if (!previousP.IsTangencyPoint()) { Ext1.SetTangent(previousP.TangentOnS1()); Ext2.SetTangent(previousP.TangentOnS2()); diff --git a/src/BlendFunc/BlendFunc_CSCircular.cxx b/src/BlendFunc/BlendFunc_CSCircular.cxx index a7aba14bbf..659446b712 100644 --- a/src/BlendFunc/BlendFunc_CSCircular.cxx +++ b/src/BlendFunc/BlendFunc_CSCircular.cxx @@ -901,12 +901,12 @@ Standard_Boolean BlendFunc_CSCircular::Section { gp_Vec d1u1,d1v1,d2u1,d2v1,d2uv1,d1,d2; gp_Vec ns,ns2,dnplan,dnw,dn2w; //,np2,dnp2; - gp_Vec ncrossns;; + gp_Vec ncrossns; gp_Vec resulu,resulv,temp,tgct,resul; gp_Pnt Center; - Standard_Real norm,ndotns,grosterme;; + Standard_Real norm,ndotns,grosterme; math_Vector sol(1,2),valsol(1,2),secmember(1,2); math_Matrix gradsol(1,2,1,2); diff --git a/src/BlendFunc/BlendFunc_CSConstRad.cxx b/src/BlendFunc/BlendFunc_CSConstRad.cxx index 26e033a9c7..714099bc3d 100644 --- a/src/BlendFunc/BlendFunc_CSConstRad.cxx +++ b/src/BlendFunc/BlendFunc_CSConstRad.cxx @@ -875,7 +875,7 @@ Standard_Boolean BlendFunc_CSConstRad::Section gp_Vec d1u1,d1v1,d2u1,d2v1,d2uv1,d1; gp_Vec ns,ns2,dnplan,dnw,dn2w; //,np2,dnp2; - gp_Vec ncrossns;; + gp_Vec ncrossns; gp_Vec resulu,resulv,temp,tgct,resul; gp_Pnt Center; diff --git a/src/BlendFunc/BlendFunc_ConstThroatInv.cxx b/src/BlendFunc/BlendFunc_ConstThroatInv.cxx index 27c2260ca7..9b5a054aac 100644 --- a/src/BlendFunc/BlendFunc_ConstThroatInv.cxx +++ b/src/BlendFunc/BlendFunc_ConstThroatInv.cxx @@ -99,7 +99,7 @@ Standard_Boolean BlendFunc_ConstThroatInv::IsSolution(const math_Vector& Sol, co Abs(valsol(4)) <= Tol*Tol) return Standard_True; - return Standard_False;; + return Standard_False; } //======================================================================= diff --git a/src/BlendFunc/BlendFunc_ConstThroatWithPenetrationInv.cxx b/src/BlendFunc/BlendFunc_ConstThroatWithPenetrationInv.cxx index 7c0ad100e4..28e854ef7d 100644 --- a/src/BlendFunc/BlendFunc_ConstThroatWithPenetrationInv.cxx +++ b/src/BlendFunc/BlendFunc_ConstThroatWithPenetrationInv.cxx @@ -52,7 +52,7 @@ Standard_Boolean BlendFunc_ConstThroatWithPenetrationInv::IsSolution(const math_ Abs(valsol(4)) <= Tol) return Standard_True; - return Standard_False;; + return Standard_False; } //======================================================================= diff --git a/src/CDM/CDM_Document.hxx b/src/CDM/CDM_Document.hxx index 895c70329f..e8892cf15d 100644 --- a/src/CDM/CDM_Document.hxx +++ b/src/CDM/CDM_Document.hxx @@ -310,7 +310,7 @@ Standard_OStream& operator << (Standard_OStream& anOStream); //! A referenced document may indicate through this //! virtual method that it does not allow the closing of //! aDocument which it references through the reference - //! aReferenceIdentifier. By default returns Standard_True;; + //! aReferenceIdentifier. By default returns Standard_True. Standard_EXPORT virtual Standard_Boolean CanCloseReference (const Handle(CDM_Document)& aDocument, const Standard_Integer aReferenceIdentifier) const; //! A referenced document may update its internal diff --git a/src/ChFi3d/ChFi3d_Builder_0.cxx b/src/ChFi3d/ChFi3d_Builder_0.cxx index d03784b98d..a86bef8161 100644 --- a/src/ChFi3d/ChFi3d_Builder_0.cxx +++ b/src/ChFi3d/ChFi3d_Builder_0.cxx @@ -2311,7 +2311,7 @@ void ChFi3d_FilDS(const Standard_Integer SolidIndex, Standard_Integer IArcspine = DStr.AddShape(Arcspine); Standard_Integer IVtx = CorDat->IndexFirstPointOnS1(); - TopAbs_Orientation OVtx = TopAbs_FORWARD;; + TopAbs_Orientation OVtx = TopAbs_FORWARD; for(ex.Init(Arcspine.Oriented(TopAbs_FORWARD),TopAbs_VERTEX); ex.More(); ex.Next()) { diff --git a/src/ChFi3d/ChFi3d_Builder_C1.cxx b/src/ChFi3d/ChFi3d_Builder_C1.cxx index 7f6d9a29e4..369d4dcd7a 100644 --- a/src/ChFi3d/ChFi3d_Builder_C1.cxx +++ b/src/ChFi3d/ChFi3d_Builder_C1.cxx @@ -803,7 +803,7 @@ void ChFi3d_Builder::PerformOneCorner(const Standard_Integer Index, #endif TopoDS_Edge edgecouture; - Standard_Boolean couture,intcouture=Standard_False;; + Standard_Boolean couture,intcouture=Standard_False; Standard_Real tolreached = tolesp; Standard_Real par1 =0.,par2 =0.; Standard_Integer indpt = 0,Icurv1 = 0,Icurv2 = 0; @@ -3990,7 +3990,7 @@ void ChFi3d_Builder::IntersectMoreCorner(const Standard_Integer Index) #endif TopoDS_Edge edgecouture; - Standard_Boolean couture,intcouture=Standard_False;; + Standard_Boolean couture,intcouture=Standard_False; Standard_Real tolreached = tolesp; Standard_Real par1 = 0.,par2 = 0.; Standard_Integer indpt =0,Icurv1 =0,Icurv2 =0; diff --git a/src/ChFi3d/ChFi3d_ChBuilder.cxx b/src/ChFi3d/ChFi3d_ChBuilder.cxx index 16270f3493..912441c93d 100644 --- a/src/ChFi3d/ChFi3d_ChBuilder.cxx +++ b/src/ChFi3d/ChFi3d_ChBuilder.cxx @@ -344,8 +344,10 @@ void ChFi3d_ChBuilder::Add(const Standard_Real Dis1, Spine->SetMode(myMode); Standard_Real Offset = -1; if (myMode == ChFiDS_ConstThroatWithPenetrationChamfer) - Offset = Min(Dis1,Dis2);; - + { + Offset = Min(Dis1,Dis2); + } + Spine->SetEdges(E_wnt); if(PerformElement(Spine, Offset, F)){ Spine->Load(); diff --git a/src/ChFi3d/ChFi3d_FilBuilder.cxx b/src/ChFi3d/ChFi3d_FilBuilder.cxx index c3020493be..1f9573c049 100644 --- a/src/ChFi3d/ChFi3d_FilBuilder.cxx +++ b/src/ChFi3d/ChFi3d_FilBuilder.cxx @@ -1461,7 +1461,7 @@ void ChFi3d_FilBuilder::PerformSurf(ChFiDS_SequenceOfSurfData& SeqData const Standard_Boolean RecRst, const math_Vector& Soldep) { - Handle(ChFiDS_SurfData) Data = SeqData(1);; + Handle(ChFiDS_SurfData) Data = SeqData(1); Handle(ChFiDS_FilSpine) fsp = Handle(ChFiDS_FilSpine)::DownCast(Spine); if(fsp.IsNull()) throw Standard_ConstructionError("PerformSurf : this is not the spine of a fillet"); Handle(BRepBlend_Line) lin; @@ -1577,7 +1577,7 @@ void ChFi3d_FilBuilder::PerformSurf(ChFiDS_SequenceOfSurfData& SeqData const Standard_Boolean RecRst2, const math_Vector& Soldep) { - Handle(ChFiDS_SurfData) Data = SeqData(1);; + Handle(ChFiDS_SurfData) Data = SeqData(1); Handle(ChFiDS_FilSpine) fsp = Handle(ChFiDS_FilSpine)::DownCast(Spine); if(fsp.IsNull()) throw Standard_ConstructionError("PerformSurf : this is not the spine of a fillet"); Handle(BRepBlend_Line) lin; diff --git a/src/DDataStd/DDataStd_BasicCommands.cxx b/src/DDataStd/DDataStd_BasicCommands.cxx index 9e24dd1f0c..54dd87b4b7 100644 --- a/src/DDataStd/DDataStd_BasicCommands.cxx +++ b/src/DDataStd/DDataStd_BasicCommands.cxx @@ -1421,7 +1421,7 @@ static Standard_Integer DDataStd_KeepUTF (Draw_Interpretor& di, #endif if (!anIS) { // Can not open file - std::cout << "Error: can't open file " << aFileName <Save(filename); diff --git a/src/Draw/Draw_Window.cxx b/src/Draw/Draw_Window.cxx index f096767e67..fc2aa8fe51 100644 --- a/src/Draw/Draw_Window.cxx +++ b/src/Draw/Draw_Window.cxx @@ -2496,6 +2496,6 @@ void DrawWindow::SelectNoWait(HANDLE& hWnd, int& x, int& y, int& button) Standard_Boolean DrawWindow::DefineColor (const Standard_Integer, const char*) { return Standard_True; -}; +} #endif diff --git a/src/Expr/Expr_Sum.cxx b/src/Expr/Expr_Sum.cxx index f3a1889991..7c651f4e1e 100644 --- a/src/Expr/Expr_Sum.cxx +++ b/src/Expr/Expr_Sum.cxx @@ -232,7 +232,7 @@ TCollection_AsciiString Expr_Sum::String() const if (op->NbSubExpressions() > 1) { str = "("; str += op->String(); - str += ")";; + str += ")"; } else { str = op->String(); @@ -243,7 +243,7 @@ TCollection_AsciiString Expr_Sum::String() const if (op->NbSubExpressions() > 1) { str += "("; str += op->String(); - str += ")";; + str += ")"; } else { str += op->String(); diff --git a/src/Expr/Expr_UnaryFunction.cxx b/src/Expr/Expr_UnaryFunction.cxx index ab2c0576e7..a484ab175e 100644 --- a/src/Expr/Expr_UnaryFunction.cxx +++ b/src/Expr/Expr_UnaryFunction.cxx @@ -125,6 +125,6 @@ TCollection_AsciiString Expr_UnaryFunction::String() const TCollection_AsciiString res = myFunction->GetStringName(); res += "("; res += Operand()->String(); - res += ")";; + res += ")"; return res; } diff --git a/src/FilletSurf/FilletSurf_InternalBuilder.cxx b/src/FilletSurf/FilletSurf_InternalBuilder.cxx index ac8725e65f..5d53443837 100644 --- a/src/FilletSurf/FilletSurf_InternalBuilder.cxx +++ b/src/FilletSurf/FilletSurf_InternalBuilder.cxx @@ -602,7 +602,7 @@ FilletSurf_StatusType FilletSurf_InternalBuilder::StartSectionStatus() const Standard_Boolean isonedge1 = myListStripe.First()->SetOfSurfData()->Value(1)-> VertexFirstOnS1().IsOnArc(); Standard_Boolean isonedge2= myListStripe.First()->SetOfSurfData()->Value(1)-> - VertexFirstOnS2().IsOnArc();; + VertexFirstOnS2().IsOnArc(); if (isonedge1 && isonedge2) {return FilletSurf_TwoExtremityOnEdge;} diff --git a/src/Font/Font_FontMgr.cxx b/src/Font/Font_FontMgr.cxx index d1ad58bf96..9d226bbf50 100644 --- a/src/Font/Font_FontMgr.cxx +++ b/src/Font/Font_FontMgr.cxx @@ -42,7 +42,6 @@ IMPLEMENT_STANDARD_RTTIEXT(Font_FontMgr,Standard_Transient) namespace { - // list of supported extensions static Standard_CString Font_FontMgr_Extensions[] = { @@ -51,8 +50,7 @@ IMPLEMENT_STANDARD_RTTIEXT(Font_FontMgr,Standard_Transient) "ttc", NULL }; - - }; + } #else diff --git a/src/GccAna/GccAna_Circ2d2TanRad_1.cxx b/src/GccAna/GccAna_Circ2d2TanRad_1.cxx index 6dc567ef7b..bab390c906 100644 --- a/src/GccAna/GccAna_Circ2d2TanRad_1.cxx +++ b/src/GccAna/GccAna_Circ2d2TanRad_1.cxx @@ -446,7 +446,7 @@ GccAna_Circ2d2TanRad:: WellDone = Standard_True; NbrSol = 1; TheSame1(1) = 0; - qualifier1(1) = Qualified1.Qualifier();; + qualifier1(1) = Qualified1.Qualifier(); qualifier2(1) = Qualified2.Qualifier(); pnttg1sol(1)=gp_Pnt2d(Cen.XY()+cote*Radius*gp_XY(ydir,-xdir)); pnttg2sol(1)=gp_Pnt2d(Cen.XY()+Radius*gp_XY(ydir,-xdir)); diff --git a/src/Geom2dGcc/Geom2dGcc_Circ2d2TanOnIter.cxx b/src/Geom2dGcc/Geom2dGcc_Circ2d2TanOnIter.cxx index 203a9e4785..53e94cedbb 100644 --- a/src/Geom2dGcc/Geom2dGcc_Circ2d2TanOnIter.cxx +++ b/src/Geom2dGcc/Geom2dGcc_Circ2d2TanOnIter.cxx @@ -1006,7 +1006,7 @@ Geom2dGcc_Circ2d2TanOnIter (const GccEnt_QualifiedCirc& Qualified1 , tol(1) = 2.e-15*M_PI; tol(2) = Geom2dGcc_CurveTool::EpsX(Cu2,Abs(Tolerance)); tol(3) = Geom2dGcc_CurveTool::EpsX(OnCurv,Abs(Tolerance)); - tol(4) = Tol/10.;; + tol(4) = Tol/10.; gp_Pnt2d point1 = ElCLib::Value(Param1,C1); gp_Pnt2d point2 = Geom2dGcc_CurveTool::Value(Cu2,Param2); gp_Pnt2d point3 = Geom2dGcc_CurveTool::Value(OnCurv,ParamOn); diff --git a/src/GeomFill/GeomFill_NSections.cxx b/src/GeomFill/GeomFill_NSections.cxx index a00e9a6551..85afec1aed 100644 --- a/src/GeomFill/GeomFill_NSections.cxx +++ b/src/GeomFill/GeomFill_NSections.cxx @@ -114,7 +114,7 @@ Standard_Boolean verifD2(const TColgp_Array1OfVec& DP1, const Standard_Real wTol, const Standard_Real pas) { - Standard_Boolean ok = Standard_True;; + Standard_Boolean ok = Standard_True; Standard_Integer ii, L = DP1.Length(); Standard_Real d2w; gp_Vec d2P; diff --git a/src/GeomFill/GeomFill_Sweep.cxx b/src/GeomFill/GeomFill_Sweep.cxx index cc1b9708f9..6e8ce1426c 100644 --- a/src/GeomFill/GeomFill_Sweep.cxx +++ b/src/GeomFill/GeomFill_Sweep.cxx @@ -812,7 +812,7 @@ static Standard_Boolean IsSweepParallelSpine (const Handle(GeomFill_LocationLaw) if ((SectionType == GeomAbs_Circle) && IsTrsf) { gp_Circ C = AC.Circle(); Standard_Real Radius; - Standard_Boolean IsGoodSide = Standard_True;; + Standard_Boolean IsGoodSide = Standard_True; C.Transform(Tf2); gp_Vec DC; // On calcul le centre eventuel diff --git a/src/GeomPlate/GeomPlate_BuildPlateSurface.cxx b/src/GeomPlate/GeomPlate_BuildPlateSurface.cxx index 6d730ef132..507db23b79 100644 --- a/src/GeomPlate/GeomPlate_BuildPlateSurface.cxx +++ b/src/GeomPlate/GeomPlate_BuildPlateSurface.cxx @@ -1013,7 +1013,7 @@ Disc3dContour (const Standard_Integer /*nbp*/, for(i=1; i<=NTCurve; i++) if (myLinCont->Value(i)->Order()!=-1) - { Standard_Integer NbPt=myParCont->Value(i).Length();; + { Standard_Integer NbPt=myParCont->Value(i).Length(); // first constraint point (j=0) // Standard_Integer NbPt=myParCont->Length(); if (iordre==0) { diff --git a/src/GeomToIGES/GeomToIGES_GeomCurve.cxx b/src/GeomToIGES/GeomToIGES_GeomCurve.cxx index 01fd76e039..423ceed56d 100644 --- a/src/GeomToIGES/GeomToIGES_GeomCurve.cxx +++ b/src/GeomToIGES/GeomToIGES_GeomCurve.cxx @@ -501,7 +501,7 @@ Handle(IGESData_IGESEntity) GeomToIGES_GeomCurve::TransferCurve if (start.IsNull()) { return res; } - Handle(IGESGeom_CircularArc) Circle = new IGESGeom_CircularArc;; + Handle(IGESGeom_CircularArc) Circle = new IGESGeom_CircularArc(); IGESConvGeom_GeomBuilder Build; Standard_Real U1 = Udeb; diff --git a/src/IGESAppli/IGESAppli_ToolNodalDisplAndRot.cxx b/src/IGESAppli/IGESAppli_ToolNodalDisplAndRot.cxx index 89225a9a0f..c8a72a9e62 100644 --- a/src/IGESAppli/IGESAppli_ToolNodalDisplAndRot.cxx +++ b/src/IGESAppli/IGESAppli_ToolNodalDisplAndRot.cxx @@ -251,7 +251,7 @@ void IGESAppli_ToolNodalDisplAndRot::OwnDump for (Standard_Integer j = 1; j <= nbnodes; j ++) { S << "[" << j << "]: - NodeIdentifier : " - << ent->NodeIdentifier(j) << " - Node :"<NodeIdentifier(j) << " - Node :"<Node(j),S, 1); S << " - Parameters : " << Message_EndLine; diff --git a/src/IGESData/IGESData_IGESReaderTool.cxx b/src/IGESData/IGESData_IGESReaderTool.cxx index 23d91152c5..b5769bfb84 100644 --- a/src/IGESData/IGESData_IGESReaderTool.cxx +++ b/src/IGESData/IGESData_IGESReaderTool.cxx @@ -333,7 +333,7 @@ IGESData_IGESReaderTool::IGESData_IGESReaderTool const Handle(IGESData_IGESReaderData)& IR, IGESData_ParamReader& PR) const { - Handle(Interface_Check) ach = new Interface_Check;; + Handle(Interface_Check) ach = new Interface_Check(); Handle(Interface_ReaderModule) imodule; Standard_Integer CN; diff --git a/src/IGESDraw/IGESDraw_Protocol.cxx b/src/IGESDraw/IGESDraw_Protocol.cxx index e835ea268a..e8d06f4255 100644 --- a/src/IGESDraw/IGESDraw_Protocol.cxx +++ b/src/IGESDraw/IGESDraw_Protocol.cxx @@ -68,7 +68,7 @@ IGESDraw_Protocol::IGESDraw_Protocol() Handle(Interface_Protocol) IGESDraw_Protocol::Resource (const Standard_Integer /*num*/) const { - Handle(Interface_Protocol) res = IGESDimen::Protocol();; + Handle(Interface_Protocol) res = IGESDimen::Protocol(); return res; } diff --git a/src/IGESGeom/IGESGeom_Protocol.cxx b/src/IGESGeom/IGESGeom_Protocol.cxx index 4453ef5a30..413ef3ed4c 100644 --- a/src/IGESGeom/IGESGeom_Protocol.cxx +++ b/src/IGESGeom/IGESGeom_Protocol.cxx @@ -86,7 +86,7 @@ IGESGeom_Protocol::IGESGeom_Protocol() Handle(Interface_Protocol) IGESGeom_Protocol::Resource (const Standard_Integer /*num*/) const { - Handle(Interface_Protocol) res = IGESBasic::Protocol();; + Handle(Interface_Protocol) res = IGESBasic::Protocol(); return res; } diff --git a/src/IGESGeom/IGESGeom_ToolSplineCurve.cxx b/src/IGESGeom/IGESGeom_ToolSplineCurve.cxx index 3b7b893071..246d40f4b5 100644 --- a/src/IGESGeom/IGESGeom_ToolSplineCurve.cxx +++ b/src/IGESGeom/IGESGeom_ToolSplineCurve.cxx @@ -50,7 +50,7 @@ void IGESGeom_ToolSplineCurve::ReadOwnParams //Standard_Boolean st; //szv#4:S4163:12Mar99 not needed Standard_Integer nbSegments; - Standard_Integer aType, aDegree, nbDimensions;; + Standard_Integer aType, aDegree, nbDimensions; Handle(TColStd_HArray1OfReal) allBreakPoints; Handle(TColStd_HArray2OfReal) allXPolynomials; Handle(TColStd_HArray2OfReal) allYPolynomials; diff --git a/src/IGESGraph/IGESGraph_Protocol.cxx b/src/IGESGraph/IGESGraph_Protocol.cxx index 3343c298e6..250a4a3b87 100644 --- a/src/IGESGraph/IGESGraph_Protocol.cxx +++ b/src/IGESGraph/IGESGraph_Protocol.cxx @@ -67,7 +67,7 @@ IGESGraph_Protocol::IGESGraph_Protocol() Handle(Interface_Protocol) IGESGraph_Protocol::Resource (const Standard_Integer /*num*/) const { - Handle(Interface_Protocol) res = IGESBasic::Protocol();; + Handle(Interface_Protocol) res = IGESBasic::Protocol(); return res; } diff --git a/src/IGESSolid/IGESSolid_Protocol.cxx b/src/IGESSolid/IGESSolid_Protocol.cxx index 1db40fb75e..abd6be3139 100644 --- a/src/IGESSolid/IGESSolid_Protocol.cxx +++ b/src/IGESSolid/IGESSolid_Protocol.cxx @@ -88,7 +88,7 @@ IGESSolid_Protocol::IGESSolid_Protocol() Handle(Interface_Protocol) IGESSolid_Protocol::Resource (const Standard_Integer /*num*/) const { - Handle(Interface_Protocol) res = IGESGeom::Protocol();; + Handle(Interface_Protocol) res = IGESGeom::Protocol(); return res; } diff --git a/src/IGESSolid/IGESSolid_ToolShell.cxx b/src/IGESSolid/IGESSolid_ToolShell.cxx index d37266f5cc..dd8466de9a 100644 --- a/src/IGESSolid/IGESSolid_ToolShell.cxx +++ b/src/IGESSolid/IGESSolid_ToolShell.cxx @@ -62,7 +62,7 @@ void IGESSolid_ToolShell::ReadOwnParams(const Handle(IGESSolid_Shell)& ent, // MGE 03/08/98 //Standard_Boolean abool; //szv#4:S4163:12Mar99 moved down - Standard_Integer nbfaces=0;; //szv#4:S4163:12Mar99 `i` moved in for + Standard_Integer nbfaces=0; //szv#4:S4163:12Mar99 `i` moved in for //Handle(IGESSolid_Face) aface; //szv#4:S4163:12Mar99 moved down Handle(IGESSolid_HArray1OfFace) tempFaces; Handle(TColStd_HArray1OfInteger) tempOrientation; diff --git a/src/IntCurveSurface/IntCurveSurface_Polyhedron.gxx b/src/IntCurveSurface/IntCurveSurface_Polyhedron.gxx index 6a0e59aafc..e20a795690 100644 --- a/src/IntCurveSurface/IntCurveSurface_Polyhedron.gxx +++ b/src/IntCurveSurface/IntCurveSurface_Polyhedron.gxx @@ -506,12 +506,12 @@ Standard_Integer IntCurveSurface_Polyhedron::TriConnex if (colT==(colP+colP)) { colT++; linO=(ligP>ligE)? ligP : ligE; //--linO=Max(ligP, ligE); - colO=colP+1;; + colO=colP+1; } else { colT--; linO=(ligPfloatGap || div<-floatGap) { parO[iObj]=dpOeT[iObj][iToo]/ - (dpOeT[iObj][iToo]-dpOeT[inext][iToo]);; + (dpOeT[iObj][iToo]-dpOeT[inext][iToo]); piO=(IntPatch_PolyhedronTool::Point(FirstPol,OI[iObj]).XYZ()) + (voo[iObj]*parO[iObj]); } diff --git a/src/IntPatch/IntPatch_Polyhedron.cxx b/src/IntPatch/IntPatch_Polyhedron.cxx index 48f4e8726b..c0d9da535a 100644 --- a/src/IntPatch/IntPatch_Polyhedron.cxx +++ b/src/IntPatch/IntPatch_Polyhedron.cxx @@ -402,12 +402,12 @@ Standard_Integer IntPatch_Polyhedron::TriConnex (const Standard_Integer Triang, if (colT==(colP+colP)) { colT++; linO=(ligP>ligE)? ligP : ligE; //--linO=Max(ligP, ligE); - colO=colP+1;; + colO=colP+1; } else { colT--; linO=(ligP= 0 ; jj--) { Factor = binomial_array[jj] * PolesArray[(ii-jj) * Dimension1 + Dimension]; diff --git a/src/QABugs/QABugs_16.cxx b/src/QABugs/QABugs_16.cxx index 5409cdcffe..6622ba1171 100644 --- a/src/QABugs/QABugs_16.cxx +++ b/src/QABugs/QABugs_16.cxx @@ -586,7 +586,7 @@ static Standard_Integer OCC394 (Draw_Interpretor& di, Standard_Integer argc, con aSfwr->CheckSmallEdges(theSmallEdges,theEdgeToFaces,theFaceWithSmall, theMultyEdges); aSfwr->MergeSmallEdges (theSmallEdges,theEdgeToFaces,theFaceWithSmall, theMultyEdges, aModeDrop,tolang); //aSfwr->FixSmallEdges(); - TopoDS_Shape resShape = aSfwr->Shape();; + TopoDS_Shape resShape = aSfwr->Shape(); DBRep::Set ( argv[1], resShape ); return 0; } diff --git a/src/QABugs/QABugs_19.cxx b/src/QABugs/QABugs_19.cxx index b87dfa16e7..7a25f78b30 100644 --- a/src/QABugs/QABugs_19.cxx +++ b/src/QABugs/QABugs_19.cxx @@ -1688,7 +1688,7 @@ static Standard_Integer OCC23951 (Draw_Interpretor& di, Standard_Integer argc, c di << "Usage: " << argv[0] << " invalid number of arguments\n"; return 1; } - Handle(TDocStd_Document) aDoc = new TDocStd_Document("dummy");; + Handle(TDocStd_Document) aDoc = new TDocStd_Document("dummy"); TopoDS_Shape s1 = BRepPrimAPI_MakeBox(1,1,1).Shape(); TDF_Label lab1 = XCAFDoc_DocumentTool::ShapeTool (aDoc->Main ())->NewShape(); XCAFDoc_DocumentTool::ShapeTool (aDoc->Main ())->SetShape(lab1, s1); diff --git a/src/QABugs/QABugs_20.cxx b/src/QABugs/QABugs_20.cxx index 3d81fbf3f5..6060ac4746 100644 --- a/src/QABugs/QABugs_20.cxx +++ b/src/QABugs/QABugs_20.cxx @@ -2716,7 +2716,7 @@ template void AllocDummyArr (Draw_Interpretor& theDI, int theN1, int if (aMem1 > aMem0) theDI << "Error: memory increased by " << (int)(aMem1 - aMem0) << " bytes\n"; -}; +} static Standard_Integer OCC29064 (Draw_Interpretor& theDI, Standard_Integer theArgc, const char** theArgv) { diff --git a/src/STEPConstruct/STEPConstruct_ValidationProps.cxx b/src/STEPConstruct/STEPConstruct_ValidationProps.cxx index 0ad3cf5f82..975efe28da 100644 --- a/src/STEPConstruct/STEPConstruct_ValidationProps.cxx +++ b/src/STEPConstruct/STEPConstruct_ValidationProps.cxx @@ -707,7 +707,7 @@ Standard_Boolean STEPConstruct_ValidationProps::GetPropPnt (const Handle(StepRep #ifdef OCCT_DEBUG std::cout << "Warning: Point " << Model()->StringLabel ( P )->String() << " is not valid for centroid" << std::endl; #endif - return Standard_False;; + return Standard_False; } gp_Pnt pos ( P->CoordinatesValue(1), P->CoordinatesValue(2), P->CoordinatesValue(3) ); diff --git a/src/SWDRAW/SWDRAW_ShapeFix.cxx b/src/SWDRAW/SWDRAW_ShapeFix.cxx index 1dcd8af02b..3ec30f92d2 100644 --- a/src/SWDRAW/SWDRAW_ShapeFix.cxx +++ b/src/SWDRAW/SWDRAW_ShapeFix.cxx @@ -629,7 +629,7 @@ static Standard_Integer fixsmalledges(Draw_Interpretor& di, Standard_Integer n, aSfwr->CheckSmallEdges(theSmallEdges,theEdgeToFaces,theFaceWithSmall, theMultyEdges); aSfwr->MergeSmallEdges (theSmallEdges,theEdgeToFaces,theFaceWithSmall, theMultyEdges, aModeDrop,tolang); //aSfwr->FixSmallEdges(); - TopoDS_Shape resShape = aSfwr->Shape();; + TopoDS_Shape resShape = aSfwr->Shape(); DBRep::Set ( a[1], resShape ); return 0; } diff --git a/src/ShapeCustom/ShapeCustom_BSplineRestriction.cxx b/src/ShapeCustom/ShapeCustom_BSplineRestriction.cxx index c934aa4b93..fa14cf4261 100644 --- a/src/ShapeCustom/ShapeCustom_BSplineRestriction.cxx +++ b/src/ShapeCustom/ShapeCustom_BSplineRestriction.cxx @@ -641,7 +641,7 @@ Standard_Boolean ShapeCustom_BSplineRestriction::ConvertSurface(const Handle(Geo /*if(aSurf->IsVPeriodic()) { Standard_Real aDelta = (VL > VF ? VL - VF : VF - VL ); - v1 = (aDelta > 2.*M_PI ? 0. : VF + ShapeAnalysis::AdjustByPeriod(VF,0.5*(UL+UF),2*M_PI)); ; + v1 = (aDelta > 2.*M_PI ? 0. : VF + ShapeAnalysis::AdjustByPeriod(VF,0.5*(UL+UF),2*M_PI)); v2 = (aDelta > 2.*M_PI ? 2.* M_PI : v1 + aDelta); }*/ if(!aSurf->IsVPeriodic()) {//else diff --git a/src/ShapeFix/ShapeFix.cxx b/src/ShapeFix/ShapeFix.cxx index abeeff3afa..4dca08cdef 100644 --- a/src/ShapeFix/ShapeFix.cxx +++ b/src/ShapeFix/ShapeFix.cxx @@ -202,7 +202,7 @@ Standard_Boolean ShapeFix::SameParameter(const TopoDS_Shape& shape, if ( crv.IsNull() ) continue; - Handle(Geom2d_Curve) c2d = BRep_Tool::CurveOnSurface ( edge, face, f, l );; + Handle(Geom2d_Curve) c2d = BRep_Tool::CurveOnSurface ( edge, face, f, l ); if ( c2d.IsNull() ) continue; Handle(Geom2dAdaptor_HCurve) GHPC = new Geom2dAdaptor_HCurve ( c2d, f, l ); Adaptor3d_CurveOnSurface ACS(GHPC,AS); diff --git a/src/ShapeFix/ShapeFix_ComposeShell.cxx b/src/ShapeFix/ShapeFix_ComposeShell.cxx index 3d3709e344..c57e0bad8d 100644 --- a/src/ShapeFix/ShapeFix_ComposeShell.cxx +++ b/src/ShapeFix/ShapeFix_ComposeShell.cxx @@ -634,7 +634,7 @@ Standard_Integer ShapeFix_ComposeShell::ComputeCode (const Handle(ShapeExtend_Wi Standard_Integer i; // svv #1 for ( i=begInd; ; i++ ) { if ( i > nb ) i = 1; - TopoDS_Edge edge = wire->Edge ( i );; + TopoDS_Edge edge = wire->Edge ( i ); Handle(Geom2d_Curve) c2d; Standard_Real f, l; diff --git a/src/ShapeFix/ShapeFix_Wire.cxx b/src/ShapeFix/ShapeFix_Wire.cxx index b1d8eb45cb..54da471f22 100644 --- a/src/ShapeFix/ShapeFix_Wire.cxx +++ b/src/ShapeFix/ShapeFix_Wire.cxx @@ -1421,7 +1421,7 @@ Standard_Boolean ShapeFix_Wire::FixShifted() ShapeBuild_Edge sbe; Standard_Integer nb = sbwd->NbEdges(); - Standard_Boolean end = (nb == 0), degstop = Standard_False;; + Standard_Boolean end = (nb == 0), degstop = Standard_False; Standard_Integer stop = nb; Standard_Integer degn2 = 0; gp_Pnt pdeg; @@ -2239,7 +2239,7 @@ Standard_Boolean ShapeFix_Wire::FixSelfIntersectingEdge (const Standard_Integer if (myRemoveLoopMode<1) { for ( Standard_Integer iter=0; iter < 30; iter++ ) { - Standard_Boolean loopRemoved = Standard_False;; + Standard_Boolean loopRemoved = Standard_False; Standard_Real prevFirst = 0 , prevLast = 0; for ( Standard_Integer i=1; i<=points2d.Length(); i++ ) { gp_Pnt pint = points3d.Value(i); diff --git a/src/ShapeUpgrade/ShapeUpgrade_SplitSurfaceContinuity.cxx b/src/ShapeUpgrade/ShapeUpgrade_SplitSurfaceContinuity.cxx index 3da6393165..ff02775809 100644 --- a/src/ShapeUpgrade/ShapeUpgrade_SplitSurfaceContinuity.cxx +++ b/src/ShapeUpgrade/ShapeUpgrade_SplitSurfaceContinuity.cxx @@ -176,7 +176,7 @@ ShapeUpgrade_SplitSurfaceContinuity::ShapeUpgrade_SplitSurfaceContinuity() default : case GeomAbs_C1 : BasCriterion = GeomAbs_C2; break; case GeomAbs_C2 : BasCriterion = GeomAbs_C3; break; - case GeomAbs_C3 : //if (ShapeUpgrade::Debug()) std::cout<<". this criterion is not suitable for a Offset Surface"< StepVisual_VectorOfHSequenceOfInteger; -DEFINE_STANDARD_HANDLE(StepVisual_TessellatedCurveSet, StepVisual_TessellatedItem); +DEFINE_STANDARD_HANDLE(StepVisual_TessellatedCurveSet, StepVisual_TessellatedItem) class StepVisual_TessellatedCurveSet : public StepVisual_TessellatedItem @@ -55,6 +55,6 @@ private: NCollection_Handle myCurves; public : - DEFINE_STANDARD_RTTIEXT(StepVisual_TessellatedCurveSet,StepVisual_TessellatedItem); + DEFINE_STANDARD_RTTIEXT(StepVisual_TessellatedCurveSet,StepVisual_TessellatedItem) }; #endif // StepVisual_TessellatedCurveSet diff --git a/src/StepVisual/StepVisual_TessellatedItem.hxx b/src/StepVisual/StepVisual_TessellatedItem.hxx index 81fe88d6a3..72ea067a76 100644 --- a/src/StepVisual/StepVisual_TessellatedItem.hxx +++ b/src/StepVisual/StepVisual_TessellatedItem.hxx @@ -32,6 +32,6 @@ public: //! Returns a DraughtingCalloutElement select type Standard_EXPORT StepVisual_TessellatedItem(); - DEFINE_STANDARD_RTTIEXT(StepVisual_TessellatedItem,StepGeom_GeometricRepresentationItem); + DEFINE_STANDARD_RTTIEXT(StepVisual_TessellatedItem,StepGeom_GeometricRepresentationItem) }; #endif // StepVisual_TessellatedItem diff --git a/src/TDF/TDF_Delta.cxx b/src/TDF/TDF_Delta.cxx index ce36db131c..29544bd730 100644 --- a/src/TDF/TDF_Delta.cxx +++ b/src/TDF/TDF_Delta.cxx @@ -116,7 +116,7 @@ void TDF_Delta::BeforeOrAfterApply(const Standard_Boolean before) const std::cout<<"Undo(): dead lock between these attributes:"<NbGeometries(); if (nbgeom < 4) { #ifdef OCCT_DEBUG - std::cout << "TPrsStd_ConstraintTools::ComputeEqual: at least four geometries are needed" << std::endl;; + std::cout << "TPrsStd_ConstraintTools::ComputeEqual: at least four geometries are needed" << std::endl; #endif NullifyAIS(anAIS); return; @@ -1547,7 +1547,7 @@ void TPrsStd_ConstraintTools::ComputeEqualRadius(const Handle(TDataXtd_Constrain Standard_Integer nbgeom = aConst->NbGeometries(); if (nbgeom < 2) { #ifdef OCCT_DEBUG - std::cout << "TPrsStd_ConstraintTools::ComputeEqualRadius: at least two geometries are needed" << std::endl;; + std::cout << "TPrsStd_ConstraintTools::ComputeEqualRadius: at least two geometries are needed" << std::endl; #endif NullifyAIS(anAIS); return; @@ -1639,7 +1639,7 @@ void TPrsStd_ConstraintTools::ComputeDiameter(const Handle(TDataXtd_Constraint)& Standard_Integer nbgeom = aConst->NbGeometries(); if (nbgeom < 1) { #ifdef OCCT_DEBUG - std::cout << "TPrsStd_ConstraintTools::ComputeDiameter: at least one constrainte is needed" << std::endl;; + std::cout << "TPrsStd_ConstraintTools::ComputeDiameter: at least one constrainte is needed" << std::endl; #endif NullifyAIS(anAIS); return; @@ -1700,14 +1700,14 @@ void TPrsStd_ConstraintTools::ComputeFix(const Handle(TDataXtd_Constraint)& aCon Standard_Integer nbgeom = aConst->NbGeometries(); if (nbgeom < 1) { #ifdef OCCT_DEBUG - std::cout << "TPrsStd_ConstraintTools::ComputeFix: at least one constrainte is needed" << std::endl;; + std::cout << "TPrsStd_ConstraintTools::ComputeFix: at least one constrainte is needed" << std::endl; #endif NullifyAIS(anAIS); return; } if (!aConst->IsPlanar()) { #ifdef OCCT_DEBUG - std::cout << "TPrsStd_ConstraintTools::ComputeFix: must be a planar constraint" << std::endl;; + std::cout << "TPrsStd_ConstraintTools::ComputeFix: must be a planar constraint" << std::endl; #endif NullifyAIS(anAIS); return; diff --git a/src/TopOpeBRep/TopOpeBRep_FacesIntersector.cxx b/src/TopOpeBRep/TopOpeBRep_FacesIntersector.cxx index 72b456351f..c940dd72d3 100644 --- a/src/TopOpeBRep/TopOpeBRep_FacesIntersector.cxx +++ b/src/TopOpeBRep/TopOpeBRep_FacesIntersector.cxx @@ -390,7 +390,7 @@ void TopOpeBRep_FacesIntersector::PrepareLines() const Handle(IntPatch_Line)& L = myIntersector.Line(i); LI.SetLine(L,S1,S2); LI.Index(i); - myLineNb++;; + myLineNb++; }*/} if (newV) { diff --git a/src/TopOpeBRepBuild/TopOpeBRepBuild_Builder1_1.cxx b/src/TopOpeBRepBuild/TopOpeBRepBuild_Builder1_1.cxx index 3aa89067b3..f30f19fc36 100644 --- a/src/TopOpeBRepBuild/TopOpeBRepBuild_Builder1_1.cxx +++ b/src/TopOpeBRepBuild/TopOpeBRepBuild_Builder1_1.cxx @@ -131,7 +131,7 @@ void DumpMapOfShapeWithState (const Standard_Integer iP, aFName+=postfix; for (i=1; i<=n; i++) { - TCollection_AsciiString aI(i), aName;; + TCollection_AsciiString aI(i), aName; aName+=aFName; aName+=aI; const TopoDS_Shape& aShape=aMapOfShapeWithState.FindKey(i); diff --git a/src/TopOpeBRepBuild/TopOpeBRepBuild_Section.cxx b/src/TopOpeBRepBuild/TopOpeBRepBuild_Section.cxx index 674d41a397..2a494208ee 100644 --- a/src/TopOpeBRepBuild/TopOpeBRepBuild_Section.cxx +++ b/src/TopOpeBRepBuild/TopOpeBRepBuild_Section.cxx @@ -437,7 +437,7 @@ void TopOpeBRepBuild_Builder::SplitSectionEdges() if (tSPS) debsplitsemess(iE); #endif - Standard_Boolean isspliton = IsSplit(E,TopAbs_ON);; + Standard_Boolean isspliton = IsSplit(E,TopAbs_ON); if (!isspliton) continue; const TopTools_ListOfShape& LESD = BDS.ShapeSameDomain(E); diff --git a/src/TopOpeBRepDS/TopOpeBRepDS_Check.cxx b/src/TopOpeBRepDS/TopOpeBRepDS_Check.cxx index d0f70db3c8..e093e32327 100644 --- a/src/TopOpeBRepDS/TopOpeBRepDS_Check.cxx +++ b/src/TopOpeBRepDS/TopOpeBRepDS_Check.cxx @@ -214,7 +214,7 @@ Standard_Boolean TopOpeBRepDS_Check::CheckDS(const Standard_Integer I, } if(!myMapShapeStatus.IsBound(I)) myMapShapeStatus.Bind(I,TopOpeBRepDS_OK); - return Standard_True;; + return Standard_True; } //======================================================================= diff --git a/src/TopOpeBRepTool/TopOpeBRepTool_PURGE.cxx b/src/TopOpeBRepTool/TopOpeBRepTool_PURGE.cxx index 467c4ef634..0e7f643935 100644 --- a/src/TopOpeBRepTool/TopOpeBRepTool_PURGE.cxx +++ b/src/TopOpeBRepTool/TopOpeBRepTool_PURGE.cxx @@ -705,7 +705,7 @@ Standard_Boolean TopOpeBRepTool::CorrectONUVISO(const TopoDS_Face& Fin, TopoDS_F #ifdef OCCT_DEBUG if (trc) { std::cout<<"CorrectONUVISO "; - std::cout<<"iso faulty "<ModeWriteBounds (modemin,modemax)) { sout<<"Write Mode : allowed values "<ModeWriteHelp (modd)<ModeWriteHelp (modd)<= (-Epsilon(Delta))) && (X <= Delta + Epsilon(Delta))) { if (Abs(A-C+E) <= Eps) {