diff --git a/src/Adaptor3d/Adaptor3d_TopolTool.cxx b/src/Adaptor3d/Adaptor3d_TopolTool.cxx index 81319ac31b..6ce96fd440 100644 --- a/src/Adaptor3d/Adaptor3d_TopolTool.cxx +++ b/src/Adaptor3d/Adaptor3d_TopolTool.cxx @@ -933,6 +933,7 @@ void Adaptor3d_TopolTool::BSplSamplePnts(const Standard_Real theDefl, const Standard_Integer theNUmin, const Standard_Integer theNVmin) { + const Standard_Integer aMaxPnts = 1001; const Handle(Geom_BSplineSurface)& aBS = myS->BSpline(); Standard_Real uinf,usup,vinf,vsup; uinf = myS->FirstUParameter(); usup = myS->LastUParameter(); @@ -999,11 +1000,20 @@ void Adaptor3d_TopolTool::BSplSamplePnts(const Standard_Real theDefl, nbsu = theNUmin; bUuniform = Standard_True; } - + else if (nbsu > aMaxPnts) + { + nbsu = aMaxPnts; + bUuniform = Standard_True; + } if(nbsv < theNVmin) { nbsv = theNVmin; bVuniform = Standard_True; } + else if (nbsv > aMaxPnts) + { + nbsv = aMaxPnts; + bVuniform = Standard_True; + } TColStd_Array1OfReal anUPars(1, nbsu); TColStd_Array1OfBoolean anUFlg(1, nbsu); diff --git a/src/Approx/Approx_SameParameter.cxx b/src/Approx/Approx_SameParameter.cxx index 54a8b569e2..7258312053 100644 --- a/src/Approx/Approx_SameParameter.cxx +++ b/src/Approx/Approx_SameParameter.cxx @@ -14,7 +14,6 @@ // Alternatively, this file may be used under the terms of Open CASCADE // commercial license or contractual agreement. -// Modified by skv - Wed Jun 2 11:49:59 2004 OCC5898 #include #include @@ -25,22 +24,20 @@ #include #include #include -#include #include #include #include #include #include #include -#include #include #include -#include #include #include #include #include #include +#include //======================================================================= //class : Approx_SameParameter_Evaluator @@ -125,7 +122,7 @@ static void ProjectPointOnCurve(const Standard_Real InitValue, Standard_Boolean& Status, Standard_Real& Result) { - Standard_Integer num_iter = 0, not_done = 1, ii; + Standard_Integer num_iter = 0, not_done = 1; gp_Pnt a_point; gp_Vec vector, d1, d2; @@ -136,8 +133,7 @@ static void ProjectPointOnCurve(const Standard_Real InitValue, { num_iter++; Curve.D2(param, a_point, d1, d2); - for (ii = 1 ; ii <= 3 ; ii++) - vector.SetCoord(ii, APoint.Coord(ii) - a_point.Coord(ii)); + vector = gp_Vec(a_point,APoint); func = vector.Dot(d1); if ( Abs(func) < Tolerance * d1.Magnitude()) @@ -189,7 +185,7 @@ static Standard_Real ComputeTolReached(const Handle(Adaptor3d_HCurve)& c3d, d2 = Max(d2, Pc3d.SquareDistance(Pcons)); } - const Standard_Real aMult = 1.5; // To be tolerant to discrete tolerance computing. + const Standard_Real aMult = 1. + 0.05; // Standard_Real aDeviation = aMult * sqrt(d2); aDeviation = Max(aDeviation, Precision::Confusion()); // Tolerance in modeling space. return aDeviation; @@ -199,11 +195,10 @@ static Standard_Real ComputeTolReached(const Handle(Adaptor3d_HCurve)& c3d, //function : Check //purpose : Check current interpolation for validity. //======================================================================= -static Standard_Boolean Check(const TColStd_Array1OfReal& FlatKnots, +static Standard_Boolean Check(const TColStd_Array1OfReal& FlatKnots, const TColStd_Array1OfReal& Poles, const Standard_Integer nbp, - const TColStd_Array1OfReal& pc3d, - const TColStd_Array1OfReal& , + const Standard_Real *pc3d, const Handle(Adaptor3d_HCurve)& c3d, const Adaptor3d_CurveOnSurface& cons, Standard_Real& tol, @@ -217,8 +212,8 @@ static Standard_Boolean Check(const TColStd_Array1OfReal& FlatKnots, // it fixes the bug OCC5898. To develop more or less sensible criterion it is // necessary to deeply investigate this problem which is not possible in frames // of debugging. - Standard_Real aParamFirst = 3.0 * pc3d(1) - 2.0 * pc3d(nbp); - Standard_Real aParamLast = 3.0 * pc3d(nbp) - 2.0 * pc3d(1); + Standard_Real aParamFirst = 3.0 * pc3d[0] - 2.0 * pc3d[nbp - 1]; + Standard_Real aParamLast = 3.0 * pc3d[nbp - 1] - 2.0 * pc3d[0]; Standard_Real FirstPar = cons.FirstParameter(); Standard_Real LastPar = cons.LastParameter(); @@ -227,27 +222,29 @@ static Standard_Boolean Check(const TColStd_Array1OfReal& FlatKnots, if (aParamLast > LastPar) aParamLast = LastPar; - Standard_Real d2 = 0.0; // Maximum square deviation on the samples. const Standard_Real d = tol; const Standard_Integer nn = 2 * nbp; - const Standard_Real unsurnn = 1.0/nn; + const Standard_Real unsurnn = 1.0 / nn; + Standard_Real tprev = aParamFirst; for(Standard_Integer i = 0; i <= nn; i++) { // Compute corresponding parameter on 2d curve. // It should be inside of 3d curve parameter space. Standard_Real t = unsurnn*i; - Standard_Real tc3d = pc3d(1)*(1.-t) + pc3d(nbp)*t; + Standard_Real tc3d = pc3d[0]*(1.0 - t) + pc3d[nbp - 1] * t; // weight function. gp_Pnt Pc3d = c3d->Value(tc3d); Standard_Real tcons; - BSplCLib::Eval(tc3d,Standard_False,0,extrap_mode[0], - aDegree,FlatKnots,1, (Standard_Real&)Poles(1),tcons); - if (tcons < aParamFirst || + BSplCLib::Eval(tc3d, Standard_False, 0, extrap_mode[0], + aDegree, FlatKnots, 1, (Standard_Real&)Poles(1), tcons); + + if (tcons < tprev || tcons > aParamLast) { tol = Precision::Infinite(); return Standard_False; } + tprev = tcons; gp_Pnt Pcons = cons.Value(tcons); Standard_Real temp = Pc3d.SquareDistance(Pcons); if(temp > d2) d2 = temp; @@ -275,7 +272,8 @@ Approx_SameParameter::Approx_SameParameter(const Handle(Geom_Curve)& C3D, const Handle(Geom2d_Curve)& C2D, const Handle(Geom_Surface)& S, const Standard_Real Tol) -: mySameParameter(Standard_True), +: myDeltaMin(Precision::PConfusion()), + mySameParameter(Standard_True), myDone(Standard_False) { myHCurve2d = new Geom2dAdaptor_HCurve(C2D); @@ -292,7 +290,8 @@ Approx_SameParameter::Approx_SameParameter(const Handle(Adaptor3d_HCurve)& C3D const Handle(Geom2d_Curve)& C2D, const Handle(Adaptor3d_HSurface)& S, const Standard_Real Tol) -: mySameParameter(Standard_True), +: myDeltaMin(Precision::PConfusion()), + mySameParameter(Standard_True), myDone(Standard_False) { myC3d = C3D; @@ -309,7 +308,8 @@ Approx_SameParameter::Approx_SameParameter(const Handle(Adaptor3d_HCurve)& C3D const Handle(Adaptor2d_HCurve2d)& C2D, const Handle(Adaptor3d_HSurface)& S, const Standard_Real Tol) -: mySameParameter(Standard_True), +: myDeltaMin(Precision::PConfusion()), + mySameParameter(Standard_True), myDone(Standard_False) { myC3d = C3D; @@ -324,525 +324,174 @@ Approx_SameParameter::Approx_SameParameter(const Handle(Adaptor3d_HCurve)& C3D //======================================================================= void Approx_SameParameter::Build(const Standard_Real Tolerance) { - const Standard_Real anErrorMAX = 1.0e15; - const Standard_Integer aMaxArraySize = 1000; - const Standard_Integer NCONTROL = 22; + // Algorithm: + // 1) Build initial distribution. Increase number of samples in case of C0 continuity. + // 2.1) Check same parameter state on samples. + // 2.2) Compute parameters in 2d space if not same parameter. + // 3) Loop over poles number and try to interpolate 2d curve. + // 4) If loop is failed build 2d curve forcibly or use original pcurve. + Standard_Real qpcons[myMaxArraySize], qnewpcons[myMaxArraySize], + qpc3d[myMaxArraySize], qnewpc3d[myMaxArraySize]; - Standard_Integer ii ; - Adaptor3d_CurveOnSurface CurveOnSurface(myHCurve2d,mySurf); - Standard_Real fcons = CurveOnSurface.FirstParameter(); - Standard_Real lcons = CurveOnSurface.LastParameter(); - Standard_Real fc3d = myC3d->FirstParameter(); - Standard_Real lc3d = myC3d->LastParameter(); + // Create and fill data structure. + Approx_SameParameter_Data aData; + aData.myCOnS = Adaptor3d_CurveOnSurface(myHCurve2d,mySurf); + aData.myC2dPF = aData.myCOnS.FirstParameter(); + aData.myC2dPL = aData.myCOnS.LastParameter(); + aData.myC3dPF = myC3d->FirstParameter(); + aData.myC3dPL = myC3d->LastParameter(); + aData.myNbPnt = 0; // No points initially. + aData.myPC2d = qpcons; + aData.myPC3d = qpc3d; + aData.myNewPC2d = qnewpcons; + aData.myNewPC3d = qnewpc3d; + aData.myTol = Tolerance; - //Control tangents at the extremities to know if the - //reparametring is possible and calculate the tangents - //at the extremities of the function of change of variable. - Standard_Real tangent[2] = { 0.0, 0.0 }; - gp_Pnt Pcons,Pc3d; - gp_Vec Vcons,Vc3d; - - const Standard_Real Tol = Tolerance; - const Standard_Real Tol2 = Tol * Tol; - Standard_Real deltamin = Precision::PConfusion(); - - Standard_Real besttol2 = Tol2; - - // Check tangency on curve border. - Standard_Boolean extrok = 1; - CurveOnSurface.D1(fcons,Pcons,Vcons); - myC3d->D1(fc3d,Pc3d,Vc3d); - Standard_Real dist2 = Pcons.SquareDistance(Pc3d); - Standard_Real dmax2 = dist2; - - Standard_Real magVcons = Vcons.Magnitude(); - if (magVcons > 1.e-12) - tangent[0] = Vc3d.Magnitude() / magVcons; - else extrok = 0; - - CurveOnSurface.D1(lcons,Pcons,Vcons); - myC3d->D1(lc3d,Pc3d,Vc3d); - dist2 = Pcons.SquareDistance(Pc3d); - - dmax2 = Max(dmax2, dist2); - magVcons = Vcons.Magnitude(); - if (magVcons > 1.e-12) - tangent[1] = Vc3d.Magnitude() / magVcons; - else extrok = 0; - - - //Take a multiple of the sample pof CheckShape, - //at least the control points will be correct. No comment!!! - - Standard_Boolean interpolok = 0; - Standard_Real tolsov = 1.e200; - //Take parameters with constant step on the curve on surface - //and on curve 3d. - Standard_Real deltacons = lcons - fcons; - deltacons /= (NCONTROL); - Standard_Real deltac3d = lc3d - fc3d; - deltac3d /= (NCONTROL); - - Standard_Real wcons = fcons; - Standard_Real wc3d = fc3d; - - Standard_Real qpcons[aMaxArraySize], qnewpcons[aMaxArraySize], - qpc3d[aMaxArraySize], qnewpc3d[aMaxArraySize]; - Standard_Real * pcons = qpcons; Standard_Real * newpcons = qnewpcons; - Standard_Real * pc3d = qpc3d; Standard_Real * newpc3d = qnewpc3d; - - for ( ii = 0 ; ii < NCONTROL; ii++) { - pcons[ii] = wcons; - pc3d[ii] = wc3d; - wcons += deltacons; - wc3d += deltac3d; - } - pcons[NCONTROL] = lcons; - pc3d[NCONTROL] = lc3d; - - // Change number of points in case of C0 continuity. - Standard_Integer New_NCONTROL = NCONTROL; - GeomAbs_Shape Continuity = myHCurve2d->Continuity(); - if(Continuity > GeomAbs_C1) Continuity = GeomAbs_C1; - if(Continuity < GeomAbs_C1) + // Build initial distribution. + if (!BuildInitialDistribution(aData)) { - Standard_Integer NbInt = myHCurve2d->NbIntervals(GeomAbs_C1) + 1; - TColStd_Array1OfReal Param_de_decoupeC1 (1, NbInt); - myHCurve2d->Intervals(Param_de_decoupeC1, GeomAbs_C1); - TColStd_SequenceOfReal new_par; - Standard_Integer inter = 1; - ii =1; - new_par.Append(fcons); + mySameParameter = Standard_False; + myDone = Standard_False; + return; + } - while(inter <= NbInt && Param_de_decoupeC1(inter) <= fcons + deltamin) inter++; - while(NbInt > 0 && Param_de_decoupeC1(NbInt) >= lcons - deltamin) NbInt--; - - while(inter <= NbInt || (ii < NCONTROL && inter <= Param_de_decoupeC1.Length()) ) { - if(Param_de_decoupeC1(inter) < pcons[ii]) { - new_par.Append(Param_de_decoupeC1(inter)); - if((pcons[ii] - Param_de_decoupeC1(inter)) <= deltamin) { - ii++; - if(ii > NCONTROL) {ii = NCONTROL;} - } - inter++; - } - else { - if((Param_de_decoupeC1(inter) - pcons[ii]) > deltamin) { - new_par.Append(pcons[ii]); - } - ii++; - } - } - - new_par.Append(lcons); - New_NCONTROL = new_par.Length() - 1; - // Simple protection if New_NCONTROL > allocated elements in array but one - // aMaxArraySize - 1 index may be filled after projection. - if (New_NCONTROL > aMaxArraySize - 1) { - mySameParameter = Standard_False; + // Check same parameter state on distribution. + Standard_Real aMaxSqDeviation = 0.0; + const Standard_Real aPercentOfBadProj = 0.3; + Standard_Integer aNbPnt = aData.myNbPnt - RealToInt(aPercentOfBadProj * aData.myNbPnt); + mySameParameter = CheckSameParameter(aData, aMaxSqDeviation); + if(mySameParameter) + { + myTolReached = ComputeTolReached(myC3d, aData.myCOnS, 2 * myNbSamples); + myDone = Standard_True; + return; + } + else + { + // Control number of sample points after checking sameparameter + // If number of points is less then initial one, it means that there are + // problems with projection + if(aData.myNbPnt < aNbPnt ) + { + myTolReached = ComputeTolReached(myC3d,aData.myCOnS, 2 * myNbSamples); + myCurve2d = Geom2dAdaptor::MakeCurve(myHCurve2d->Curve2d()); + myDone = Standard_False; return; } - for(ii = 1; ii <= New_NCONTROL; ii++){ - pcons[ii] = pc3d[ii] = new_par.Value(ii + 1); - } - pc3d[New_NCONTROL] = lc3d; } - // Check existing same parameter state. - Extrema_LocateExtPC Projector; - Projector.Initialize(myC3d->Curve(),fc3d,lc3d,Tol); - - Standard_Integer count = 1; - Standard_Real previousp = fc3d, initp=0, curp; - Standard_Real bornesup = lc3d - deltamin; - Standard_Boolean projok = 0, - use_parameter ; - for (ii = 1; ii < New_NCONTROL; ii++){ - CurveOnSurface.D0(pcons[ii],Pcons); - myC3d->D0(pc3d[ii],Pc3d); - dist2 = Pcons.SquareDistance(Pc3d); - use_parameter = (dist2 <= Tol2 && (pc3d[ii] > pc3d[count-1] + deltamin)) ; - Standard_Real aDistMin = RealLast(); - if(use_parameter) { - - if(dist2 > dmax2) dmax2 = dist2; - initp = previousp = pc3d[count] = pc3d[ii]; - pcons[count] = pcons[ii]; - count++; - - } - else { - if(!projok) initp = pc3d[ii]; - projok = mySameParameter = Standard_False; - Projector.Perform(Pcons, initp); - if (Projector.IsDone()) { - curp = Projector.Point().Parameter(); - Standard_Real dist_2 = Projector.SquareDistance(); - projok = Standard_True; - aDistMin = dist_2; - } - else - { - ProjectPointOnCurve(initp,Pcons,Tol,30,myC3d->Curve(),projok,curp); - if(projok) - { - const gp_Pnt& ap1 =myC3d->Value(curp); - aDistMin = Pcons.SquareDistance(ap1); - } - } - projok = (projok && (curp > previousp + deltamin && curp < bornesup)); - if(projok) - { - initp = previousp = pc3d[count] = curp; - pcons[count] = pcons[ii]; - count++; - - } - else - { - Extrema_ExtPC PR(Pcons,myC3d->Curve(),fc3d,lc3d,Tol); - if(PR.IsDone()) - { - const Standard_Integer aNbExt = PR.NbExt(); - if(aNbExt > 0) - { - Standard_Integer anIndMin = 0; - Standard_Real aCurDistMin = RealLast(); - for(Standard_Integer i = 1; i <= aNbExt; i++) - { - const gp_Pnt &aP = PR.Point(i).Value(); - Standard_Real aDist2 = aP.SquareDistance(Pcons); - if(aDist2 < aCurDistMin) - { - aCurDistMin = aDist2; - anIndMin = i; - } - } - if(anIndMin) - { - curp = PR.Point(anIndMin).Parameter(); - if( curp > previousp + deltamin && curp < bornesup) - { - aDistMin = aCurDistMin; - initp = previousp = pc3d[count] = curp; - pcons[count] = pcons[ii]; - count++; - projok = Standard_True; - - } - } - - } - } - } - if(projok && besttol2 < aDistMin) - besttol2 = aDistMin; - - else if(!projok) - { - //Projector -#ifdef OCCT_DEBUG - std::cout << "Projection not done" << std::endl; -#endif - } - } - } - - if(mySameParameter){ - myTolReached = 1.5*sqrt(dmax2); - return; - } - - if(!extrok) + // Control tangents at the extremities to know if the + // reparametring is possible and calculate the tangents + // at the extremities of the function of change of variable. + Standard_Real tangent[2] = { 0.0, 0.0 }; + if(!ComputeTangents(aData.myCOnS, tangent[0], tangent[1])) { - // If not already SameP and tangent to mill, abandon. + // Cannot compute tangents. mySameParameter = Standard_False; -#ifdef OCCT_DEBUG - std::cout<<"SameParameter problem : zero tangent to extremities"<Continuity(); + if(aContinuity > GeomAbs_C1) aContinuity = GeomAbs_C1; + + Standard_Real besttol2 = aData.myTol * aData.myTol, + tolsov = Precision::Infinite(); + Standard_Boolean interpolok = Standard_False, + hasCountChanged = Standard_False; do { - // The tables and their limits for the interpolation. - Standard_Integer num_knots = count + 7; - Standard_Integer num_poles = count + 3; - TColStd_Array1OfReal Paramc3d(*pc3d,1,count+1); - TColStd_Array1OfReal Paramcons(*pcons,1,count+1); - TColStd_Array1OfInteger ContactOrder(1,num_poles) ; - TColStd_Array1OfReal Poles(1,num_poles) ; - TColStd_Array1OfReal InterpolationParameters(1,num_poles) ; - TColStd_Array1OfReal FlatKnots(1,num_knots) ; + // Interpolation data. + Standard_Integer num_knots = aData.myNbPnt + 7; + Standard_Integer num_poles = aData.myNbPnt + 3; + TColStd_Array1OfReal Poles(1, num_poles); + TColStd_Array1OfReal FlatKnots(1 ,num_knots); - // Fill tables taking attention to end values. - ContactOrder.Init(0); - ContactOrder(2) = ContactOrder(num_poles - 1) = 1; - - FlatKnots(1) = FlatKnots(2) = FlatKnots(3) = FlatKnots(4) = fc3d; - FlatKnots(num_poles + 1) = FlatKnots(num_poles + 2) = - FlatKnots(num_poles + 3) = FlatKnots(num_poles + 4) = lc3d; - - Poles(1) = fcons; Poles(num_poles) = lcons; - Poles(2) = tangent[0]; Poles(num_poles - 1) = tangent[1]; - - InterpolationParameters(1) = InterpolationParameters(2) = fc3d; - InterpolationParameters(num_poles - 1) = InterpolationParameters(num_poles) = lc3d; - - for (ii = 3; ii <= num_poles - 2; ii++) { - Poles(ii) = Paramcons(ii - 1); - InterpolationParameters(ii) = FlatKnots(ii+2) = Paramc3d(ii - 1); - } - Standard_Integer inversion_problem; - BSplCLib::Interpolate(3,FlatKnots,InterpolationParameters,ContactOrder, - 1,Poles(1),inversion_problem); - if(inversion_problem) { - throw Standard_ConstructionError(); - } - - // Test if par2d(par3d) is monotonous function or not ----- IFV, Jan 2000 - // and try to insert new point to improve BSpline interpolation - - Standard_Integer extrap_mode[2] ; - extrap_mode[0] = extrap_mode[1] = 3; - Standard_Real eval_result[2] ; - Standard_Integer DerivativeRequest = 0; - Standard_Real *PolesArray = - (Standard_Real *) &Poles(Poles.Lower()) ; - - Standard_Integer newcount = 0; - for (ii = 0; ii < count; ii++) { - - newpcons[newcount] = pcons[ii]; - newpc3d[newcount] = pc3d[ii]; - newcount++; - - if(count - ii + newcount == aMaxArraySize) continue; - - BSplCLib::Eval(.5*(pc3d[ii]+pc3d[ii+1]), Standard_False, DerivativeRequest, - extrap_mode[0], 3, FlatKnots, 1, PolesArray[0], eval_result[0]); - - if(eval_result[0] < pcons[ii] || eval_result[0] > pcons[ii+1]) { - Standard_Real ucons = 0.5*(pcons[ii]+pcons[ii+1]); - Standard_Real uc3d = 0.5*(pc3d[ii]+pc3d[ii+1]); - - CurveOnSurface.D0(ucons,Pcons); - Projector.Perform(Pcons, uc3d); - if (Projector.IsDone()) { - curp = Projector.Point().Parameter(); - Standard_Real dist_2 = Projector.SquareDistance(); - if(dist_2 > besttol2) besttol2 = dist_2; - projok = 1; - } - else { - ProjectPointOnCurve(uc3d,Pcons,Tol,30,myC3d->Curve(),projok,curp); - } - if(projok){ - if(curp > pc3d[ii] + deltamin && curp < pc3d[ii+1] - deltamin){ - newpc3d[newcount] = curp; - newpcons[newcount] = ucons; - newcount ++; - } - } - else { -#ifdef OCCT_DEBUG - std::cout << "Projection not done" << std::endl; -#endif - } - } - - } - - newpc3d[newcount] = pc3d[count]; - newpcons[newcount] = pcons[count]; - Standard_Real * temp; - temp = pc3d; - pc3d = newpc3d; - newpc3d = temp; - temp = pcons; - pcons = newpcons; - newpcons = temp; - - if((count != newcount) && newcount < aMaxArraySize) + if (!Interpolate(aData, tangent[0], tangent[1], Poles, FlatKnots)) { - hasCountChanged = Standard_True; - count = newcount; - continue; - } - - count = newcount; - - Standard_Real algtol = sqrt(besttol2); - - interpolok = Check (FlatKnots, Poles, count+1, Paramc3d, Paramcons, - myC3d, CurveOnSurface, algtol, tolsov); - - if (Precision::IsInfinite(algtol)) { + // Interpolation fails. mySameParameter = Standard_False; -#ifdef OCCT_DEBUG - std::cout<<"SameParameter problem : function of interpolation of parametration at mills !!"<= aMaxArraySize - 1 ); // Number of points. - - if(interpolok) { + // Try to build 2d curve and check it for validity. + if(interpolok) + { Standard_Real besttol = sqrt(besttol2); Handle(TColStd_HArray1OfReal) tol1d,tol2d,tol3d; - tol1d = new TColStd_HArray1OfReal(1,2) ; + tol1d = new TColStd_HArray1OfReal(1,2); tol1d->SetValue(1, mySurf->UResolution(besttol)); tol1d->SetValue(2, mySurf->VResolution(besttol)); - Approx_SameParameter_Evaluator ev (FlatKnots, Poles, myHCurve2d); - AdvApprox_ApproxAFunction anApproximator(2,0,0,tol1d,tol2d,tol3d,fc3d,lc3d, - Continuity,11,40,ev); + Approx_SameParameter_Evaluator ev (FlatKnots, Poles, myHCurve2d); + Standard_Integer aMaxDeg = 11, aMaxSeg = 1000; + AdvApprox_ApproxAFunction anApproximator(2,0,0,tol1d,tol2d,tol3d,aData.myC3dPF,aData.myC3dPL, + aContinuity,aMaxDeg,aMaxSeg,ev); - if (anApproximator.IsDone() || anApproximator.HasResult()) { - Adaptor3d_CurveOnSurface ACS = CurveOnSurface; - GeomLib_MakeCurvefromApprox aCurveBuilder(anApproximator) ; - Handle(Geom2d_BSplineCurve) aC2d = aCurveBuilder.Curve2dFromTwo1d(1,2) ; + if (anApproximator.IsDone() || anApproximator.HasResult()) + { + Adaptor3d_CurveOnSurface ACS = aData.myCOnS; + GeomLib_MakeCurvefromApprox aCurveBuilder(anApproximator); + Handle(Geom2d_BSplineCurve) aC2d = aCurveBuilder.Curve2dFromTwo1d(1,2); Handle(Adaptor2d_HCurve2d) aHCurve2d = new Geom2dAdaptor_HCurve(aC2d); - CurveOnSurface.Load(aHCurve2d); + aData.myCOnS.Load(aHCurve2d); + myTolReached = ComputeTolReached(myC3d,aData.myCOnS, 2 * myNbSamples); - myTolReached = ComputeTolReached(myC3d,CurveOnSurface,NCONTROL); - - if(myTolReached > anErrorMAX) - { - //This tolerance is too big. Probably, we will not be able to get - //edge with sameparameter in this case. - - myDone = Standard_False; - return; - } - - if( (myTolReached < 250.0*besttol) || - (count >= aMaxArraySize-2) || - !hasCountChanged) //if count does not change after adding new point - //(else we can have circularity) + const Standard_Real aMult = 250.0; // To be tolerant with discrete tolerance. + if (myTolReached < aMult * besttol ) { myCurve2d = aC2d; - myHCurve2d = aHCurve2d; + myHCurve2d = aHCurve2d; myDone = Standard_True; + break; + } + else if(aData.myNbPnt < myMaxArraySize - 1) + { + interpolok = Standard_False; + aData.myCOnS = ACS; } else { - interpolok = Standard_False; - CurveOnSurface = ACS; + break; } - } - } - - if(!interpolok) - { - - newcount = 0; - for(Standard_Integer n = 0; n < count; n++){ - newpc3d[newcount] = pc3d[n]; - newpcons[newcount] = pcons[n]; - newcount ++; - - if(count - n + newcount == aMaxArraySize) continue; - - Standard_Real ucons = 0.5*(pcons[n]+pcons[n+1]); - Standard_Real uc3d = 0.5*(pc3d[n]+pc3d[n+1]); - - CurveOnSurface.D0(ucons,Pcons); - Projector.Perform(Pcons, uc3d); - if (Projector.IsDone()) { - curp = Projector.Point().Parameter(); - Standard_Real dist_2 = Projector.SquareDistance(); - if(dist_2 > besttol2) besttol2 = dist_2; - projok = 1; - } - else { - ProjectPointOnCurve(uc3d,Pcons,Tol,30,myC3d->Curve(),projok,curp); - } - if(projok){ - if(curp > pc3d[n] + deltamin && curp < pc3d[n+1] - deltamin){ - newpc3d[newcount] = curp; - newpcons[newcount] = ucons; - newcount ++; - } - } - else { -#ifdef OCCT_DEBUG - std::cout << "Projection not done" << std::endl; -#endif - } - } - newpc3d[newcount] = pc3d[count]; - newpcons[newcount] = pcons[count]; - Standard_Real * tempx; - tempx = pc3d; - pc3d = newpc3d; - newpc3d = tempx; - tempx = pcons; - pcons = newpcons; - newpcons = tempx; - - if(count != newcount) - { - count = newcount; - hasCountChanged = Standard_True; - } - else - { - hasCountChanged = Standard_False; } } + + if (!interpolok) + hasCountChanged = IncreaseNbPoles(Poles, FlatKnots, aData, besttol2); + } while(!interpolok && hasCountChanged); if (!myDone) { // Loop is finished unsuccessfully. Fix tolerance by maximal deviation, - // using data from the last loop iteration. - Standard_Integer num_knots = count + 7; - Standard_Integer num_poles = count + 3; - TColStd_Array1OfReal Paramc3d(*pc3d,1,count + 1); - TColStd_Array1OfReal Paramcons(*pcons,1,count + 1); - TColStd_Array1OfInteger ContactOrder(1,num_poles) ; - TColStd_Array1OfReal Poles(1,num_poles) ; - TColStd_Array1OfReal InterpolationParameters(1,num_poles) ; - TColStd_Array1OfReal FlatKnots(1,num_knots) ; + // using data from the last loop iteration or initial data. Use data set with minimal deflection. - // Fill tables taking attention to end values. - ContactOrder.Init(0); - ContactOrder(2) = ContactOrder(num_poles - 1) = 1; + // Original 2d curve. + aData.myCOnS.Load(myHCurve2d); + myTolReached = ComputeTolReached(myC3d,aData.myCOnS, 2 * myNbSamples); + myCurve2d = Geom2dAdaptor::MakeCurve(myHCurve2d->Curve2d()); - FlatKnots(1) = FlatKnots(2) = FlatKnots(3) = FlatKnots(4) = fc3d; - FlatKnots(num_poles + 1) = FlatKnots(num_poles + 2) = - FlatKnots(num_poles + 3) = FlatKnots(num_poles + 4) = lc3d; + // Approximation curve. + Standard_Integer num_knots = aData.myNbPnt + 7; + Standard_Integer num_poles = aData.myNbPnt + 3; + TColStd_Array1OfReal Poles(1, num_poles); + TColStd_Array1OfReal FlatKnots(1 ,num_knots); - Poles(1) = fcons; Poles(num_poles) = lcons; - Poles(2) = tangent[0]; Poles(num_poles - 1) = tangent[1]; - - InterpolationParameters(1) = InterpolationParameters(2) = fc3d; - InterpolationParameters(num_poles - 1) = InterpolationParameters(num_poles) = lc3d; - - for (ii = 3; ii <= num_poles - 2; ii++) - { - Poles(ii) = Paramcons(ii - 1); - InterpolationParameters(ii) = FlatKnots(ii+2) = Paramc3d(ii - 1); - } - Standard_Integer inversion_problem; - BSplCLib::Interpolate(3,FlatKnots,InterpolationParameters,ContactOrder, - 1,Poles(1),inversion_problem); - if(inversion_problem) - { - throw Standard_ConstructionError(); - } + Interpolate(aData, tangent[0], tangent[1], + Poles, FlatKnots); Standard_Real besttol = sqrt(besttol2); Handle(TColStd_HArray1OfReal) tol1d,tol2d,tol3d; @@ -850,9 +499,9 @@ void Approx_SameParameter::Build(const Standard_Real Tolerance) tol1d->SetValue(1, mySurf->UResolution(besttol)); tol1d->SetValue(2, mySurf->VResolution(besttol)); - Approx_SameParameter_Evaluator ev (FlatKnots, Poles, myHCurve2d); - AdvApprox_ApproxAFunction anApproximator(2,0,0,tol1d,tol2d,tol3d,fc3d,lc3d, - Continuity,11,40,ev); + Approx_SameParameter_Evaluator ev(FlatKnots, Poles, myHCurve2d); + AdvApprox_ApproxAFunction anApproximator(2,0,0,tol1d,tol2d,tol3d,aData.myC3dPF,aData.myC3dPL, + aContinuity,11,40,ev); if (!anApproximator.IsDone() && !anApproximator.HasResult() ) @@ -861,23 +510,434 @@ void Approx_SameParameter::Build(const Standard_Real Tolerance) return; } - GeomLib_MakeCurvefromApprox aCurveBuilder(anApproximator) ; - Handle(Geom2d_BSplineCurve) aC2d = aCurveBuilder.Curve2dFromTwo1d(1,2) ; + GeomLib_MakeCurvefromApprox aCurveBuilder(anApproximator); + Handle(Geom2d_BSplineCurve) aC2d = aCurveBuilder.Curve2dFromTwo1d(1,2); Handle(Adaptor2d_HCurve2d) aHCurve2d = new Geom2dAdaptor_HCurve(aC2d); - CurveOnSurface.Load(aHCurve2d); + aData.myCOnS.Load(aHCurve2d); - myTolReached = ComputeTolReached(myC3d,CurveOnSurface,NCONTROL); - - if(myTolReached > anErrorMAX) + Standard_Real anApproxTol = ComputeTolReached(myC3d,aData.myCOnS,2 * myNbSamples); + if (anApproxTol < myTolReached) { - //This tolerance is too big. Probably, we will not be able to get - //edge with sameparameter in this case. - myDone = Standard_False; - return; + myTolReached = anApproxTol; + myCurve2d = aC2d; + myHCurve2d = aHCurve2d; } - - myCurve2d = aC2d; - myHCurve2d = aHCurve2d; myDone = Standard_True; } } + +//======================================================================= +//function : BuildInitialDistribution +//purpose : Sub-method in Build. +//======================================================================= +Standard_Boolean Approx_SameParameter::BuildInitialDistribution(Approx_SameParameter_Data &theData) const +{ + // Take a multiple of the sample pof CheckShape, + // at least the control points will be correct. + // Take parameters with constant step on the curve on surface + // and on curve 3d. + const Standard_Real deltacons = (theData.myC2dPL - theData.myC2dPF) / myNbSamples; + const Standard_Real deltac3d = (theData.myC3dPL - theData.myC3dPF) / myNbSamples; + Standard_Real wcons = theData.myC2dPF; + Standard_Real wc3d = theData.myC3dPF; + for (Standard_Integer ii = 0 ; ii < myNbSamples; ii++) + { + theData.myPC2d[ii] = wcons; + theData.myPC3d[ii] = wc3d; + wcons += deltacons; + wc3d += deltac3d; + } + theData.myNbPnt = myNbSamples; + theData.myPC2d[theData.myNbPnt] = theData.myC2dPL; + theData.myPC3d[theData.myNbPnt] = theData.myC3dPL; + + // Change number of points in case of C0 continuity. + GeomAbs_Shape Continuity = myHCurve2d->Continuity(); + if(Continuity < GeomAbs_C1) + { + if (!IncreaseInitialNbSamples(theData)) + { + // Number of samples is too big. + return Standard_False; + } + } + + return Standard_True; +} + +//======================================================================= +//function : IncreaseInitialNbSamples +//purpose : Get number of C1 intervals and build new distribution on them. +// Sub-method in BuildInitialDistribution. +//======================================================================= +Standard_Boolean Approx_SameParameter::IncreaseInitialNbSamples(Approx_SameParameter_Data &theData) const +{ + Standard_Integer NbInt = myHCurve2d->NbIntervals(GeomAbs_C1) + 1; + TColStd_Array1OfReal aC1Intervals (1, NbInt); + myHCurve2d->Intervals(aC1Intervals, GeomAbs_C1); + + Standard_Integer inter = 1; + while(inter <= NbInt && aC1Intervals(inter) <= theData.myC3dPF + myDeltaMin) inter++; + while(NbInt > 0 && aC1Intervals(NbInt) >= theData.myC3dPL - myDeltaMin) NbInt--; + + // Compute new parameters. + TColStd_SequenceOfReal aNewPar; + aNewPar.Append(theData.myC3dPF); + Standard_Integer ii = 1; + while(inter <= NbInt || (ii < myNbSamples && inter <= aC1Intervals.Length()) ) + { + if(aC1Intervals(inter) < theData.myPC2d[ii]) + { + aNewPar.Append(aC1Intervals(inter)); + if((theData.myPC2d[ii] - aC1Intervals(inter)) <= myDeltaMin) + { + ii++; + if(ii > myNbSamples) + { + ii = myNbSamples; + } + } + inter++; + } + else + { + if((aC1Intervals(inter) - theData.myPC2d[ii]) > myDeltaMin) + { + aNewPar.Append(theData.myPC2d[ii]); + } + ii++; + } + } + // Simple protection if theNewNbPoints > allocated elements in array but one + // myMaxArraySize - 1 index may be filled after projection. + theData.myNbPnt = aNewPar.Length(); + if (theData.myNbPnt > myMaxArraySize - 1) + { + return Standard_False; + } + + for(ii = 1; ii < theData.myNbPnt; ii++) + { + // Copy only internal points. + theData.myPC2d[ii] = theData.myPC3d[ii] = aNewPar.Value(ii + 1); + } + theData.myPC3d[theData.myNbPnt] = theData.myC3dPL; + theData.myPC2d[theData.myNbPnt] = theData.myC2dPL; + + return Standard_True; +} + +//======================================================================= +//function : CheckSameParameter +//purpose : Sub-method in Build. +//======================================================================= +Standard_Boolean Approx_SameParameter::CheckSameParameter(Approx_SameParameter_Data &theData, + Standard_Real &theSqDist) const +{ + const Standard_Real Tol2 = theData.myTol * theData.myTol; + Standard_Boolean isSameParam = Standard_True; + + // Compute initial distance on boundary points. + gp_Pnt Pcons, Pc3d; + theData.myCOnS.D0(theData.myC2dPF, Pcons); + myC3d->D0(theData.myC3dPF, Pc3d); + Standard_Real dist2 = Pcons.SquareDistance(Pc3d); + Standard_Real dmax2 = dist2; + + theData.myCOnS.D0(theData.myC2dPL, Pcons); + myC3d->D0(theData.myC3dPL, Pc3d); + dist2 = Pcons.SquareDistance(Pc3d); + dmax2 = Max(dmax2, dist2); + + Extrema_LocateExtPC Projector; + Projector.Initialize(myC3d->Curve(), theData.myC3dPF, theData.myC3dPL, theData.myTol); + + Standard_Integer count = 1; + Standard_Real previousp = theData.myC3dPF, initp=0, curp; + Standard_Real bornesup = theData.myC3dPL - myDeltaMin; + Standard_Boolean isProjOk = Standard_False; + for (Standard_Integer ii = 1; ii < theData.myNbPnt; ii++) + { + theData.myCOnS.D0(theData.myPC2d[ii],Pcons); + myC3d->D0(theData.myPC3d[ii],Pc3d); + dist2 = Pcons.SquareDistance(Pc3d); + + // Same parameter point. + Standard_Boolean isUseParam = (dist2 <= Tol2 && // Good distance. + (theData.myPC3d[ii] > theData.myPC3d[count-1] + myDeltaMin)); // Point is separated from previous. + if(isUseParam) + { + if(dmax2 < dist2) + dmax2 = dist2; + initp = previousp = theData.myPC3d[count] = theData.myPC3d[ii]; + theData.myPC2d[count] = theData.myPC2d[ii]; + count++; + continue; + } + + // Local search: local extrema and iterative projection algorithm. + if(!isProjOk) + initp = theData.myPC3d[ii]; + isProjOk = isSameParam = Standard_False; + Projector.Perform(Pcons, initp); + if (Projector.IsDone()) + { + // Local extrema is found. + curp = Projector.Point().Parameter(); + isProjOk = Standard_True; + } + else + { + ProjectPointOnCurve(initp,Pcons,theData.myTol,30,myC3d->Curve(),isProjOk,curp); + } + isProjOk = isProjOk && // Good projection. + curp > previousp + myDeltaMin && // Point is separated from previous. + curp < bornesup; // Inside of parameter space. + if(isProjOk) + { + initp = previousp = theData.myPC3d[count] = curp; + theData.myPC2d[count] = theData.myPC2d[ii]; + count++; + continue; + } + + // Whole parameter space search using general extrema. + Extrema_ExtPC PR(Pcons,myC3d->Curve(),theData.myC3dPF, theData.myC3dPL,theData.myTol); + if (!PR.IsDone() || PR.NbExt() == 0) // Lazy evaluation is used. + continue; + + const Standard_Integer aNbExt = PR.NbExt(); + Standard_Integer anIndMin = 0; + Standard_Real aCurDistMin = RealLast(); + for(Standard_Integer i = 1; i <= aNbExt; i++) + { + const gp_Pnt &aP = PR.Point(i).Value(); + Standard_Real aDist2 = aP.SquareDistance(Pcons); + if(aDist2 < aCurDistMin) + { + aCurDistMin = aDist2; + anIndMin = i; + } + } + if(anIndMin) + { + curp = PR.Point(anIndMin).Parameter(); + if( curp > previousp + myDeltaMin && curp < bornesup) + { + initp = previousp = theData.myPC3d[count] = curp; + theData.myPC2d[count] = theData.myPC2d[ii]; + count++; + isProjOk = Standard_True; + } + } + } + theData.myNbPnt = count; + theData.myPC2d[theData.myNbPnt] = theData.myC2dPL; + theData.myPC3d[theData.myNbPnt] = theData.myC3dPL; + + theSqDist = dmax2; + return isSameParam; +} + +//======================================================================= +//function : ComputeTangents +//purpose : Sub-method in Build. +//======================================================================= +Standard_Boolean Approx_SameParameter::ComputeTangents(const Adaptor3d_CurveOnSurface & theCOnS, + Standard_Real &theFirstTangent, + Standard_Real &theLastTangent) const +{ + const Standard_Real aSmallMagnitude = 1.0e-12; + // Check tangency on curve border. + gp_Pnt aPnt, aPntCOnS; + gp_Vec aVec, aVecConS; + + // First point. + const Standard_Real aParamFirst = myC3d->FirstParameter(); + theCOnS.D1(aParamFirst, aPntCOnS, aVecConS); + myC3d->D1(aParamFirst, aPnt, aVec); + Standard_Real aMagnitude = aVecConS.Magnitude(); + if (aMagnitude > aSmallMagnitude) + theFirstTangent = aVec.Magnitude() / aMagnitude; + else + return Standard_False; + + // Last point. + const Standard_Real aParamLast = myC3d->LastParameter(); + theCOnS.D1(aParamLast,aPntCOnS,aVecConS); + myC3d->D1(aParamLast, aPnt, aVec); + + aMagnitude = aVecConS.Magnitude(); + if (aMagnitude > aSmallMagnitude) + theLastTangent = aVec.Magnitude() / aMagnitude; + else + return Standard_False; + + return Standard_True; +} + +//======================================================================= +//function : Interpolate +//purpose : Sub-method in Build. +//======================================================================= +Standard_Boolean Approx_SameParameter::Interpolate(const Approx_SameParameter_Data & theData, + const Standard_Real aTangFirst, + const Standard_Real aTangLast, + TColStd_Array1OfReal & thePoles, + TColStd_Array1OfReal & theFlatKnots) const +{ + Standard_Integer num_poles = theData.myNbPnt + 3; + TColStd_Array1OfInteger ContactOrder(1,num_poles); + TColStd_Array1OfReal aParameters(1, num_poles); + + // Fill tables taking attention to end values. + ContactOrder.Init(0); + ContactOrder(2) = ContactOrder(num_poles - 1) = 1; + + theFlatKnots(1) = theFlatKnots(2) = theFlatKnots(3) = theFlatKnots(4) = theData.myC3dPF; + theFlatKnots(num_poles + 1) = theFlatKnots(num_poles + 2) = + theFlatKnots(num_poles + 3) = theFlatKnots(num_poles + 4) = theData.myC3dPL; + + thePoles(1) = theData.myC2dPF; thePoles(num_poles) = theData.myC2dPL; + thePoles(2) = aTangFirst; thePoles(num_poles - 1) = aTangLast; + + aParameters(1) = aParameters(2) = theData.myC3dPF; + aParameters(num_poles - 1) = aParameters(num_poles) = theData.myC3dPL; + + for (Standard_Integer ii = 3; ii <= num_poles - 2; ii++) + { + thePoles(ii) = theData.myPC2d[ii - 2]; + aParameters(ii) = theFlatKnots(ii+2) = theData.myPC3d[ii - 2]; + } + Standard_Integer inversion_problem; + BSplCLib::Interpolate(3,theFlatKnots,aParameters,ContactOrder, + 1,thePoles(1),inversion_problem); + if(inversion_problem) + { + return Standard_False; + } + + return Standard_True; +} + +//======================================================================= +//function : IncreaseNbPoles +//purpose : Sub-method in Build. +//======================================================================= +Standard_Boolean Approx_SameParameter::IncreaseNbPoles(const TColStd_Array1OfReal & thePoles, + const TColStd_Array1OfReal & theFlatKnots, + Approx_SameParameter_Data & theData, + Standard_Real &theBestSqTol) const +{ + Extrema_LocateExtPC Projector; + Projector.Initialize(myC3d->Curve(), myC3d->FirstParameter(), myC3d->LastParameter(), theData.myTol); + Standard_Real curp = 0.0; + Standard_Boolean projok = Standard_False; + + // Project middle point to fix parameterization and check projection existence. + const Standard_Integer aDegree = 3; + const Standard_Integer DerivativeRequest = 0; + Standard_Integer extrap_mode[2] = {aDegree, aDegree}; + Standard_Real eval_result; + Standard_Real *PolesArray = (Standard_Real *) &thePoles(thePoles.Lower()); + Standard_Integer newcount = 0; + for (Standard_Integer ii = 0; ii < theData.myNbPnt; ii++) + { + theData.myNewPC2d[newcount] = theData.myPC2d[ii]; + theData.myNewPC3d[newcount] = theData.myPC3d[ii]; + newcount++; + + if(theData.myNbPnt - ii + newcount == myMaxArraySize) continue; + + BSplCLib::Eval(0.5*(theData.myPC3d[ii]+theData.myPC3d[ii+1]), Standard_False, DerivativeRequest, + extrap_mode[0], 3, theFlatKnots, 1, PolesArray[0], eval_result); + + if(eval_result < theData.myPC2d[ii] || eval_result > theData.myPC2d[ii+1]) + { + Standard_Real ucons = 0.5*(theData.myPC2d[ii]+theData.myPC2d[ii+1]); + Standard_Real uc3d = 0.5*(theData.myPC3d[ii]+theData.myPC3d[ii+1]); + + gp_Pnt Pcons; + theData.myCOnS.D0(ucons,Pcons); + Projector.Perform(Pcons, uc3d); + if (Projector.IsDone()) + { + curp = Projector.Point().Parameter(); + Standard_Real dist_2 = Projector.SquareDistance(); + if(dist_2 > theBestSqTol) theBestSqTol = dist_2; + projok = 1; + } + else + { + ProjectPointOnCurve(uc3d,Pcons,theData.myTol,30,myC3d->Curve(),projok,curp); + } + if(projok) + { + if(curp > theData.myPC3d[ii] + myDeltaMin && curp < theData.myPC3d[ii+1] - myDeltaMin) + { + theData.myNewPC3d[newcount] = curp; + theData.myNewPC2d[newcount] = ucons; + newcount ++; + } + } + } + } // for (ii = 0; ii < count; ii++) + theData.myNewPC3d[newcount] = theData.myPC3d[theData.myNbPnt]; + theData.myNewPC2d[newcount] = theData.myPC2d[theData.myNbPnt]; + + if((theData.myNbPnt != newcount) && newcount < myMaxArraySize - 1) + { + // Distribution is changed. + theData.Swap(newcount); + return Standard_True; + } + + // Increase number of samples in two times. + newcount = 0; + for(Standard_Integer n = 0; n < theData.myNbPnt; n++) + { + theData.myNewPC3d[newcount] = theData.myPC3d[n]; + theData.myNewPC2d[newcount] = theData.myPC2d[n]; + newcount ++; + + if(theData.myNbPnt - n + newcount == myMaxArraySize) continue; + + Standard_Real ucons = 0.5*(theData.myPC2d[n]+theData.myPC2d[n+1]); + Standard_Real uc3d = 0.5*(theData.myPC3d[n]+theData.myPC3d[n+1]); + + gp_Pnt Pcons; + theData.myCOnS.D0(ucons,Pcons); + Projector.Perform(Pcons, uc3d); + if (Projector.IsDone()) + { + curp = Projector.Point().Parameter(); + Standard_Real dist_2 = Projector.SquareDistance(); + if(dist_2 > theBestSqTol) theBestSqTol = dist_2; + projok = 1; + } + else + { + ProjectPointOnCurve(uc3d,Pcons,theData.myTol,30,myC3d->Curve(),projok,curp); + } + if(projok) + { + if(curp > theData.myPC3d[n] + myDeltaMin && curp < theData.myPC3d[n+1] - myDeltaMin) + { + theData.myNewPC3d[newcount] = curp; + theData.myNewPC2d[newcount] = ucons; + newcount ++; + } + } + } + theData.myNewPC3d[newcount] = theData.myPC3d[theData.myNbPnt]; + theData.myNewPC2d[newcount] = theData.myPC2d[theData.myNbPnt]; + + if(theData.myNbPnt != newcount) + { + // Distribution is changed. + theData.Swap(newcount); + return Standard_True; + } + + return Standard_False; +} diff --git a/src/Approx/Approx_SameParameter.hxx b/src/Approx/Approx_SameParameter.hxx index 4d69b22433..7f56fc3f91 100644 --- a/src/Approx/Approx_SameParameter.hxx +++ b/src/Approx/Approx_SameParameter.hxx @@ -20,21 +20,17 @@ #include #include #include - +#include #include #include -class Geom2d_BSplineCurve; class Adaptor2d_HCurve2d; class Adaptor3d_HCurve; class Adaptor3d_HSurface; -class Standard_OutOfRange; -class Standard_ConstructionError; class Geom_Curve; class Geom2d_Curve; class Geom_Surface; - -//! Approximation of a PCurve on a surface to make its +//! Approximation of a PCurve on a surface to make its //! parameter be the same that the parameter of a given 3d //! reference curve. class Approx_SameParameter @@ -43,63 +39,149 @@ public: DEFINE_STANDARD_ALLOC - + //! Warning: the C3D and C2D must have the same parametric domain. + Standard_EXPORT Approx_SameParameter(const Handle(Geom_Curve)& C3D, + const Handle(Geom2d_Curve)& C2D, + const Handle(Geom_Surface)& S, + const Standard_Real Tol); //! Warning: the C3D and C2D must have the same parametric domain. - Standard_EXPORT Approx_SameParameter(const Handle(Geom_Curve)& C3D, const Handle(Geom2d_Curve)& C2D, const Handle(Geom_Surface)& S, const Standard_Real Tol); - - Standard_EXPORT Approx_SameParameter(const Handle(Adaptor3d_HCurve)& C3D, const Handle(Geom2d_Curve)& C2D, const Handle(Adaptor3d_HSurface)& S, const Standard_Real Tol); - + Standard_EXPORT Approx_SameParameter(const Handle(Adaptor3d_HCurve)& C3D, + const Handle(Geom2d_Curve)& C2D, + const Handle(Adaptor3d_HSurface)& S, + const Standard_Real Tol); //! Warning: the C3D and C2D must have the same parametric domain. - Standard_EXPORT Approx_SameParameter(const Handle(Adaptor3d_HCurve)& C3D, const Handle(Adaptor2d_HCurve2d)& C2D, const Handle(Adaptor3d_HSurface)& S, const Standard_Real Tol); - - Standard_Boolean IsDone() const; - - Standard_Real TolReached() const; - - //! Tells whether the original data had already the same - //! parameter up to the tolerance : in that case nothing + Standard_EXPORT Approx_SameParameter(const Handle(Adaptor3d_HCurve)& C3D, + const Handle(Adaptor2d_HCurve2d)& C2D, + const Handle(Adaptor3d_HSurface)& S, + const Standard_Real Tol); + + //!@Returns .false. if calculations failed, + //! .true. if calculations succeed + Standard_Boolean IsDone() const + { + return myDone; + } + + //!@Returns tolerance (maximal distance) between 3d curve + //! and curve on surface, generated by 2d curve and surface. + Standard_Real TolReached() const + { + return myTolReached; + } + + //! Tells whether the original data had already the same + //! parameter up to the tolerance : in that case nothing //! is done. - Standard_Boolean IsSameParameter() const; - - //! Returns the 2D curve that has the same parameter as - //! the 3D curve once evaluated on the surface up to the - //! specified tolerance - Handle(Geom2d_BSplineCurve) Curve2d() const; - - - - -protected: - - - + Standard_Boolean IsSameParameter() const + { + return mySameParameter; + } + //! Returns the 2D curve that has the same parameter as + //! the 3D curve once evaluated on the surface up to the + //! specified tolerance. + Handle(Geom2d_Curve) Curve2d() const + { + return myCurve2d; + } private: - - //! Compute the Pcurve (internal use only). + //! Internal data structure to unify access to the most actively used data. + //! This structure is not intended to be class field since + //! a lot of memory is used in intermediate computations. + struct Approx_SameParameter_Data + { + Adaptor3d_CurveOnSurface myCOnS; // Curve on surface. + Standard_Integer myNbPnt; // Number of points. + Standard_Real *myPC3d; // Parameters on 3d curve. + Standard_Real *myPC2d; // Parameters on 2d curve. + + // Second data arrays. Used in loop over poles. + Standard_Real *myNewPC3d; // Parameters on 3d curve. + Standard_Real *myNewPC2d; // Parameters on 2d curve. + + // Parameters ranges. + Standard_Real myC3dPF; // Curve 3d Parameter First. + Standard_Real myC3dPL; // Curve 3d Parameter Last. + Standard_Real myC2dPF; // Curve 2d Parameter First. + Standard_Real myC2dPL; // Curve 2d Parameter Last. + + Standard_Real myTol; // Working tolerance. + + // Swap data arrays and update number of points. + void Swap(const Standard_Integer theNewNbPoints) + { + myNbPnt = theNewNbPoints; + Standard_Real * temp; + + // 3-D + temp = myPC3d; + myPC3d = myNewPC3d; + myNewPC3d = temp; + + // 2-D + temp = myPC2d; + myPC2d = myNewPC2d; + myNewPC2d = temp; + } + }; + + + Approx_SameParameter(const Approx_SameParameter &); + Approx_SameParameter& operator=(const Approx_SameParameter &); + + //! Computes the pcurve (internal use only). Standard_EXPORT void Build (const Standard_Real Tol); + //! Computes initial point distribution. + Standard_Boolean BuildInitialDistribution(Approx_SameParameter_Data &theData) const; + + //! Increases initial number of samples in case of the C0 continuity. + //! Return new number of points and corresponding data arrays. + //@return true if new number of samples is good and false otherwise. + Standard_Boolean IncreaseInitialNbSamples(Approx_SameParameter_Data &theData) const; + + //! Computes tangents on boundary points. + //@return true if tangents are not null and false otherwise. + Standard_Boolean ComputeTangents(const Adaptor3d_CurveOnSurface & theCOnS, + Standard_Real &theFirstTangent, + Standard_Real &theLastTangent) const; + + //! Method to check same parameter state + //! and build dependency between 2d and 3d curves. + //@return true if 2d and 3d curves have same parameter state and false otherwise. + Standard_Boolean CheckSameParameter(Approx_SameParameter_Data &theData, + Standard_Real &theSqDist) const; + + //! Computes interpolated values. + //!@Returns .false. if computations failed; + Standard_Boolean Interpolate(const Approx_SameParameter_Data & theData, + const Standard_Real aTangFirst, + const Standard_Real aTangLast, + TColStd_Array1OfReal & thePoles, + TColStd_Array1OfReal & theFlatKnots) const; + + //! Increases number of poles in poles loop. + //@return true if poles is changed and false otherwise. + Standard_Boolean IncreaseNbPoles(const TColStd_Array1OfReal & thePoles, + const TColStd_Array1OfReal & theFlatKnots, + Approx_SameParameter_Data & theData, + Standard_Real &theBestSqTol) const; + + static const Standard_Integer myNbSamples = 22; // To be consistent with "checkshape". + static const Standard_Integer myMaxArraySize = 1000; + const Standard_Real myDeltaMin; // Initialization is allowed only for integral types. Standard_Boolean mySameParameter; Standard_Boolean myDone; Standard_Real myTolReached; - Handle(Geom2d_BSplineCurve) myCurve2d; + Handle(Geom2d_Curve) myCurve2d; Handle(Adaptor2d_HCurve2d) myHCurve2d; Handle(Adaptor3d_HCurve) myC3d; Handle(Adaptor3d_HSurface) mySurf; - - }; - -#include - - - - - #endif // _Approx_SameParameter_HeaderFile diff --git a/src/Approx/Approx_SameParameter.lxx b/src/Approx/Approx_SameParameter.lxx deleted file mode 100644 index 012ab93159..0000000000 --- a/src/Approx/Approx_SameParameter.lxx +++ /dev/null @@ -1,44 +0,0 @@ -// Created on: 1995-06-06 -// Created by: Modelistation -// Copyright (c) 1995-1999 Matra Datavision -// Copyright (c) 1999-2014 OPEN CASCADE SAS -// -// This file is part of Open CASCADE Technology software library. -// -// This library is free software; you can redistribute it and/or modify it under -// the terms of the GNU Lesser General Public License version 2.1 as published -// by the Free Software Foundation, with special exception defined in the file -// OCCT_LGPL_EXCEPTION.txt. Consult the file LICENSE_LGPL_21.txt included in OCCT -// distribution for complete text of the license and disclaimer of any warranty. -// -// Alternatively, this file may be used under the terms of Open CASCADE -// commercial license or contractual agreement. - -//======================================================================= -//function : IsDone -//purpose : -//======================================================================= - -inline Standard_Boolean Approx_SameParameter::IsDone() const -{ return myDone ; } -//======================================================================= -//function : TolReached -//purpose : -//======================================================================= - -inline Standard_Real Approx_SameParameter::TolReached() const -{ return myTolReached; } -//======================================================================= -//function : IsSameParameter -//purpose : -//======================================================================= - -inline Standard_Boolean Approx_SameParameter::IsSameParameter() const -{ return mySameParameter ; } -//======================================================================= -//function : Curve2d -//purpose : -//======================================================================= - -inline Handle(Geom2d_BSplineCurve) Approx_SameParameter::Curve2d() const -{ return myCurve2d ; } diff --git a/src/Approx/FILES b/src/Approx/FILES index 6cd02d9bc1..939d6e53d5 100644 --- a/src/Approx/FILES +++ b/src/Approx/FILES @@ -24,7 +24,6 @@ Approx_MCurvesToBSpCurve.hxx Approx_ParametrizationType.hxx Approx_SameParameter.cxx Approx_SameParameter.hxx -Approx_SameParameter.lxx Approx_SequenceOfHArray1OfReal.hxx Approx_Status.hxx Approx_SweepApproximation.cxx diff --git a/src/Geom2dAdaptor/Geom2dAdaptor.cxx b/src/Geom2dAdaptor/Geom2dAdaptor.cxx index a07354e888..c206365c77 100644 --- a/src/Geom2dAdaptor/Geom2dAdaptor.cxx +++ b/src/Geom2dAdaptor/Geom2dAdaptor.cxx @@ -16,6 +16,7 @@ #include +#include #include #include #include @@ -88,7 +89,21 @@ Handle(Geom2d_Curve) Geom2dAdaptor::MakeCurve C2D = HC.BSpline(); } break; - + + case GeomAbs_OffsetCurve: + { + const Geom2dAdaptor_Curve* pGAC = dynamic_cast(&HC); + if (pGAC != 0) + { + C2D = pGAC->Curve(); + } + else + { + Standard_DomainError::Raise("Geom2dAdaptor::MakeCurve, Not Geom2dAdaptor_Curve"); + } + } + break; + default: throw Standard_DomainError("Geom2dAdaptor::MakeCurve, OtherCurve"); @@ -99,8 +114,19 @@ Handle(Geom2d_Curve) Geom2dAdaptor::MakeCurve ((HC.FirstParameter() != C2D->FirstParameter()) || (HC.LastParameter() != C2D->LastParameter()))) { - C2D = new Geom2d_TrimmedCurve - (C2D,HC.FirstParameter(),HC.LastParameter()); + if (C2D->IsPeriodic() || + (HC.FirstParameter() >= C2D->FirstParameter() && + HC.LastParameter() <= C2D->LastParameter())) + { + C2D = new Geom2d_TrimmedCurve + (C2D, HC.FirstParameter(), HC.LastParameter()); + } + else + { + Standard_Real tf = Max(HC.FirstParameter(), C2D->FirstParameter()); + Standard_Real tl = Min(HC.LastParameter(), C2D->LastParameter()); + C2D = new Geom2d_TrimmedCurve(C2D, tf, tl); + } } return C2D; diff --git a/tests/blend/simple/X4 b/tests/blend/simple/X4 index 3e60060b3d..4edc216d18 100644 --- a/tests/blend/simple/X4 +++ b/tests/blend/simple/X4 @@ -1,4 +1,4 @@ -puts "TODO #OCC26740 ALL: Faulty shapes in variables faulty_1 to faulty_2" +#puts "TODO #OCC26740 ALL: Faulty shapes in variables faulty_1 to faulty_2" ## =========================================== ## Grid : CCV001 diff --git a/tests/bugs/iges/bug306 b/tests/bugs/iges/bug306 index 1e0a1ac19f..0e844344e3 100755 --- a/tests/bugs/iges/bug306 +++ b/tests/bugs/iges/bug306 @@ -20,7 +20,7 @@ vsetdispmode result 1 vdisplay result vfit -checktrinfo result -tri 5814 -nod 5811 +checktrinfo result -tri 5812 -nod 5809 checkmaxtol result -ref 0.92213088179312575 checknbshapes result -shell 1 diff --git a/tests/bugs/modalg_1/buc60905 b/tests/bugs/modalg_1/buc60905 index 6cfcdc8a59..ae4c133271 100755 --- a/tests/bugs/modalg_1/buc60905 +++ b/tests/bugs/modalg_1/buc60905 @@ -20,7 +20,7 @@ vdisplay result # checkshape res -checkmaxtol result -ref 1.56901e+001 +checkmaxtol result -ref 1.098308e+001 checknbshapes result -shell 2 checkfreebounds result 115 diff --git a/tests/bugs/modalg_2/bug22770_10 b/tests/bugs/modalg_2/bug22770_10 index ddf37475fd..09d5a7d2a2 100755 --- a/tests/bugs/modalg_2/bug22770_10 +++ b/tests/bugs/modalg_2/bug22770_10 @@ -14,7 +14,7 @@ sewing result +t 0.01 a b +mint 0.01 -a set nbshapes_expected " Number of shapes in shape - VERTEX : 479 + VERTEX : 480 EDGE : 748 WIRE : 273 FACE : 259 @@ -22,11 +22,11 @@ Number of shapes in shape SOLID : 0 COMPSOLID : 0 COMPOUND : 1 - SHAPE : 1762 + SHAPE : 1763 " checknbshapes result -ref ${nbshapes_expected} -t -m "sewing result" -checkmaxtol result -ref 0.066338232054955981 -checkfreebounds result 12 +checkmaxtol result -ref 0.04656161000546645 +checkfreebounds result 14 checkprops result -s 1.8847e+07 -eps 0.1 checkshape result diff --git a/tests/bugs/modalg_2/bug22770_11 b/tests/bugs/modalg_2/bug22770_11 index 38a5ab692d..fd420486d1 100755 --- a/tests/bugs/modalg_2/bug22770_11 +++ b/tests/bugs/modalg_2/bug22770_11 @@ -16,7 +16,7 @@ checkprops result -s 1.88469e+07 checkshape result checknbshapes result -vertex 476 -edge 748 -wire 273 -face 259 -shell 2 -solid 0 -compsolid 0 -compound 1 -shape 1759 -checkmaxtol result -ref 0.066338232054955981 +checkmaxtol result -ref 0.04656161000546645 checknbshapes result -shell 2 checkfreebounds result 6 checkview -display result -3d -path ${imagedir}/${test_image}.png diff --git a/tests/bugs/modalg_2/bug22770_13 b/tests/bugs/modalg_2/bug22770_13 index 92e6237160..fbe4ce43e4 100755 --- a/tests/bugs/modalg_2/bug22770_13 +++ b/tests/bugs/modalg_2/bug22770_13 @@ -32,7 +32,7 @@ checkprops result -s 1.8847e+07 checkshape result checknbshapes result -vertex 964 -edge 1222 -wire 273 -face 259 -shell 18 -solid 0 -compsolid 0 -compound 1 -shape 2737 -checkmaxtol result -ref 0.046734236640099257 +checkmaxtol result -ref 0.0451323239933289 checknbshapes result -shell 18 checkfreebounds result 926 checkview -display result -3d -path ${imagedir}/${test_image}.png diff --git a/tests/bugs/modalg_2/bug22770_15 b/tests/bugs/modalg_2/bug22770_15 index 22c4fb2242..47dab4893b 100755 --- a/tests/bugs/modalg_2/bug22770_15 +++ b/tests/bugs/modalg_2/bug22770_15 @@ -32,7 +32,7 @@ checkprops result -s 1.8847e+07 checkshape result checknbshapes result -vertex 964 -edge 1222 -wire 273 -face 259 -shell 18 -solid 0 -compsolid 0 -compound 1 -shape 2737 -checkmaxtol result -ref 0.046734236640099257 +checkmaxtol result -ref 0.0451323239933289 checknbshapes result -shell 18 checkfreebounds result 926 checkview -display result -3d -path ${imagedir}/${test_image}.png diff --git a/tests/bugs/modalg_2/bug22770_18 b/tests/bugs/modalg_2/bug22770_18 index 0f8e564829..4c18f970c3 100755 --- a/tests/bugs/modalg_2/bug22770_18 +++ b/tests/bugs/modalg_2/bug22770_18 @@ -19,7 +19,7 @@ checkprops result -s 12 checkshape result checknbshapes result -vertex 4 -edge 4 -wire 2 -face 2 -shell 1 -solid 0 -compsolid 0 -compound 0 -shape 13 -checkmaxtol result -ref 1.5 +checkmaxtol result -ref 1.05 checknbshapes result -shell 1 checkfreebounds result 0 checkview -display result -3d -path ${imagedir}/${test_image}.png diff --git a/tests/bugs/modalg_2/bug22770_20 b/tests/bugs/modalg_2/bug22770_20 index e2155a4477..346c64bc10 100755 --- a/tests/bugs/modalg_2/bug22770_20 +++ b/tests/bugs/modalg_2/bug22770_20 @@ -19,7 +19,7 @@ checkprops result -s 12 checkshape result checknbshapes result -vertex 4 -edge 4 -wire 2 -face 2 -shell 1 -solid 0 -compsolid 0 -compound 0 -shape 13 -checkmaxtol result -ref 1.5 +checkmaxtol result -ref 1.05 checknbshapes result -shell 1 checkfreebounds result 0 checkview -display result -3d -path ${imagedir}/${test_image}.png diff --git a/tests/bugs/modalg_2/bug22770_23 b/tests/bugs/modalg_2/bug22770_23 index 10e27ecc77..d48ad3916e 100755 --- a/tests/bugs/modalg_2/bug22770_23 +++ b/tests/bugs/modalg_2/bug22770_23 @@ -17,7 +17,7 @@ checkprops result -s 1.8847e+07 checkshape result checknbshapes result -vertex 480 -edge 741 -wire 273 -face 259 -shell 2 -solid 0 -compsolid 0 -compound 1 -shape 1756 -checkmaxtol result -ref 0.080878557461246572 +checkmaxtol result -ref 0.083903522096914374 checknbshapes result -shell 2 checkfreebounds result 0 checkview -display result -3d -path ${imagedir}/${test_image}.png diff --git a/tests/bugs/modalg_2/bug22770_24 b/tests/bugs/modalg_2/bug22770_24 index 4b826ac781..45fe73d304 100755 --- a/tests/bugs/modalg_2/bug22770_24 +++ b/tests/bugs/modalg_2/bug22770_24 @@ -19,7 +19,7 @@ checkprops result -s 1.88469e+07 checkshape result checknbshapes result -vertex 476 -edge 748 -wire 273 -face 259 -shell 2 -solid 0 -compsolid 0 -compound 1 -shape 1759 -checkmaxtol result -ref 0.080878557461246572 +checkmaxtol result -ref 0.083903522096914374 checknbshapes result -shell 2 checkfreebounds result 0 checkview -display result -3d -path ${imagedir}/${test_image}.png diff --git a/tests/bugs/modalg_2/bug22770_25 b/tests/bugs/modalg_2/bug22770_25 index e5a16066df..fd88aae140 100755 --- a/tests/bugs/modalg_2/bug22770_25 +++ b/tests/bugs/modalg_2/bug22770_25 @@ -1,4 +1,4 @@ -puts "TODO OCC11111 ALL: Error : is WRONG because number of " +#puts "TODO OCC11111 ALL: Error : is WRONG because number of " puts "================" puts "OCC22770" @@ -18,8 +18,8 @@ sewing result 0.1 a b +mint 0.01 -a checkprops result -s 1.88469e+07 checkshape result -checknbshapes result -vertex 478 -edge 748 -wire 273 -face 259 -shell 2 -solid 0 -compsolid 0 -compound 1 -shape 1761 -checkmaxtol result -ref 0.080878557461246572 +checknbshapes result -vertex 479 -edge 746 -wire 273 -face 259 -shell 2 -solid 0 -compsolid 0 -compound 1 -shape 1760 +checkmaxtol result -ref 0.083903522096914374 checknbshapes result -shell 2 -checkfreebounds result 6 +checkfreebounds result 8 checkview -display result -3d -path ${imagedir}/${test_image}.png diff --git a/tests/bugs/modalg_2/bug22770_26 b/tests/bugs/modalg_2/bug22770_26 index 2ddf589402..5fe88694c8 100755 --- a/tests/bugs/modalg_2/bug22770_26 +++ b/tests/bugs/modalg_2/bug22770_26 @@ -19,7 +19,7 @@ checkprops result -s 1.88469e+07 checkshape result checknbshapes result -vertex 476 -edge 748 -wire 273 -face 259 -shell 2 -solid 0 -compsolid 0 -compound 1 -shape 1759 -checkmaxtol result -ref 0.080878557461246572 +checkmaxtol result -ref 0.083903522096914374 checknbshapes result -shell 2 checkfreebounds result 0 checkview -display result -3d -path ${imagedir}/${test_image}.png diff --git a/tests/bugs/modalg_2/bug22770_27 b/tests/bugs/modalg_2/bug22770_27 index 71ab081ada..f96c9bae23 100755 --- a/tests/bugs/modalg_2/bug22770_27 +++ b/tests/bugs/modalg_2/bug22770_27 @@ -17,7 +17,7 @@ checkprops result -s 1.8847e+07 checkshape result checknbshapes result -vertex 483 -edge 744 -wire 273 -face 259 -shell 2 -solid 0 -compsolid 0 -compound 1 -shape 1762 -checkmaxtol result -ref 0.080645000662448688 +checkmaxtol result -ref 0.083710669564248399 checknbshapes result -shell 2 checkfreebounds result 9 checkview -display result -3d -path ${imagedir}/${test_image}.png diff --git a/tests/bugs/modalg_2/bug22770_28 b/tests/bugs/modalg_2/bug22770_28 index b1db90beaf..b0d774ec3b 100755 --- a/tests/bugs/modalg_2/bug22770_28 +++ b/tests/bugs/modalg_2/bug22770_28 @@ -17,7 +17,7 @@ checkprops result -s 1.8847e+07 checkshape result checknbshapes result -vertex 480 -edge 741 -wire 273 -face 259 -shell 2 -solid 0 -compsolid 0 -compound 1 -shape 1756 -checkmaxtol result -ref 0.080878557461246572 +checkmaxtol result -ref 0.083903522096914374 checknbshapes result -shell 2 checkfreebounds result 0 checkview -display result -3d -path ${imagedir}/${test_image}.png diff --git a/tests/bugs/modalg_2/bug22770_3 b/tests/bugs/modalg_2/bug22770_3 index 10415b62ba..8d6c4fbb84 100755 --- a/tests/bugs/modalg_2/bug22770_3 +++ b/tests/bugs/modalg_2/bug22770_3 @@ -25,7 +25,7 @@ sewing result +t 1.1 a_2 b_1 checkprops result -s 12 checkshape result checknbshapes result -vertex 4 -edge 4 -wire 2 -face 2 -shell 1 -solid 0 -compsolid 0 -compound 0 -shape 13 -checkmaxtol result -ref 1.5 +checkmaxtol result -ref 1.05 checknbshapes result -shell 1 checkfreebounds result 0 checkview -display result -3d -path ${imagedir}/${test_image}.png diff --git a/tests/bugs/modalg_2/bug22770_30 b/tests/bugs/modalg_2/bug22770_30 index d8e3cfadd0..6fe96c931d 100755 --- a/tests/bugs/modalg_2/bug22770_30 +++ b/tests/bugs/modalg_2/bug22770_30 @@ -17,7 +17,7 @@ checkprops result -s 1.8847e+07 checkshape result checknbshapes result -vertex 480 -edge 741 -wire 273 -face 259 -shell 2 -solid 0 -compsolid 0 -compound 1 -shape 1756 -checkmaxtol result -ref 0.080878557461246572 +checkmaxtol result -ref 0.083903522096914374 checknbshapes result -shell 2 checkfreebounds result 0 checkview -display result -3d -path ${imagedir}/${test_image}.png diff --git a/tests/bugs/modalg_2/bug22770_5 b/tests/bugs/modalg_2/bug22770_5 index cc01b8b1ca..43c03eb243 100755 --- a/tests/bugs/modalg_2/bug22770_5 +++ b/tests/bugs/modalg_2/bug22770_5 @@ -17,7 +17,7 @@ sewing result +t 1.1 a_2 b_1 +f checkprops result -s 12 checkshape result checknbshapes result -vertex 4 -edge 4 -wire 2 -face 2 -shell 1 -solid 0 -compsolid 0 -compound 0 -shape 13 -checkmaxtol result -ref 1.5 +checkmaxtol result -ref 1.05 checknbshapes result -shell 1 checkfreebounds result 0 checkview -display result -3d -path ${imagedir}/${test_image}.png diff --git a/tests/bugs/modalg_2/bug22770_8 b/tests/bugs/modalg_2/bug22770_8 index 0efef4e4c8..d9ad299028 100755 --- a/tests/bugs/modalg_2/bug22770_8 +++ b/tests/bugs/modalg_2/bug22770_8 @@ -18,7 +18,7 @@ checkprops result -s 1.88469e+07 checkshape result checknbshapes result -vertex 482 -edge 744 -wire 273 -face 259 -shell 2 -solid 0 -compsolid 0 -compound 1 -shape 1761 -checkmaxtol result -ref 0.066338232054955981 +checkmaxtol result -ref 0.04656161000546645 checknbshapes result -shell 2 checkfreebounds result 6 checkview -display result -3d -path ${imagedir}/${test_image}.png diff --git a/tests/bugs/modalg_2/bug22770_9 b/tests/bugs/modalg_2/bug22770_9 index 1df78add47..572b26e942 100755 --- a/tests/bugs/modalg_2/bug22770_9 +++ b/tests/bugs/modalg_2/bug22770_9 @@ -16,7 +16,7 @@ checkprops result -s 1.88469e+07 checkshape result checknbshapes result -vertex 476 -edge 748 -wire 273 -face 259 -shell 2 -solid 0 -compsolid 0 -compound 1 -shape 1759 -checkmaxtol result -ref 0.066338232054955981 +checkmaxtol result -ref 0.04656161000546645 checknbshapes result -shell 2 checkfreebounds result 6 checkview -display result -3d -path ${imagedir}/${test_image}.png diff --git a/tests/bugs/modalg_2/bug22804 b/tests/bugs/modalg_2/bug22804 index 8b794093dc..7850befe3d 100755 --- a/tests/bugs/modalg_2/bug22804 +++ b/tests/bugs/modalg_2/bug22804 @@ -28,7 +28,7 @@ if { ${minTolerance} > ${VertexTolerance} } { checkreal "Min tolerance" ${minTolerance} ${oTolerance} 0 0.001 -checkmaxtol result -ref 2352.4465999220711 +checkmaxtol result -ref 1699.9358291469857 checknbshapes result -shell 1 checkfreebounds result 5 diff --git a/tests/bugs/modalg_4/bug714 b/tests/bugs/modalg_4/bug714 index 3c3d2265e3..972e017dda 100755 --- a/tests/bugs/modalg_4/bug714 +++ b/tests/bugs/modalg_4/bug714 @@ -29,7 +29,7 @@ if { $ve1 != $ve2 || $ed1 != $ed2 || $we1 != $we2} { puts "OK OCC714: SEWING operation was made PROPERLY" } -checkmaxtol result -ref 0.25619311354638169 +checkmaxtol result -ref 0.17933517948246736 checknbshapes result -shell 1 checkfreebounds result 0 diff --git a/tests/bugs/modalg_5/bug25175 b/tests/bugs/modalg_5/bug25175 index 0912b2591e..ee7c73ee82 100644 --- a/tests/bugs/modalg_5/bug25175 +++ b/tests/bugs/modalg_5/bug25175 @@ -12,7 +12,7 @@ igesread [locate_data_file bug25175_3.igs] a * sewing result 0.1 a -checkmaxtol result -ref 0.40493352048584974 +checkmaxtol result -ref 0.21794517334615857 checknbshapes result -shell 1 checkfreebounds result 0 diff --git a/tests/bugs/modalg_6/bug27015 b/tests/bugs/modalg_6/bug27015 index b554ed3f95..a065ebb5fe 100644 --- a/tests/bugs/modalg_6/bug27015 +++ b/tests/bugs/modalg_6/bug27015 @@ -1,4 +1,4 @@ -puts "TODO OCC27531 ALL: Error: Max tolerance" +#puts "TODO OCC27531 ALL: Error: Max tolerance" puts "========" puts "0027015: Sewing returns invalid shape if some faces are nearly plane cones" puts "========" @@ -14,4 +14,4 @@ checkshape result # Check tolerance of the result shape. # Currently same parameter algorithm can not interpolate pcurve. #"same parameter" state is obtained increasing tolerance to ~130.0 mm (max deviation between curves in 3d and 2d). -checkmaxtol result -ref 1.0 +checkmaxtol result -ref 0.029697490042886372 diff --git a/tests/bugs/modalg_7/bug29663 b/tests/bugs/modalg_7/bug29663 index 321de4bd13..af381765e9 100644 --- a/tests/bugs/modalg_7/bug29663 +++ b/tests/bugs/modalg_7/bug29663 @@ -21,7 +21,7 @@ fixshape result rr checkshape result checkprops result -s 2.14316e+011 -checkmaxtol result -ref 0.070055357229360987 +checkmaxtol result -ref 0.049038750060552701 checknbshapes result -shell 1 -face 201 -wire 201 diff --git a/tests/bugs/moddata_2/bug343 b/tests/bugs/moddata_2/bug343 index bd84779c5d..e37e88b6dc 100755 --- a/tests/bugs/moddata_2/bug343 +++ b/tests/bugs/moddata_2/bug343 @@ -18,7 +18,7 @@ if [catch {igesbrep $filepath a *} catch_result] { # sewing result1 100. a - checkmaxtol result1 -ref 9.43897e+001 + checkmaxtol result1 -ref 66.0727572 checknbshapes result1 -shell 1 checkfreebounds result1 86 @@ -71,7 +71,7 @@ if [catch {igesbrep $filepath a *} catch_result] { tpcompound a sewing result2 100. a - checkmaxtol result2 -ref 9.43897e+001 + checkmaxtol result2 -ref 66.072757207851282 checknbshapes result2 -shell 1 checkfreebounds result2 86 diff --git a/tests/bugs/moddata_2/bug42 b/tests/bugs/moddata_2/bug42 index 091eefd028..6dc628f20d 100755 --- a/tests/bugs/moddata_2/bug42 +++ b/tests/bugs/moddata_2/bug42 @@ -34,7 +34,7 @@ if { [llength $closed_wires] != 1} { puts "Error : Amount of free closed wires is not equal 1" } -checkmaxtol result -ref 9.43897e+001 +checkmaxtol result -ref 66.072757207853044 checknbshapes result -shell 1 checkfreebounds result 86 diff --git a/tests/bugs/xde/bug6491 b/tests/bugs/xde/bug6491 index d81477f368..cb65b657a4 100755 --- a/tests/bugs/xde/bug6491 +++ b/tests/bugs/xde/bug6491 @@ -15,7 +15,7 @@ set tolerance 1000 sewing result ${tolerance} a checknbshapes result -face 263 -shell 1 -checkmaxtol result -ref 185.91005891234283 +checkmaxtol result -ref 130.21536414731227 checkfreebounds result 73 checkview -display result -2d -path ${imagedir}/${test_image}.png diff --git a/tests/de/step_1/ZH1 b/tests/de/step_1/ZH1 index 31638358b8..4a8460bc25 100644 --- a/tests/de/step_1/ZH1 +++ b/tests/de/step_1/ZH1 @@ -11,7 +11,7 @@ TPSTAT : Faulties = 0 ( 0 ) Warnings = 0 ( 7 ) Summary = 0 ( 7 ) CHECKSHAPE : Wires = 0 ( 0 ) Faces = 0 ( 0 ) Shells = 0 ( 0 ) Solids = 0 ( 0 ) NBSHAPES : Solid = 0 ( 0 ) Shell = 9 ( 0 ) Face = 9 ( 9 ) STATSHAPE : Solid = 0 ( 0 ) Shell = 9 ( 0 ) Face = 9 ( 9 ) FreeWire = 0 ( 0 ) -TOLERANCE : MaxTol = 0.003863207397 ( 0.02717230043 ) AvgTol = 0.0004713629464 ( 0.003097464066 ) +TOLERANCE : MaxTol = 0.003863207397 ( 0.03790164928 ) AvgTol = 0.0004713629464 ( 0.003090287092 ) LABELS : N0Labels = 1 ( 1 ) N1Labels = 5 ( 5 ) N2Labels = 0 ( 0 ) TotalLabels = 6 ( 6 ) NameLabels = 1 ( 1 ) ColorLabels = 0 ( 0 ) LayerLabels = 5 ( 5 ) PROPS : Centroid = 0 ( 0 ) Volume = 0 ( 0 ) Area = 0 ( 0 ) NCOLORS : NColors = 0 ( 0 ) diff --git a/tests/heal/data/advanced/K2 b/tests/heal/data/advanced/K2 index dd1e15fa1f..1faa827553 100644 --- a/tests/heal/data/advanced/K2 +++ b/tests/heal/data/advanced/K2 @@ -1,5 +1,5 @@ -if { [string compare $command "ShapeConvertRev"] == 0 } { - puts "TODO OCC23127 ALL: Error : The area of the resulting shape is" -} +#if { [string compare $command "ShapeConvertRev"] == 0 } { + #puts "TODO OCC23127 ALL: Error : The area of the resulting shape is" +#} restore [locate_data_file CTO901_cts20172_base.rle] a diff --git a/tests/heal/data/advanced/V2 b/tests/heal/data/advanced/V2 index ea4d5e06c1..36bc188ab7 100644 --- a/tests/heal/data/advanced/V2 +++ b/tests/heal/data/advanced/V2 @@ -1,2 +1,5 @@ +if { [string compare $command "SplitAngle"] == 0 } { + puts "REQUIRED All: Faulty shapes in variables faulty_1 to faulty_" +} restore [locate_data_file ANSCHLUSS.brep] a diff --git a/tests/heal/surface_to_revolution_advanced/end b/tests/heal/surface_to_revolution_advanced/end index 63ab3db33e..7d6858c032 100644 --- a/tests/heal/surface_to_revolution_advanced/end +++ b/tests/heal/surface_to_revolution_advanced/end @@ -12,10 +12,10 @@ regexp {Number +of +other +pcurves +- +([-0-9.+eE]+)} $expsh full nb_pcurve if { $nb_plane != 0 || $nb_other_surf != 0 || $nb_curve != 0 || $nb_pcurve != 0} { puts "Error : The resulting shape is not correct" } -regexp {Mass +: +([-0-9.+eE]+)} [sprops a] full mass -regexp {Mass +: +([-0-9.+eE]+)} [sprops result] full m +regexp {Mass +: +([-0-9.+eE]+)} [sprops a $rel_tol] full mass +regexp {Mass +: +([-0-9.+eE]+)} [sprops result $rel_tol] full m -if { ($mass != 0 && [expr 1.*abs($mass - $m)/$mass] > $rel_tol) || ($mass == 0 && $m != 0) } { +if { ($mass != 0 && [expr 1.*abs($mass - $m)/$mass] > 1.5*$rel_tol) || ($mass == 0 && $m != 0) } { puts "Error : The area of the resulting shape is $m" } else { puts "The areas of the initial and the resulting shape are equal" diff --git a/tests/hlr/poly_hlr/Plate b/tests/hlr/poly_hlr/Plate index b2be509335..536d8018d5 100644 --- a/tests/hlr/poly_hlr/Plate +++ b/tests/hlr/poly_hlr/Plate @@ -1,4 +1,5 @@ puts "TODO OCC30286 Windows: Error : The length of result shape is 404.004, expected 404.386" +puts "TODO OCC30286 Linux: Error : The length of result shape is 404.492, expected 404.386" polyline f1 0 0 0 0 -10 0 100 -10 0 100 0 0 0 0 0 polyline f2 100 0 0 110 0 0 110 100 0 100 100 0 100 0 0 diff --git a/tests/mkface/after_extsurf_and_offset/B3 b/tests/mkface/after_extsurf_and_offset/B3 index f5bb3426ca..5b163d034f 100644 --- a/tests/mkface/after_extsurf_and_offset/B3 +++ b/tests/mkface/after_extsurf_and_offset/B3 @@ -4,5 +4,5 @@ offset es_bspline_3d_p_nr_of es_bspline_3d_p_nr 1 offset es_bspline_3d_p_nr_of_of es_bspline_3d_p_nr_of 1 mkface result es_bspline_3d_p_nr_of_of 0 1 0 3 set MaxFTol 9.9999999999999995e-08 -set MaxETol 3.0212868909361951e-07 -set MaxVTol 3.0212868909361962e-07 +set MaxETol 3.2685874571489216e-007 +set MaxVTol 3.2685874571489216e-007 diff --git a/tests/mkface/after_extsurf_and_offset/C6 b/tests/mkface/after_extsurf_and_offset/C6 index 91e3cb2adf..23f6d9ef34 100644 --- a/tests/mkface/after_extsurf_and_offset/C6 +++ b/tests/mkface/after_extsurf_and_offset/C6 @@ -2,6 +2,7 @@ beziercurve beziercurve_nr 3 0 0 0 2 2 2 4 5 2 extsurf es_beziercurve_nr beziercurve_nr 0 0 1 offset es_beziercurve_nr_of es_beziercurve_nr 1 puts "TODO #23133 ALL: Error : Incorrect input parameters are not processed correctly" +puts "REQUIRED All: Faulty shapes in variables faulty_1 to faulty" if { [catch { mkface result es_beziercurve_nr_of 0 3 0 30 } out] == 0 } { puts "Error : Incorrect input parameters are not processed correctly." } diff --git a/tests/mkface/after_extsurf_and_offset/C7 b/tests/mkface/after_extsurf_and_offset/C7 index 29e1c1bf90..ee86c9418c 100644 --- a/tests/mkface/after_extsurf_and_offset/C7 +++ b/tests/mkface/after_extsurf_and_offset/C7 @@ -3,6 +3,7 @@ extsurf es_beziercurve_nr beziercurve_nr 0 0 1 offset es_beziercurve_nr_of es_beziercurve_nr 1 offset es_beziercurve_nr_of_of es_beziercurve_nr_of 5 puts "TODO #23133 ALL: Error : Incorrect input parameters are not processed correctly" +puts "REQUIRED All: Faulty shapes in variables faulty_1 to faulty" if { [catch { mkface result es_beziercurve_nr_of_of 0 3 0 30 } out] == 0 } { puts "Error : Incorrect input parameters are not processed correctly." } diff --git a/tests/mkface/after_extsurf_and_offset/C8 b/tests/mkface/after_extsurf_and_offset/C8 index aea8e92cc1..eefb7d789c 100644 --- a/tests/mkface/after_extsurf_and_offset/C8 +++ b/tests/mkface/after_extsurf_and_offset/C8 @@ -2,6 +2,7 @@ beziercurve beziercurve_r 3 0 0 0 1 2 2 2 2 4 5 2 1 extsurf es_beziercurve_r beziercurve_r 0 0 1 offset es_beziercurve_r_of es_beziercurve_r 1 puts "TODO #23133 ALL: Error : Incorrect input parameters are not processed correctly" +puts "REQUIRED All: Faulty shapes in variables faulty_1 to faulty" if { [catch { mkface result es_beziercurve_r_of 0 3 0 30 } out] == 0 } { puts "Error : Incorrect input parameters are not processed correctly." } diff --git a/tests/mkface/after_extsurf_and_offset/C9 b/tests/mkface/after_extsurf_and_offset/C9 index a6c4831baa..c29543ca42 100644 --- a/tests/mkface/after_extsurf_and_offset/C9 +++ b/tests/mkface/after_extsurf_and_offset/C9 @@ -3,6 +3,7 @@ extsurf es_beziercurve_r beziercurve_r 0 0 1 offset es_beziercurve_r_of es_beziercurve_r 1 offset es_beziercurve_r_of_of es_beziercurve_r_of 5 puts "TODO #23133 ALL: Error : Incorrect input parameters are not processed correctly" +puts "REQUIRED All: Faulty shapes in variables faulty_1 to faulty" if { [catch { mkface result es_beziercurve_r_of_of 0 3 0 30 } out] == 0 } { puts "Error : Incorrect input parameters are not processed correctly." } diff --git a/tests/offset/with_intersect_80/L6 b/tests/offset/with_intersect_80/L6 index 05aed64a79..96047e17a5 100644 --- a/tests/offset/with_intersect_80/L6 +++ b/tests/offset/with_intersect_80/L6 @@ -1,5 +1,6 @@ puts "TODO OCC26577 All: Error : is WRONG because number of EDGE entities in shape" puts "TODO OCC26577 All: Error : is WRONG because number of SHELL entities in shape" +puts "REQUIRED All: Faulty shapes in variables faulty_1 to faulty" restore [locate_data_file bug26663_test_offset_L6.brep] s OFFSETSHAPE ${off_param} {} ${calcul} ${type} checknbshapes result -ref [lrange [nbshapes s] 8 19] diff --git a/tests/offset/with_intersect_80/N7 b/tests/offset/with_intersect_80/N7 index 9494f7d3b7..71fa2ab75a 100644 --- a/tests/offset/with_intersect_80/N7 +++ b/tests/offset/with_intersect_80/N7 @@ -1,5 +1,5 @@ -puts "TODO OCC26577 All: Error : is WRONG because number of EDGE entities in shape" -puts "TODO OCC26577 All: Error : is WRONG because number of SHELL entities in shape" +#puts "TODO OCC26577 All: Error : is WRONG because number of EDGE entities in shape" +#puts "TODO OCC26577 All: Error : is WRONG because number of SHELL entities in shape" restore [locate_data_file bug26663_test_offset_N7.brep] s OFFSETSHAPE ${off_param} {} ${calcul} ${type} checknbshapes result -ref [lrange [nbshapes s] 8 19] diff --git a/tests/sewing/tol_0_01/F1 b/tests/sewing/tol_0_01/F1 index 17d2101a91..3daa035000 100644 --- a/tests/sewing/tol_0_01/F1 +++ b/tests/sewing/tol_0_01/F1 @@ -2,7 +2,7 @@ restore [locate_data_file CCH_indushej.rle] a sewing result $tol a -checkmaxtol result -ref 0.014670260636369852 +checkmaxtol result -ref 0.010269182445458897 checknbshapes result -shell 1 checkfreebounds result 26 checkfaults result a 0 diff --git a/tests/sewing/tol_0_01/F8 b/tests/sewing/tol_0_01/F8 index f7b147bb69..f08c612ea0 100644 --- a/tests/sewing/tol_0_01/F8 +++ b/tests/sewing/tol_0_01/F8 @@ -1,9 +1,9 @@ -puts "TODO OCC24592 ALL: Error : Number of free edges is" +#puts "TODO OCC24592 ALL: Error : Number of free edges is" restore [locate_data_file CCH_indusheq.rle] a sewing result $tol a -checkmaxtol result -ref 0.014624921005106987 +checkmaxtol result -ref 0.0094066994984719748 checknbshapes result -shell 1 -checkfreebounds result 33 +checkfreebounds result 31 checkfaults result a 2 diff --git a/tests/sewing/tol_1/S5 b/tests/sewing/tol_1/S5 index 6a46c56745..945614c3c3 100755 --- a/tests/sewing/tol_1/S5 +++ b/tests/sewing/tol_1/S5 @@ -2,7 +2,7 @@ restore [locate_data_file CIN001_a20.rle] a sewing result $tol a -checkmaxtol result -ref 0.0035821432134069929 +checkmaxtol result -ref 0.0025075002493848949 checknbshapes result -shell 1 checkfreebounds result 74 checkfaults result a 0 diff --git a/tests/sewing/tol_100/C5 b/tests/sewing/tol_100/C5 index 05c52f2cee..110d7f16b7 100644 --- a/tests/sewing/tol_100/C5 +++ b/tests/sewing/tol_100/C5 @@ -2,7 +2,7 @@ restore [locate_data_file CFI_pro11907.rle] a sewing result $tol a -checkmaxtol result -ref 119.7091229132561 +checkmaxtol result -ref 83.796386040226665 checknbshapes result -shell 1 -checkfreebounds result 5 +checkfreebounds result 8 checkfaults result a 0 diff --git a/tests/sewing/tol_100/D3 b/tests/sewing/tol_100/D3 index aee1cbeca6..59b9a08bba 100644 --- a/tests/sewing/tol_100/D3 +++ b/tests/sewing/tol_100/D3 @@ -4,7 +4,7 @@ restore [locate_data_file CFI_pro15441.rle] a sewing result $tol a -checkmaxtol result -ref 77.938759360032321 +checkmaxtol result -ref 72.971139124346976 checknbshapes result -shell 1 checkfreebounds result 4 checkfaults result a 5 diff --git a/tests/sewing/tol_100/I6 b/tests/sewing/tol_100/I6 index 2b0e90824f..09621ac2e6 100755 --- a/tests/sewing/tol_100/I6 +++ b/tests/sewing/tol_100/I6 @@ -4,7 +4,7 @@ restore [locate_data_file CIN901_intcqhmj.rle] a sewing result $tol a -checkmaxtol result -ref 71.039012505679182 +checkmaxtol result -ref 50.653334255238171 checknbshapes result -shell 1 checkfreebounds result 34 checkfaults result a 3 diff --git a/tests/sewing/tol_100/I9 b/tests/sewing/tol_100/I9 index c5cb6dfeb1..ce3c0c243a 100755 --- a/tests/sewing/tol_100/I9 +++ b/tests/sewing/tol_100/I9 @@ -4,7 +4,7 @@ restore [locate_data_file CIN902_intcqhmm.rle] a sewing result $tol a -checkmaxtol result -ref 4.30764e+001 +checkmaxtol result -ref 28.717617980682633 checknbshapes result -shell 1 checkfreebounds result 28 checkfaults result a 11 diff --git a/tests/sewing/tol_100/J1 b/tests/sewing/tol_100/J1 index aa7901677a..99445e9dca 100644 --- a/tests/sewing/tol_100/J1 +++ b/tests/sewing/tol_100/J1 @@ -4,7 +4,7 @@ restore [locate_data_file CIN902_intcqhmn.rle] a sewing result $tol a -checkmaxtol result -ref 31.117378506550729 +checkmaxtol result -ref 32.67324743187833 checknbshapes result -shell 1 checkfreebounds result 47 checkfaults result a 7 diff --git a/tests/sewing/tol_100/J2 b/tests/sewing/tol_100/J2 index b6d95b07f1..6d6eb5a8bc 100644 --- a/tests/sewing/tol_100/J2 +++ b/tests/sewing/tol_100/J2 @@ -4,7 +4,7 @@ restore [locate_data_file CIN902_intcqhmo.rle] a sewing result $tol a -checkmaxtol result -ref 31.117378506550729 +checkmaxtol result -ref 32.67324743187833 checknbshapes result -shell 1 checkfreebounds result 47 checkfaults result a 7 diff --git a/tests/sewing/tol_100/J3 b/tests/sewing/tol_100/J3 index 2c8170d680..0801345660 100755 --- a/tests/sewing/tol_100/J3 +++ b/tests/sewing/tol_100/J3 @@ -4,7 +4,7 @@ restore [locate_data_file CIN902_intcqhmp.rle] a sewing result $tol a -checkmaxtol result -ref 122.47700432877426 +checkmaxtol result -ref 98.605773005137095 checknbshapes result -shell 1 checkfreebounds result 19 checkfaults result a 7 diff --git a/tests/sewing/tol_100/J5 b/tests/sewing/tol_100/J5 index 5198e6cda4..222c567d16 100644 --- a/tests/sewing/tol_100/J5 +++ b/tests/sewing/tol_100/J5 @@ -1,9 +1,9 @@ -puts "TODO OCC24592 ALL: Error : Number of free edges is" +#puts "TODO OCC24592 ALL: Error : Number of free edges is" restore [locate_data_file CIN902_intcqhmr.rle] a sewing result $tol a -checkmaxtol result -ref 103.91426175652668 +checkmaxtol result -ref 69.276181431972319 checknbshapes result -shell 1 checkfreebounds result 21 checkfaults result a 7 diff --git a/tests/sewing/tol_100/J6 b/tests/sewing/tol_100/J6 index abb2495246..d22db11b01 100644 --- a/tests/sewing/tol_100/J6 +++ b/tests/sewing/tol_100/J6 @@ -1,10 +1,10 @@ puts "TODO OCC24592 ALL: Error : Number of faults is" -puts "TODO OCC24592 ALL: Error : Number of free edges is" +#puts "TODO OCC24592 ALL: Error : Number of free edges is" restore [locate_data_file CIN902_intcqhms.rle] a sewing result $tol a -checkmaxtol result -ref 129.56600395440302 +checkmaxtol result -ref 92.086165513507652 checknbshapes result -shell 1 -checkfreebounds result 53 +checkfreebounds result 46 checkfaults result a 30 diff --git a/tests/sewing/tol_100/K1 b/tests/sewing/tol_100/K1 index 07e93e08df..d21f46d7d1 100644 --- a/tests/sewing/tol_100/K1 +++ b/tests/sewing/tol_100/K1 @@ -1,10 +1,10 @@ puts "TODO OCC24592 ALL: Error : Number of free edges is" -puts "TODO OCC24592 ALL: Error : Number of faults is" +#puts "TODO OCC24592 ALL: Error : Number of faults is" restore [locate_data_file CNP002_projoiep.rle] a sewing result $tol a -checkmaxtol result -ref 2.81877e+001 +checkmaxtol result -ref 19.731382910922985 checknbshapes result -shell 1 checkfreebounds result 15 checkfaults result a 1 diff --git a/tests/sewing/tol_100/K3 b/tests/sewing/tol_100/K3 index a6b52d19cf..ca661abbe0 100644 --- a/tests/sewing/tol_100/K3 +++ b/tests/sewing/tol_100/K3 @@ -2,7 +2,7 @@ restore [locate_data_file CNP002_projoier.rle] a sewing result $tol a -checkmaxtol result -ref 106.44142183190296 +checkmaxtol result -ref 70.960954984042459 checknbshapes result -shell 1 checkfreebounds result 39 checkfaults result a 0 diff --git a/tests/sewing/tol_100/T8 b/tests/sewing/tol_100/T8 index e8cc7af5a4..8458403b4b 100755 --- a/tests/sewing/tol_100/T8 +++ b/tests/sewing/tol_100/T8 @@ -2,7 +2,7 @@ restore [locate_data_file ma-test3.rle] a sewing result $tol a -checkmaxtol result -ref 1.75025e+002 +checkmaxtol result -ref 99.599628445249778 checknbshapes result -shell 1 -checkfreebounds result 0 +checkfreebounds result 2 checkfaults result a 0 diff --git a/tests/sewing/tol_100/U1 b/tests/sewing/tol_100/U1 index 705dcda5bb..d468bc8e47 100755 --- a/tests/sewing/tol_100/U1 +++ b/tests/sewing/tol_100/U1 @@ -2,7 +2,7 @@ restore [locate_data_file ma-test5.rle] a sewing result $tol a -checkmaxtol result -ref 1.57832e+000 +checkmaxtol result -ref 1.54111715485806 checknbshapes result -shell 1 checkfreebounds result 0 checkfaults result a 0 diff --git a/tests/sewing/tol_100/Y7 b/tests/sewing/tol_100/Y7 index b68283aa83..78c97e9015 100644 --- a/tests/sewing/tol_100/Y7 +++ b/tests/sewing/tol_100/Y7 @@ -2,7 +2,7 @@ restore [locate_data_file CTO904_pro10095b.rle] a sewing result $tol a -checkmaxtol result -ref 114.90666646781224 +checkmaxtol result -ref 80.434666527468579 checknbshapes result -shell 1 checkfreebounds result 4 checkfaults result a 0