mirror of
https://git.dev.opencascade.org/repos/occt.git
synced 2025-04-06 18:26:22 +03:00
The root of the problem is incorrect processing of cases when intersection line goes through the apex(es) of sphere. The fix improves this situation. The algorithm is taken from DecomposeResult(...) function (see IntPatch_ImpPrmIntersection.cxx file). Before the fix, faltering steps were done to solve this problem. As result, it worked in some particular cases. Now, its possibilities have been extended significantly. Following changes have been made in the fix: 1. Class IntPatch_ALineToWLine has been rewritten cardinally. It touches as interfaces of existing methods as adding/removing some methods/fields. Correction touches both cases: going through seam of Cone/Sphere and through pole(s) of sphere. Old interface did not allow making some actions with analytical line (ALine), e.g. splitting it on several Walking-lines (WLine). 2. Restriction-line support has been removed from Implicit-Implicit intersection result (see IntPatch_Intersection::GeomGeomPerfom(...) method). It connects with the fact that the intersection algorithm itself returns precise intersection line in analytical cases (in compare with parametric intersector). Therefore, we do not need in additional (restriction) line. 3. New class IntPatch_SpecialPoints has been added. This class contains methods to add some special points (such as apex of cone, pole of sphere, point on surface boundary etc.) in intersection line (IntPatch_PointLine). It is based on the static functions, which already exist in IntPatch_ImpPrmIntersection.cxx file (these functions have been moved to the new class). 4. Method IntPatch_WLineTool::ExtendTwoWlinesToEachOther(...) has been renamed to IntPatch_WLineTool::ExtendTwoWLines(...). It is connected with changing main idea of the method. Now it allows extending WLine to the surface boundary or to the singular point (if it is possible): cone apex, sphere pole etc. Interface of this method has been corrected, too. At that, old functionality (extending to each other) has been kept. For implementation of this algorithm, new enumeration "IntPatchWT_WLsConnectionType" has been created. 5. Method IntPatch_PointLine::CurvatureRadiusOfIntersLine(...) has been added. See IntPatch_PointLine.hxx for detail information. It allows correct step computing depended on the local curvature of the intersection line. This method uses geometrical properties of intersected surfaces to compute local curvature. Therefore, it can be applied in wide range of cases even if the intersection curve is not represented in explicit form (e.g. in case of param-param-intersection). 6. Method IntSurf::SetPeriod(...) has been created. 7. Additional check has been added in Draft_Modification::Perform() method for better choice of correct fragment of intersection line for processing DRAFT operation. 8. New overload method IntPatch_Point::SetValue() has been added. 9. Some refactoring of the code has been made. Creation of test case for issue #27431. --------------------------------------------------------------------------------------------- Some test cases have been adjusted according to their new behavior. tests\bugs\modalg_4\bug62 It is really IMPROVEMENT (but fortuitous). tests\bugs\modalg_5\bug25838 The behavior of this test has been reverted to the state before fixing the issue #27341. Main problem has not been fixed in #27341. It was fortuitous improvement. tests\bugs\moddata_2\bug565 Quality of intersection curve was not checked. And the curve is bad on both MASTER and FIX. Input data are really wrong: plane-like-cone. However, on the MASTER, four intersection curves (the quality is insignificant) are expected. On the fix, not empty intersection result is expected simply. tests\boolean\volumemaker\A8 Differences in images and CPU is expected. Difference in images is expected to be fixed in the issue #26020. Now, we should apply this behavior. Much CPU time is spent by IntTools_FaceFace::ComputeTolReached3d(...) and GeomInt_IntSS::BuildPCurves(...) methods calling. These methods are not touched by the algorithm. It is the result of change of intersection curve(s) form. However, the new Curve(s) seems to be valid and can be applied. As result, new behavior can be applied, too. tests\boolean\volumemaker\F8 tests\boolean\volumemaker\F9 tests\boolean\volumemaker\G5 tests\boolean\volumemaker\G6 CPU difference is expected. Much CPU time is spent by IntPatch_PointLine::CurvatureRadiusOfIntersLine(...) method calling. This method is really new (it does not exist on the MASTER) and is really useful. Therefore, we should apply new behavior. tests\boolean\volumemaker\G1 CPU difference is expected. Much CPU time is spent by IntTools_WLineTool::DecompositionOfWLine(...) and IntTools_FaceFace::ComputeTolReached3d(...) methods calling. These methods are not touched by the algorithm. It is the result of change of intersection curve(s) form. However, the new Curve(s) seems to be valid and can be applied. As result, new behavior can be applied, too. tests\bugs\modalg_6\bug26619 Differences in images is expected. The test keeps its BAD status on the FIX. But the result on the fix is nearer to expected than on the MASTER. Issue #27014 is still actual. As before, it is not clear, why the number of entities is different. The number of section curves has not been changed. Interfered entities are the same as on the MASTER. tests\bugs\modalg_5\bug25319_1(2) The reason is described in the issue #27896. Small correction in the test case
1737 lines
61 KiB
C++
1737 lines
61 KiB
C++
// Created by: Modelization
|
|
// 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.
|
|
|
|
#include <stdio.h>
|
|
#include <IntPatch_Intersection.hxx>
|
|
|
|
#include <Adaptor3d_HSurface.hxx>
|
|
#include <Adaptor3d_TopolTool.hxx>
|
|
#include <IntPatch_ALine.hxx>
|
|
#include <IntPatch_ALineToWLine.hxx>
|
|
#include <IntPatch_GLine.hxx>
|
|
#include <IntPatch_ImpImpIntersection.hxx>
|
|
#include <IntPatch_ImpPrmIntersection.hxx>
|
|
#include <IntPatch_PrmPrmIntersection.hxx>
|
|
#include <IntPatch_WLine.hxx>
|
|
#include <IntPatch_WLineTool.hxx>
|
|
|
|
//======================================================================
|
|
// function: SequenceOfLine
|
|
//======================================================================
|
|
const IntPatch_SequenceOfLine& IntPatch_Intersection::SequenceOfLine() const { return(slin); }
|
|
|
|
//======================================================================
|
|
// function: IntPatch_Intersection
|
|
//======================================================================
|
|
IntPatch_Intersection::IntPatch_Intersection ()
|
|
: done(Standard_False),
|
|
//empt, tgte, oppo,
|
|
myTolArc(0.0), myTolTang(0.0),
|
|
myUVMaxStep(0.0), myFleche(0.0),
|
|
myIsStartPnt(Standard_False)
|
|
//myU1Start, myV1Start, myU2Start, myV2Start
|
|
{
|
|
}
|
|
|
|
//======================================================================
|
|
// function: IntPatch_Intersection
|
|
//======================================================================
|
|
IntPatch_Intersection::IntPatch_Intersection(const Handle(Adaptor3d_HSurface)& S1,
|
|
const Handle(Adaptor3d_TopolTool)& D1,
|
|
const Handle(Adaptor3d_HSurface)& S2,
|
|
const Handle(Adaptor3d_TopolTool)& D2,
|
|
const Standard_Real TolArc,
|
|
const Standard_Real TolTang)
|
|
: done(Standard_False),
|
|
//empt, tgte, oppo,
|
|
myTolArc(TolArc), myTolTang(TolTang),
|
|
myUVMaxStep(0.0), myFleche(0.0),
|
|
myIsStartPnt(Standard_False)
|
|
//myU1Start, myV1Start, myU2Start, myV2Start
|
|
{
|
|
if(myTolArc<1e-8) myTolArc=1e-8;
|
|
if(myTolTang<1e-8) myTolTang=1e-8;
|
|
if(myTolArc>0.5) myTolArc=0.5;
|
|
if(myTolTang>0.5) myTolTang=0.5;
|
|
Perform(S1,D1,S2,D2,TolArc,TolTang);
|
|
}
|
|
|
|
//======================================================================
|
|
// function: IntPatch_Intersection
|
|
//======================================================================
|
|
IntPatch_Intersection::IntPatch_Intersection(const Handle(Adaptor3d_HSurface)& S1,
|
|
const Handle(Adaptor3d_TopolTool)& D1,
|
|
const Standard_Real TolArc,
|
|
const Standard_Real TolTang)
|
|
: done(Standard_False),
|
|
//empt, tgte, oppo,
|
|
myTolArc(TolArc), myTolTang(TolTang),
|
|
myUVMaxStep(0.0), myFleche(0.0),
|
|
myIsStartPnt(Standard_False)
|
|
//myU1Start, myV1Start, myU2Start, myV2Start
|
|
{
|
|
Perform(S1,D1,TolArc,TolTang);
|
|
}
|
|
|
|
//======================================================================
|
|
// function: SetTolerances
|
|
//======================================================================
|
|
void IntPatch_Intersection::SetTolerances(const Standard_Real TolArc,
|
|
const Standard_Real TolTang,
|
|
const Standard_Real UVMaxStep,
|
|
const Standard_Real Fleche)
|
|
{
|
|
myTolArc = TolArc;
|
|
myTolTang = TolTang;
|
|
myUVMaxStep = UVMaxStep;
|
|
myFleche = Fleche;
|
|
if(myTolArc<1e-8) myTolArc=1e-8;
|
|
if(myTolTang<1e-8) myTolTang=1e-8;
|
|
if(myTolArc>0.5) myTolArc=0.5;
|
|
if(myTolTang>0.5) myTolTang=0.5;
|
|
if(myFleche<1.0e-3) myFleche=1e-3;
|
|
if(myUVMaxStep<1.0e-3) myUVMaxStep=1e-3;
|
|
if(myFleche>10) myFleche=10;
|
|
if(myUVMaxStep>0.5) myUVMaxStep=0.5;
|
|
}
|
|
|
|
//======================================================================
|
|
// function: Perform
|
|
//======================================================================
|
|
void IntPatch_Intersection::Perform(const Handle(Adaptor3d_HSurface)& S1,
|
|
const Handle(Adaptor3d_TopolTool)& D1,
|
|
const Standard_Real TolArc,
|
|
const Standard_Real TolTang)
|
|
{
|
|
myTolArc = TolArc;
|
|
myTolTang = TolTang;
|
|
if(myFleche == 0.0) myFleche = 0.01;
|
|
if(myUVMaxStep==0.0) myUVMaxStep = 0.01;
|
|
|
|
done = Standard_True;
|
|
spnt.Clear();
|
|
slin.Clear();
|
|
|
|
empt = Standard_True;
|
|
tgte = Standard_False;
|
|
oppo = Standard_False;
|
|
|
|
switch (S1->GetType())
|
|
{
|
|
case GeomAbs_Plane:
|
|
case GeomAbs_Cylinder:
|
|
case GeomAbs_Sphere:
|
|
case GeomAbs_Cone:
|
|
case GeomAbs_Torus: break;
|
|
default:
|
|
{
|
|
IntPatch_PrmPrmIntersection interpp;
|
|
interpp.Perform(S1,D1,TolTang,TolArc,myFleche,myUVMaxStep);
|
|
if (interpp.IsDone())
|
|
{
|
|
done = Standard_True;
|
|
tgte = Standard_False;
|
|
empt = interpp.IsEmpty();
|
|
const Standard_Integer nblm = interpp.NbLines();
|
|
for (Standard_Integer i=1; i<=nblm; i++) slin.Append(interpp.Line(i));
|
|
}
|
|
}
|
|
break;
|
|
}
|
|
}
|
|
|
|
/////////////////////////////////////////////////////////////////////////////
|
|
// These several support functions provide methods which can help basic //
|
|
// algorithm to intersect infinite surfaces of the following types: //
|
|
// //
|
|
// a.) SurfaceOfExtrusion; //
|
|
// b.) SurfaceOfRevolution; //
|
|
// c.) OffsetSurface. //
|
|
// //
|
|
/////////////////////////////////////////////////////////////////////////////
|
|
#include <TColgp_Array1OfXYZ.hxx>
|
|
#include <TColgp_Array1OfPnt.hxx>
|
|
#include <TColgp_SequenceOfPnt.hxx>
|
|
#include <Extrema_ExtPS.hxx>
|
|
#include <Extrema_POnSurf.hxx>
|
|
#include <Geom2d_Curve.hxx>
|
|
#include <Geom2dAPI_InterCurveCurve.hxx>
|
|
#include <GeomAdaptor.hxx>
|
|
#include <GeomAdaptor_HCurve.hxx>
|
|
#include <GeomAdaptor_Curve.hxx>
|
|
#include <GeomAdaptor_Surface.hxx>
|
|
#include <GeomAdaptor_HSurface.hxx>
|
|
#include <Geom_Plane.hxx>
|
|
#include <ProjLib_ProjectOnPlane.hxx>
|
|
#include <GeomProjLib.hxx>
|
|
#include <ElCLib.hxx>
|
|
#include <Geom_TrimmedCurve.hxx>
|
|
#include <Geom_Surface.hxx>
|
|
#include <Geom_SurfaceOfLinearExtrusion.hxx>
|
|
#include <Geom_OffsetSurface.hxx>
|
|
#include <Geom_SurfaceOfRevolution.hxx>
|
|
#include <Geom_RectangularTrimmedSurface.hxx>
|
|
|
|
//===============================================================
|
|
//function: FUN_GetMinMaxXYZPnt
|
|
//===============================================================
|
|
static void FUN_GetMinMaxXYZPnt( const Handle(Adaptor3d_HSurface)& S,
|
|
gp_Pnt& pMin, gp_Pnt& pMax )
|
|
{
|
|
const Standard_Real DU = 0.25 * Abs(S->LastUParameter() - S->FirstUParameter());
|
|
const Standard_Real DV = 0.25 * Abs(S->LastVParameter() - S->FirstVParameter());
|
|
Standard_Real tMinXYZ = RealLast();
|
|
Standard_Real tMaxXYZ = -tMinXYZ;
|
|
gp_Pnt PUV, ptMax, ptMin;
|
|
for(Standard_Real U = S->FirstUParameter(); U <= S->LastUParameter(); U += DU)
|
|
{
|
|
for(Standard_Real V = S->FirstVParameter(); V <= S->LastVParameter(); V += DV)
|
|
{
|
|
S->D0(U,V,PUV);
|
|
const Standard_Real cXYZ = PUV.XYZ().Modulus();
|
|
if(cXYZ > tMaxXYZ) { tMaxXYZ = cXYZ; ptMax = PUV; }
|
|
if(cXYZ < tMinXYZ) { tMinXYZ = cXYZ; ptMin = PUV; }
|
|
}
|
|
}
|
|
pMin = ptMin;
|
|
pMax = ptMax;
|
|
}
|
|
//==========================================================================
|
|
//function: FUN_TrimInfSurf
|
|
//==========================================================================
|
|
static void FUN_TrimInfSurf(const gp_Pnt& Pmin,
|
|
const gp_Pnt& Pmax,
|
|
const Handle(Adaptor3d_HSurface)& InfSurf,
|
|
const Standard_Real& AlternativeTrimPrm,
|
|
Handle(Adaptor3d_HSurface)& TrimS)
|
|
{
|
|
Standard_Real TP = AlternativeTrimPrm;
|
|
Extrema_ExtPS ext1(Pmin, InfSurf->Surface(), 1.e-7, 1.e-7);
|
|
Extrema_ExtPS ext2(Pmax, InfSurf->Surface(), 1.e-7, 1.e-7);
|
|
if(ext1.IsDone() || ext2.IsDone())
|
|
{
|
|
Standard_Real Umax = -1.e+100, Umin = 1.e+100, Vmax = -1.e+100, Vmin = 1.e+100, cU, cV;
|
|
if(ext1.IsDone())
|
|
{
|
|
for(Standard_Integer i = 1; i <= ext1.NbExt(); i++)
|
|
{
|
|
const Extrema_POnSurf & pons = ext1.Point(i);
|
|
pons.Parameter(cU,cV);
|
|
if(cU > Umax) Umax = cU;
|
|
if(cU < Umin) Umin = cU;
|
|
if(cV > Vmax) Vmax = cV;
|
|
if(cV < Vmin) Vmin = cV;
|
|
}
|
|
}
|
|
if(ext2.IsDone())
|
|
{
|
|
for(Standard_Integer i = 1; i <= ext2.NbExt(); i++)
|
|
{
|
|
const Extrema_POnSurf & pons = ext2.Point(i);
|
|
pons.Parameter(cU,cV);
|
|
if(cU > Umax) Umax = cU;
|
|
if(cU < Umin) Umin = cU;
|
|
if(cV > Vmax) Vmax = cV;
|
|
if(cV < Vmin) Vmin = cV;
|
|
}
|
|
}
|
|
TP = Max(Abs(Umin),Max(Abs(Umax),Max(Abs(Vmin),Abs(Vmax))));
|
|
}
|
|
if(TP == 0.) { TrimS = InfSurf; return; }
|
|
else
|
|
{
|
|
const Standard_Boolean Uinf = Precision::IsNegativeInfinite(InfSurf->FirstUParameter());
|
|
const Standard_Boolean Usup = Precision::IsPositiveInfinite(InfSurf->LastUParameter());
|
|
const Standard_Boolean Vinf = Precision::IsNegativeInfinite(InfSurf->FirstVParameter());
|
|
const Standard_Boolean Vsup = Precision::IsPositiveInfinite(InfSurf->LastVParameter());
|
|
Handle(Adaptor3d_HSurface) TmpSS;
|
|
Standard_Integer IsTrimed = 0;
|
|
const Standard_Real tp = 1000.0 * TP;
|
|
if(Vinf && Vsup) { TrimS = InfSurf->VTrim(-tp, tp, 1.0e-7); IsTrimed = 1; }
|
|
if(Vinf && !Vsup){ TrimS = InfSurf->VTrim(-tp, InfSurf->LastVParameter(), 1.0e-7); IsTrimed = 1; }
|
|
if(!Vinf && Vsup){ TrimS = InfSurf->VTrim(InfSurf->FirstVParameter(), tp, 1.0e-7); IsTrimed = 1; }
|
|
if(IsTrimed)
|
|
{
|
|
TmpSS = TrimS;
|
|
if(Uinf && Usup) TrimS = TmpSS->UTrim(-tp, tp, 1.0e-7);
|
|
if(Uinf && !Usup) TrimS = TmpSS->UTrim(-tp, InfSurf->LastUParameter(), 1.0e-7);
|
|
if(!Uinf && Usup) TrimS = TmpSS->UTrim(InfSurf->FirstUParameter(), tp, 1.0e-7);
|
|
}
|
|
else
|
|
{
|
|
if(Uinf && Usup) TrimS = InfSurf->UTrim(-tp, tp, 1.0e-7);
|
|
if(Uinf && !Usup) TrimS = InfSurf->UTrim(-tp, InfSurf->LastUParameter(), 1.0e-7);
|
|
if(!Uinf && Usup) TrimS = InfSurf->UTrim(InfSurf->FirstUParameter(), tp, 1.0e-7);
|
|
}
|
|
}
|
|
}
|
|
//================================================================================
|
|
//function: FUN_GetUiso
|
|
//================================================================================
|
|
static void FUN_GetUiso(const Handle(Geom_Surface)& GS,
|
|
const GeomAbs_SurfaceType& T,
|
|
const Standard_Real& FirstV,
|
|
const Standard_Real& LastV,
|
|
const Standard_Boolean& IsVC,
|
|
const Standard_Boolean& IsVP,
|
|
const Standard_Real& U,
|
|
Handle(Geom_Curve)& I)
|
|
{
|
|
if(T != GeomAbs_OffsetSurface)
|
|
{
|
|
Handle(Geom_Curve) gc = GS->UIso(U);
|
|
if(IsVP && (FirstV == 0.0 && LastV == (2.*M_PI))) I = gc;
|
|
else
|
|
{
|
|
Handle(Geom_TrimmedCurve) gtc = new Geom_TrimmedCurve(gc,FirstV,LastV);
|
|
//szv:I = Handle(Geom_Curve)::DownCast(gtc);
|
|
I = gtc;
|
|
}
|
|
}
|
|
else//OffsetSurface
|
|
{
|
|
const Handle(Geom_OffsetSurface) gos = Handle(Geom_OffsetSurface)::DownCast (GS);
|
|
const Handle(Geom_Surface) bs = gos->BasisSurface();
|
|
Handle(Geom_Curve) gcbs = bs->UIso(U);
|
|
GeomAdaptor_Curve gac(gcbs);
|
|
const GeomAbs_CurveType GACT = gac.GetType();
|
|
if(IsVP || IsVC || GACT == GeomAbs_BSplineCurve || GACT == GeomAbs_BezierCurve || Abs(LastV - FirstV) < 1.e+5)
|
|
{
|
|
Handle(Geom_Curve) gc = gos->UIso(U);
|
|
if(IsVP && (FirstV == 0.0 && LastV == (2*M_PI))) I = gc;
|
|
else
|
|
{
|
|
Handle(Geom_TrimmedCurve) gtc = new Geom_TrimmedCurve(gc,FirstV,LastV);
|
|
//szv:I = Handle(Geom_Curve)::DownCast(gtc);
|
|
I = gtc;
|
|
}
|
|
}
|
|
else//Offset Line, Parab, Hyperb
|
|
{
|
|
Standard_Real VmTr, VMTr;
|
|
if(GACT != GeomAbs_Hyperbola)
|
|
{
|
|
if(FirstV >= 0. && LastV >= 0.){ VmTr = FirstV; VMTr = ((LastV - FirstV) > 1.e+4) ? (FirstV + 1.e+4) : LastV; }
|
|
else if(FirstV < 0. && LastV < 0.){ VMTr = LastV; VmTr = ((FirstV - LastV) < -1.e+4) ? (LastV - 1.e+4) : FirstV; }
|
|
else { VmTr = (FirstV < -1.e+4) ? -1.e+4 : FirstV; VMTr = (LastV > 1.e+4) ? 1.e+4 : LastV; }
|
|
}
|
|
else//Hyperbola
|
|
{
|
|
if(FirstV >= 0. && LastV >= 0.)
|
|
{
|
|
if(FirstV > 4.) return;
|
|
VmTr = FirstV; VMTr = (LastV > 4.) ? 4. : LastV;
|
|
}
|
|
else if(FirstV < 0. && LastV < 0.)
|
|
{
|
|
if(LastV < -4.) return;
|
|
VMTr = LastV; VmTr = (FirstV < -4.) ? -4. : FirstV;
|
|
}
|
|
else { VmTr = (FirstV < -4.) ? -4. : FirstV; VMTr = (LastV > 4.) ? 4. : LastV; }
|
|
}
|
|
//Make trimmed surface
|
|
Handle(Geom_RectangularTrimmedSurface) rts = new Geom_RectangularTrimmedSurface(gos,VmTr,VMTr,Standard_True);
|
|
I = rts->UIso(U);
|
|
}
|
|
}
|
|
}
|
|
//================================================================================
|
|
//function: FUN_GetViso
|
|
//================================================================================
|
|
static void FUN_GetViso(const Handle(Geom_Surface)& GS,
|
|
const GeomAbs_SurfaceType& T,
|
|
const Standard_Real& FirstU,
|
|
const Standard_Real& LastU,
|
|
const Standard_Boolean& IsUC,
|
|
const Standard_Boolean& IsUP,
|
|
const Standard_Real& V,
|
|
Handle(Geom_Curve)& I)
|
|
{
|
|
if(T != GeomAbs_OffsetSurface)
|
|
{
|
|
Handle(Geom_Curve) gc = GS->VIso(V);
|
|
if(IsUP && (FirstU == 0.0 && LastU == (2*M_PI))) I = gc;
|
|
else
|
|
{
|
|
Handle(Geom_TrimmedCurve) gtc = new Geom_TrimmedCurve(gc,FirstU,LastU);
|
|
//szv:I = Handle(Geom_Curve)::DownCast(gtc);
|
|
I = gtc;
|
|
}
|
|
}
|
|
else//OffsetSurface
|
|
{
|
|
const Handle(Geom_OffsetSurface) gos = Handle(Geom_OffsetSurface)::DownCast (GS);
|
|
const Handle(Geom_Surface) bs = gos->BasisSurface();
|
|
Handle(Geom_Curve) gcbs = bs->VIso(V);
|
|
GeomAdaptor_Curve gac(gcbs);
|
|
const GeomAbs_CurveType GACT = gac.GetType();
|
|
if(IsUP || IsUC || GACT == GeomAbs_BSplineCurve || GACT == GeomAbs_BezierCurve || Abs(LastU - FirstU) < 1.e+5)
|
|
{
|
|
Handle(Geom_Curve) gc = gos->VIso(V);
|
|
if(IsUP && (FirstU == 0.0 && LastU == (2*M_PI))) I = gc;
|
|
else
|
|
{
|
|
Handle(Geom_TrimmedCurve) gtc = new Geom_TrimmedCurve(gc,FirstU,LastU);
|
|
//szv:I = Handle(Geom_Curve)::DownCast(gtc);
|
|
I = gtc;
|
|
}
|
|
}
|
|
else//Offset Line, Parab, Hyperb
|
|
{
|
|
Standard_Real UmTr, UMTr;
|
|
if(GACT != GeomAbs_Hyperbola)
|
|
{
|
|
if(FirstU >= 0. && LastU >= 0.){ UmTr = FirstU; UMTr = ((LastU - FirstU) > 1.e+4) ? (FirstU + 1.e+4) : LastU; }
|
|
else if(FirstU < 0. && LastU < 0.){ UMTr = LastU; UmTr = ((FirstU - LastU) < -1.e+4) ? (LastU - 1.e+4) : FirstU; }
|
|
else { UmTr = (FirstU < -1.e+4) ? -1.e+4 : FirstU; UMTr = (LastU > 1.e+4) ? 1.e+4 : LastU; }
|
|
}
|
|
else//Hyperbola
|
|
{
|
|
if(FirstU >= 0. && LastU >= 0.)
|
|
{
|
|
if(FirstU > 4.) return;
|
|
UmTr = FirstU; UMTr = (LastU > 4.) ? 4. : LastU;
|
|
}
|
|
else if(FirstU < 0. && LastU < 0.)
|
|
{
|
|
if(LastU < -4.) return;
|
|
UMTr = LastU; UmTr = (FirstU < -4.) ? -4. : FirstU;
|
|
}
|
|
else { UmTr = (FirstU < -4.) ? -4. : FirstU; UMTr = (LastU > 4.) ? 4. : LastU; }
|
|
}
|
|
//Make trimmed surface
|
|
Handle(Geom_RectangularTrimmedSurface) rts = new Geom_RectangularTrimmedSurface(gos,UmTr,UMTr,Standard_True);
|
|
I = rts->VIso(V);
|
|
}
|
|
}
|
|
}
|
|
//================================================================================
|
|
//function: FUN_PL_Intersection
|
|
//================================================================================
|
|
static void FUN_PL_Intersection(const Handle(Adaptor3d_HSurface)& S1,
|
|
const GeomAbs_SurfaceType& T1,
|
|
const Handle(Adaptor3d_HSurface)& S2,
|
|
const GeomAbs_SurfaceType& T2,
|
|
Standard_Boolean& IsOk,
|
|
TColgp_SequenceOfPnt& SP,
|
|
gp_Vec& DV)
|
|
{
|
|
IsOk = Standard_False;
|
|
// 1. Check: both surfaces have U(V)isos - lines.
|
|
DV = gp_Vec(0.,0.,1.);
|
|
Standard_Boolean isoS1isLine[2] = {0, 0};
|
|
Standard_Boolean isoS2isLine[2] = {0, 0};
|
|
Handle(Geom_Curve) C1, C2;
|
|
const GeomAdaptor_Surface & gas1 = *(GeomAdaptor_Surface*)(&(S1->Surface()));
|
|
const GeomAdaptor_Surface & gas2 = *(GeomAdaptor_Surface*)(&(S2->Surface()));
|
|
const Handle(Geom_Surface) gs1 = gas1.Surface();
|
|
const Handle(Geom_Surface) gs2 = gas2.Surface();
|
|
Standard_Real MS1[2], MS2[2];
|
|
MS1[0] = 0.5 * (S1->LastUParameter() + S1->FirstUParameter());
|
|
MS1[1] = 0.5 * (S1->LastVParameter() + S1->FirstVParameter());
|
|
MS2[0] = 0.5 * (S2->LastUParameter() + S2->FirstUParameter());
|
|
MS2[1] = 0.5 * (S2->LastVParameter() + S2->FirstVParameter());
|
|
if(T1 == GeomAbs_SurfaceOfExtrusion) isoS1isLine[0] = Standard_True;
|
|
else if(!S1->IsVPeriodic() && !S1->IsVClosed()) {
|
|
if(T1 != GeomAbs_OffsetSurface) C1 = gs1->UIso(MS1[0]);
|
|
else {
|
|
const Handle(Geom_OffsetSurface) gos = Handle(Geom_OffsetSurface)::DownCast (gs1);
|
|
const Handle(Geom_Surface) bs = gos->BasisSurface();
|
|
C1 = bs->UIso(MS1[0]);
|
|
}
|
|
GeomAdaptor_Curve gac(C1);
|
|
if(gac.GetType() == GeomAbs_Line) isoS1isLine[0] = Standard_True;
|
|
}
|
|
if(!S1->IsUPeriodic() && !S1->IsUClosed()) {
|
|
if(T1 != GeomAbs_OffsetSurface) C1 = gs1->VIso(MS1[1]);
|
|
else {
|
|
const Handle(Geom_OffsetSurface) gos = Handle(Geom_OffsetSurface)::DownCast (gs1);
|
|
const Handle(Geom_Surface) bs = gos->BasisSurface();
|
|
C1 = bs->VIso(MS1[1]);
|
|
}
|
|
GeomAdaptor_Curve gac(C1);
|
|
if(gac.GetType() == GeomAbs_Line) isoS1isLine[1] = Standard_True;
|
|
}
|
|
if(T2 == GeomAbs_SurfaceOfExtrusion) isoS2isLine[0] = Standard_True;
|
|
else if(!S2->IsVPeriodic() && !S2->IsVClosed()) {
|
|
if(T2 != GeomAbs_OffsetSurface) C2 = gs2->UIso(MS2[0]);
|
|
else {
|
|
const Handle(Geom_OffsetSurface) gos = Handle(Geom_OffsetSurface)::DownCast (gs2);
|
|
const Handle(Geom_Surface) bs = gos->BasisSurface();
|
|
C2 = bs->UIso(MS2[0]);
|
|
}
|
|
GeomAdaptor_Curve gac(C2);
|
|
if(gac.GetType() == GeomAbs_Line) isoS2isLine[0] = Standard_True;
|
|
}
|
|
if(!S2->IsUPeriodic() && !S2->IsUClosed()) {
|
|
if(T2 != GeomAbs_OffsetSurface) C2 = gs2->VIso(MS2[1]);
|
|
else {
|
|
const Handle(Geom_OffsetSurface) gos = Handle(Geom_OffsetSurface)::DownCast (gs2);
|
|
const Handle(Geom_Surface) bs = gos->BasisSurface();
|
|
C2 = bs->VIso(MS2[1]);
|
|
}
|
|
GeomAdaptor_Curve gac(C2);
|
|
if(gac.GetType() == GeomAbs_Line) isoS2isLine[1] = Standard_True;
|
|
}
|
|
Standard_Boolean IsBothLines = ((isoS1isLine[0] || isoS1isLine[1]) &&
|
|
(isoS2isLine[0] || isoS2isLine[1]));
|
|
if(!IsBothLines){
|
|
return;
|
|
}
|
|
// 2. Check: Uiso lines of both surfaces are collinear.
|
|
gp_Pnt puvS1, puvS2;
|
|
gp_Vec derS1[2], derS2[2];
|
|
S1->D1(MS1[0], MS1[1], puvS1, derS1[0], derS1[1]);
|
|
S2->D1(MS2[0], MS2[1], puvS2, derS2[0], derS2[1]);
|
|
C1.Nullify(); C2.Nullify();
|
|
Standard_Integer iso = 0;
|
|
if(isoS1isLine[0] && isoS2isLine[0] &&
|
|
derS1[1].IsParallel(derS2[1],Precision::Angular())) {
|
|
iso = 1;
|
|
FUN_GetViso(gs1,T1,S1->FirstUParameter(),S1->LastUParameter(),
|
|
S1->IsUClosed(),S1->IsUPeriodic(),MS1[1],C1);
|
|
FUN_GetViso(gs2,T2,S2->FirstUParameter(),S2->LastUParameter(),
|
|
S2->IsUClosed(),S2->IsUPeriodic(),MS2[1],C2);
|
|
}
|
|
else if(isoS1isLine[0] && isoS2isLine[1] &&
|
|
derS1[1].IsParallel(derS2[0],Precision::Angular())) {
|
|
iso = 1;
|
|
FUN_GetViso(gs1,T1,S1->FirstUParameter(),S1->LastUParameter(),
|
|
S1->IsUClosed(),S1->IsUPeriodic(),MS1[1],C1);
|
|
FUN_GetUiso(gs2,T2,S2->FirstVParameter(),S2->LastVParameter(),
|
|
S2->IsVClosed(),S2->IsVPeriodic(),MS2[0],C2);
|
|
}
|
|
else if(isoS1isLine[1] && isoS2isLine[0] &&
|
|
derS1[0].IsParallel(derS2[1],Precision::Angular())) {
|
|
iso = 0;
|
|
FUN_GetUiso(gs1,T1,S1->FirstVParameter(),S1->LastVParameter(),
|
|
S1->IsVClosed(),S1->IsVPeriodic(),MS1[0],C1);
|
|
FUN_GetViso(gs2,T2,S2->FirstUParameter(),S2->LastUParameter(),
|
|
S2->IsUClosed(),S2->IsUPeriodic(),MS2[1],C2);
|
|
}
|
|
else if(isoS1isLine[1] && isoS2isLine[1] &&
|
|
derS1[0].IsParallel(derS2[0],Precision::Angular())) {
|
|
iso = 0;
|
|
FUN_GetUiso(gs1,T1,S1->FirstVParameter(),S1->LastVParameter(),
|
|
S1->IsVClosed(),S1->IsVPeriodic(),MS1[0],C1);
|
|
FUN_GetUiso(gs2,T2,S2->FirstVParameter(),S2->LastVParameter(),
|
|
S2->IsVClosed(),S2->IsVPeriodic(),MS2[0],C2);
|
|
}
|
|
else {
|
|
IsOk = Standard_False;
|
|
return;
|
|
}
|
|
IsOk = Standard_True;
|
|
// 3. Make intersections of V(U)isos
|
|
if(C1.IsNull() || C2.IsNull()) return;
|
|
DV = derS1[iso];
|
|
Handle(Geom_Plane) GPln = new Geom_Plane(gp_Pln(puvS1,gp_Dir(DV)));
|
|
Handle(Geom_Curve) C1Prj =
|
|
GeomProjLib::ProjectOnPlane(C1,GPln,gp_Dir(DV),Standard_True);
|
|
Handle(Geom_Curve) C2Prj =
|
|
GeomProjLib::ProjectOnPlane(C2,GPln,gp_Dir(DV),Standard_True);
|
|
if(C1Prj.IsNull() || C2Prj.IsNull()) return;
|
|
Handle(Geom2d_Curve) C1Prj2d = GeomProjLib::Curve2d (C1Prj,GPln);
|
|
Handle(Geom2d_Curve) C2Prj2d = GeomProjLib::Curve2d (C2Prj,GPln);
|
|
Geom2dAPI_InterCurveCurve ICC(C1Prj2d,C2Prj2d,1.0e-7);
|
|
if(ICC.NbPoints() > 0 )
|
|
{
|
|
for(Standard_Integer ip = 1; ip <= ICC.NbPoints(); ip++)
|
|
{
|
|
gp_Pnt2d P = ICC.Point(ip);
|
|
gp_Pnt P3d = ElCLib::To3d(gp_Ax2(puvS1,gp_Dir(DV)),P);
|
|
SP.Append(P3d);
|
|
}
|
|
}
|
|
}
|
|
//================================================================================
|
|
//function: FUN_NewFirstLast
|
|
//================================================================================
|
|
static void FUN_NewFirstLast(const GeomAbs_CurveType& ga_ct,
|
|
const Standard_Real& Fst,
|
|
const Standard_Real& Lst,
|
|
const Standard_Real& TrVal,
|
|
Standard_Real& NewFst,
|
|
Standard_Real& NewLst,
|
|
Standard_Boolean& NeedTr)
|
|
{
|
|
NewFst = Fst; NewLst = Lst; NeedTr = Standard_False;
|
|
switch (ga_ct)
|
|
{
|
|
case GeomAbs_Line:
|
|
case GeomAbs_Parabola:
|
|
{
|
|
if(Abs(Lst - Fst) > TrVal)
|
|
{
|
|
if(Fst >= 0. && Lst >= 0.)
|
|
{
|
|
NewFst = Fst;
|
|
NewLst = ((Fst + TrVal) < Lst) ? (Fst + TrVal) : Lst;
|
|
}
|
|
if(Fst < 0. && Lst < 0.)
|
|
{
|
|
NewLst = Lst;
|
|
NewFst = ((Lst - TrVal) > Fst) ? (Lst - TrVal) : Fst;
|
|
}
|
|
else
|
|
{
|
|
NewFst = (Fst < -TrVal) ? -TrVal : Fst;
|
|
NewLst = (Lst > TrVal) ? TrVal : Lst;
|
|
}
|
|
NeedTr = Standard_True;
|
|
}
|
|
break;
|
|
}
|
|
case GeomAbs_Hyperbola:
|
|
{
|
|
if(Abs(Lst - Fst) > 10.)
|
|
{
|
|
if(Fst >= 0. && Lst >= 0.)
|
|
{
|
|
if(Fst > 4.) return;
|
|
NewFst = Fst;
|
|
NewLst = (Lst > 4.) ? 4. : Lst;
|
|
}
|
|
if(Fst < 0. && Lst < 0.)
|
|
{
|
|
if(Lst < -4.) return;
|
|
NewLst = Lst;
|
|
NewFst = (Fst < -4.) ? -4. : Fst;
|
|
}
|
|
else
|
|
{
|
|
NewFst = (Fst < -4.) ? -4. : Fst;
|
|
NewLst = (Lst > 4.) ? 4. : Lst;
|
|
}
|
|
NeedTr = Standard_True;
|
|
}
|
|
break;
|
|
}
|
|
default:
|
|
break;
|
|
}
|
|
}
|
|
//================================================================================
|
|
//function: FUN_TrimBothSurf
|
|
//================================================================================
|
|
static void FUN_TrimBothSurf(const Handle(Adaptor3d_HSurface)& S1,
|
|
const GeomAbs_SurfaceType& T1,
|
|
const Handle(Adaptor3d_HSurface)& S2,
|
|
const GeomAbs_SurfaceType& T2,
|
|
const Standard_Real& TV,
|
|
Handle(Adaptor3d_HSurface)& NS1,
|
|
Handle(Adaptor3d_HSurface)& NS2)
|
|
{
|
|
const GeomAdaptor_Surface & gas1 = *(GeomAdaptor_Surface*)(&(S1->Surface()));
|
|
const GeomAdaptor_Surface & gas2 = *(GeomAdaptor_Surface*)(&(S2->Surface()));
|
|
const Handle(Geom_Surface) gs1 = gas1.Surface();
|
|
const Handle(Geom_Surface) gs2 = gas2.Surface();
|
|
const Standard_Real UM1 = 0.5 * (S1->LastUParameter() + S1->FirstUParameter());
|
|
const Standard_Real UM2 = 0.5 * (S2->LastUParameter() + S2->FirstUParameter());
|
|
const Standard_Real VM1 = 0.5 * (S1->LastVParameter() + S1->FirstVParameter());
|
|
const Standard_Real VM2 = 0.5 * (S2->LastVParameter() + S2->FirstVParameter());
|
|
Handle(Geom_Curve) visoS1, visoS2, uisoS1, uisoS2;
|
|
if(T1 != GeomAbs_OffsetSurface){ visoS1 = gs1->VIso(VM1); uisoS1 = gs1->UIso(UM1); }
|
|
else
|
|
{
|
|
const Handle(Geom_OffsetSurface) gos = Handle(Geom_OffsetSurface)::DownCast (gs1);
|
|
const Handle(Geom_Surface) bs = gos->BasisSurface();
|
|
visoS1 = bs->VIso(VM1); uisoS1 = bs->UIso(UM1);
|
|
}
|
|
if(T2 != GeomAbs_OffsetSurface){ visoS2 = gs2->VIso(VM2); uisoS2 = gs2->UIso(UM2); }
|
|
else
|
|
{
|
|
const Handle(Geom_OffsetSurface) gos = Handle(Geom_OffsetSurface)::DownCast (gs2);
|
|
const Handle(Geom_Surface) bs = gos->BasisSurface();
|
|
visoS2 = bs->VIso(VM2); uisoS2 = bs->UIso(UM2);
|
|
}
|
|
if(uisoS1.IsNull() || uisoS2.IsNull() || visoS1.IsNull() || visoS2.IsNull()){ NS1 = S1; NS2 = S2; return; }
|
|
GeomAdaptor_Curve gau1(uisoS1);
|
|
GeomAdaptor_Curve gav1(visoS1);
|
|
GeomAdaptor_Curve gau2(uisoS2);
|
|
GeomAdaptor_Curve gav2(visoS2);
|
|
GeomAbs_CurveType GA_U1 = gau1.GetType();
|
|
GeomAbs_CurveType GA_V1 = gav1.GetType();
|
|
GeomAbs_CurveType GA_U2 = gau2.GetType();
|
|
GeomAbs_CurveType GA_V2 = gav2.GetType();
|
|
Standard_Boolean TrmU1 = Standard_False;
|
|
Standard_Boolean TrmV1 = Standard_False;
|
|
Standard_Boolean TrmU2 = Standard_False;
|
|
Standard_Boolean TrmV2 = Standard_False;
|
|
Standard_Real V1S1,V2S1,U1S1,U2S1, V1S2,V2S2,U1S2,U2S2;
|
|
FUN_NewFirstLast(GA_U1,S1->FirstVParameter(),S1->LastVParameter(),TV,V1S1,V2S1,TrmV1);
|
|
FUN_NewFirstLast(GA_V1,S1->FirstUParameter(),S1->LastUParameter(),TV,U1S1,U2S1,TrmU1);
|
|
FUN_NewFirstLast(GA_U2,S2->FirstVParameter(),S2->LastVParameter(),TV,V1S2,V2S2,TrmV2);
|
|
FUN_NewFirstLast(GA_V2,S2->FirstUParameter(),S2->LastUParameter(),TV,U1S2,U2S2,TrmU2);
|
|
if(TrmV1) NS1 = S1->VTrim(V1S1, V2S1, 1.0e-7);
|
|
if(TrmV2) NS2 = S2->VTrim(V1S2, V2S2, 1.0e-7);
|
|
if(TrmU1)
|
|
{
|
|
if(TrmV1)
|
|
{
|
|
Handle(Adaptor3d_HSurface) TS = NS1;
|
|
NS1 = TS->UTrim(U1S1, U2S1, 1.0e-7);
|
|
}
|
|
else NS1 = S1->UTrim(U1S1, U2S1, 1.0e-7);
|
|
}
|
|
if(TrmU2)
|
|
{
|
|
if(TrmV2)
|
|
{
|
|
Handle(Adaptor3d_HSurface) TS = NS2;
|
|
NS2 = TS->UTrim(U1S2, U2S2, 1.0e-7);
|
|
}
|
|
else NS2 = S2->UTrim(U1S2, U2S2, 1.0e-7);
|
|
}
|
|
}
|
|
|
|
//=======================================================================
|
|
//function : Perform
|
|
//purpose :
|
|
//=======================================================================
|
|
void IntPatch_Intersection::Perform(const Handle(Adaptor3d_HSurface)& theS1,
|
|
const Handle(Adaptor3d_TopolTool)& theD1,
|
|
const Handle(Adaptor3d_HSurface)& theS2,
|
|
const Handle(Adaptor3d_TopolTool)& theD2,
|
|
const Standard_Real TolArc,
|
|
const Standard_Real TolTang,
|
|
const Standard_Boolean isGeomInt,
|
|
const Standard_Boolean theIsReqToKeepRLine,
|
|
const Standard_Boolean theIsReqToPostWLProc)
|
|
{
|
|
myTolArc = TolArc;
|
|
myTolTang = TolTang;
|
|
if(myFleche <= Precision::PConfusion())
|
|
myFleche = 0.01;
|
|
if(myUVMaxStep <= Precision::PConfusion())
|
|
myUVMaxStep = 0.01;
|
|
|
|
done = Standard_False;
|
|
spnt.Clear();
|
|
slin.Clear();
|
|
empt = Standard_True;
|
|
tgte = Standard_False;
|
|
oppo = Standard_False;
|
|
|
|
GeomAbs_SurfaceType typs1 = theS1->GetType();
|
|
GeomAbs_SurfaceType typs2 = theS2->GetType();
|
|
|
|
//treatment of the cases with cone or torus
|
|
Standard_Boolean TreatAsBiParametric = Standard_False;
|
|
Standard_Integer bGeomGeom = 0;
|
|
//
|
|
if (typs1 == GeomAbs_Cone || typs2 == GeomAbs_Cone ||
|
|
typs1 == GeomAbs_Torus || typs2 == GeomAbs_Torus) {
|
|
gp_Ax1 aCTAx, aGeomAx;
|
|
GeomAbs_SurfaceType aCTType;
|
|
Standard_Boolean bToCheck;
|
|
//
|
|
const Handle(Adaptor3d_HSurface)& aCTSurf =
|
|
(typs1 == GeomAbs_Cone || typs1 == GeomAbs_Torus) ? theS1 : theS2;
|
|
const Handle(Adaptor3d_HSurface)& aGeomSurf =
|
|
(typs1 == GeomAbs_Cone || typs1 == GeomAbs_Torus) ? theS2 : theS1;
|
|
//
|
|
aCTType = aCTSurf->GetType();
|
|
bToCheck = Standard_False;
|
|
//
|
|
if (typs1 == GeomAbs_Cone || typs2 == GeomAbs_Cone) {
|
|
const gp_Cone aCon1 = (aCTType == GeomAbs_Cone) ?
|
|
aCTSurf->Cone() : aGeomSurf->Cone();
|
|
Standard_Real a1 = Abs(aCon1.SemiAngle());
|
|
bToCheck = (a1 < 0.02) || (a1 > 1.55);
|
|
//
|
|
if (typs1 == typs2) {
|
|
const gp_Cone aCon2 = aGeomSurf->Cone();
|
|
Standard_Real a2 = Abs(aCon2.SemiAngle());
|
|
bToCheck = bToCheck || (a2 < 0.02) || (a2 > 1.55);
|
|
//
|
|
if (a1 > 1.55 && a2 > 1.55) {//quasi-planes: if same domain, treat as canonic
|
|
const gp_Ax1 A1 = aCon1.Axis(), A2 = aCon2.Axis();
|
|
if (A1.IsParallel(A2,Precision::Angular())) {
|
|
const gp_Pnt Apex1 = aCon1.Apex(), Apex2 = aCon2.Apex();
|
|
const gp_Pln Plan1( Apex1, A1.Direction() );
|
|
if (Plan1.Distance( Apex2 ) <= Precision::Confusion()) {
|
|
bToCheck = Standard_False;
|
|
}
|
|
}
|
|
}
|
|
}
|
|
//
|
|
TreatAsBiParametric = bToCheck;
|
|
if (aCTType == GeomAbs_Cone) {
|
|
aCTAx = aCon1.Axis();
|
|
}
|
|
}
|
|
//
|
|
if (typs1 == GeomAbs_Torus || typs2 == GeomAbs_Torus) {
|
|
const gp_Torus aTor1 = (aCTType == GeomAbs_Torus) ?
|
|
aCTSurf->Torus() : aGeomSurf->Torus();
|
|
bToCheck = aTor1.MajorRadius() > aTor1.MinorRadius();
|
|
if (typs1 == typs2) {
|
|
const gp_Torus aTor2 = aGeomSurf->Torus();
|
|
bToCheck = aTor2.MajorRadius() > aTor2.MinorRadius();
|
|
}
|
|
//
|
|
if (aCTType == GeomAbs_Torus) {
|
|
aCTAx = aTor1.Axis();
|
|
}
|
|
}
|
|
//
|
|
if (bToCheck) {
|
|
const gp_Lin aL1(aCTAx);
|
|
//
|
|
switch (aGeomSurf->GetType()) {
|
|
case GeomAbs_Plane: {
|
|
aGeomAx = aGeomSurf->Plane().Axis();
|
|
if (aCTType == GeomAbs_Cone) {
|
|
bGeomGeom = 1;
|
|
if (Abs(aCTSurf->Cone().SemiAngle()) < 0.02) {
|
|
Standard_Real ps = Abs(aCTAx.Direction().Dot(aGeomAx.Direction()));
|
|
if(ps < 0.015) {
|
|
bGeomGeom = 0;
|
|
}
|
|
}
|
|
}
|
|
else {
|
|
if (aCTAx.IsParallel(aGeomAx, Precision::Angular()) ||
|
|
(aCTAx.IsNormal(aGeomAx, Precision::Angular()) &&
|
|
(aGeomSurf->Plane().Distance(aCTAx.Location()) < Precision::Confusion()))) {
|
|
bGeomGeom = 1;
|
|
}
|
|
}
|
|
bToCheck = Standard_False;
|
|
break;
|
|
}
|
|
case GeomAbs_Sphere: {
|
|
if (aL1.Distance(aGeomSurf->Sphere().Location()) < Precision::Confusion()) {
|
|
bGeomGeom = 1;
|
|
}
|
|
bToCheck = Standard_False;
|
|
break;
|
|
}
|
|
case GeomAbs_Cylinder:
|
|
aGeomAx = aGeomSurf->Cylinder().Axis();
|
|
break;
|
|
case GeomAbs_Cone:
|
|
aGeomAx = aGeomSurf->Cone().Axis();
|
|
break;
|
|
case GeomAbs_Torus:
|
|
aGeomAx = aGeomSurf->Torus().Axis();
|
|
break;
|
|
default:
|
|
bToCheck = Standard_False;
|
|
break;
|
|
}
|
|
//
|
|
if (bToCheck) {
|
|
if (aCTAx.IsParallel(aGeomAx, Precision::Angular()) &&
|
|
(aL1.Distance(aGeomAx.Location()) <= Precision::Confusion())) {
|
|
bGeomGeom = 1;
|
|
}
|
|
}
|
|
//
|
|
if (bGeomGeom == 1) {
|
|
TreatAsBiParametric = Standard_False;
|
|
}
|
|
}
|
|
}
|
|
//
|
|
|
|
if(theD1->DomainIsInfinite() || theD2->DomainIsInfinite()) {
|
|
TreatAsBiParametric= Standard_False;
|
|
}
|
|
|
|
// Modified by skv - Mon Sep 26 14:58:30 2005 Begin
|
|
// if(TreatAsBiParametric) { typs1 = typs2 = GeomAbs_BezierSurface; }
|
|
if(TreatAsBiParametric)
|
|
{
|
|
if (typs1 == GeomAbs_Cone && typs2 == GeomAbs_Plane)
|
|
typs1 = GeomAbs_BezierSurface; // Using Imp-Prm Intersector
|
|
else if (typs1 == GeomAbs_Plane && typs2 == GeomAbs_Cone)
|
|
typs2 = GeomAbs_BezierSurface; // Using Imp-Prm Intersector
|
|
else {
|
|
// Using Prm-Prm Intersector
|
|
typs1 = GeomAbs_BezierSurface;
|
|
typs2 = GeomAbs_BezierSurface;
|
|
}
|
|
}
|
|
// Modified by skv - Mon Sep 26 14:58:30 2005 End
|
|
|
|
// Surface type definition
|
|
Standard_Integer ts1 = 0;
|
|
switch (typs1)
|
|
{
|
|
case GeomAbs_Plane:
|
|
case GeomAbs_Cylinder:
|
|
case GeomAbs_Sphere:
|
|
case GeomAbs_Cone: ts1 = 1; break;
|
|
case GeomAbs_Torus: ts1 = bGeomGeom; break;
|
|
default: break;
|
|
}
|
|
|
|
Standard_Integer ts2 = 0;
|
|
switch (typs2)
|
|
{
|
|
case GeomAbs_Plane:
|
|
case GeomAbs_Cylinder:
|
|
case GeomAbs_Sphere:
|
|
case GeomAbs_Cone: ts2 = 1; break;
|
|
case GeomAbs_Torus: ts2 = bGeomGeom; break;
|
|
default: break;
|
|
}
|
|
//
|
|
// treatment of the cases with torus and any other geom surface
|
|
//
|
|
// Possible intersection types: 1. ts1 == ts2 == 1 <Geom-Geom>
|
|
// 2. ts1 != ts2 <Geom-Param>
|
|
// 3. ts1 == ts2 == 0 <Param-Param>
|
|
|
|
// Geom - Geom
|
|
const Standard_Boolean RestrictLine = Standard_True;
|
|
if(ts1 == ts2 && ts1 == 1)
|
|
{
|
|
IntSurf_ListOfPntOn2S ListOfPnts;
|
|
ListOfPnts.Clear();
|
|
if(isGeomInt)
|
|
{
|
|
GeomGeomPerfom( theS1, theD1, theS2, theD2, TolArc,
|
|
TolTang, ListOfPnts, RestrictLine,
|
|
typs1, typs2, theIsReqToKeepRLine);
|
|
}
|
|
else
|
|
{
|
|
ParamParamPerfom(theS1, theD1, theS2, theD2,
|
|
TolArc, TolTang, ListOfPnts, RestrictLine, typs1, typs2);
|
|
}
|
|
}
|
|
|
|
// Geom - Param
|
|
if(ts1 != ts2)
|
|
{
|
|
GeomParamPerfom(theS1, theD1, theS2, theD2, ts1 == 0, typs1, typs2);
|
|
}
|
|
|
|
// Param - Param
|
|
if(ts1 == ts2 && ts1 == 0)
|
|
{
|
|
IntSurf_ListOfPntOn2S ListOfPnts;
|
|
ListOfPnts.Clear();
|
|
|
|
ParamParamPerfom(theS1, theD1, theS2, theD2, TolArc,
|
|
TolTang, ListOfPnts, RestrictLine, typs1, typs2);
|
|
}
|
|
|
|
if(!theIsReqToPostWLProc)
|
|
return;
|
|
|
|
for(Standard_Integer i = slin.Lower(); i <= slin.Upper(); i++)
|
|
{
|
|
Handle(IntPatch_WLine) aWL = Handle(IntPatch_WLine)::DownCast(slin.Value(i));
|
|
|
|
if(aWL.IsNull())
|
|
continue;
|
|
|
|
if (!aWL->IsPurgingAllowed())
|
|
continue;
|
|
|
|
Handle(IntPatch_WLine) aRW =
|
|
IntPatch_WLineTool::ComputePurgedWLine(aWL, theS1, theS2, theD1, theD2, RestrictLine);
|
|
|
|
if(aRW.IsNull())
|
|
continue;
|
|
|
|
slin.InsertAfter(i, aRW);
|
|
slin.Remove(i);
|
|
}
|
|
}
|
|
|
|
//=======================================================================
|
|
//function : Perform
|
|
//purpose :
|
|
//=======================================================================
|
|
void IntPatch_Intersection::Perform(const Handle(Adaptor3d_HSurface)& theS1,
|
|
const Handle(Adaptor3d_TopolTool)& theD1,
|
|
const Handle(Adaptor3d_HSurface)& theS2,
|
|
const Handle(Adaptor3d_TopolTool)& theD2,
|
|
const Standard_Real TolArc,
|
|
const Standard_Real TolTang,
|
|
IntSurf_ListOfPntOn2S& ListOfPnts,
|
|
const Standard_Boolean RestrictLine,
|
|
const Standard_Boolean isGeomInt,
|
|
const Standard_Boolean theIsReqToKeepRLine,
|
|
const Standard_Boolean theIsReqToPostWLProc)
|
|
{
|
|
myTolArc = TolArc;
|
|
myTolTang = TolTang;
|
|
if(myFleche <= Precision::PConfusion())
|
|
myFleche = 0.01;
|
|
if(myUVMaxStep <= Precision::PConfusion())
|
|
myUVMaxStep = 0.01;
|
|
|
|
done = Standard_False;
|
|
spnt.Clear();
|
|
slin.Clear();
|
|
empt = Standard_True;
|
|
tgte = Standard_False;
|
|
oppo = Standard_False;
|
|
|
|
GeomAbs_SurfaceType typs1 = theS1->GetType();
|
|
GeomAbs_SurfaceType typs2 = theS2->GetType();
|
|
//
|
|
//treatment of the cases with cone or torus
|
|
Standard_Boolean TreatAsBiParametric = Standard_False;
|
|
Standard_Integer bGeomGeom = 0;
|
|
//
|
|
if (typs1 == GeomAbs_Cone || typs2 == GeomAbs_Cone ||
|
|
typs1 == GeomAbs_Torus || typs2 == GeomAbs_Torus) {
|
|
gp_Ax1 aCTAx, aGeomAx;
|
|
GeomAbs_SurfaceType aCTType;
|
|
Standard_Boolean bToCheck;
|
|
//
|
|
const Handle(Adaptor3d_HSurface)& aCTSurf =
|
|
(typs1 == GeomAbs_Cone || typs1 == GeomAbs_Torus) ? theS1 : theS2;
|
|
const Handle(Adaptor3d_HSurface)& aGeomSurf =
|
|
(typs1 == GeomAbs_Cone || typs1 == GeomAbs_Torus) ? theS2 : theS1;
|
|
//
|
|
aCTType = aCTSurf->GetType();
|
|
bToCheck = Standard_False;
|
|
//
|
|
if (typs1 == GeomAbs_Cone || typs2 == GeomAbs_Cone) {
|
|
const gp_Cone aCon1 = (aCTType == GeomAbs_Cone) ?
|
|
aCTSurf->Cone() : aGeomSurf->Cone();
|
|
Standard_Real a1 = Abs(aCon1.SemiAngle());
|
|
bToCheck = (a1 < 0.02) || (a1 > 1.55);
|
|
//
|
|
if (typs1 == typs2) {
|
|
const gp_Cone aCon2 = aGeomSurf->Cone();
|
|
Standard_Real a2 = Abs(aCon2.SemiAngle());
|
|
bToCheck = bToCheck || (a2 < 0.02) || (a2 > 1.55);
|
|
//
|
|
if (a1 > 1.55 && a2 > 1.55) {//quasi-planes: if same domain, treat as canonic
|
|
const gp_Ax1 A1 = aCon1.Axis(), A2 = aCon2.Axis();
|
|
if (A1.IsParallel(A2,Precision::Angular())) {
|
|
const gp_Pnt Apex1 = aCon1.Apex(), Apex2 = aCon2.Apex();
|
|
const gp_Pln Plan1( Apex1, A1.Direction() );
|
|
if (Plan1.Distance( Apex2 ) <= Precision::Confusion()) {
|
|
bToCheck = Standard_False;
|
|
}
|
|
}
|
|
}
|
|
}
|
|
//
|
|
TreatAsBiParametric = bToCheck;
|
|
if (aCTType == GeomAbs_Cone) {
|
|
aCTAx = aCon1.Axis();
|
|
}
|
|
}
|
|
//
|
|
if (typs1 == GeomAbs_Torus || typs2 == GeomAbs_Torus) {
|
|
const gp_Torus aTor1 = (aCTType == GeomAbs_Torus) ?
|
|
aCTSurf->Torus() : aGeomSurf->Torus();
|
|
bToCheck = aTor1.MajorRadius() > aTor1.MinorRadius();
|
|
if (typs1 == typs2) {
|
|
const gp_Torus aTor2 = aGeomSurf->Torus();
|
|
bToCheck = aTor2.MajorRadius() > aTor2.MinorRadius();
|
|
}
|
|
//
|
|
if (aCTType == GeomAbs_Torus) {
|
|
aCTAx = aTor1.Axis();
|
|
}
|
|
}
|
|
//
|
|
if (bToCheck) {
|
|
const gp_Lin aL1(aCTAx);
|
|
//
|
|
switch (aGeomSurf->GetType()) {
|
|
case GeomAbs_Plane: {
|
|
aGeomAx = aGeomSurf->Plane().Axis();
|
|
if (aCTType == GeomAbs_Cone) {
|
|
bGeomGeom = 1;
|
|
if (Abs(aCTSurf->Cone().SemiAngle()) < 0.02) {
|
|
Standard_Real ps = Abs(aCTAx.Direction().Dot(aGeomAx.Direction()));
|
|
if(ps < 0.015) {
|
|
bGeomGeom = 0;
|
|
}
|
|
}
|
|
}
|
|
else {
|
|
if (aCTAx.IsParallel(aGeomAx, Precision::Angular()) ||
|
|
(aCTAx.IsNormal(aGeomAx, Precision::Angular()) &&
|
|
(aGeomSurf->Plane().Distance(aCTAx.Location()) < Precision::Confusion()))) {
|
|
bGeomGeom = 1;
|
|
}
|
|
}
|
|
bToCheck = Standard_False;
|
|
break;
|
|
}
|
|
case GeomAbs_Sphere: {
|
|
if (aL1.Distance(aGeomSurf->Sphere().Location()) < Precision::Confusion()) {
|
|
bGeomGeom = 1;
|
|
}
|
|
bToCheck = Standard_False;
|
|
break;
|
|
}
|
|
case GeomAbs_Cylinder:
|
|
aGeomAx = aGeomSurf->Cylinder().Axis();
|
|
break;
|
|
case GeomAbs_Cone:
|
|
aGeomAx = aGeomSurf->Cone().Axis();
|
|
break;
|
|
case GeomAbs_Torus:
|
|
aGeomAx = aGeomSurf->Torus().Axis();
|
|
break;
|
|
default:
|
|
bToCheck = Standard_False;
|
|
break;
|
|
}
|
|
//
|
|
if (bToCheck) {
|
|
if (aCTAx.IsParallel(aGeomAx, Precision::Angular()) &&
|
|
(aL1.Distance(aGeomAx.Location()) <= Precision::Confusion())) {
|
|
bGeomGeom = 1;
|
|
}
|
|
}
|
|
//
|
|
if (bGeomGeom == 1) {
|
|
TreatAsBiParametric = Standard_False;
|
|
}
|
|
}
|
|
}
|
|
//
|
|
|
|
if(theD1->DomainIsInfinite() || theD2->DomainIsInfinite()) {
|
|
TreatAsBiParametric= Standard_False;
|
|
}
|
|
|
|
if(TreatAsBiParametric)
|
|
{
|
|
// Using Prm-Prm Intersector
|
|
typs1 = GeomAbs_BezierSurface;
|
|
typs2 = GeomAbs_BezierSurface;
|
|
}
|
|
|
|
// Surface type definition
|
|
Standard_Integer ts1 = 0;
|
|
switch (typs1)
|
|
{
|
|
case GeomAbs_Plane:
|
|
case GeomAbs_Cylinder:
|
|
case GeomAbs_Sphere:
|
|
case GeomAbs_Cone: ts1 = 1; break;
|
|
case GeomAbs_Torus: ts1 = bGeomGeom; break;
|
|
default: break;
|
|
}
|
|
|
|
Standard_Integer ts2 = 0;
|
|
switch (typs2)
|
|
{
|
|
case GeomAbs_Plane:
|
|
case GeomAbs_Cylinder:
|
|
case GeomAbs_Sphere:
|
|
case GeomAbs_Cone: ts2 = 1; break;
|
|
case GeomAbs_Torus: ts2 = bGeomGeom; break;
|
|
default: break;
|
|
}
|
|
//
|
|
// Possible intersection types: 1. ts1 == ts2 == 1 <Geom-Geom>
|
|
// 2. ts1 != ts2 <Geom-Param>
|
|
// 3. ts1 == ts2 == 0 <Param-Param>
|
|
|
|
if(!isGeomInt)
|
|
{
|
|
ParamParamPerfom(theS1, theD1, theS2, theD2,
|
|
TolArc, TolTang, ListOfPnts, RestrictLine, typs1, typs2);
|
|
}
|
|
else if(ts1 != ts2)
|
|
{
|
|
GeomParamPerfom(theS1, theD1, theS2, theD2, ts1 == 0, typs1, typs2);
|
|
}
|
|
else if (ts1 == 0)
|
|
{
|
|
ParamParamPerfom(theS1, theD1, theS2, theD2,
|
|
TolArc, TolTang, ListOfPnts, RestrictLine, typs1, typs2);
|
|
}
|
|
else if(ts1 == 1)
|
|
{
|
|
GeomGeomPerfom(theS1, theD1, theS2, theD2, TolArc,
|
|
TolTang, ListOfPnts, RestrictLine, typs1, typs2, theIsReqToKeepRLine);
|
|
}
|
|
|
|
if(!theIsReqToPostWLProc)
|
|
return;
|
|
|
|
for(Standard_Integer i = slin.Lower(); i <= slin.Upper(); i++)
|
|
{
|
|
Handle(IntPatch_WLine) aWL = Handle(IntPatch_WLine)::DownCast(slin.Value(i));
|
|
|
|
if(aWL.IsNull())
|
|
continue;
|
|
|
|
if(!aWL->IsPurgingAllowed())
|
|
continue;
|
|
|
|
Handle(IntPatch_WLine) aRW =
|
|
IntPatch_WLineTool::ComputePurgedWLine(aWL, theS1, theS2, theD1, theD2, RestrictLine);
|
|
|
|
if(aRW.IsNull())
|
|
continue;
|
|
|
|
slin.InsertAfter(i, aRW);
|
|
slin.Remove(i);
|
|
}
|
|
}
|
|
|
|
//=======================================================================
|
|
//function : ParamParamPerfom
|
|
//purpose :
|
|
//=======================================================================
|
|
void IntPatch_Intersection::ParamParamPerfom(const Handle(Adaptor3d_HSurface)& theS1,
|
|
const Handle(Adaptor3d_TopolTool)& theD1,
|
|
const Handle(Adaptor3d_HSurface)& theS2,
|
|
const Handle(Adaptor3d_TopolTool)& theD2,
|
|
const Standard_Real TolArc,
|
|
const Standard_Real TolTang,
|
|
IntSurf_ListOfPntOn2S& ListOfPnts,
|
|
const Standard_Boolean RestrictLine,
|
|
const GeomAbs_SurfaceType typs1,
|
|
const GeomAbs_SurfaceType typs2)
|
|
{
|
|
IntPatch_PrmPrmIntersection interpp;
|
|
if(!theD1->DomainIsInfinite() && !theD2->DomainIsInfinite())
|
|
{
|
|
Standard_Boolean ClearFlag = Standard_True;
|
|
if(!ListOfPnts.IsEmpty())
|
|
{
|
|
interpp.Perform(theS1,theD1,theS2,theD2,TolTang,TolArc,myFleche,myUVMaxStep, ListOfPnts, RestrictLine);
|
|
ClearFlag = Standard_False;
|
|
}
|
|
interpp.Perform(theS1,theD1,theS2,theD2,TolTang,TolArc,myFleche,myUVMaxStep,ClearFlag); //double call!!!!!!!
|
|
}
|
|
else if((theD1->DomainIsInfinite()) ^ (theD2->DomainIsInfinite()))
|
|
{
|
|
gp_Pnt pMaxXYZ, pMinXYZ;
|
|
if(theD1->DomainIsInfinite())
|
|
{
|
|
FUN_GetMinMaxXYZPnt( theS2, pMinXYZ, pMaxXYZ );
|
|
const Standard_Real MU = Max(Abs(theS2->FirstUParameter()),Abs(theS2->LastUParameter()));
|
|
const Standard_Real MV = Max(Abs(theS2->FirstVParameter()),Abs(theS2->LastVParameter()));
|
|
const Standard_Real AP = Max(MU, MV);
|
|
Handle(Adaptor3d_HSurface) SS;
|
|
FUN_TrimInfSurf(pMinXYZ, pMaxXYZ, theS1, AP, SS);
|
|
interpp.Perform(SS,theD1,theS2,theD2,TolTang,TolArc,myFleche,myUVMaxStep);
|
|
}
|
|
else
|
|
{
|
|
FUN_GetMinMaxXYZPnt( theS1, pMinXYZ, pMaxXYZ );
|
|
const Standard_Real MU = Max(Abs(theS1->FirstUParameter()),Abs(theS1->LastUParameter()));
|
|
const Standard_Real MV = Max(Abs(theS1->FirstVParameter()),Abs(theS1->LastVParameter()));
|
|
const Standard_Real AP = Max(MU, MV);
|
|
Handle(Adaptor3d_HSurface) SS;
|
|
FUN_TrimInfSurf(pMinXYZ, pMaxXYZ, theS2, AP, SS);
|
|
interpp.Perform(theS1, theD1, SS, theD2,TolTang, TolArc,myFleche,myUVMaxStep);
|
|
}
|
|
}//(theD1->DomainIsInfinite()) ^ (theD2->DomainIsInfinite())
|
|
else
|
|
{
|
|
if(typs1 == GeomAbs_OtherSurface || typs2 == GeomAbs_OtherSurface)
|
|
{
|
|
done = Standard_False;
|
|
return;
|
|
}
|
|
|
|
Standard_Boolean IsPLInt = Standard_False;
|
|
TColgp_SequenceOfPnt sop;
|
|
gp_Vec v;
|
|
FUN_PL_Intersection(theS1,typs1,theS2,typs2,IsPLInt,sop,v);
|
|
|
|
if(IsPLInt)
|
|
{
|
|
if(sop.Length() > 0)
|
|
{
|
|
for(Standard_Integer ip = 1; ip <= sop.Length(); ip++)
|
|
{
|
|
gp_Lin lin(sop.Value(ip),gp_Dir(v));
|
|
Handle(IntPatch_Line) gl = new IntPatch_GLine(lin,Standard_False);
|
|
slin.Append(gl);
|
|
}
|
|
|
|
done = Standard_True;
|
|
}
|
|
else
|
|
done = Standard_False;
|
|
|
|
return;
|
|
}// 'COLLINEAR LINES'
|
|
else
|
|
{
|
|
Handle(Adaptor3d_HSurface) nS1 = theS1;
|
|
Handle(Adaptor3d_HSurface) nS2 = theS2;
|
|
FUN_TrimBothSurf(theS1,typs1,theS2,typs2,1.e+8,nS1,nS2);
|
|
interpp.Perform(nS1,theD1,nS2,theD2,TolTang,TolArc,myFleche,myUVMaxStep);
|
|
}// 'NON - COLLINEAR LINES'
|
|
}// both domains are infinite
|
|
|
|
if (interpp.IsDone())
|
|
{
|
|
done = Standard_True;
|
|
tgte = Standard_False;
|
|
empt = interpp.IsEmpty();
|
|
|
|
for(Standard_Integer i = 1; i <= interpp.NbLines(); i++)
|
|
{
|
|
if(interpp.Line(i)->ArcType() != IntPatch_Walking)
|
|
slin.Append(interpp.Line(i));
|
|
}
|
|
|
|
for (Standard_Integer i = 1; i <= interpp.NbLines(); i++)
|
|
{
|
|
if(interpp.Line(i)->ArcType() == IntPatch_Walking)
|
|
slin.Append(interpp.Line(i));
|
|
}
|
|
}
|
|
}
|
|
|
|
//=======================================================================
|
|
////function : GeomGeomPerfom
|
|
//purpose :
|
|
//=======================================================================
|
|
void IntPatch_Intersection::GeomGeomPerfom(const Handle(Adaptor3d_HSurface)& theS1,
|
|
const Handle(Adaptor3d_TopolTool)& theD1,
|
|
const Handle(Adaptor3d_HSurface)& theS2,
|
|
const Handle(Adaptor3d_TopolTool)& theD2,
|
|
const Standard_Real TolArc,
|
|
const Standard_Real TolTang,
|
|
IntSurf_ListOfPntOn2S& ListOfPnts,
|
|
const Standard_Boolean RestrictLine,
|
|
const GeomAbs_SurfaceType theTyps1,
|
|
const GeomAbs_SurfaceType theTyps2,
|
|
const Standard_Boolean theIsReqToKeepRLine)
|
|
{
|
|
IntPatch_ImpImpIntersection interii(theS1,theD1,theS2,theD2,
|
|
myTolArc,myTolTang, theIsReqToKeepRLine);
|
|
|
|
if (!interii.IsDone())
|
|
{
|
|
done = Standard_False;
|
|
ParamParamPerfom(theS1, theD1, theS2, theD2,
|
|
TolArc, TolTang, ListOfPnts, RestrictLine, theTyps1, theTyps2);
|
|
return;
|
|
}
|
|
|
|
done = (interii.GetStatus() == IntPatch_ImpImpIntersection::IntStatus_OK);
|
|
empt = interii.IsEmpty();
|
|
|
|
if(empt)
|
|
{
|
|
return;
|
|
}
|
|
|
|
const Standard_Integer aNbPointsInALine = 200;
|
|
|
|
tgte = interii.TangentFaces();
|
|
if (tgte)
|
|
oppo = interii.OppositeFaces();
|
|
|
|
Standard_Boolean isWLExist = Standard_False;
|
|
IntPatch_ALineToWLine AToW(theS1, theS2, aNbPointsInALine);
|
|
|
|
for (Standard_Integer i = 1; i <= interii.NbLines(); i++)
|
|
{
|
|
const Handle(IntPatch_Line)& line = interii.Line(i);
|
|
if (line->ArcType() == IntPatch_Analytic)
|
|
{
|
|
isWLExist = Standard_True;
|
|
AToW.MakeWLine(Handle(IntPatch_ALine)::DownCast(line), slin);
|
|
}
|
|
else
|
|
{
|
|
if (line->ArcType() == IntPatch_Walking)
|
|
{
|
|
Handle(IntPatch_WLine)::DownCast(line)->EnablePurging(Standard_False);
|
|
}
|
|
|
|
if((line->ArcType() != IntPatch_Restriction) || theIsReqToKeepRLine)
|
|
slin.Append(line);
|
|
}
|
|
}
|
|
|
|
for (Standard_Integer i = 1; i <= interii.NbPnts(); i++)
|
|
{
|
|
spnt.Append(interii.Point(i));
|
|
}
|
|
|
|
if((theTyps1 == GeomAbs_Cylinder) && (theTyps2 == GeomAbs_Cylinder))
|
|
{
|
|
IntPatch_WLineTool::JoinWLines( slin, spnt, TolTang,
|
|
theS1->IsUPeriodic()? theS1->UPeriod() : 0.0,
|
|
theS2->IsUPeriodic()? theS2->UPeriod() : 0.0,
|
|
theS1->IsVPeriodic()? theS1->VPeriod() : 0.0,
|
|
theS2->IsVPeriodic()? theS2->VPeriod() : 0.0,
|
|
theS1->FirstUParameter(),
|
|
theS1->LastUParameter(),
|
|
theS1->FirstVParameter(),
|
|
theS1->LastVParameter(),
|
|
theS2->FirstUParameter(),
|
|
theS2->LastUParameter(),
|
|
theS2->FirstVParameter(),
|
|
theS2->LastVParameter());
|
|
}
|
|
|
|
if(isWLExist)
|
|
{
|
|
Bnd_Box2d aBx1, aBx2;
|
|
const Standard_Real aU1F = theS1->FirstUParameter(),
|
|
aU1L = theS1->LastUParameter(),
|
|
aV1F = theS1->FirstVParameter(),
|
|
aV1L = theS1->LastVParameter(),
|
|
aU2F = theS2->FirstUParameter(),
|
|
aU2L = theS2->LastUParameter(),
|
|
aV2F = theS2->FirstVParameter(),
|
|
aV2L = theS2->LastVParameter();
|
|
aBx1.Add(gp_Pnt2d(aU1F, aV1F));
|
|
aBx1.Add(gp_Pnt2d(aU1L, aV1F));
|
|
aBx1.Add(gp_Pnt2d(aU1L, aV1L));
|
|
aBx1.Add(gp_Pnt2d(aU1F, aV1L));
|
|
aBx2.Add(gp_Pnt2d(aU2F, aV2F));
|
|
aBx2.Add(gp_Pnt2d(aU2L, aV2F));
|
|
aBx2.Add(gp_Pnt2d(aU2L, aV2L));
|
|
aBx2.Add(gp_Pnt2d(aU2F, aV2L));
|
|
|
|
aBx1.Enlarge(Precision::PConfusion());
|
|
aBx2.Enlarge(Precision::PConfusion());
|
|
|
|
const Standard_Real
|
|
anArrOfPeriod[4] = {theS1->IsUPeriodic()? theS1->UPeriod() : 0.0,
|
|
theS1->IsVPeriodic()? theS1->VPeriod() : 0.0,
|
|
theS2->IsUPeriodic()? theS2->UPeriod() : 0.0,
|
|
theS2->IsVPeriodic()? theS2->VPeriod() : 0.0};
|
|
IntPatch_WLineTool::ExtendTwoWLines(slin, theS1, theS2, TolTang,
|
|
anArrOfPeriod, aBx1, aBx2);
|
|
}
|
|
}
|
|
|
|
//=======================================================================
|
|
//function : GeomParamPerfom
|
|
//purpose :
|
|
//=======================================================================
|
|
void IntPatch_Intersection::
|
|
GeomParamPerfom(const Handle(Adaptor3d_HSurface)& theS1,
|
|
const Handle(Adaptor3d_TopolTool)& theD1,
|
|
const Handle(Adaptor3d_HSurface)& theS2,
|
|
const Handle(Adaptor3d_TopolTool)& theD2,
|
|
const Standard_Boolean isNotAnalitical,
|
|
const GeomAbs_SurfaceType typs1,
|
|
const GeomAbs_SurfaceType typs2)
|
|
{
|
|
IntPatch_ImpPrmIntersection interip;
|
|
if (myIsStartPnt)
|
|
{
|
|
if (isNotAnalitical/*ts1 == 0*/)
|
|
interip.SetStartPoint(myU1Start,myV1Start);
|
|
else
|
|
interip.SetStartPoint(myU2Start,myV2Start);
|
|
}
|
|
|
|
if(theD1->DomainIsInfinite() && theD2->DomainIsInfinite())
|
|
{
|
|
Standard_Boolean IsPLInt = Standard_False;
|
|
TColgp_SequenceOfPnt sop;
|
|
gp_Vec v;
|
|
FUN_PL_Intersection(theS1,typs1,theS2,typs2,IsPLInt,sop,v);
|
|
|
|
if(IsPLInt)
|
|
{
|
|
if(sop.Length() > 0)
|
|
{
|
|
for(Standard_Integer ip = 1; ip <= sop.Length(); ip++)
|
|
{
|
|
gp_Lin lin(sop.Value(ip),gp_Dir(v));
|
|
Handle(IntPatch_Line) gl = new IntPatch_GLine(lin,Standard_False);
|
|
slin.Append(gl);
|
|
}
|
|
|
|
done = Standard_True;
|
|
}
|
|
else
|
|
done = Standard_False;
|
|
|
|
return;
|
|
}
|
|
else
|
|
{
|
|
Handle(Adaptor3d_HSurface) nS1 = theS1;
|
|
Handle(Adaptor3d_HSurface) nS2 = theS2;
|
|
FUN_TrimBothSurf(theS1,typs1,theS2,typs2,1.e+5,nS1,nS2);
|
|
interip.Perform(nS1,theD1,nS2,theD2,myTolArc,myTolTang,myFleche,myUVMaxStep);
|
|
}
|
|
}
|
|
else
|
|
interip.Perform(theS1,theD1,theS2,theD2,myTolArc,myTolTang,myFleche,myUVMaxStep);
|
|
|
|
if (interip.IsDone())
|
|
{
|
|
done = Standard_True;
|
|
empt = interip.IsEmpty();
|
|
|
|
if (!empt)
|
|
{
|
|
const Standard_Integer aNbLines = interip.NbLines();
|
|
for(Standard_Integer i = 1; i <= aNbLines; i++)
|
|
{
|
|
if(interip.Line(i)->ArcType() != IntPatch_Walking)
|
|
slin.Append(interip.Line(i));
|
|
}
|
|
|
|
for(Standard_Integer i = 1; i <= aNbLines; i++)
|
|
{
|
|
if(interip.Line(i)->ArcType() == IntPatch_Walking)
|
|
slin.Append(interip.Line(i));
|
|
}
|
|
|
|
for (Standard_Integer i = 1; i <= interip.NbPnts(); i++)
|
|
spnt.Append(interip.Point(i));
|
|
}
|
|
}
|
|
}
|
|
|
|
void IntPatch_Intersection::Perform(const Handle(Adaptor3d_HSurface)& S1,
|
|
const Handle(Adaptor3d_TopolTool)& D1,
|
|
const Handle(Adaptor3d_HSurface)& S2,
|
|
const Handle(Adaptor3d_TopolTool)& D2,
|
|
const Standard_Real U1,
|
|
const Standard_Real V1,
|
|
const Standard_Real U2,
|
|
const Standard_Real V2,
|
|
const Standard_Real TolArc,
|
|
const Standard_Real TolTang)
|
|
{
|
|
myTolArc = TolArc;
|
|
myTolTang = TolTang;
|
|
if(myFleche == 0.0) {
|
|
#if DEBUG
|
|
//cout<<" -- IntPatch_Intersection::myFleche fixe par defaut a 0.01 --"<<endl;
|
|
//cout<<" -- Utiliser la Methode SetTolerances( ... ) "<<endl;
|
|
#endif
|
|
myFleche = 0.01;
|
|
}
|
|
if(myUVMaxStep==0.0) {
|
|
#if DEBUG
|
|
//cout<<" -- IntPatch_Intersection::myUVMaxStep fixe par defaut a 0.01 --"<<endl;
|
|
//cout<<" -- Utiliser la Methode SetTolerances( ... ) "<<endl;
|
|
#endif
|
|
myUVMaxStep = 0.01;
|
|
}
|
|
|
|
done = Standard_False;
|
|
spnt.Clear();
|
|
slin.Clear();
|
|
|
|
empt = Standard_True;
|
|
tgte = Standard_False;
|
|
oppo = Standard_False;
|
|
|
|
const GeomAbs_SurfaceType typs1 = S1->GetType();
|
|
const GeomAbs_SurfaceType typs2 = S2->GetType();
|
|
|
|
if( typs1==GeomAbs_Plane
|
|
|| typs1==GeomAbs_Cylinder
|
|
|| typs1==GeomAbs_Sphere
|
|
|| typs1==GeomAbs_Cone
|
|
|| typs2==GeomAbs_Plane
|
|
|| typs2==GeomAbs_Cylinder
|
|
|| typs2==GeomAbs_Sphere
|
|
|| typs2==GeomAbs_Cone)
|
|
{
|
|
myIsStartPnt = Standard_True;
|
|
myU1Start = U1; myV1Start = V1; myU2Start = U2; myV2Start = V2;
|
|
Perform(S1,D1,S2,D2,TolArc,TolTang);
|
|
myIsStartPnt = Standard_False;
|
|
}
|
|
else
|
|
{
|
|
IntPatch_PrmPrmIntersection interpp;
|
|
interpp.Perform(S1,D1,S2,D2,U1,V1,U2,V2,TolTang,TolArc,myFleche,myUVMaxStep);
|
|
if (interpp.IsDone())
|
|
{
|
|
done = Standard_True;
|
|
tgte = Standard_False;
|
|
empt = interpp.IsEmpty();
|
|
const Standard_Integer nblm = interpp.NbLines();
|
|
Standard_Integer i = 1;
|
|
for (; i<=nblm; i++) slin.Append(interpp.Line(i));
|
|
}
|
|
}
|
|
|
|
for(Standard_Integer i = slin.Lower(); i <= slin.Upper(); i++)
|
|
{
|
|
Handle(IntPatch_WLine) aWL = Handle(IntPatch_WLine)::DownCast(slin.Value(i));
|
|
|
|
if(aWL.IsNull())
|
|
continue;
|
|
|
|
if (!aWL->IsPurgingAllowed())
|
|
continue;
|
|
|
|
Handle(IntPatch_WLine) aRW =
|
|
IntPatch_WLineTool::ComputePurgedWLine(aWL, S1, S2, D1, D2, Standard_True);
|
|
|
|
if(aRW.IsNull())
|
|
continue;
|
|
|
|
slin.InsertAfter(i, aRW);
|
|
slin.Remove(i);
|
|
}
|
|
}
|
|
|
|
#ifdef DUMPOFIntPatch_Intersection
|
|
|
|
void IntPatch_Intersection__MAJ_R(Handle(Adaptor2d_HCurve2d) *R1,
|
|
Handle(Adaptor2d_HCurve2d) *,
|
|
int *NR1,
|
|
int *,
|
|
Standard_Integer nbR1,
|
|
Standard_Integer ,
|
|
const IntPatch_Point& VTX)
|
|
{
|
|
|
|
if(VTX.IsOnDomS1()) {
|
|
|
|
//-- long unsigned ptr= *((long unsigned *)(((Handle(Standard_Transient) *)(&(VTX.ArcOnS1())))));
|
|
for(Standard_Integer i=0; i<nbR1;i++) {
|
|
if(VTX.ArcOnS1()==R1[i]) {
|
|
NR1[i]++;
|
|
printf("\n ******************************");
|
|
return;
|
|
}
|
|
}
|
|
printf("\n R Pas trouvee (IntPatch)\n");
|
|
|
|
}
|
|
}
|
|
#endif
|
|
|
|
void IntPatch_Intersection::Dump(const Standard_Integer /*Mode*/,
|
|
const Handle(Adaptor3d_HSurface)& /*S1*/,
|
|
const Handle(Adaptor3d_TopolTool)& /*D1*/,
|
|
const Handle(Adaptor3d_HSurface)& /*S2*/,
|
|
const Handle(Adaptor3d_TopolTool)& /*D2*/) const
|
|
{
|
|
#ifdef DUMPOFIntPatch_Intersection
|
|
const int MAXR = 200;
|
|
//-- ----------------------------------------------------------------------
|
|
//-- construction de la liste des restrictions & vertex
|
|
//--
|
|
int NR1[MAXR],NR2[MAXR];
|
|
Handle(Adaptor2d_HCurve2d) R1[MAXR],R2[MAXR];
|
|
Standard_Integer nbR1=0,nbR2=0;
|
|
for(D1->Init();D1->More() && nbR1<MAXR; D1->Next()) {
|
|
R1[nbR1]=D1->Value();
|
|
NR1[nbR1]=0;
|
|
nbR1++;
|
|
}
|
|
for(D2->Init();D2->More() && nbR2<MAXR; D2->Next()) {
|
|
R2[nbR2]=D2->Value();
|
|
NR2[nbR2]=0;
|
|
nbR2++;
|
|
}
|
|
|
|
printf("\nDUMP_INT: ----empt:%2ud tgte:%2ud oppo:%2ud ---------------------------------",empt,tgte,empt);
|
|
Standard_Integer i,nbr1,nbr2,nbgl,nbgc,nbge,nbgp,nbgh,nbl,nbr,nbg,nbw,nba;
|
|
nbl=nbr=nbg=nbw=nba=nbgl=nbge=nbr1=nbr2=nbgc=nbgp=nbgh=0;
|
|
nbl=NbLines();
|
|
for(i=1;i<=nbl;i++) {
|
|
const Handle(IntPatch_Line)& line=Line(i);
|
|
const IntPatch_IType IType=line->ArcType();
|
|
if(IType == IntPatch_Walking) nbw++;
|
|
else if(IType == IntPatch_Restriction) {
|
|
nbr++;
|
|
Handle(IntPatch_RLine) rlin (Handle(IntPatch_RLine)::DownCast (line));
|
|
if(rlin->IsArcOnS1()) nbr1++;
|
|
if(rlin->IsArcOnS2()) nbr2++;
|
|
}
|
|
else if(IType == IntPatch_Analytic) nba++;
|
|
else {
|
|
nbg++;
|
|
if(IType == IntPatch_Lin) nbgl++;
|
|
else if(IType == IntPatch_Circle) nbgc++;
|
|
else if(IType == IntPatch_Parabola) nbgp++;
|
|
else if(IType == IntPatch_Hyperbola) nbgh++;
|
|
else if(IType == IntPatch_Ellipse) nbge++;
|
|
}
|
|
}
|
|
|
|
|
|
printf("\nDUMP_INT:Lines:%2d Wlin:%2d Restr:%2d(On1:%2d On2:%2d) Ana:%2d Geom:%2d(L:%2d C:%2d E:%2d H:%2d P:%2d)",
|
|
nbl,nbw,nbr,nbr1,nbr2,nba,nbg,nbgl,nbgc,nbge,nbgh,nbgp);
|
|
|
|
IntPatch_LineConstructor LineConstructor(2);
|
|
|
|
Standard_Integer nbllc=0;
|
|
nbw=nbr=nbg=nba=0;
|
|
Standard_Integer nbva,nbvw,nbvr,nbvg;
|
|
nbva=nbvr=nbvw=nbvg=0;
|
|
for (j=1; j<=nbl; j++) {
|
|
Standard_Integer v,nbvtx;
|
|
const Handle(IntPatch_Line)& intersLinej = Line(j);
|
|
Standard_Integer NbLines;
|
|
LineConstructor.Perform(SequenceOfLine(),intersLinej,S1,D1,S2,D2,1e-7);
|
|
NbLines = LineConstructor.NbLines();
|
|
|
|
for(Standard_Integer k=1;k<=NbLines;k++) {
|
|
nbllc++;
|
|
const Handle(IntPatch_Line)& LineK = LineConstructor.Line(k);
|
|
if (LineK->ArcType() == IntPatch_Analytic) {
|
|
Handle(IntPatch_ALine) alin (Handle(IntPatch_ALine)::DownCast (LineK));
|
|
nbvtx=alin->NbVertex();
|
|
nbva+=nbvtx; nba++;
|
|
for(v=1;v<=nbvtx;v++) {
|
|
IntPatch_Intersection__MAJ_R(R1,R2,NR1,NR2,nbR1,nbR2,alin->Vertex(v));
|
|
}
|
|
}
|
|
else if (LineK->ArcType() == IntPatch_Restriction) {
|
|
Handle(IntPatch_RLine) rlin (Handle(IntPatch_RLine)::DownCast (LineK));
|
|
nbvtx=rlin->NbVertex();
|
|
nbvr+=nbvtx; nbr++;
|
|
for(v=1;v<=nbvtx;v++) {
|
|
IntPatch_Intersection__MAJ_R(R1,R2,NR1,NR2,nbR1,nbR2,rlin->Vertex(v));
|
|
}
|
|
}
|
|
else if (LineK->ArcType() == IntPatch_Walking) {
|
|
Handle(IntPatch_WLine) wlin (Handle(IntPatch_WLine)::DownCast (LineK));
|
|
nbvtx=wlin->NbVertex();
|
|
nbvw+=nbvtx; nbw++;
|
|
for(v=1;v<=nbvtx;v++) {
|
|
IntPatch_Intersection__MAJ_R(R1,R2,NR1,NR2,nbR1,nbR2,wlin->Vertex(v));
|
|
}
|
|
}
|
|
else {
|
|
Handle(IntPatch_GLine) glin (Handle(IntPatch_GLine)::DownCast (LineK));
|
|
nbvtx=glin->NbVertex();
|
|
nbvg+=nbvtx; nbg++;
|
|
for(v=1;v<=nbvtx;v++) {
|
|
IntPatch_Intersection__MAJ_R(R1,R2,NR1,NR2,nbR1,nbR2,glin->Vertex(v));
|
|
}
|
|
}
|
|
}
|
|
}
|
|
printf("\nDUMP_LC :Lines:%2d WLin:%2d Restr:%2d Ana:%2d Geom:%2d",
|
|
nbllc,nbw,nbr,nba,nbg);
|
|
printf("\nDUMP_LC :vtx :%2d r:%2d :%2d :%2d",
|
|
nbvw,nbvr,nbva,nbvg);
|
|
|
|
printf("\n");
|
|
|
|
#endif
|
|
}
|