Removed #ifndef DEB ... #else ... #endif directives where the variables were being initialized only in release mode.
Removed unused part of code.
{
GeomAPI_ProjectPointOnSurf aProjector;
Quantity_Parameter U, V;
-#ifndef DEB
TopAbs_State State = TopAbs_UNKNOWN;
-#else
- TopAbs_State State;
-#endif
if (AutomaticPos)
{
TopExp_Explorer Explo( FirstFace, TopAbs_VERTEX );
DirAttach = gp_Dir( D1U ^ D1V );
aProjector.Init( FirstAttach, SecondSurf );
-#ifndef DEB
Standard_Integer Index = 0;
-#else
- Standard_Integer Index;
-#endif
Quantity_Length MinDist = RealLast();
gp_Dir LocalDir;
for (Standard_Integer i = 1; i <= aProjector.NbPoints(); i++)
void AIS_DiameterDimension::ComputeOnePlanarFaceDiameter(const Handle(Prs3d_Presentation)& aPresentation)
{
gp_Pnt curPos ;
-#ifndef DEB
Standard_Real parfirst =0., parend =0.;
-#else
- Standard_Real parfirst, parend;
-#endif
if (myAutomaticPosition) {
Handle(Geom_Curve) curv;
gp_Pnt ptfirst,ptend;
Standard_Boolean recadp1, recadp2, recadrst1, recadrst2;
Standard_Real wp1, wp2, wrst1, wrst2;
-#ifndef DEB
Blend_Status State = Blend_OnRst12;
Standard_Real trst11 = 0., trst12 = 0., trst21 = 0., trst22 = 0.;
-#else
- Blend_Status State;
- Standard_Real trst11, trst12, trst21, trst22;
-#endif
math_Vector infbound(1, 2), supbound(1, 2), tolerance(1, 2);
math_Vector solinvp1(1, 2), solinvp2(1, 2), solinvrst1(1, 3), solinvrst2(1, 3);
Handle(Adaptor3d_HVertex) Vtxp1, Vtxp2, Vtxrst1, Vtxrst2, Vtxc;
if (sens* (parprec - Bound) >= -tolgui) {
return;
}
-#ifndef DEB
Blend_Status State = Blend_OnRst12;
Standard_Real trst11 = 0., trst12 = 0., trst21 = 0., trst22 = 0.;
-#else
- Blend_Status State;
- Standard_Real trst11, trst12, trst21, trst22;
-#endif
TopAbs_State situonc1, situonc2;
Blend_DecrochStatus decroch;
Standard_Boolean Arrive, recadp1, recadp2, recadrst1, recadrst2, echecrecad;
Arrive = Standard_True;
}
break;
-#ifndef DEB
default:
break;
-#endif
}
if (Arrive) {
if (sens > 0.) {
else {
Extrem.SetVertex(Vtx);
while (Iter->More()) {
-//#ifndef DEB
Handle(Adaptor2d_HCurve2d) arc = Iter->Value();
-//#else
-// Handle(Adaptor2d_HCurve2d)& arc = Iter->Value();
-//#endif
if (arc != Arc) {
Iter->Initialize(arc);
Iter->InitVertexIterator();
prevTg = previousP.TangentOnC1();
}
Standard_Real Norme, curNorme;
-#ifndef DEB
Standard_Real prevNorme = 0.;
-#else
- Standard_Real prevNorme;
-#endif
gp_Vec Corde(prevP, Psurf);
Norme = Corde.SquareMagnitude();
if (!curpointistangent) curNorme = Tgsurf.SquareMagnitude();
prevTg = previousP.TangentOnC2();
}
Standard_Real Norme, curNorme;
-#ifndef DEB
Standard_Real prevNorme = 0.;
-#else
- Standard_Real prevNorme;
-#endif
gp_Vec Corde(prevP, Psurf);
Norme = Corde.SquareMagnitude();
if (!curpointistangent) curNorme = Tgsurf.SquareMagnitude();
gp_Vec tgrst1, tgrst2;
gp_Vec2d tg2drst1, tg2drst2;
Blend_Status StateRst1, StateRst2;
-#ifndef DEB
IntSurf_TypeTrans trarst1 = IntSurf_Undecided, trarst2 = IntSurf_Undecided;
-#else
- IntSurf_TypeTrans trarst1, trarst2;
-#endif
Blend_Point curpoint;
if (Func.IsSolution(sol, tolesp)) {
else {
sens = -1.;
}
-#ifndef DEB
Blend_Status State = Blend_OnRst12;
Standard_Real trst = 0.;
-#else
- Blend_Status State;
- Standard_Real trst;
-#endif
Standard_Boolean recadp,recadrst,recads;
Standard_Real wp,wrst,ws;
Standard_Real U,V;
if (sens*(parprec - Bound) >= -tolgui) {
return;
}
-#ifndef DEB
Blend_Status State = Blend_OnRst12;
-#else
- Blend_Status State;
-#endif
TopAbs_State situonc,situons;
Standard_Boolean decroch;
Standard_Boolean Arrive,recadp,recadrst,recads,echecrecad;
Standard_Real wp,wrst,ws;
Standard_Real U,V;
-#ifndef DEB
Standard_Real trst = 0.;
-#else
- Standard_Real trst;
-#endif
math_Vector infbound(1,3),supbound(1,3);
math_Vector parinit(1,3),tolerance(1,3);
math_Vector solinvp(1,3),solinvrst(1,4),solinvs(1,3);
Arrive = Standard_True;
}
break;
-#ifndef DEB
default:
break;
-#endif
}
if (Arrive) {
if (sens > 0.) {
else {
Extrem.SetVertex(Vtx);
while (Iter->More()) {
-//#ifndef DEB
Handle(Adaptor2d_HCurve2d) arc = Iter->Value();
-//#else
-// Handle(Adaptor2d_HCurve2d)& arc = Iter->Value();
-//#endif
if (arc != Arc) {
Iter->Initialize(arc);
Iter->InitVertexIterator();
if(!prevpointistangent){
prevTg = previousP.TangentOnS();
}
-#ifndef DEB
Standard_Real Norme,prevNorme = 0.;
-#else
- Standard_Real Norme,prevNorme;
-#endif
gp_Vec Corde(prevP,Psurf);
Norme = Corde.SquareMagnitude();
// if(!curpointistangent) curNorme = Tgsurf.SquareMagnitude();
if(!prevpointistangent){
prevTg = previousP.TangentOnC();
}
-#ifndef DEB
Standard_Real Norme,prevNorme = 0.;
-#else
- Standard_Real Norme,prevNorme;
-#endif
gp_Vec Corde(prevP,Psurf);
Norme = Corde.SquareMagnitude();
// if(!curpointistangent) curNorme = Tgsurf.SquareMagnitude();
gp_Vec tgs,tgrst;
gp_Vec2d tg2ds,tg2drst;
Blend_Status StateS,StateRst;
-#ifndef DEB
IntSurf_TypeTrans tras = IntSurf_Undecided, trarst = IntSurf_Undecided;
-#else
- IntSurf_TypeTrans tras,trarst;
-#endif
Blend_Point curpoint;
if (Func.IsSolution(sol,tolesp)) {
case BRepCheck_CheckFail:
OS << "BRepCheck_CheckFail\n";
break;
-#ifndef DEB
default:
break;
-#endif
}
}
case TopAbs_COMPSOLID:
case TopAbs_COMPOUND:
break;
-#ifndef DEB
default:
break;
-#endif
}
myMap.Bind(S,HR);
for(TopoDS_Iterator theIterator(S);theIterator.More();theIterator.Next()) {
}
gp_Pnt2d pt2d(C2d->Value(prm));
-#ifdef DEB
- TopAbs_State st2=
-#endif
- FClass2d.Perform(pt2d,Standard_False);
-//-- if(st1!=st2) {
-//-- static int p=0;
-//-- printf("\n point p%d %g %g \n",++p,pt2d.X(),pt2d.Y());
-//-- }
if(WireBienOriente) {
-#ifndef DEB
return(FClass2d.Perform(pt2d,Standard_False) == TopAbs_OUT);
}
else {
return(FClass2d.Perform(pt2d,Standard_False) == TopAbs_IN);
}
-#else
- return(st2 == TopAbs_OUT);
- }
- else {
- return(st2 == TopAbs_IN);
- }
-#endif
}
return Standard_False;
}
theOstat = BRepCheck_NoError;
TopoDS_Vertex VF,VL;
-#ifndef DEB
TopAbs_Orientation orient, ortmp = TopAbs_FORWARD;
-#else
- TopAbs_Orientation orient, ortmp;
-#endif
TopTools_ListOfShape ledge, ListOfPassedEdge;
TopExp_Explorer exp,vte;
TopTools_MapOfShape mapS;
Standard_Real MinAngle, MaxAngle, angle;
Standard_Real gpResolution=gp::Resolution();
TopAbs_Orientation aVOrientation, aEdgOrientation;
-#ifndef DEB
Standard_Real dist2d = 0, p = 0;
-#else
- Standard_Real dist2d, p;
-#endif
Standard_Real f, l, parpiv;
Standard_Real tolv = BRep_Tool::Tolerance(V);
BRepAdaptor_Surface Ads(F,Standard_False); // no restriction
IntCurvesFace_Intersector& BRepClass3d_SolidExplorer::Intersector(const TopoDS_Face& F) const {
void *ptr = (void*)(myMapOfInter.Find(F));
-#ifndef DEB
IntCurvesFace_Intersector& curr = (*((IntCurvesFace_Intersector *)ptr));
return curr;
-#else
- return(*((IntCurvesFace_Intersector *)ptr));
-#endif
}
//=======================================================================
LocOpe_CSIntersector ASI2(mySbase);
ASI1.Perform(scur);
ASI2.Perform(scur);
-#ifndef DEB
TopAbs_Orientation OrU = TopAbs_FORWARD, OrF = TopAbs_FORWARD;
-#else
- TopAbs_Orientation OrU, OrF;
-#endif
TopoDS_Face FUntil, FFrom;
if (ASI1.IsDone() && ASI1.NbPoints(1) >=1) {
OrU = ASI1.Point(1,1).Orientation();
TopExp_Explorer Ex;
TopoDS_Edge eb, ec;
gp_Pnt p1, p2;
-#ifndef DEB
Standard_Real t1 = 0., t2 = 0.;
-#else
- Standard_Real t1, t2;
-#endif
Standard_Boolean c1f, c2f, c1l, c2l;
for (Ex.Init(sect.Shape(), TopAbs_EDGE); Ex.More(); Ex.Next()) {
LocOpe_CSIntersector ASI2(mySbase);
ASI1.Perform(scur);
ASI2.Perform(scur);
-#ifndef DEB
TopAbs_Orientation OrU = TopAbs_FORWARD, OrF = TopAbs_FORWARD;
-#else
- TopAbs_Orientation OrU, OrF;
-#endif
TopoDS_Face FUntil, FFrom;
if (ASI1.IsDone() && ASI1.NbPoints(1) >=1) {
OrU = ASI1.Point(1,1).Orientation();
BRepBndLib::Add(theSbase,Box);
BRepBndLib::Add(theSkface,Box);
if(!theSFrom.IsNull()) {
-#ifndef DEB
Standard_Boolean FacRevolInfini = Standard_False;
-#else
- Standard_Boolean FacRevolInfini;
-#endif
TopExp_Explorer exp;
exp.Init(theSFrom, TopAbs_EDGE);
for(; exp.More(); exp.Next()) {
BRepBndLib::Add(theSFrom,Box);
}
if(!theSUntil.IsNull()) {
-#ifndef DEB
- Standard_Boolean FacRevolInfini = Standard_False;
-#else
Standard_Boolean FacRevolInfini;
-#endif
TopExp_Explorer exp;
exp.Init(theSUntil, TopAbs_EDGE);
for(; exp.More(); exp.Next()) {
// find the particular case
gp_Pnt pos1, pos;
Standard_Real dist;
-#ifndef DEB
Standard_Real dist1 =0.;
-#else
- Standard_Real dist1;
-#endif
gp_Ax1 axe1, axe;
if (degen1) {
gp_Mat M1, M2, DM1, DM2;
Standard_Real First, Last, EpsNul = 1.e-12;
Standard_Real TolEps = SpatialTolerance;
-#ifndef DEB
Standard_Boolean Ok_D1 = Standard_False;
-#else
- Standard_Boolean Ok_D1;
-#endif
TopoDS_Vertex V;
TopoDS_Edge E;
TColgp_Array1OfPnt2d Bid1 (1,1);
Standard_Integer jj;
GeomAbs_Shape cont_jj;
-#ifndef DEB
GeomAbs_Shape cont = GeomAbs_C0;
-#else
- GeomAbs_Shape cont;
-#endif
for (jj=1; jj<=myShapes.Length(); jj++) {
explode = Standard_True;
break;
}
-#ifndef DEB
default:
break;
-#endif
}
if (explode) {
case TopAbs_COMPSOLID :
Standard_DomainError::Raise("BRepFill_Pipe::SOLID or COMPSOLID");
break;
-#ifndef DEB
default:
break;
-#endif
}
return result;
case TopAbs_COMPSOLID :
Standard_DomainError::Raise("BRepFill_Pipe::SOLID or COMPSOLID");
break;
-#ifndef DEB
default:
break;
-#endif
}
return result;
{
gp_Pnt2d PE1,PE2,PF1,PF2;
Standard_Real VDeg;
-#ifndef DEB
Standard_Real V = 0.;
-#else
- Standard_Real V;
-#endif
BRep_Tool::UVPoints(Edge,Face,PE1,PE2);
VDeg = PE1.Y();
TopExp_Explorer Exp(Face,TopAbs_EDGE);
((*((Handle(BRep_TEdge)*)&AnEdge.TShape()))->ChangeCurves());
Standard_Real first, last;
-#ifndef DEB
Standard_Real current_first =0., current_last =0. ;
-#else
- Standard_Real current_first,current_last ;
-#endif
Handle(BRep_GCurve) geometric_representation_ptr ;
while (IsSameRange && an_Iterator.More()) {
GeomAdaptor_Curve& GAC = HC->ChangeCurve();
Geom2dAdaptor_Curve& GAC2d = HC2d->ChangeCurve2d();
GeomAdaptor_Surface& GAS = HS->ChangeSurface();
-#ifndef DEB
Standard_Real f3d =0.,l3d =0.;
-#else
- Standard_Real f3d,l3d;
-#endif
TopLoc_Location L3d;
Handle(Geom_Curve) C3d;
Standard_Boolean rev1 = (F1.Orientation() == TopAbs_REVERSED);
Standard_Boolean rev2 = (F2.Orientation() == TopAbs_REVERSED);
Standard_Real f,l,eps, angmax = -M_PI;
-#ifndef DEB
Standard_Real ang =0.;
-#else
- Standard_Real ang;
-#endif
BRep_Tool::Range(E,f,l);
Extrema_LocateExtPC ext;
Standard_Boolean IsInitialized = Standard_False;
rlist.Prepend(edVer);
nlist.Prepend(edVer);
if (!mapLocale.Contains(edVer)) {
-#ifndef DEB
Standard_Boolean notYetFound = Standard_True;
-#else
- Standard_Boolean notYetFound;
-#endif
Standard_Real gap=BRep_Tool::Tolerance(edVer);
gp_Pnt pVer=BRep_Tool::Pnt(edVer);
for (itMS.Initialize(mapLocale); itMS.More(); itMS.Next()) {
TopoDS_Vertex vf, vl;
TopoDS_Shape theKey;
Standard_Boolean usedVertex;
-#ifndef DEB
Standard_Boolean closedEdge = Standard_False;
-#else
- Standard_Boolean closedEdge;
-#endif
Standard_Integer vvInd, lastInd;
do {
if (!VL.IsNull() && lesMeres.Contains(VL)) {
BRepAdaptor_Curve NC(NE);
Standard_Real Of = OC.FirstParameter(); Standard_Real Ol = OC.LastParameter();
Standard_Real Nf = NC.FirstParameter(); Standard_Real Nl = NC.LastParameter();
-#ifndef DEB
Standard_Real U = 0.;
-#else
- Standard_Real U;
-#endif
Standard_Real ParTol = Precision::PConfusion();
gp_Pnt P = BRep_Tool::Pnt(V);
Standard_Boolean OK = Standard_False;
aShape.Reverse();
}
break;
-#ifndef DEB
default:
break;
-#endif
}
return aShape;
case GeomAbs_BSplineCurve:
C2d = Proj.BSpline();
break;
-#ifndef DEB
default:
break;
-#endif
}
if (AS.IsUPeriodic() || AS.IsVPeriodic()) {
#endif
BRep_Builder B;
Standard_Real f,l;
-#ifndef DEB
Standard_Real U = 0.;
-#else
- Standard_Real U;
-#endif
TopLoc_Location L;
Standard_Boolean found = Standard_False;
return;
}
#endif
-#ifndef DEB
Standard_Real U1 = 0.,U2 = 0.;
-#else
- Standard_Real U1,U2;
-#endif
gp_Pnt2d P2d;
if (itry == 1) {
fl1[0] = C1->FirstParameter(); fl1[1] = C1->LastParameter();
BRepAdaptor_Curve NC(NE);
Standard_Real Of = OC.FirstParameter(); Standard_Real Ol = OC.LastParameter();
Standard_Real Nf = NC.FirstParameter(); Standard_Real Nl = NC.LastParameter();
-#ifndef DEB
Standard_Real U = 0.;
-#else
- Standard_Real U;
-#endif
gp_Pnt P = BRep_Tool::Pnt(V);
Standard_Boolean OK = Standard_False;
//case GeomAbs_Intersection: cout << " Intersection"; break;
case GeomAbs_Arc: di << " Arc"; break;
case GeomAbs_Intersection: di << " Intersection"; break;
-#ifndef DEB
default:
break ;
-#endif
}
//cout << endl;
di << "\n";
//cout << "C2"<<endl;
di << "C2"<<"\n";
break;
-#ifndef DEB
default:
break;
-#endif
}
return 0;
}
Standard_Real PfX,PfY,PlX,PlY;
gp_Pnt2d aPf, aPl;
Standard_Boolean closed;
-#ifndef DEB
GeomAbs_Shape reg = GeomAbs_C0;
-#else
- GeomAbs_Shape reg;
-#endif
switch (T) {
const TopoDS_Face& F,
const TopTools_ListOfShape& L)
{
-#ifndef DEB
TopAbs_Orientation Orien = TopAbs_FORWARD;
-#else
- TopAbs_Orientation Orien;
-#endif
TopTools_ListIteratorOfListOfShape itld;
for ( itld.Initialize(L); itld.More(); itld.Next()) {
if ( itld.Value().IsSame(E)) {
gp_Pnt2d aPf, aPl;
Standard_Boolean closed, bval;
Standard_SStream aMsg;
-#ifndef DEB
GeomAbs_Shape reg = GeomAbs_C0;
-#else
- GeomAbs_Shape reg;
-#endif
try {
OCC_CATCH_SIGNALS
switch (T) {
case GeomAbs_C2 : return GeomAbs_C1;
case GeomAbs_C3 : return GeomAbs_C2;
case GeomAbs_CN : return GeomAbs_CN;
-#ifndef DEB
default: break;
-#endif
}
return GeomAbs_C0;
}
case GeomAbs_C2 : return GeomAbs_C1;
case GeomAbs_C3 : return GeomAbs_C2;
case GeomAbs_CN : return GeomAbs_CN;
-#ifndef DEB
default: break;
-#endif
}
return GeomAbs_C0;
}
Bisector_PointOnBis PRef;
gp_Pnt2d P,P1,P2,PBis;
gp_Vec2d T1,Tang;
-#ifndef DEB
Standard_Real dU = 0.;
-#else
- Standard_Real dU;
-#endif
Standard_Boolean ExtensionTangent = Standard_False;
if (myPolygon.Length() == 0) {
//=============================================================================
static Standard_Real ProjOnCurve (const gp_Pnt2d& P,
const Handle(Geom2d_Curve)& C)
-{
-#ifndef DEB
+{
Standard_Real UOnCurve =0.;
-#else
- Standard_Real UOnCurve;
-#endif
gp_Pnt2d PF,PL;
gp_Vec2d TF,TL;
case GeomAbs_C2 : return GeomAbs_C1;
case GeomAbs_C3 : return GeomAbs_C2;
case GeomAbs_CN : return GeomAbs_CN;
-#ifndef DEB
default: break;
-#endif
}
return GeomAbs_C0;
}
case GeomAbs_C2 : return GeomAbs_C1;
case GeomAbs_C3 : return GeomAbs_C2;
case GeomAbs_CN : return GeomAbs_CN;
-#ifndef DEB
default: break;
-#endif
}
return GeomAbs_C0;
}
const Standard_Real U2) const
{
Standard_Real Dist1,Dist2,DistMid,U11,U22;
-#ifndef DEB
Standard_Real UMid = 0.;
-#else
- Standard_Real UMid;
-#endif
Standard_Real Tol = Precision::PConfusion();
Standard_Real DistMax2 = distMax*distMax;
U11 = U1; U22 = U2;
//=============================================================================
void Bisector_BisecPC::ComputeIntervals ()
{
-#ifndef DEB
Standard_Real U1 =0.,U2 =0.,UProj =0.;
-#else
- Standard_Real U1,U2,UProj;
-#endif
Standard_Real UStart,UEnd;
Standard_Real Dist1,Dist2,DistProj;
isEmpty = Standard_False;
return U + endIntervals.Value(bisInterval);
}
}
-#ifndef DEB
Standard_Real UOnCurve = 0.;
-#else
- Standard_Real UOnCurve;
-#endif
Geom2dAPI_ProjectPointOnCurve Proj(P,curve,
curve->FirstParameter(),curve->LastParameter());
if (Proj.NbPoints() > 0) {
const Standard_Real Tol)
{
Standard_Real USol,U1,U2,Dist;
-#ifndef DEB
Standard_Real UMin =0.,UMax =0.;
-#else
- Standard_Real UMin,UMax;
-#endif
Standard_Real Eps = Precision::PConfusion();
gp_Pnt2d PSol;
Standard_Failure::Raise("cannot close this document because a document "
"referencing it refuses");
break;
-#ifndef DEB
default:
break;
-#endif
}
if(FromReferencesNumber() != 0) {
CDM_ListIteratorOfListOfReferences it(myFromReferences);
//construct fillets on each vertex + feed the Ds
if (done) {
- //Standard_Integer nbresult=0;
-// for (Standard_Integer j=1;j<=myVDataMap.Extent();j++) {
-#ifndef DEB
- static
-#endif //to avoid Linux warning:<< variable `j' might be clobbered by `longjmp' or `vfork' >>
Standard_Integer j;
- for (j=1;j<=myVDataMap.Extent();j++) {
- try {
+ for (j=1;j<=myVDataMap.Extent();j++)
+ {
+ try
+ {
OCC_CATCH_SIGNALS
- PerformFilletOnVertex(j);
+ PerformFilletOnVertex(j);
}
- catch(Standard_Failure) {
- Handle(Standard_Failure) exc = Standard_Failure::Caught();
+ catch(Standard_Failure)
+ {
+ Handle(Standard_Failure) exc = Standard_Failure::Caught();
#ifdef DEB
- cout <<"EXCEPTION Corner compute " << exc << endl;
+ cout <<"EXCEPTION Corner compute " << exc << endl;
#endif
- badvertices.Append(myVDataMap.FindKey(j));
+ badvertices.Append(myVDataMap.FindKey(j));
hasresult=Standard_False;
- done = Standard_True;
+ done = Standard_True;
}
if (!done) badvertices.Append(myVDataMap.FindKey(j));
done = Standard_True;
}
- if (!hasresult) done = badvertices.IsEmpty();
+ if (!hasresult) done = badvertices.IsEmpty();
}
Handle(ChFiDS_SurfData) Fd;
Standard_Integer i, Icurv;
-#ifndef DEB
Standard_Integer Ivtx = 0;
-#else
- Standard_Integer Ivtx;
-#endif
for (It.Initialize(myVDataMap(Index)), i=0; It.More(); It.Next(),i++){
stripe = It.Value();
// SurfData concerned and its CommonPoints,
Standard_Integer i;
Standard_Boolean nondegenere = Standard_True;
Standard_Boolean toujoursdegenere = Standard_True;
-#ifndef DEB
Standard_Boolean isfirst = Standard_False;
-#else
- Standard_Boolean isfirst;
-#endif
for (It.Initialize(myVDataMap(Index)), i=0; It.More(); It.Next(),i++){
stripe = It.Value();
sp = stripe->Spine();
Standard_Boolean Fini = Standard_False;
Standard_Integer Nb;
-#ifndef DEB
ChFiDS_State CurSt = ChFiDS_Closed;
-#else
- ChFiDS_State CurSt;
-#endif
if (VStart.IsSame(LVEc)) {//case if only one edge is closed
CEc.Initialize(Ec);
Wl = BRep_Tool::Parameter(VStart,Ec);
// in which case FVoi = FRef is returned (less frequent case).
TopExp_Explorer Ex;
Standard_Boolean orset = Standard_False;
-#ifndef DEB
TopAbs_Orientation orient = TopAbs_FORWARD ;
-#else
- TopAbs_Orientation orient;
-#endif
TopoDS_Edge ed;
for(Ex.Init(FRef,TopAbs_EDGE); Ex.More(); Ex.Next()){
ed = TopoDS::Edge(Ex.Current());
Standard_Real wl = 0.9973 * Spine->LastParameter(nbed) +
0.0027 * Spine->FirstParameter(nbed);
-#ifndef DEB
Standard_Real TolE = 1.0e-7;
-#else
- Standard_Real TolE;
-#endif
BRepAdaptor_Surface AS;
Standard_Integer nbessai;
TopoDS_Edge cured;
TopoDS_Face f1,f2;
TopAbs_Orientation Or1,Or2;
-#ifndef DEB
Standard_Integer Choix = 0;
-#else
- Standard_Integer Choix;
-#endif
math_Vector SolDep(1,4);
Handle(Geom2d_Curve) PC;
Extrema_ExtPC PExt;
}
}
Standard_Real MaxStep = (bidl-bidf)*0.05/nbed;
-#ifndef DEB
Standard_Real Firstsov = 0.;
-#else
- Standard_Real Firstsov;
-#endif
Standard_Boolean intf = 0, intl = 0;
while(!fini){
// are these the ends (no extension on periodic).
Standard_Real fp = cursd->FirstSpineParam();
Standard_Real lp = cursd->LastSpineParam();
Standard_Integer j;
-#ifndef DEB
Standard_Integer jf = 0, jl = 0;
-#else
- Standard_Integer jf,jl;
-#endif
if(lp < WF+tolesp || fp > WL-tolesp) continue;
for(j = IF; j < IL; j++){
jf = j;
if(checkcurve.IsNull()) checkcurve = new GeomAdaptor_HCurve();
GeomAdaptor_Curve& chc = checkcurve->ChangeCurve();
Standard_Real tolget3d, tolget2d, tolaux, tolC1, tolcheck;
-#ifndef DEB
Standard_Real tolC2 = 0.;
-#else
- Standard_Real tolC2;
-#endif
approx.TolReached(tolget3d, tolget2d);
tolaux = approx.TolCurveOnSurf(1);
tolC1 = tolget3d + tolaux;
Standard_Real MS = MaxStep;
Standard_Integer again = 0;
Standard_Integer nbptmin = 3; //jlr
-#ifndef DEB
Standard_Integer Nbpnt = 0;
-#else
- Standard_Integer Nbpnt;
-#endif
// the initial solution is reframed if necessary.
math_Vector ParSol(1,3);
Standard_Real NewFirst = PFirst;
Standard_Real MS = MaxStep;
Standard_Integer again = 0;
Standard_Integer nbptmin = 3; //jlr
-#ifndef DEB
Standard_Integer Nbpnt = 0;
-#else
- Standard_Integer Nbpnt;
-#endif
// the initial solution is reframed if necessary.
math_Vector ParSol(1,2);
Standard_Real NewFirst = PFirst;
Standard_Real MS = MaxStep;
Standard_Integer again = 0;
-#ifndef DEB
Standard_Integer Nbpnt = 0;
-#else
- Standard_Integer Nbpnt;
-#endif
// the starting solution is reframed if needed.
math_Vector ParSol(1,3);
Standard_Real NewFirst = PFirst;
Standard_Real MS = MaxStep;
Standard_Integer again = 0;
-#ifndef DEB
Standard_Integer Nbpnt = 0;
-#else
- Standard_Integer Nbpnt;
-#endif
// The initial solution is reframed if necessary.
math_Vector ParSol(1,2);
Standard_Real NewFirst = PFirst;
//******************************************************************//
Standard_Integer again = 0;
Standard_Boolean tchernobyl = 0;
-#ifndef DEB
Standard_Real u1sov = 0., u2sov = 0.;
-#else
- Standard_Real u1sov, u2sov;
-#endif
TopoDS_Face bif;
//Max step is relevant, but too great, the vector is required to detect
//the twists.
}
Standard_Real Targetsov = Target;
-#ifndef DEB
Standard_Real u1sov = 0., u2sov = 0.;
-#else
- Standard_Real u1sov, u2sov;
-#endif
// on recadre la solution de depart a la demande.
math_Vector ParSol(1,4);
Standard_Real NewFirst = PFirst;
//are already in place at this stage.
//Modif lvt : the periodic cases are reframed, espercially if nothing was found.
Standard_Real w,uf = ct->FirstParameter(),ul = ct->LastParameter();
-#ifndef DEB
+
Standard_Real wbis = 0.;
-#else
- Standard_Real wbis;
-#endif
+
Standard_Boolean isperiodic = ct->IsPeriodic(),recadrebis = Standard_False;
Intersection.Perform(ct,fb);
if (Intersection.IsDone()) {
TopoDS_Edge Arcpiv,Arcprol,Arcspine;
if (isfirst) Arcspine = spine->Edges(1);
else Arcspine = spine->Edges(spine->NbEdges());
-#ifndef DEB
TopAbs_Orientation OArcprolv = TopAbs_FORWARD, OArcprolop = TopAbs_FORWARD;
-#else
- TopAbs_Orientation OArcprolv,OArcprolop;
-#endif
Standard_Integer ICurve;
Handle(BRepAdaptor_HSurface) HBs = new BRepAdaptor_HSurface();
Handle(BRepAdaptor_HSurface) HBad = new BRepAdaptor_HSurface();
Handle(Geom_Curve) Cc;
Handle(Geom2d_Curve) Pc,Ps;
Standard_Real Ubid,Vbid;//,mu,Mu,mv,Mv;
-#ifndef DEB
Standard_Real Udeb = 0.,Ufin = 0.;
-#else
- Standard_Real Udeb,Ufin;
-#endif
// gp_Pnt2d UVf1,UVl1,UVf2,UVl2;
// Standard_Real Du,Dv,Step;
Standard_Boolean inters = Standard_True;
TopoDS_Edge edgecouture;
Standard_Boolean couture,intcouture=Standard_False;;
Standard_Real tolreached;
-#ifndef DEB
Standard_Real par1 =0.,par2 =0.;
Standard_Integer indpt = 0,Icurv1 = 0,Icurv2 = 0;
-#else
- Standard_Real par1,par2;
- Standard_Integer indpt,Icurv1,Icurv2;
-#endif
Handle(Geom_TrimmedCurve) curv1,curv2;
Handle(Geom2d_Curve) c2d1,c2d2;
Standard_NotImplemented::Raise("OneCorner : bouchon non ecrit");
}
Standard_Integer IShape = DStr.AddShape(Fv);
-#ifndef DEB
TopAbs_Orientation Et = TopAbs_FORWARD;
-#else
- TopAbs_Orientation Et;
-#endif
if (IFadArc == 1) {
TopExp_Explorer Exp;
for (Exp.Init(Fv.Oriented(TopAbs_FORWARD),
// First of all the ponts are cut with the edge of the spine.
Standard_Integer IArcspine = DStr.AddShape(Arcspine);
Standard_Integer IVtx = DStr.AddShape(Vtx);
-#ifndef DEB
TopAbs_Orientation OVtx = TopAbs_FORWARD;
-#else
- TopAbs_Orientation OVtx;
-#endif
for(ex.Init(Arcspine.Oriented(TopAbs_FORWARD),TopAbs_VERTEX);
ex.More(); ex.Next()) {
if (Vtx.IsSame(ex.Current())) {
// gp_Pnt2d p2d;
Standard_Real dist;
Standard_Integer Ishape1=Fd->IndexOfS1();
-#ifndef DEB
TopAbs_Orientation trafil1 = TopAbs_FORWARD;
-#else
- TopAbs_Orientation trafil1;
-#endif
if (Ishape1 != 0) {
if (Ishape1 > 0) {
trafil1 = DStr.Shape(Ishape1).Orientation();
// storage for the face
//////////////////////////////////////////////////////////////////////
-#ifndef DEB
TopAbs_Orientation ori = TopAbs_FORWARD;
-#else
- TopAbs_Orientation ori;
-#endif
orface=Face[nb-1].Orientation();
if (orface==orsurfdata ) orien = TopAbs::Reverse(orcourbe);
else orien = orcourbe ;
if(isfirst) Arcspine = spine->Edges(1);
else Arcspine = spine->Edges(spine->NbEdges());
TopAbs_Orientation OArcprolbis;
-#ifndef DEB
TopAbs_Orientation OArcprolv = TopAbs_FORWARD, OArcprolop = TopAbs_FORWARD;
-#else
- TopAbs_Orientation OArcprolv, OArcprolop;
-#endif
Standard_Integer ICurve;
Handle(BRepAdaptor_HSurface) HBs = new BRepAdaptor_HSurface();
Handle(BRepAdaptor_HSurface) HBad = new BRepAdaptor_HSurface();
Handle(Geom_Curve) Cc;
Handle(Geom2d_Curve) Pc,Ps;
Standard_Real Ubid,Vbid;//,mu,Mu,mv,Mv;
-#ifndef DEB
Standard_Real Udeb = 0.,Ufin = 0.;
-#else
- Standard_Real Udeb,Ufin;
-#endif
//gp_Pnt2d UVf1,UVl1,UVf2,UVl2;
//Standard_Real Du,Dv,Step;
Standard_Boolean inters = Standard_True;
TopoDS_Edge edgecouture;
Standard_Boolean couture,intcouture=Standard_False;;
Standard_Real tolreached;
-#ifndef DEB
Standard_Real par1 = 0.,par2 = 0.;
Standard_Integer indpt =0,Icurv1 =0,Icurv2 =0;
-#else
- Standard_Real par1,par2;
- Standard_Integer indpt,Icurv1,Icurv2;
-#endif
Handle(Geom_TrimmedCurve) curv1,curv2;
Handle(Geom2d_Curve) c2d1,c2d2;
Standard_NotImplemented::Raise("OneCorner : cap not written");
}
Standard_Integer IShape = DStr.AddShape(Fv);
-#ifndef DEB
TopAbs_Orientation Et = TopAbs_FORWARD;
-#else
- TopAbs_Orientation Et;
-#endif
if(IFadArc == 1){
TopExp_Explorer Exp;
for (Exp.Init(Fv.Oriented(TopAbs_FORWARD),
Standard_Integer IArcspine = DStr.AddShape(Arcspine);
Standard_Integer IVtx = DStr.AddShape(Vtx);
TopAbs_Orientation OVtx2;
-#ifndef DEB
TopAbs_Orientation OVtx = TopAbs_FORWARD;
-#else
- TopAbs_Orientation OVtx;
-#endif
for(ex.Init(Arcspine.Oriented(TopAbs_FORWARD),TopAbs_VERTEX);
ex.More(); ex.Next()){
if(Vtx.IsSame(ex.Current())) {
// on the opposing face with the surface of the big,
// and finally intersect the big with the face at end
// between this point and the point on arc.
-#ifndef DEB
Standard_Boolean parcrois = Standard_False ;
-#else
- Standard_Boolean parcrois;
-#endif
TopExp_Explorer Expl;
for(Expl.Init(pivot.Oriented(TopAbs_FORWARD),TopAbs_VERTEX);
Expl.More(); Expl.Next()){
Handle (Geom2d_Curve)& pcurve)
{
Standard_Boolean isplane;
-#ifndef DEB
Standard_Boolean anglebig = Standard_False;
-#else
- Standard_Boolean anglebig;
-#endif
isplane=ASurf->GetType()==GeomAbs_Plane;
gp_Dir2d dir1 (xdir, ydir);
Geom2dLProp_CLProps2d CL1(curv2d1, picicplus, 1, 1.e-4);
TopAbs_Orientation & orien)
{ // orinterf is orientation of edge ic corresponding to face Fviveicicplus taken FORWARD
-#ifndef DEB
TopAbs_Orientation orinterf = TopAbs_FORWARD;
-#else
- TopAbs_Orientation orinterf;
-#endif
TopoDS_Face F=TopoDS::Face( Fviveicicplus);
TopoDS_Edge E=TopoDS::Edge( Eviveic);
TopExp_Explorer ex;
// between edges (or stripes ) icmoins and indfin.
// Then this courbe3d is projected on all faces (nbface) that
// separate icmoins and indfin
-#ifndef DEB
Standard_Integer nbface = 0;
-#else
- Standard_Integer nbface;
-#endif
Standard_Real error;
TColGeom2d_Array1OfCurve proj2d1(0,size);
TColGeom2d_Array1OfCurve proj2d2(0,size);
Standard_Boolean intersection=Standard_False, introuve;
if (nconges==2 && !deuxconges) {
gp_Pnt P1,P2,P3,P4;
-#ifndef DEB
Standard_Integer ic1 = 0,ic2 = 0;
-#else
- Standard_Integer ic1,ic2;
-#endif
trouve=Standard_False;
for (ic=0;ic<nedge&&!trouve;ic++) {
if (!sharp.Value(ic)){
else
Arcspine= CD.Value(ic)->Spine()->Edges(nbedge);
Standard_Integer IArcspine = DStr.AddShape(Arcspine);
-#ifndef DEB
TopAbs_Orientation OVtx = TopAbs_FORWARD;
-#else
- TopAbs_Orientation OVtx;
-#endif
for(ex.Init(Arcspine.Oriented(TopAbs_FORWARD),TopAbs_VERTEX);
ex.More(); ex.Next()){
if(V1.IsSame(ex.Current())) {
// the curves from ic to icplus the pcurves of Plate
// all have the same orientation
Standard_Integer Ishape1,Ishape2;
-#ifndef DEB
TopAbs_Orientation trafil1 = TopAbs_FORWARD, trafil2 = TopAbs_FORWARD;
-#else
- TopAbs_Orientation trafil1,trafil2;
-#endif
Ishape1 = Fd->IndexOfS1();
Ishape2 = Fd->IndexOfS2();
const ChFiDS_FaceInterference& Fi1 = Fd->InterferenceOnS1();
Standard_Real pitol = Precision::PIntersection();
ChFiKPart_RstMap M1, M2;
-#ifndef DEB
Standard_Integer iH1 = 0,iH2 = 0;
-#else
- Standard_Integer iH1,iH2;
-#endif
Standard_Integer Nb1 = 1,Nb2 = 1;
// Cutting of tangency lines (hatching).
Standard_Real ang = (u2-u1);
gp_Cone Co = AS.Cone();
Standard_Real rad = Co.RefRadius(), sang = Co.SemiAngle();
-//#ifndef DEB
Standard_Integer n = (Standard_Integer) (36.*ang/M_PI + 1);
-//#else
-// Standard_Integer n = 36.*ang/M_PI + 1;
-//#endif
if(n<2) n = 2;
sec = new ChFiDS_SecHArray1(1, n);
for (Standard_Integer i = 1; i <= n; i++) {
void ChFi3d_ChBuilder::ExtentTwoCorner(const TopoDS_Vertex& V,
const ChFiDS_ListOfStripe& LS)
{
-#ifndef DEB
Standard_Integer Sens = 0;
-#else
- Standard_Integer Sens;
-#endif
ChFiDS_ListIteratorOfListOfStripe itel(LS);
Standard_Boolean FF = Standard_True;
Standard_Boolean isfirst[2];
void ChFi3d_ChBuilder::ExtentThreeCorner(const TopoDS_Vertex& V,
const ChFiDS_ListOfStripe& LS)
{
-#ifndef DEB
Standard_Integer Sens = 0;
-#else
- Standard_Integer Sens;
-#endif
ChFiDS_ListOfStripe check;
Standard_Boolean isfirst[3];
Standard_Integer Iedge[3];
Standard_Integer ChFi3d_ChBuilder::FindChoiceDistAngle(const Standard_Integer Choice,
const Standard_Boolean DisOnF1) const
{
-#ifndef DEB
Standard_Integer ch = 0;
-#else
- Standard_Integer ch;
-#endif
if (!DisOnF1) {
switch (Choice) {
ChFi3d_FilletShape ChFi3d_FilBuilder::GetFilletShape() const
{
-#ifndef DEB
ChFi3d_FilletShape filshape = ChFi3d_Rational; // need to set default value
-#else
- ChFi3d_FilletShape filshape;
-#endif
switch (myShape) {
case BlendFunc_Rational:
filshape= ChFi3d_Rational;
Standard_Real ang = (u2-u1);
gp_Torus To = AS.Torus();
Standard_Real majr = To.MajorRadius(), minr = To.MinorRadius();
-//#ifndef DEB
Standard_Integer n = (Standard_Integer) (36.*ang/M_PI + 1);
-//#else
-// Standard_Integer n = 36.*ang/M_PI + 1;
-//#endif
if(n<2) n = 2;
sec = new ChFiDS_SecHArray1(1, n);
for (Standard_Integer i = 1; i <= n; i++) {
Standard_Real ang = (u2-u1);
gp_Sphere Sp = AS.Sphere();
Standard_Real rad = Sp.Radius();
-//#ifndef DEB
Standard_Integer n = (Standard_Integer) (36.*ang/M_PI + 1);
-//#else
-// Standard_Integer n = 36.*ang/M_PI + 1;
-//#endif
if(n<2) n = 2;
sec = new ChFiDS_SecHArray1(1, n);
for (Standard_Integer i = 1; i <= n; i++) {
{
// review by using the data at end of fillets (point, radius, normal
// to the faces and tangents of the guideline).
-#ifndef DEB
Standard_Integer Sens = 0;
-#else
- Standard_Integer Sens;
-#endif
Standard_Real Coeff = 0.5;
Handle(ChFiDS_Spine) Spine = S->Spine();
ChFi3d_IndexOfSurfData(V,S,Sens);
{
// Review by using the data at end of fillets (point, radius, normal
// to faces and tangents to the guideline.
-#ifndef DEB
Standard_Integer Sens = 0;
-#else
- Standard_Integer Sens;
-#endif
Standard_Real Coeff = 0.1;
ChFiDS_ListOfStripe check;
// Standard_Boolean FF = Standard_True;
yapiv = (pivot.IsSame(CP2.Arc()));
}
Handle(BRepAdaptor_HCurve) Hpivot;
-#ifndef DEB
Standard_Boolean sameparam = Standard_False;
Standard_Real parCP1 = 0., parCP2 = 0.;
-#else
- Standard_Boolean sameparam;
- Standard_Real parCP1, parCP2;
-#endif
if(yapiv) {
Hpivot = new BRepAdaptor_HCurve(pivot);
parCP1 = CP1.ParameterOnArc();
BRFaCo.Initialize(FaCo);
TopoDS_Face FF1,FF2,F,FaPiv;
-#ifndef DEB
TopAbs_Orientation pctrans = TopAbs_FORWARD ;
-#else
- TopAbs_Orientation pctrans;
-#endif
Handle(Geom2d_BSplineCurve) PCurveOnPiv;
FF1 = TopoDS::Face(DStr.Shape(sd1->Index(IFaArc1)));
FF2 = TopoDS::Face(DStr.Shape(sd2->Index(IFaArc2)));
}
Handle(ChFiDS_Stripe) stsam, stdif;
Handle(ChFiDS_SurfData) sdsam, sddif;
-#ifndef DEB
Standard_Real uintpcsam = 0., uintpcdif = 0.;
Standard_Integer ifacosam = 0, ifacodif = 0, ifaopsam = 0, ifaopdif = 0;
Standard_Boolean isfirstsam = Standard_False, isfirstdif = Standard_False;
-#else
- Standard_Real uintpcsam, uintpcdif;
- Standard_Integer ifacosam, ifacodif, ifaopsam, ifaopdif;
- Standard_Boolean isfirstsam, isfirstdif;
-#endif
if(Stat1 == ChFiDS_OnSame && Stat2 == ChFiDS_OnDiff){
stsam = st1; sdsam = sd1; uintpcsam = UIntPC1;
ifacosam = IFaCo1; ifaopsam = IFaArc1; isfirstsam = isfirst1;
Handle(Law_Composite) loi = new Law_Composite();
Law_Laws& list = loi->ChangeLaws();
-#ifndef DEB
Standard_Real Rdeb = 0., Rfin = 0., Rcur;
-#else
- Standard_Real Rdeb, Rfin, Rcur;
-#endif
Standard_Integer icur = 1;
Handle(Law_S) sl;
Handle(Law_Constant) lastloi;
return UFirst - fp;
case GeomAbs_Circle:
return C.Circle().Radius()*(UFirst-fp);
-#ifndef DEB
default:
break;
-#endif
}
Standard_NotImplemented::Raise("calcul abscisse not processed");
return 0.;
Handle(ChFiDS_FilSpine) Spine = Handle(ChFiDS_FilSpine)::DownCast(Sp);
Handle(ChFiDS_ChamfSpine) CSpine = Handle(ChFiDS_ChamfSpine)::DownCast(Sp);
-#ifndef DEB
Standard_Boolean surfok = Standard_False;
-#else
- Standard_Boolean surfok;
-#endif
GeomAbs_SurfaceType typ1 = S1->GetType();
GeomAbs_SurfaceType typ2 = S2->GetType();
GeomAbs_CurveType ctyp;
gp_Vec DirSOrC = VecTranslCyl.Normalized();
Standard_Real cosA1 = DirSOrC.Dot(VecTranslPln.Normalized());
Standard_Real sinA1 = Sqrt(1. - cosA1 * cosA1);
-#ifndef DEB
Standard_Real dis1 = 0.;
-#else
- Standard_Real dis1;
-#endif
Standard_Real dis2, ray = Cyl.Radius();
Standard_Boolean IsDisOnP = ( (plandab && DisOnP) || (!plandab && !DisOnP) );
// command
di << "COMMAND : ";
if (D->HasOpenCommand()) di << " Is Open";
-#ifndef DEB
else di << " Is Not Open";
-#else
- else " Is Not Open"; // ???
-#endif
// undo
di << "UNDO :";
di << " limit :" << D->GetUndoLimit();
C.SetLocation(pt);
Draw(C, 0, 2*M_PI, Standard_False);
break;
-#ifndef DEB
default:
break;
-#endif
}
Draw_Bounds = Standard_True;
position = BRep_Tool::Pnt(TopoDS::Vertex(ashape));
}
break;
-#ifndef DEB
default:
break;
-#endif
}
t+=aname; //Name();
Handle(Draw_Text3D) text = new Draw_Text3D (position,t.ToCString(),Draw_blanc);
length);
break;
}
-#ifndef DEB
default:
break;
-#endif
}
}
aDrawer->LengthAspect()->Arrow1Aspect()->Angle(),
aDrawer->LengthAspect()->Arrow1Aspect()->Length());
break;
-#ifndef DEB
default:
break;
-#endif
}
Prs3d_Root::CurrentGroup(aPrs)->EndPrimitives();
Standard_Integer max = NbOperands();
Handle(Expr_GeneralExpression) op;
Expr_SequenceOfGeneralExpression newops;
-#ifndef DEB
Standard_Real vals = 0.;
-#else
- Standard_Real vals;
-#endif
Standard_Integer nbvals = 0;
Standard_Boolean subprod = Standard_False;
for (i=1; (i<= max) && !subprod; i++) {
sumop = new Expr_Sum(newops);
return sumop->ShallowSimplified();
}
-#ifndef DEB
Standard_Real vals = 0.;
-#else
- Standard_Real vals;
-#endif
Standard_Boolean noone = Standard_True;
for (i = 1; i <= max ; i++) {
op = Operand(i);
case GeomAbs_Parabola:
E.Perform(P, C->Parabola(), Tol, -Precision::Infinite(),Precision::Infinite());
return;
-#ifndef DEB
default:
return;
-#endif
}
}
case GeomAbs_Parabola:
E.Perform(P, C->Parabola(), Tol, -Precision::Infinite(),Precision::Infinite());
return;
-#ifndef DEB
default:
return ;
-#endif
}
}
Standard_Integer GeomFill_SnglrFunc::NbIntervals(const GeomAbs_Shape S)
{
-#ifndef DEB
GeomAbs_Shape HCS=GeomAbs_C0;
-#else
- GeomAbs_Shape HCS;
-#endif
switch(S) {
case GeomAbs_C0: HCS = GeomAbs_C2; break;
case GeomAbs_C1: HCS = GeomAbs_C3; break;
void GeomFill_SnglrFunc::Intervals(TColStd_Array1OfReal& T,const GeomAbs_Shape S)
{
-#ifndef DEB
GeomAbs_Shape HCS=GeomAbs_C0;
-#else
- GeomAbs_Shape HCS ;
-#endif
switch(S) {
case GeomAbs_C0: HCS = GeomAbs_C2; break;
case GeomAbs_C1: HCS = GeomAbs_C3; break;
N = 3;
break;
}
-#ifndef DEB
default:
break;
-#endif
}
switch (C2) {
N += 3;
break;
}
-#ifndef DEB
default:
break;
-#endif
}
return N;
}
}
break;
}
-#ifndef DEB
default:
break;
-#endif
} else {
myXmin = myYmin = RealLast();
myXmax = myYmax = RealFirst();
,P);
break;
}
-#ifndef DEB
default:
break;
-#endif
}
return(Param);
ElCLib::HyperbolaD1(U,PConic.Axis2(),PConic.Param1(),
PConic.Param2(),Pt,Tan);
break;
-#ifndef DEB
default:
break;
-#endif
}
}
ElCLib::HyperbolaD2(U,PConic.Axis2(),PConic.Param1(),
PConic.Param2(),Pt,Tan,Norm);
break;
-#ifndef DEB
default:
break;
-#endif
}
}
,ThePConic.Param2(),P);
break;
}
-#ifndef DEB
default:
break;
-#endif
}
if(ParamInf!=ParamSup) {
if(Param<ParamInf) return(ParamInf);
,ThePConic.Param2(),P);
break;
}
-#ifndef DEB
default:
break;
-#endif
}
return(Param);
const Handle(Adaptor3d_TopolTool)& myDom2,
const Standard_Real TolArc) {
-#ifndef DEB
Standard_Integer i=1,nbvtx;
-#else
- Standard_Integer i,nbvtx;
-#endif
Standard_Real firstp,lastp;
Standard_Real Tol = Precision::PConfusion()*100.; // JMB le 13 Jan 2000. Report de la correction du PRO19653
GeomAbs_SurfaceType typs1 = mySurf1->GetType();
Standard_Integer colP = Pivotm1 - ligP * nbdeltaVp1;
// Point sur Edge position in the MaTriangle and edge typ :
-#ifndef DEB
Standard_Integer ligE = 0, colE = 0, typE = 0;
-#else
- Standard_Integer ligE, colE, typE;
-#endif
if (Pedge!=0) {
ligE= (Pedge-1)/nbdeltaVp1;
colE= (Pedge-1) - (ligE * nbdeltaVp1);
}
// Triangle position General case :
-#ifndef DEB
Standard_Integer linT = 0, colT = 0;
Standard_Integer linO = 0, colO = 0;
-#else
- Standard_Integer linT, colT;
- Standard_Integer linO, colO;
-#endif
Standard_Integer t,tt;
if (Triang!=0) {
t = (Triang-1)/(nbdeltaVm2);
Standard_Real pe2p= Cote.Dot(PE2);
Standard_Real pt1p= Cote.Dot(PT1);
Standard_Real pt2p= Cote.Dot(PT2);
-#ifndef DEB
Standard_Real lambda1 =0.,lambda2 =0.,alpha1 =0.,alpha2 =0.;
-#else
- Standard_Real lambda1,lambda2,alpha1,alpha2;
-#endif
IntPolyh_Point PEP1,PTP1,PEP2,PTP2;
if (pe1p>pe2p) {
Result.AddExtCur(0.0 , Standard_True);
}
break;
-#ifndef DEB
default:
break;
-#endif
}
}
TColStd_SequenceOfInteger Set2;
Standard_Real DistS1S2;
Standard_Integer IndiceLine1,IndiceLine2;
-#ifndef DEB
Standard_Integer ISuiv =0,MinOnSet1 =0,MinOnSet2 =0;
-#else
- Standard_Integer ISuiv,MinOnSet1,MinOnSet2;
-#endif
//---------------------------------------------------------------------------
// - 0 Set1 est initialise avec la ligne de depart.
// Set2 contient toutes les autres.
const Standard_Integer IL2) const
{
Extrema_POnCurv2d PointOnCurv1,PointOnCurv2;
-#ifndef DEB
Standard_Integer IC1,IC2,IMinC1 =0,IMinC2 =0,i;
-#else
- Standard_Integer IC1,IC2,IMinC1,IMinC2,i;
-#endif
Standard_Real DistL1L2_2,DistP1P2_2;
-#ifndef DEB
Standard_Real ParameterOnC1 =0.,ParameterOnC2 =0.;
-#else
- Standard_Real ParameterOnC1,ParameterOnC2;
-#endif
TColGeom2d_SequenceOfGeometry L1,L2;
gp_Pnt2d Point1,Point2,P1,P2;
Handle(Geom2d_Curve) Item1;
//TrTool.UpdateCompound(aShape,pHShape);
TrTool->UpdateShape(aShape,pHShape);
break;
-#ifndef DEB
default:
break;
-#endif
}
// bind and copy the sub-elements
//TrTool.UpdateCompound(aHShape,theShape);
TrTool->UpdateShape(aHShape,theShape);
break;
-#ifndef DEB
default:
break;
-#endif
}
// bind and copy the sub-elements
TrTool->MakeCompound(aPShape);
TrTool->UpdateShape(aShape,aPShape);
break;
-#ifndef DEB
default:
break;
-#endif
}
// bind and copy the sub-elements
//TrTool.UpdateCompound(aPShape,aShape);
TrTool->UpdateShape(aPShape,aShape);
break;
-#ifndef DEB
default:
break;
-#endif
}
// bind and copy the sub-elements
buffer += "Lock is already blocked by another process";
extCode = ERR_FDEADLK;
break;
-#ifndef DEB
default:
break;
-#endif
}
break;
#endif
buffer += "File is locked";
extCode = ERR_FLOCKED;
break;
-#ifndef DEB
default:
break;
-#endif
}
break;
#endif
buffer += "File is locked";
extCode = ERR_FLOCKED;
break;
-#ifndef DEB
default:
break;
-#endif
}
break;
#endif
MacExtract(aDependentName,myDisk,myTrek,myName,myExtension);
break;
default:
-#ifndef DEB
+#ifdef DEB
cout << " WARNING WARNING : OSD Path for an Unknown SYSTEM : " << (Standard_Integer)todo << endl;
#endif
break ;
case _T_LSTR: {
ProcessParamVal (NULL, FLAG_DEFVAL, myDefValue);
} break;
-#ifndef DEB
default:
break ;
-#endif
}
// Check the configuration
if (myFlags & FLAG_DEFVAL && myDefValue.IsEmpty())
GeomAbs_CurveType Type = C->GetType();
gp_Ax2 Axis;
-#ifndef DEB
Standard_Real R1 =0., R2 =0.;
-#else
- Standard_Real R1, R2;
-#endif
if ( Type != GeomAbs_Line) // on garde le parametrage
myKeepParam = Standard_True;
{
theBuilder.Select(theNS, theOS);
}
-#ifndef DEB
default:
break;
-#endif
}
}
const Standard_Real aTol,
Standard_Real& DMin)
{
-#ifndef DEB
Standard_Real DMin2 = 0.;
-#else
- Standard_Real DMin2;
-#endif
Standard_Real Xmin,Ymin,Xmax,Ymax;
if(!Bnd_Box2d(mybox2d).IsVoid())
{
case Select3D_TOS_INTERIOR:
Res = Status(X,Y,aTol,DMin);
return (Res==0 || Res == 1);
-#ifndef DEB
default:
break;
-#endif
}
return Standard_True;
}
Sel->UpdateStatus(SelectMgr_TOU_None);
break;
}
-#ifndef DEB
default:
break;
-#endif
}
curview->Activate(Sel,AutomaticProj);
anObject->UpdateLocation(Sel);
break;
}
-#ifndef DEB
default:
break;
-#endif
}
Sel->UpdateStatus(SelectMgr_TOU_None);
case SelectMgr_TOU_Partial:
anObject->UpdateLocation(Sel);
break;
-#ifndef DEB
default:
break;
-#endif
}
if(Found){
VS->Convert(Sel);
anObject->UpdateLocation(Sel);
wasrecomputed = Standard_True;
break;
-#ifndef DEB
default:
break;
-#endif
}
Sel->UpdateStatus(SelectMgr_TOU_None);
}
anObject->UpdateLocation(Sel);
wasrecomputed = Standard_True;
break;
-#ifndef DEB
default:
break;
-#endif
}
if(wasrecomputed)
VS->Convert(Sel);
anObject->UpdateLocation(Sel);
wasrecomputed = Standard_True;
break;
-#ifndef DEB
default:
break;
-#endif
}
Sel->UpdateStatus(SelectMgr_TOU_None);
}
anObject->UpdateLocation(Sel);
wasrecomputed = Standard_True;
break;
-#ifndef DEB
default:
break;
-#endif
}
if(wasrecomputed)
aViewSel->Convert(Sel);
else if (o == BOOP_C12 || o == BOOP_C21 || o == BOOP_COM || o == BOOP_FUS) {
-#ifndef DEB
TopAbs_State t1=TopAbs_UNKNOWN,t2=TopAbs_UNKNOWN;
-#else
- TopAbs_State t1,t2;
-#endif
if (o == BOOP_C12) { t1 = TopAbs_OUT; t2 = TopAbs_IN; }
else if (o == BOOP_C21) { t1 = TopAbs_IN; t2 = TopAbs_OUT; }
else if (o == BOOP_COM) { t1 = TopAbs_IN; t2 = TopAbs_IN; }
Poin.Tolerance(tol);
break;
}
-#ifndef DEB
default:
break;
-#endif
}
TopOpeBRepDS::Print(K, index, cout);
cout<<endl;
// SeeAnyKI
//-----------------------------------------------------------------------
Standard_Integer SeeAnyKI(const TopOpeBRepDS_Kind TK,const Standard_Integer I) {
-#ifndef DEB
TopAbs_ShapeEnum TS = TopAbs_COMPOUND;
-#else
- TopAbs_ShapeEnum TS;
-#endif
Standard_Boolean isshape,isgeome; isshape = isgeome = Standard_False;
isshape = TopOpeBRepDS::IsTopology(TK);
if (isshape) TS = TopOpeBRepDS::KindToShape(TK);
P = SU.Value(u,v);
}
break;
-#ifndef DEB
default:
break;
-#endif
}
return P;
// appendtoG = Standard_True;
// BDS.ChangePointInterferences(G).Append(I);
break;
-#ifndef DEB
default:
break;
-#endif
-
}
#ifdef DEB
return;
mySectEdgeDSCurve.Clear();
myMakeCurveAncestorIsDone = Standard_True;
-#ifndef DEB
-// static const TopOpeBRepDS_DataStructure& DS = DataStructure()->DS();
- const TopOpeBRepDS_DataStructure& DS = DataStructure()->DS(); // How to do static <--> const
-#else
const TopOpeBRepDS_DataStructure& DS = DataStructure()->DS();
-#endif
TopTools_ListIteratorOfListOfShape itloe;
TopOpeBRepDS_CurveExplorer cex(DS,Standard_True);
// Standard_Integer ic, icm;
static Standard_Integer FUN_getAncestorFsp(TopOpeBRepBuild_Builder& B,TopOpeBRepTool_ShapeClassifier& SC,const TopTools_ListOfShape& LF,const TopoDS_Shape& fsp,Standard_Boolean& p3ddef,gp_Pnt& p3d)
{
-#ifndef DEB
-// static const TopOpeBRepDS_DataStructure& BDS = B.DataStructure()->DS();
const TopOpeBRepDS_DataStructure& BDS = B.DataStructure()->DS(); // How to do static <--> const
-#else
- const TopOpeBRepDS_DataStructure& BDS = B.DataStructure()->DS();
-#endif
+
TopTools_ListIteratorOfListOfShape itf(LF);
for (; itf.More(); itf.Next()){
const TopoDS_Face& f = TopoDS::Face(itf.Value());
{
// IMPORTANT : fsp is split IN/OUT of F1,so it has only one ancestor face
// LF1 faces sdm with LF2
-#ifndef DEB
- const TopOpeBRepDS_DataStructure& BDS = B.DataStructure()->DS();
-#else
const TopOpeBRepDS_DataStructure& BDS = B.DataStructure()->DS();
-#endif
Standard_Boolean of1,of2; FUNBUILD_ANCESTORRANKGET(B,fsp,of1,of2);
Standard_Integer rkfsp = 0;
if (of1 && !of2) rkfsp = 1;
Standard_Integer iF; Standard_Boolean tSPS = GtraceSPS(FOR,iF);
if(tSPS)cout<<endl;
#endif
-#ifndef DEB
-// static const TopOpeBRepDS_DataStructure& BDS = myDataStructure->DS();
- const TopOpeBRepDS_DataStructure& BDS = myDataStructure->DS();
-#else
const TopOpeBRepDS_DataStructure& BDS = myDataStructure->DS();
-#endif
Standard_Boolean tosplit = GToSplit(FOR,TB1);
Standard_Boolean tomerge = GToMerge(FOR);
#ifdef DEB