#include <ShapeAnalysis_FreeBounds.hxx>
#include <ShapeAnalysis_Edge.hxx>
+#include <ShapeFix_Face.hxx>
+#include <ShapeFix_Shell.hxx>
#include <BRep_Tool.hxx>
#include <BRep_Builder.hxx>
#include <BRepOffsetAPI_MakePipeShell.hxx>
#include <GProp_GProps.hxx>
#include <BRepGProp.hxx>
+#include <BRepBuilderAPI_MakeFace.hxx>
#include <TopAbs.hxx>
#include <TopExp.hxx>
#include <TopTools_ListIteratorOfListOfShape.hxx>
#include <GeomAPI_ProjectPointOnCurve.hxx>
+#include <GeomAPI_Interpolate.hxx>
#include <Geom_TrimmedCurve.hxx>
+#include <Geom_Plane.hxx>
+#include <Geom_RectangularTrimmedSurface.hxx>
+#include <Geom_BezierSurface.hxx>
+#include <Geom_Line.hxx>
+#include <Geom_Conic.hxx>
+#include <Geom_BSplineCurve.hxx>
+#include <Geom_BSplineSurface.hxx>
+#include <GeomFill_BSplineCurves.hxx>
+#include <GeomConvert_ApproxCurve.hxx>
+#include <GeomConvert.hxx>
#include <TColgp_SequenceOfPnt.hxx>
+#include <TColgp_HArray1OfPnt.hxx>
+#include <TColgp_Array2OfPnt.hxx>
#include <TColStd_HSequenceOfTransient.hxx>
#include <Precision.hxx>
#include "utilities.h"
//#include "BRepTools.hxx"
+//#include "GeomTools.hxx"
+#include <GEOMAlgo_GlueAnalyser.hxx>
//=======================================================================
// creating map of vertex edges for both faces
TopTools_IndexedDataMapOfShapeListOfShape aMapVertEdge1;
TopExp::MapShapesAndAncestors(F1, TopAbs_VERTEX, TopAbs_EDGE, aMapVertEdge1);
+ if(!FF.Contains(F1))
+ cout<<" FillForOtherEdges: map FF not contains key F1"<<endl;
+ if(!FF.Contains(E1))
+ cout<<" FillForOtherEdges: map FF not contains key E1"<<endl;
+ if(!FF.Contains(V1))
+ cout<<" FillForOtherEdges: map FF not contains key V1"<<endl;
const TopoDS_Shape& F2 = FF.FindFromKey(F1);
const TopoDS_Shape& E2 = FF.FindFromKey(E1);
const TopoDS_Shape& V2 = FF.FindFromKey(V1);
ShapeAnalysis_Edge sae;
while(1) {
+ if(!aMapVertEdge1.Contains(VS1))
+ cout<<" FillForOtherEdges: map aMapVertEdge1 not contains key VS1"<<endl;
const TopTools_ListOfShape& aList1 = aMapVertEdge1.FindFromKey(VS1);
//TopoDS_Shape E1next;
TopTools_ListIteratorOfListOfShape anIter1(aList1);
anIter1.Next();
}
//E1next = anIter1.Value();
+ if(!aMapVertEdge2.Contains(VS2))
+ cout<<" FillForOtherEdges: map aMapVertEdge2 not contains key VS2"<<endl;
const TopTools_ListOfShape& aList2 = aMapVertEdge2.FindFromKey(VS2);
//TopoDS_Shape E2next;
TopTools_ListIteratorOfListOfShape anIter2(aList2);
}
+//=======================================================================
+//function : FillCorrespondingEdges
+//purpose : auxilary for CreatePipeShellsWithoutPath()
+//=======================================================================
+static bool FillCorrespondingEdges(const TopoDS_Shape& FS1,
+ const TopoDS_Shape& FS2,
+ const TopoDS_Vertex& aLoc1,
+ const TopoDS_Vertex& aLoc2,
+ TopTools_IndexedDataMapOfShapeShape& FF)
+{
+ //cout<<"FillCorrespondingEdges"<<endl;
+
+ gp_Pnt P1 = BRep_Tool::Pnt(aLoc1);
+ gp_Pnt P2 = BRep_Tool::Pnt(aLoc2);
+ gp_Vec aDir(P1,P2);
+
+ ShapeAnalysis_Edge sae;
+ double tol = Max( BRep_Tool::Tolerance(TopoDS::Face(FS1)),
+ BRep_Tool::Tolerance(TopoDS::Face(FS2)) );
+ TopTools_MapOfShape Vs1,Vs2;
+
+ TopoDS_Vertex V11=aLoc1, V12=aLoc2, V21, V22;
+ TopoDS_Edge E1,E2;
+
+ TopExp_Explorer exp1;
+ for( exp1.Init(FS1,TopAbs_EDGE); exp1.More(); exp1.Next() ) {
+ E1 = TopoDS::Edge(exp1.Current());
+ TopoDS_Vertex V1 = sae.FirstVertex(E1);
+ TopoDS_Vertex V2 = sae.LastVertex(E1);
+ gp_Pnt Ptmp1 = BRep_Tool::Pnt(V1);
+ gp_Pnt Ptmp2 = BRep_Tool::Pnt(V2);
+ //cout<<"P11("<<P11.X()<<","<<P11.Y()<<","<<P11.Z()<<")"<<endl;
+ //cout<<"P21("<<P21.X()<<","<<P21.Y()<<","<<P21.Z()<<")"<<endl;
+ if(P1.Distance(Ptmp1)<tol) {
+ V21 = V2;
+ break;
+ }
+ if(P1.Distance(Ptmp2)<tol) {
+ V21 = V1;
+ break;
+ }
+ }
+
+ TopoDS_Edge E21,E22;
+ TopoDS_Vertex VE21,VE22;
+ int nbe=0;
+ for( exp1.Init(FS2,TopAbs_EDGE); exp1.More() && nbe<2; exp1.Next() ) {
+ TopoDS_Edge E = TopoDS::Edge(exp1.Current());
+ TopoDS_Vertex V1 = sae.FirstVertex(E);
+ TopoDS_Vertex V2 = sae.LastVertex(E);
+ gp_Pnt Ptmp1 = BRep_Tool::Pnt(V1);
+ gp_Pnt Ptmp2 = BRep_Tool::Pnt(V2);
+ if(P2.Distance(Ptmp1)<tol) {
+ if(nbe==0) {
+ E21 = E;
+ VE21 = V2;
+ nbe++;
+ }
+ else if(nbe==1) {
+ E22 = E;
+ VE22 = V2;
+ nbe++;
+ }
+ }
+ if(P2.Distance(Ptmp2)<tol) {
+ if(nbe==0) {
+ E21 = E;
+ VE21 = V1;
+ nbe++;
+ }
+ else if(nbe==1) {
+ E22 = E;
+ VE22 = V1;
+ nbe++;
+ }
+ }
+ }
+
+ gp_Pnt PV21 = BRep_Tool::Pnt(V21);
+ gp_Pnt PE21 = BRep_Tool::Pnt(VE21);
+ gp_Pnt PE22 = BRep_Tool::Pnt(VE22);
+ gp_Vec aDir1(PV21,PE21);
+ gp_Vec aDir2(PV21,PE22);
+ double ang1 = aDir.Angle(aDir1);
+ double ang2 = aDir.Angle(aDir2);
+ if(fabs(ang1)<fabs(ang2)) {
+ E2 = E21;
+ V22 = VE21;
+ }
+ else {
+ E2 = E22;
+ V22 = VE22;
+ }
+
+ FF.Add(V11,V12);
+ FF.Add(V21,V22);
+ FF.Add(E1,E2);
+
+ // find other pairs for vertexes and edges
+ return FillForOtherEdges(FS1,E1,V21,FF);
+}
+
+
//=======================================================================
//function : FindNextPairOfFaces
//purpose : auxilary for CreatePipeForShellSections()
if(aCI) delete aCI;
Standard_ConstructionError::Raise("FindNextPairOfFaces: Can not find edge in map");
}
+ if(!FF.Contains(E1))
+ cout<<" FindNextPairOfFaces: map FF not contains key E1"<<endl;
const TopoDS_Shape& E2 = FF.FindFromKey(E1);
TopExp_Explorer anExpV;
anExpV.Init( E1, TopAbs_VERTEX );
Standard_ConstructionError::Raise("FindNextPairOfFaces: Can not find vertex in map");
}
+ if(!aMapEdgeFaces1.Contains(E1))
+ cout<<" FindNextPairOfFaces: map aMapEdgeFaces1 not contains key E1"<<endl;
const TopTools_ListOfShape& aList1 = aMapEdgeFaces1.FindFromKey(E1);
if(aList1.Extent()<2)
continue;
if(FF.Contains(F1other))
continue;
+ if(!FF.Contains(aCurFace))
+ cout<<" FindNextPairOfFaces: map FF not contains key aCurFace"<<endl;
const TopoDS_Shape& F2 = FF.FindFromKey(aCurFace);
+ if(!aMapEdgeFaces2.Contains(E2))
+ cout<<" FindNextPairOfFaces: map aMapEdgeFaces2 not contains key E2"<<endl;
const TopTools_ListOfShape& aList2 = aMapEdgeFaces2.FindFromKey(E2);
if(aList2.Extent()<2) {
if(aCI) delete aCI;
}
+//=======================================================================
+//function : FindFirstPairFaces
+//purpose : auxilary for Execute()
+//=======================================================================
+static void FindFirstPairFaces(const TopoDS_Shape& S1, const TopoDS_Shape& S2,
+ TopoDS_Vertex& V1, TopoDS_Vertex& V2,
+ TopoDS_Shape& FS1, TopoDS_Shape& FS2)
+{
+ //cout<<"FindFirstPairFaces"<<endl;
+
+ // check if vertexes are subshapes of sections
+ gp_Pnt P1 = BRep_Tool::Pnt(V1);
+ gp_Pnt P2 = BRep_Tool::Pnt(V2);
+ TopoDS_Vertex V1new,V2new;
+ TopExp_Explorer exp;
+ double mindist = 1.e10;
+ for( exp.Init( S1, TopAbs_VERTEX ); exp.More(); exp.Next() ) {
+ TopoDS_Vertex V = TopoDS::Vertex(exp.Current());
+ gp_Pnt P = BRep_Tool::Pnt(V);
+ double dist = P1.Distance(P);
+ if(dist<mindist) {
+ mindist = dist;
+ V1new = V;
+ }
+ }
+ mindist = 1.e10;
+ for( exp.Init( S2, TopAbs_VERTEX ); exp.More(); exp.Next() ) {
+ TopoDS_Vertex V = TopoDS::Vertex(exp.Current());
+ gp_Pnt P = BRep_Tool::Pnt(V);
+ double dist = P2.Distance(P);
+ if(dist<mindist) {
+ mindist = dist;
+ V2new = V;
+ }
+ }
+
+ //gp_Pnt P1new = BRep_Tool::Pnt(V1new);
+ //gp_Pnt P2new = BRep_Tool::Pnt(V2new);
+ //cout<<" P1("<<P1.X()<<","<<P1.Y()<<","<<P1.Z()<<")"<<endl;
+ //cout<<" P2("<<P2.X()<<","<<P2.Y()<<","<<P2.Z()<<")"<<endl;
+ //cout<<" P1new("<<P1new.X()<<","<<P1new.Y()<<","<<P1new.Z()<<")"<<endl;
+ //cout<<" P2new("<<P2new.X()<<","<<P2new.Y()<<","<<P2new.Z()<<")"<<endl;
+
+ // replace vertexes if it is needed
+ if(!V1.IsSame(V1new)) {
+ V1 = V1new;
+ P1 = BRep_Tool::Pnt(V1);
+ cout<<" replace V1"<<endl;
+ }
+ else
+ cout<<" not replace V1"<<endl;
+ if(!V2.IsSame(V2new)) {
+ V2 = V2new;
+ P2 = BRep_Tool::Pnt(V2);
+ cout<<" replace V2"<<endl;
+ }
+ else
+ cout<<" not replace V2"<<endl;
+
+ TopTools_IndexedDataMapOfShapeListOfShape aMapVertFaces1;
+ TopExp::MapShapesAndAncestors(S1, TopAbs_VERTEX, TopAbs_FACE, aMapVertFaces1);
+ TopTools_IndexedDataMapOfShapeListOfShape aMapVertFaces2;
+ TopExp::MapShapesAndAncestors(S2, TopAbs_VERTEX, TopAbs_FACE, aMapVertFaces2);
+
+ if(!aMapVertFaces1.Contains(V1))
+ cout<<" FindFirstPairFaces: map aMapVertFaces1 not contains key V1"<<endl;
+ const TopTools_ListOfShape& aList1 = aMapVertFaces1.FindFromKey(V1);
+ TopTools_ListIteratorOfListOfShape anIter1(aList1);
+ FS1 = anIter1.Value();
+ // find middle point
+ double x1=0., y1=0., z1=0.;
+ int nbv1=0;
+ for( exp.Init( FS1, TopAbs_VERTEX ); exp.More(); exp.Next() ) {
+ TopoDS_Vertex V = TopoDS::Vertex(exp.Current());
+ gp_Pnt P = BRep_Tool::Pnt(V);
+ x1 += P.X();
+ y1 += P.Y();
+ z1 += P.Z();
+ nbv1++;
+ }
+ gp_Pnt PM1(x1/nbv1, y1/nbv1, z1/nbv1);
+
+ TColgp_SequenceOfPnt Ps;
+ TopTools_SequenceOfShape Fs;
+ if(!aMapVertFaces2.Contains(V2))
+ cout<<" FindFirstPairFaces: map aMapVertFaces2 not contains key V2"<<endl;
+ const TopTools_ListOfShape& aList2 = aMapVertFaces2.FindFromKey(V2);
+ TopTools_ListIteratorOfListOfShape anIter2(aList2);
+ for(; anIter2.More(); anIter2.Next()) {
+ TopoDS_Shape F = anIter2.Value();
+ double x2=0., y2=0., z2=0.;
+ int nbv2=0;
+ for( exp.Init( F, TopAbs_VERTEX ); exp.More(); exp.Next() ) {
+ TopoDS_Vertex V = TopoDS::Vertex(exp.Current());
+ gp_Pnt P = BRep_Tool::Pnt(V);
+ x2 += P.X();
+ y2 += P.Y();
+ z2 += P.Z();
+ nbv2++;
+ }
+ gp_Pnt PM(x2/nbv1, y2/nbv1, z2/nbv1);
+ Fs.Append(F);
+ Ps.Append(PM);
+ }
+
+ gp_Vec aDir(P1,P2);
+ int i=1;
+ double MinAng = PI;
+ int numface = 0;
+ for(; i<=Fs.Length(); i++) {
+ gp_Vec tmpDir(PM1,Ps(i));
+ double ang = fabs(aDir.Angle(tmpDir));
+ if(ang<MinAng) {
+ MinAng = ang;
+ numface = i;
+ }
+ }
+ FS2 = Fs(numface);
+}
+
+
//=======================================================================
//function : CreatePipeForShellSections
//purpose : auxilary for Execute()
TopoDS_Vertex V = TopoDS::Vertex(VLocs.Value(i));
PLocs.Append(BRep_Tool::Pnt(V));
}
+
TopTools_SequenceOfShape Edges;
TopTools_SequenceOfShape Wires;
- TopExp_Explorer anExp;
- for ( anExp.Init( aWirePath, TopAbs_EDGE ); anExp.More(); anExp.Next() ) {
- Edges.Append(anExp.Current());
- }
ShapeAnalysis_Edge sae;
- TopoDS_Edge edge = TopoDS::Edge(Edges.First());
- double tol = BRep_Tool::Tolerance(edge);
- TopoDS_Vertex VF = sae.FirstVertex(edge);
- gp_Pnt PF = BRep_Tool::Pnt(VF);
- //cout<<"PF("<<PF.X()<<","<<PF.Y()<<","<<PF.Z()<<")"<<endl;
- if( PF.Distance(PLocs.First()) > tol ) {
- if(aCI) delete aCI;
- Standard_ConstructionError::Raise
- ("First location shapes is not coincided with first vertex of aWirePath");
- }
- VLocs.ChangeValue(1) = VF;
- edge = TopoDS::Edge(Edges.Last());
- tol = BRep_Tool::Tolerance(edge);
- TopoDS_Vertex VL = sae.LastVertex(edge);
- gp_Pnt PL = BRep_Tool::Pnt(VL);
- if( PL.Distance(PLocs.Last()) > tol ) {
- if(aCI) delete aCI;
- Standard_ConstructionError::Raise
- ("Last location shapes is not coincided with last vertex of aWirePath");
- }
- VLocs.ChangeValue(nbLocs) = VL;
- int jcurr = 2;
- TopTools_SequenceOfShape tmpEdges;
- for(i=1; i<=Edges.Length() && jcurr<nbLocs; i++) {
- TopoDS_Edge E = TopoDS::Edge(Edges.Value(i));
- tol = BRep_Tool::Tolerance(E);
- TopoDS_Vertex V1 = sae.FirstVertex(E);
- TopoDS_Vertex V2 = sae.LastVertex(E);
- gp_Pnt P1 = BRep_Tool::Pnt(V1);
- gp_Pnt P2 = BRep_Tool::Pnt(V2);
- if( P2.Distance(PLocs.Value(jcurr)) < tol ) {
- // make wire from current edge and add created
- // wire to Wires
+
+ if(nbLocs==2) {
+ TopExp_Explorer anExp;
+ for ( anExp.Init( aWirePath, TopAbs_EDGE ); anExp.More(); anExp.Next() ) {
+ Edges.Append(anExp.Current());
+ }
+ Standard_Integer Num1 = 0;
+ Standard_Integer Num2 = 0;
+ for(i=1; i<=Edges.Length(); i++) {
+ TopoDS_Edge E = TopoDS::Edge(Edges.Value(i));
+ double tol = BRep_Tool::Tolerance(E);
+ TopoDS_Vertex V1 = sae.FirstVertex(E);
+ TopoDS_Vertex V2 = sae.LastVertex(E);
+ gp_Pnt P1 = BRep_Tool::Pnt(V1);
+ gp_Pnt P2 = BRep_Tool::Pnt(V2);
+ if( P1.Distance(PLocs.First()) < tol ) {
+ Num1 = i;
+ }
+ if( P2.Distance(PLocs.Last()) < tol ) {
+ Num2 = i;
+ }
+ }
+ if( Num1>0 && Num2>0 ) {
TopoDS_Wire W;
B.MakeWire(W);
- for(j=1; j<=tmpEdges.Length(); j++)
- B.Add(W,tmpEdges.Value(j));
- B.Add(W,E);
+ for(i=Num1; i<=Num2; i++) {
+ B.Add(W,Edges.Value(i));
+ }
Wires.Append(W);
- VLocs.ChangeValue(jcurr) = V2;
- jcurr++;
- tmpEdges.Clear();
}
else {
- // find distance between E and aLocs(jcurr)
- double fp,lp;
- Handle(Geom_Curve) C = BRep_Tool::Curve(E,fp,lp);
- GeomAPI_ProjectPointOnCurve PPC (PLocs.Value(jcurr),C);
- if( PPC.NbPoints()>0 &&
- PLocs.Value(jcurr).Distance(PPC.Point(1)) < tol ) {
- double param = PPC.Parameter(1);
- gp_Pnt PC1;
- C->D0(param,PC1);
- // split current edge
- Handle(Geom_TrimmedCurve) tc1 = new Geom_TrimmedCurve(C,fp,param);
- Handle(Geom_TrimmedCurve) tc2 = new Geom_TrimmedCurve(C,param,lp);
- TopoDS_Edge E1,E2;
- gp_Pnt Pfp;
- C->D0(fp,Pfp);
- if(Pfp.Distance(P1)<tol) {
- B.MakeEdge(E1,tc1,tol);
- B.Add(E1,V1);
- TopoDS_Shape tmpV = VLocs.Value(jcurr).Oriented(TopAbs_REVERSED);
- B.Add(E1,TopoDS::Vertex(tmpV));
- tmpEdges.Append(E1);
- B.MakeEdge(E2,tc2,tol);
- tmpV = VLocs.Value(jcurr).Oriented(TopAbs_FORWARD);
- B.Add(E2,TopoDS::Vertex(tmpV));
- B.Add(E2,V2);
- }
- else {
- B.MakeEdge(E1,tc2,tol);
- TopoDS_Shape tmpV = VLocs.Value(jcurr).Oriented(TopAbs_FORWARD);
- B.Add(E1,TopoDS::Vertex(tmpV));
- B.Add(E1,V1);
- E1.Reverse();
- tmpEdges.Append(E1);
- B.MakeEdge(E2,tc1,tol);
- B.Add(E2,V2);
- tmpV = VLocs.Value(jcurr).Oriented(TopAbs_REVERSED);
- B.Add(E2,TopoDS::Vertex(tmpV));
- E2.Reverse();
- }
- // create wire from tmpEdges
+ Wires.Append(aWirePath);
+ }
+ }
+ else {
+ TopExp_Explorer anExp;
+ for ( anExp.Init( aWirePath, TopAbs_EDGE ); anExp.More(); anExp.Next() ) {
+ Edges.Append(anExp.Current());
+ }
+ TopoDS_Edge edge = TopoDS::Edge(Edges.First());
+ double tol = BRep_Tool::Tolerance(edge);
+ TopoDS_Vertex VF = sae.FirstVertex(edge);
+ gp_Pnt PF = BRep_Tool::Pnt(VF);
+ //cout<<"PF("<<PF.X()<<","<<PF.Y()<<","<<PF.Z()<<")"<<endl;
+ if( PF.Distance(PLocs.First()) > tol ) {
+ if(aCI) delete aCI;
+ Standard_ConstructionError::Raise
+ ("First location shapes is not coincided with first vertex of aWirePath");
+ }
+ VLocs.ChangeValue(1) = VF;
+ edge = TopoDS::Edge(Edges.Last());
+ tol = BRep_Tool::Tolerance(edge);
+ TopoDS_Vertex VL = sae.LastVertex(edge);
+ gp_Pnt PL = BRep_Tool::Pnt(VL);
+ if( PL.Distance(PLocs.Last()) > tol ) {
+ if(aCI) delete aCI;
+ Standard_ConstructionError::Raise
+ ("Last location shapes is not coincided with last vertex of aWirePath");
+ }
+ VLocs.ChangeValue(nbLocs) = VL;
+ int jcurr = 2;
+ TopTools_SequenceOfShape tmpEdges;
+ for(i=1; i<=Edges.Length() && jcurr<nbLocs; i++) {
+ TopoDS_Edge E = TopoDS::Edge(Edges.Value(i));
+ tol = BRep_Tool::Tolerance(E);
+ TopoDS_Vertex V1 = sae.FirstVertex(E);
+ TopoDS_Vertex V2 = sae.LastVertex(E);
+ gp_Pnt P1 = BRep_Tool::Pnt(V1);
+ gp_Pnt P2 = BRep_Tool::Pnt(V2);
+ if( P2.Distance(PLocs.Value(jcurr)) < tol ) {
+ // make wire from current edge and add created
+ // wire to Wires
TopoDS_Wire W;
B.MakeWire(W);
for(j=1; j<=tmpEdges.Length(); j++)
B.Add(W,tmpEdges.Value(j));
+ B.Add(W,E);
Wires.Append(W);
+ VLocs.ChangeValue(jcurr) = V2;
jcurr++;
tmpEdges.Clear();
- Edges.Remove(i);
- Edges.InsertAfter(i-1,E1);
- Edges.InsertAfter(i,E2);
}
else {
- tmpEdges.Append(E);
+ // find distance between E and aLocs(jcurr)
+ double fp,lp;
+ Handle(Geom_Curve) C = BRep_Tool::Curve(E,fp,lp);
+ GeomAPI_ProjectPointOnCurve PPC (PLocs.Value(jcurr),C);
+ if( PPC.NbPoints()>0 &&
+ PLocs.Value(jcurr).Distance(PPC.Point(1)) < tol ) {
+ double param = PPC.Parameter(1);
+ gp_Pnt PC1;
+ C->D0(param,PC1);
+ // split current edge
+ Handle(Geom_TrimmedCurve) tc1 = new Geom_TrimmedCurve(C,fp,param);
+ Handle(Geom_TrimmedCurve) tc2 = new Geom_TrimmedCurve(C,param,lp);
+ TopoDS_Edge E1,E2;
+ gp_Pnt Pfp;
+ C->D0(fp,Pfp);
+ if(Pfp.Distance(P1)<tol) {
+ B.MakeEdge(E1,tc1,tol);
+ B.Add(E1,V1);
+ TopoDS_Shape tmpV = VLocs.Value(jcurr).Oriented(TopAbs_REVERSED);
+ B.Add(E1,TopoDS::Vertex(tmpV));
+ tmpEdges.Append(E1);
+ B.MakeEdge(E2,tc2,tol);
+ tmpV = VLocs.Value(jcurr).Oriented(TopAbs_FORWARD);
+ B.Add(E2,TopoDS::Vertex(tmpV));
+ B.Add(E2,V2);
+ }
+ else {
+ B.MakeEdge(E1,tc2,tol);
+ TopoDS_Shape tmpV = VLocs.Value(jcurr).Oriented(TopAbs_FORWARD);
+ B.Add(E1,TopoDS::Vertex(tmpV));
+ B.Add(E1,V1);
+ E1.Reverse();
+ tmpEdges.Append(E1);
+ B.MakeEdge(E2,tc1,tol);
+ B.Add(E2,V2);
+ tmpV = VLocs.Value(jcurr).Oriented(TopAbs_REVERSED);
+ B.Add(E2,TopoDS::Vertex(tmpV));
+ E2.Reverse();
+ }
+ // create wire from tmpEdges
+ TopoDS_Wire W;
+ B.MakeWire(W);
+ for(j=1; j<=tmpEdges.Length(); j++)
+ B.Add(W,tmpEdges.Value(j));
+ Wires.Append(W);
+ jcurr++;
+ tmpEdges.Clear();
+ Edges.Remove(i);
+ Edges.InsertAfter(i-1,E1);
+ Edges.InsertAfter(i,E2);
+ }
+ else {
+ tmpEdges.Append(E);
+ }
}
}
+ // create wire from other edges
+ TopoDS_Wire W;
+ B.MakeWire(W);
+ for(; i<=Edges.Length(); i++)
+ B.Add(W,Edges.Value(i));
+ Wires.Append(W);
+ //cout<<"Wires.Length()="<<Wires.Length()<<endl;
}
- // create wire from other edges
- TopoDS_Wire W;
- B.MakeWire(W);
- for(; i<=Edges.Length(); i++)
- B.Add(W,Edges.Value(i));
- Wires.Append(W);
- //cout<<"Wires.Length()="<<Wires.Length()<<endl;
if( Wires.Length() != nbLocs-1 ) {
if(aCI) delete aCI;
}
+//=======================================================================
+//function : CreatePipeShellsWithoutPath
+//purpose : auxilary for Execute()
+//=======================================================================
+static TopoDS_Shape CreatePipeShellsWithoutPath(GEOMImpl_IPipe* aCI)
+{
+ //cout<<"CreatePipeShellsWithoutPath"<<endl;
+ int i,j;
+ BRep_Builder B;
+
+ GEOMImpl_IPipeShellSect* aCIDS = (GEOMImpl_IPipeShellSect*)aCI;
+ // shell sections
+ Handle(TColStd_HSequenceOfTransient) aBasesObjs = aCIDS->GetBases();
+ // vertex for recognition
+ Handle(TColStd_HSequenceOfTransient) VObjs = aCIDS->GetLocations();
+
+ Standard_Integer nbBases = aBasesObjs->Length(),
+ nbv = (VObjs.IsNull() ? 0 :VObjs->Length());
+
+ if( nbv != nbBases ) {
+ if(aCI) delete aCI;
+ Standard_ConstructionError::Raise("Number of shapes for recognition is invalid");
+ }
+
+
+ TopTools_SequenceOfShape SecVs,Bases;
+ for(i=1; i<=nbBases; i++) {
+ // vertex
+ Handle(Standard_Transient) anItem = VObjs->Value(i);
+ if(anItem.IsNull())
+ continue;
+ Handle(GEOM_Function) aRef = Handle(GEOM_Function)::DownCast(anItem);
+ TopoDS_Shape V = aRef->GetValue();
+ if(V.IsNull() || V.ShapeType() != TopAbs_VERTEX)
+ continue;
+ SecVs.Append(V);
+ // section
+ anItem = aBasesObjs->Value(i);
+ if(anItem.IsNull())
+ continue;
+ aRef = Handle(GEOM_Function)::DownCast(anItem);
+ TopoDS_Shape aSh = aRef->GetValue();
+ if(aSh.IsNull())
+ continue;
+ Bases.Append(aSh);
+ }
+ nbv = SecVs.Length();
+ nbBases = Bases.Length();
+ if( nbv != nbBases ) {
+ if(aCI) delete aCI;
+ Standard_ConstructionError::Raise("One of shapes for recognition is not a vertex");
+ }
+
+ TopoDS_Compound aComp;
+ B.MakeCompound(aComp);
+
+ for(i=1 ; i<nbBases; i++) {
+ cout<<"Make pipe between sections "<<i<<" and "<<i+1<<endl;
+ TopoDS_Shape aShBase1 = Bases.Value(i);
+ TopoDS_Shape aShBase2 = Bases.Value(i+1);
+ TopExp_Explorer anExp;
+ Standard_Integer nbf1 = 0;
+ for ( anExp.Init( aShBase1, TopAbs_FACE ); anExp.More(); anExp.Next() ) {
+ nbf1++;
+ }
+ Standard_Integer nbf2 = 0;
+ for ( anExp.Init( aShBase2, TopAbs_FACE ); anExp.More(); anExp.Next() ) {
+ nbf2++;
+ }
+ //cout<<"nbf1="<<nbf1<<" nbf2="<<nbf2<<endl;
+ if(nbf1!=nbf2) {
+ if(aCI) delete aCI;
+ Standard_ConstructionError::Raise("Different number of faces in the sections");
+ }
+
+ TopTools_MapOfShape aFaces1,aFaces2;
+ for ( anExp.Init( aShBase1, TopAbs_FACE ); anExp.More(); anExp.Next() ) {
+ aFaces1.Add(anExp.Current());
+ }
+ for ( anExp.Init( aShBase2, TopAbs_FACE ); anExp.More(); anExp.Next() ) {
+ aFaces2.Add(anExp.Current());
+ }
+
+ // creating map of edge faces
+ TopTools_IndexedDataMapOfShapeListOfShape aMapEdgeFaces1;
+ TopExp::MapShapesAndAncestors(aShBase1, TopAbs_EDGE, TopAbs_FACE, aMapEdgeFaces1);
+ TopTools_IndexedDataMapOfShapeListOfShape aMapEdgeFaces2;
+ TopExp::MapShapesAndAncestors(aShBase2, TopAbs_EDGE, TopAbs_FACE, aMapEdgeFaces2);
+
+ // constuct map face->face (and subshapes)
+ TopTools_IndexedDataMapOfShapeShape FF;
+ //TopoDS_Shape FS1 = SecFs.Value(i), FS2 = SecFs.Value(i+1);
+ TopoDS_Shape FS1, FS2;
+ TopoDS_Vertex V1 = TopoDS::Vertex(SecVs(i));
+ TopoDS_Vertex V2 = TopoDS::Vertex(SecVs(i+1));
+ FindFirstPairFaces(aShBase1, aShBase2, V1, V2, FS1, FS2);
+
+ FF.Add(FS1,FS2);
+ cout<<" first pair of corresponding faces is found"<<endl;
+
+ // add pairs of edges and vertexes to FF
+ bool stat = FillCorrespondingEdges(FS1, FS2, V1, V2, FF);
+ if( !stat ) {
+ if(aCI) delete aCI;
+ Standard_ConstructionError::Raise("Can not create correct pipe");
+ }
+ cout<<" correspondences for subshapes of first pair of faces is found"<<endl;
+
+ FindNextPairOfFaces(FS1, aMapEdgeFaces1, aMapEdgeFaces2, FF, aCI);
+ cout<<" other correspondences is found, make pipe for all pairs of faces"<<endl;
+
+ // make pipe for each pair of faces
+ // auxilary map vertex->edge for created pipe edges
+ TopTools_IndexedDataMapOfShapeShape VPE;
+ ShapeAnalysis_Edge sae;
+ //cout<<"FF.Extent()="<<FF.Extent()<<endl;
+ int nbff = 0;
+ for(j=1; j<=FF.Extent(); j++) {
+ TopoDS_Shape F1 = FF.FindKey(j);
+ if( F1.ShapeType() != TopAbs_FACE )
+ continue;
+ TopoDS_Shape F2 = FF.FindFromIndex(j);
+ nbff++;
+
+ //if(nbff!=3) continue;
+
+ cout<<" make pipe for "<<nbff<<" face"<<endl;
+
+ Handle(Geom_Surface) S1 = BRep_Tool::Surface(TopoDS::Face(F1));
+ if(S1->IsKind(STANDARD_TYPE(Geom_RectangularTrimmedSurface))) {
+ Handle(Geom_RectangularTrimmedSurface) RTS =
+ Handle(Geom_RectangularTrimmedSurface)::DownCast(S1);
+ S1 = RTS->BasisSurface();
+ }
+ Handle(Geom_Plane) Pln1 =
+ Handle(Geom_Plane)::DownCast(S1);
+ if( Pln1.IsNull() ) {
+ if(aCI) delete aCI;
+ Standard_ConstructionError::Raise("Surface from face is not plane");
+ }
+ gp_Vec aDir1(Pln1->Axis().Direction());
+
+ Handle(Geom_Surface) S2 = BRep_Tool::Surface(TopoDS::Face(F2));
+ if(S2->IsKind(STANDARD_TYPE(Geom_RectangularTrimmedSurface))) {
+ Handle(Geom_RectangularTrimmedSurface) RTS =
+ Handle(Geom_RectangularTrimmedSurface)::DownCast(S2);
+ S2 = RTS->BasisSurface();
+ }
+ Handle(Geom_Plane) Pln2 =
+ Handle(Geom_Plane)::DownCast(S2);
+ if( Pln2.IsNull() ) {
+ if(aCI) delete aCI;
+ Standard_ConstructionError::Raise("Surface from face is not plane");
+ }
+ gp_Vec aDir2(Pln2->Axis().Direction());
+
+ gp_Pnt P1 = BRep_Tool::Pnt(TopoDS::Vertex(SecVs(i)));
+ gp_Pnt P2 = BRep_Tool::Pnt(TopoDS::Vertex(SecVs(i+1)));
+ gp_Vec aDir(P1,P2);
+ if(fabs(aDir.Angle(aDir1))>PI/2.)
+ aDir1.Reverse();
+ if(fabs(aDir.Angle(aDir2))>PI/2.)
+ aDir2.Reverse();
+
+ TopExp_Explorer anExpE(F1,TopAbs_EDGE);
+ TopTools_SequenceOfShape aNewFs;
+ //int nbee=0;
+ for(; anExpE.More(); anExpE.Next()) {
+ TopoDS_Edge E1 = TopoDS::Edge(anExpE.Current());
+ //nbee++;
+ if(!FF.Contains(E1))
+ cout<<"map FF not contains key E1"<<endl;
+
+ if(VPE.Contains(E1)) {
+ aNewFs.Append(VPE.FindFromKey(E1));
+#ifdef _DEBUG_
+ cout<<" using existed face"<<endl;
+#endif
+ continue;
+ }
+
+ TopoDS_Edge E3 = TopoDS::Edge(FF.FindFromKey(E1));
+ TopoDS_Vertex V1 = sae.FirstVertex(E1);
+ TopoDS_Vertex V2 = sae.LastVertex(E1);
+ if(!FF.Contains(V1))
+ cout<<"map FF not contains key V1"<<endl;
+ if(!FF.Contains(V2))
+ cout<<"map FF not contains key V2"<<endl;
+ TopoDS_Vertex V3 = TopoDS::Vertex(FF.FindFromKey(V2));
+ TopoDS_Vertex V4 = TopoDS::Vertex(FF.FindFromKey(V1));
+ TopoDS_Vertex Vtmp = sae.FirstVertex(E3);
+ if(Vtmp.IsSame(V4))
+ E3.Reverse();
+ gp_Pnt P1 = BRep_Tool::Pnt(V1);
+ gp_Pnt P2 = BRep_Tool::Pnt(V2);
+ gp_Pnt P3 = BRep_Tool::Pnt(V3);
+ gp_Pnt P4 = BRep_Tool::Pnt(V4);
+ // make E2
+ TopoDS_Edge E2;
+ Handle(Geom_BSplineCurve) C2;
+ if(VPE.Contains(V2)) {
+ E2 = TopoDS::Edge(VPE.FindFromKey(V2));
+ double fp,lp;
+ C2 = Handle(Geom_BSplineCurve)::DownCast(BRep_Tool::Curve(E2,fp,lp));
+ }
+ else {
+ Handle(TColgp_HArray1OfPnt) HAP = new TColgp_HArray1OfPnt(1,2);
+ HAP->SetValue(1,P2);
+ HAP->SetValue(2,P3);
+ GeomAPI_Interpolate anInt(HAP,Standard_False,1.e-7);
+ anInt.Load(aDir1,aDir2);
+ anInt.Perform();
+ C2 = anInt.Curve();
+ B.MakeEdge(E2,C2,1.e-7);
+ B.Add(E2,TopoDS::Vertex(V2.Oriented(TopAbs_FORWARD)));
+ B.Add(E2,TopoDS::Vertex(V3.Oriented(TopAbs_REVERSED)));
+ VPE.Add(V2,E2);
+ }
+ // make E4
+ TopoDS_Edge E4;
+ Handle(Geom_BSplineCurve) C4;
+ if(VPE.Contains(V1)) {
+ E4 = TopoDS::Edge(VPE.FindFromKey(V1));
+ double fp,lp;
+ C4 = Handle(Geom_BSplineCurve)::DownCast(BRep_Tool::Curve(E4,fp,lp));
+ }
+ else {
+ Handle(TColgp_HArray1OfPnt) HAP = new TColgp_HArray1OfPnt(1,2);
+ HAP->SetValue(1,P1);
+ HAP->SetValue(2,P4);
+ GeomAPI_Interpolate anInt(HAP,Standard_False,1.e-7);
+ anInt.Load(aDir1,aDir2);
+ anInt.Perform();
+ C4 = anInt.Curve();
+ B.MakeEdge(E4,anInt.Curve(),1.e-7);
+ B.Add(E4,TopoDS::Vertex(V1.Oriented(TopAbs_FORWARD)));
+ B.Add(E4,TopoDS::Vertex(V4.Oriented(TopAbs_REVERSED)));
+ VPE.Add(V1,E4);
+ }
+
+ TopoDS_Wire W;
+ B.MakeWire(W);
+ B.Add(W,E1);
+ B.Add(W,E2);
+ B.Add(W,E3);
+ B.Add(W,E4.Reversed());
+ //cout<<" wire for edge "<<nbee<<" is created"<<endl;
+ //BRepTools::Write(W,"/dn02/users_Linux/skl/work/Bugs/14857/w.brep");
+
+ // make surface
+
+ double fp,lp;
+ Handle(Geom_Curve) C1 = BRep_Tool::Curve(E1,fp,lp);
+ //bool IsConicC1 = false;
+ //if( C1->IsKind(STANDARD_TYPE(Geom_Conic)) ) {
+ // IsConicC1 = true;
+ // cout<<"C1 - Geom_Conic"<<endl;
+ //}
+ if( C1->IsKind(STANDARD_TYPE(Geom_Line)) || C1->IsKind(STANDARD_TYPE(Geom_Conic)) ) {
+ C1 = new Geom_TrimmedCurve(C1,fp,lp);
+ }
+ //if(IsConicC1) {
+ // double tol = BRep_Tool::Tolerance(E1);
+ // GeomConvert_ApproxCurve ApxC1(C1,tol,GeomAbs_C1,10,5);
+ // C1 = ApxC1.Curve();
+ //}
+ Handle(Geom_Curve) C3 = BRep_Tool::Curve(E3,fp,lp);
+ if( C3->IsKind(STANDARD_TYPE(Geom_Line)) || C3->IsKind(STANDARD_TYPE(Geom_Conic)) ) {
+ C3 = new Geom_TrimmedCurve(C3,fp,lp);
+ }
+ //filebuf fic;
+ //ostream os(&fic);
+ //os.precision(15);
+ Handle(Geom_BSplineCurve) CE1 =
+ GeomConvert::CurveToBSplineCurve(C1,Convert_RationalC1);
+ if(CE1->Degree()<3)
+ CE1->IncreaseDegree(3);
+ Handle(Geom_BSplineCurve) CE2 =
+ GeomConvert::CurveToBSplineCurve(C2,Convert_RationalC1);
+ if(CE2->Degree()<3)
+ CE2->IncreaseDegree(3);
+ Handle(Geom_BSplineCurve) CE3 =
+ GeomConvert::CurveToBSplineCurve(C3,Convert_RationalC1);
+ if(CE3->Degree()<3)
+ CE3->IncreaseDegree(3);
+ Handle(Geom_BSplineCurve) CE4 =
+ GeomConvert::CurveToBSplineCurve(C4,Convert_RationalC1);
+ if(CE4->Degree()<3)
+ CE4->IncreaseDegree(3);
+ //cout<<"CE1->Degree()="<<CE1->Degree()<<" CE2->Degree()="<<CE2->Degree()
+ // <<" CE3->Degree()="<<CE3->Degree()<<" CE4->Degree()="<<CE4->Degree()<<endl;
+ //if(fic.open("/dn02/users_Linux/skl/work/Bugs/14857/ce1.brep",ios::out)) {
+ // os<<"DrawTrSurf_BSplineCurve"<<endl;
+ // GeomTools::Write(CE1,os);
+ // fic.close();
+ //}
+
+ Handle(Geom_Surface) BS;
+ try {
+ GeomFill_BSplineCurves GF(CE1,CE2,CE3,CE4,GeomFill_CoonsStyle);
+ //GeomFill_BSplineCurves GF(CE1,CE2,CE3,CE4,GeomFill_StretchStyle);
+ BS = GF.Surface();
+ }
+ catch(...) {
+ cout<<" can not create BSplineSurface - create Bezier"<<endl;
+ int NbP=26;
+ TColgp_Array2OfPnt Points(1,NbP,1,NbP);
+ double fp1,lp1,fp2,lp2;
+ Handle(Geom_Curve) C1 = BRep_Tool::Curve(E1,fp1,lp1);
+ Handle(Geom_Curve) C3 = BRep_Tool::Curve(E3,fp2,lp2);
+ gp_Pnt P1C1,P2C1;
+ C1->D0(fp1,P1C1);
+ C1->D0(lp1,P2C1);
+ gp_Pnt P1C3,P2C3;
+ C3->D0(fp2,P1C3);
+ C3->D0(lp2,P2C3);
+ int n1,n2;
+ double fp,lp;
+ // get points from C1
+ if(P1.Distance(P1C1)<1.e-6) {
+ fp = fp1;
+ lp = lp1;
+ }
+ else {
+ fp = lp1;
+ lp = fp1;
+ }
+ double step = (lp-fp)/(NbP-1);
+ Points.SetValue(1,1,P1);
+ double par = fp;
+ for(n1=2; n1<NbP; n1++) {
+ gp_Pnt P;
+ par += step;
+ C1->D0(par,P);
+ Points.SetValue(1,n1,P);
+ }
+ Points.SetValue(1,NbP,P2);
+ // get points from C3
+ if(P4.Distance(P1C3)<1.e-6) {
+ fp = fp2;
+ lp = lp2;
+ }
+ else {
+ fp = lp2;
+ lp = fp2;
+ }
+ step = (lp-fp)/(NbP-1);
+ Points.SetValue(NbP,1,P4);
+ par = fp;
+ for(n1=2; n1<NbP; n1++) {
+ gp_Pnt P;
+ par += step;
+ C3->D0(par,P);
+ Points.SetValue(NbP,n1,P);
+ }
+ Points.SetValue(NbP,NbP,P3);
+ // create isolines and get points from them
+ for(n1=1; n1<=NbP; n1++) {
+ gp_Pnt PI1 = Points.Value(1,n1);
+ gp_Pnt PI2 = Points.Value(NbP,n1);
+ Handle(TColgp_HArray1OfPnt) HAP = new TColgp_HArray1OfPnt(1,2);
+ HAP->SetValue(1,PI1);
+ HAP->SetValue(2,PI2);
+ GeomAPI_Interpolate anInt(HAP,Standard_False,1.e-7);
+ anInt.Load(aDir1,aDir2);
+ anInt.Perform();
+ Handle(Geom_Curve) iso = anInt.Curve();
+ fp = iso->FirstParameter();
+ lp = iso->LastParameter();
+ step = (lp-fp)/(NbP-1);
+ par = fp;
+ TopoDS_Compound VComp;
+ B.MakeCompound(VComp);
+ for(n2=2; n2<NbP; n2++) {
+ gp_Pnt P;
+ par += step;
+ iso->D0(par,P);
+ Points.SetValue(n2,n1,P);
+ }
+ }
+ // create surface and face
+ //Handle(Geom_BezierSurface) BS = new Geom_BezierSurface(Points);
+ BS = new Geom_BezierSurface(Points);
+ }
+
+ BRepBuilderAPI_MakeFace BB(BS,W);
+ TopoDS_Face NewF = BB.Face();
+ Handle(ShapeFix_Face) sff = new ShapeFix_Face(NewF);
+ sff->Perform();
+ sff->FixOrientation();
+ TopoDS_Face FixedFace = sff->Face();
+ aNewFs.Append(FixedFace);
+ VPE.Add(E1,FixedFace);
+ //cout<<" face for edge "<<nbee<<" is created"<<endl;
+ //BRepTools::Write(FixedFace,"/dn02/users_Linux/skl/work/Bugs/14857/f.brep");
+ }
+ // make shell
+ TopoDS_Shell aShell;
+ B.MakeShell(aShell);
+ for(int nf=1; nf<=aNewFs.Length(); nf++) {
+ B.Add(aShell,aNewFs(nf));
+ }
+ B.Add(aShell,F1);
+ B.Add(aShell,F2);
+
+ // make sewing for this shell
+ Handle(BRepBuilderAPI_Sewing) aSewing = new BRepBuilderAPI_Sewing;
+ aSewing->SetTolerance(Precision::Confusion());
+ aSewing->SetFaceMode(Standard_True);
+ aSewing->SetFloatingEdgesMode(Standard_False);
+ aSewing->SetNonManifoldMode(Standard_False);
+ for ( anExp.Init( aShell, TopAbs_FACE ); anExp.More(); anExp.Next() ) {
+ aSewing->Add(anExp.Current());
+ }
+ aSewing->Perform();
+ cout<<" shell for face "<<nbff<<" is created"<<endl;
+ const TopoDS_Shape aSewShape = aSewing->SewedShape();
+ //BRepTools::Write(aSewShape,"/dn02/users_Linux/skl/work/Bugs/14857/sew.brep");
+ if( aSewShape.ShapeType() == TopAbs_SHELL ) {
+ aShell = TopoDS::Shell(aSewShape);
+ GProp_GProps aSystem;
+ BRepGProp::VolumeProperties(aShell, aSystem);
+ if(aSystem.Mass()<0) {
+ //cout<<"aSewShape is reversed"<<endl;
+ aShell.Reverse();
+ }
+ if(BRep_Tool::IsClosed(aShell)) {
+ TopoDS_Solid aSolid;
+ B.MakeSolid(aSolid);
+ B.Add(aSolid,aShell);
+ B.Add(aComp,aSolid);
+ cout<<" solid for face "<<nbff<<" is created"<<endl;
+ }
+ else {
+ B.Add(aComp,aShell);
+ cout<<" solid for face "<<nbff<<" is not created"<<endl;
+ }
+ }
+ else {
+ B.Add(aComp,aShell);
+ cout<<" solid for face "<<nbff<<" is not created"<<endl;
+ }
+ //cout<<" solid for face "<<nbff<<" is created"<<endl;
+
+ //Handle(ShapeFix_Shell) sfs = new ShapeFix_Shell(aShell);
+ //sfs->Perform();
+ //TopoDS_Shell FixedShell = sfs->Shell();
+ /*
+ GProp_GProps aSystem;
+ BRepGProp::VolumeProperties(FixedShell, aSystem);
+ if(aSystem.Mass()<0) {
+ //cout<<"aSewShape is reversed"<<endl;
+ FixedShell.Reverse();
+ }
+ if(BRep_Tool::IsClosed(FixedShell)) {
+ TopoDS_Solid aSolid;
+ B.MakeSolid(aSolid);
+ B.Add(aSolid,aShell);
+ B.Add(aComp,aSolid);
+ }
+ else {
+ B.Add(aComp,FixedShell);
+ }
+ */
+ }
+ }
+
+ //BRepTools::Write(aComp,"/dn02/users_Linux/skl/work/Bugs/14857/comp.brep");
+ return aComp;
+}
+
+
//=======================================================================
//function : Execute
//purpose :
//=======================================================================
Standard_Integer GEOMImpl_PipeDriver::Execute(TFunction_Logbook& log) const
{
+ //cout<<"PipeDriver::Execute"<<endl;
if (Label().IsNull()) return 0;
Handle(GEOM_Function) aFunction = GEOM_Function::GetFunction(Label());
GEOMImpl_IPipe* aCI= 0;
aCI = new GEOMImpl_IPipeDiffSect(aFunction);
else if(aType == PIPE_SHELL_SECTIONS)
aCI = new GEOMImpl_IPipeShellSect(aFunction);
+ else if(aType == PIPE_SHELLS_WITHOUT_PATH)
+ aCI = new GEOMImpl_IPipeShellSect(aFunction);
else
return 0;
- Handle(GEOM_Function) aRefPath = aCI->GetPath();
- TopoDS_Shape aShapePath = aRefPath->GetValue();
-
+ TopoDS_Wire aWirePath;
+ if(aType != PIPE_SHELLS_WITHOUT_PATH) {
+ // working with path
+ Handle(GEOM_Function) aRefPath = aCI->GetPath();
+ TopoDS_Shape aShapePath = aRefPath->GetValue();
- if (aShapePath.IsNull()) {
- cout<<"Driver : path is null"<<endl;
- if(aCI) delete aCI;
- Standard_NullObject::Raise("MakePipe aborted : null path argument");
- }
+ if (aShapePath.IsNull()) {
+ cout<<"Driver : path is null"<<endl;
+ if(aCI) delete aCI;
+ Standard_NullObject::Raise("MakePipe aborted : null path argument");
+ }
- // Get path contour
- TopoDS_Wire aWirePath;
- if (aShapePath.ShapeType() == TopAbs_WIRE) {
- aWirePath = TopoDS::Wire(aShapePath);
- }
- else {
- if (aShapePath.ShapeType() == TopAbs_EDGE) {
- TopoDS_Edge anEdge = TopoDS::Edge(aShapePath);
- aWirePath = BRepBuilderAPI_MakeWire(anEdge);
+ // Get path contour
+ if (aShapePath.ShapeType() == TopAbs_WIRE) {
+ aWirePath = TopoDS::Wire(aShapePath);
}
else {
- if(aCI) delete aCI;
- Standard_TypeMismatch::Raise("MakePipe aborted : path shape is neither a wire nor an edge");
- }
+ if (aShapePath.ShapeType() == TopAbs_EDGE) {
+ TopoDS_Edge anEdge = TopoDS::Edge(aShapePath);
+ aWirePath = BRepBuilderAPI_MakeWire(anEdge);
+ }
+ else {
+ if(aCI) delete aCI;
+ Standard_TypeMismatch::Raise("MakePipe aborted : path shape is neither a wire nor an edge");
+ }
+ }
}
-
+
TopoDS_Shape aShape;
if (aType == PIPE_BASE_PATH) {
}
//building pipe with different sections
- else if (aType == PIPE_DIFFERENT_SECTIONS)
- {
+ else if (aType == PIPE_DIFFERENT_SECTIONS) {
GEOMImpl_IPipeDiffSect* aCIDS = (GEOMImpl_IPipeDiffSect*)aCI;
//GEOMImpl_IPipeDiffSect* aCIDS = static_cast<GEOMImpl_IPipeDiffSect*>(aCI);
//BRepOffsetAPI_MakePipeShell aBuilder(aWirePath);
Standard_Integer i =1, nbBases = aBasesObjs->Length(),
nbLocs = (aLocObjs.IsNull() ? 0 :aLocObjs->Length());
- if(nbLocs && nbLocs != nbBases)
- {
+ if(nbLocs && nbLocs != nbBases) {
if(aCI) delete aCI;
Standard_ConstructionError::Raise("Number of sections is not equal to number of locations ");
}
TopTools_SequenceOfShape aSeqBases;
TopTools_SequenceOfShape aSeqLocs;
TopTools_SequenceOfShape aSeqFaces;
- for( ; i <= nbBases; i++)
- {
+ for( ; i <= nbBases; i++) {
Handle(Standard_Transient) anItem = aBasesObjs->Value(i);
if(anItem.IsNull())
continue;
aSeqFaces.Append(aShapeBase);
aSeqBases.Append(aWire);
}
- else if(aTypeBase == TopAbs_FACE)
- {
+ else if(aTypeBase == TopAbs_FACE) {
NeedCreateSolid = Standard_True;
//for case one path should be used other type function
aSeqFaces.Append(aShapeBase);
else if(aTypeBase == TopAbs_WIRE || aTypeBase == TopAbs_VERTEX) {
aSeqBases.Append(aShapeBase);
}
- else if(aTypeBase == TopAbs_EDGE)
- {
+ else if(aTypeBase == TopAbs_EDGE) {
TopoDS_Edge anEdge = TopoDS::Edge(aShapeBase);
TopoDS_Shape aWireProf = BRepBuilderAPI_MakeWire(anEdge);
aSeqBases.Append(aWireProf);
}
- if(nbLocs)
- {
+ if(nbLocs) {
Handle(Standard_Transient) anItemLoc = aLocObjs->Value(i);
if(anItemLoc.IsNull())
continue;
nbLocs = aSeqLocs.Length();
// skl 02.05.2007
+ TopTools_SequenceOfShape Edges;
if(nbLocs>0) {
// we have to check that each location shape is a vertex from
// path and update aSeqLocs if it is needed (and possible)
TopoDS_Vertex V = TopoDS::Vertex(aSeqLocs.Value(i));
PLocs.Append(BRep_Tool::Pnt(V));
}
- TopTools_SequenceOfShape Edges;
+ //TopTools_SequenceOfShape Edges;
TopExp_Explorer anExp;
for ( anExp.Init( aWirePath, TopAbs_EDGE ); anExp.More(); anExp.Next() ) {
Edges.Append(anExp.Current());
}
}
- BRepOffsetAPI_MakePipeShell aBuilder(aWirePath);
+ // check curvature of wire for condition that
+ // max summary angle between directions along
+ // wire path must be < 4*PI. If not - split wire
+ // and seguences of shapes, perform pipe for each
+ // and make sewing after that
+ double fp,lp;
+ Handle(Geom_Curve) C = BRep_Tool::Curve(TopoDS::Edge(Edges.Value(1)),fp,lp);
+ gp_Pnt P1,P2;
+ gp_Vec Vec1,Vec2;
+ C->D1(fp,P1,Vec1);
+ C->D1(lp,P2,Vec2);
+ double SumAng = fabs(Vec1.Angle(Vec2));
+ Vec1 = Vec2;
+ P1 = P2;
+ TColStd_SequenceOfInteger SplitEdgeNums,SplitLocNums;
+ int LastLoc = 1;
+ //cout<<"Edges.Length()="<<Edges.Length()<<endl;
+ for(i=2; i<=Edges.Length(); i++) {
+ TopoDS_Edge edge = TopoDS::Edge(Edges.Value(i));
+ double tol = BRep_Tool::Tolerance(edge);
+ Handle(Geom_Curve) C = BRep_Tool::Curve(edge,fp,lp);
+ C->D1(lp,P2,Vec2);
+ double ang = fabs(Vec1.Angle(Vec2));
+ SumAng += ang;
+ if(SumAng>4*PI) {
+ SumAng = ang;
+ SplitEdgeNums.Append(i-1);
+ int j;
+ for(j=LastLoc+1; j<=aSeqLocs.Length(); j++) {
+ TopoDS_Vertex aVert = TopoDS::Vertex(aSeqLocs.Value(j));
+ gp_Pnt P = BRep_Tool::Pnt(aVert);
+ if( P1.Distance(P) < tol ) {
+ SplitLocNums.Append(j);
+ LastLoc = j;
+ break;
+ }
+ }
+ }
+ Vec1 = Vec2;
+ P1 = P2;
+ }
- Standard_Integer nbShapes = aSeqBases.Length();
- Standard_Integer step = nbShapes/nbBases;
-
- if(nbShapes < nbBases || fmod((double)nbShapes, (double)nbBases))
- {
- if(aCI) delete aCI;
- Standard_ConstructionError::Raise("Invalid sections were specified for building pipe");
+ //cout<<"SplitEdgeNums.Length()="<<SplitEdgeNums.Length()<<endl;
+ //cout<<"SplitLocNums.Length()="<<SplitLocNums.Length()<<endl;
+ if( SplitLocNums.Length()==SplitEdgeNums.Length() && SplitEdgeNums.Length()>0 ) {
+ TopTools_SequenceOfShape aSeqRes;
+ int nn, num1 = 1, num2 = 1;
+ for(nn=1; nn<=SplitEdgeNums.Length(); nn++) {
+ // create wirepath and sequences of shapes
+ BRep_Builder B;
+ TopoDS_Wire tmpW;
+ B.MakeWire(tmpW);
+ for(i=num1; i<=SplitEdgeNums.Value(nn); i++) {
+ B.Add(tmpW,TopoDS::Edge(Edges.Value(i)));
+ }
+ num1 = SplitEdgeNums.Value(nn) + 1;
+ TopTools_SequenceOfShape aTmpSeqBases;
+ TopTools_SequenceOfShape aTmpSeqLocs;
+ for(i=num2; i<=SplitLocNums.Value(nn); i++) {
+ aTmpSeqBases.Append(aSeqBases.Value(i));
+ aTmpSeqLocs.Append(aSeqLocs.Value(i));
+ }
+ num2 = SplitLocNums.Value(nn);
+ // make pipe
+ BRepOffsetAPI_MakePipeShell aBuilder(tmpW);
+ Standard_Integer nbShapes = aTmpSeqBases.Length();
+ for(i=1; i<=nbShapes; i++) {
+ TopoDS_Shape aShapeLoc = aTmpSeqLocs.Value(i);
+ TopoDS_Vertex aVert = TopoDS::Vertex(aShapeLoc);
+ aBuilder.Add(aTmpSeqBases.Value(i), aVert, aWithContact, aWithCorrect);
+ }
+ if(!aBuilder.IsReady()) {
+ if(aCI) delete aCI;
+ Standard_ConstructionError::Raise("Invalid input data for building PIPE: bases are invalid");
+ }
+ aBuilder.Build();
+ TopoDS_Shape resShape = aBuilder.Shape();
+ aSeqRes.Append(resShape);
+ }
+ // create wirepath and sequences of shapes for last part
+ BRep_Builder B;
+ TopoDS_Wire tmpW;
+ B.MakeWire(tmpW);
+ for(i=num1; i<=Edges.Length(); i++) {
+ B.Add(tmpW,TopoDS::Edge(Edges.Value(i)));
+ }
+ TopTools_SequenceOfShape aTmpSeqBases;
+ TopTools_SequenceOfShape aTmpSeqLocs;
+ for(i=num2; i<=aSeqLocs.Length(); i++) {
+ aTmpSeqBases.Append(aSeqBases.Value(i));
+ aTmpSeqLocs.Append(aSeqLocs.Value(i));
+ }
+ // make pipe for last part
+ BRepOffsetAPI_MakePipeShell aBuilder(tmpW);
+ Standard_Integer nbShapes = aTmpSeqBases.Length();
+ for(i=1; i<=nbShapes; i++) {
+ TopoDS_Shape aShapeLoc = aTmpSeqLocs.Value(i);
+ TopoDS_Vertex aVert = TopoDS::Vertex(aShapeLoc);
+ aBuilder.Add(aTmpSeqBases.Value(i), aVert, aWithContact, aWithCorrect);
+ }
+ if(!aBuilder.IsReady()) {
+ if(aCI) delete aCI;
+ Standard_ConstructionError::Raise("Invalid input data for building PIPE: bases are invalid");
+ }
+ aBuilder.Build();
+ TopoDS_Shape resShape = aBuilder.Shape();
+ aSeqRes.Append(resShape);
+ // make sewing for result
+ Handle(BRepBuilderAPI_Sewing) aSewing = new BRepBuilderAPI_Sewing;
+ aSewing->SetTolerance(Precision::Confusion());
+ aSewing->SetFaceMode(Standard_True);
+ aSewing->SetFloatingEdgesMode(Standard_False);
+ aSewing->SetNonManifoldMode(Standard_False);
+ for(i=1; i<=aSeqRes.Length(); i++) {
+ aSewing->Add(aSeqRes.Value(i));
+ }
+ aSewing->Perform();
+ aShape = aSewing->SewedShape();
}
-
- Standard_Integer ind =0;
- for( i=1; i <= nbShapes && ind < nbShapes; i++) //i+nbBases <= nbShapes
- {
- TopTools_SequenceOfShape usedBases;
- Standard_Integer j = 1;
- for( ; j <= nbBases ; j++)
- {
- ind = i + (j-1)*step;
-
- TopoDS_Shape aWireProf = aSeqBases.Value(ind);
- usedBases.Append(aWireProf);
- if(nbLocs)
- {
- TopoDS_Shape aShapeLoc = aSeqLocs.Value(j);
- TopoDS_Vertex aVert = TopoDS::Vertex(aShapeLoc);
- aBuilder.Add(aWireProf,aVert,aWithContact,aWithCorrect);
- }
- else
- aBuilder.Add(aWireProf,aWithContact,aWithCorrect);
+ else {
+ // old implementation without splitting
+ BRepOffsetAPI_MakePipeShell aBuilder(aWirePath);
+
+ Standard_Integer nbShapes = aSeqBases.Length();
+ Standard_Integer step = nbShapes/nbBases;
+
+ if(nbShapes < nbBases || fmod((double)nbShapes, (double)nbBases)) {
+ if(aCI) delete aCI;
+ Standard_ConstructionError::Raise("Invalid sections were specified for building pipe");
}
- if(!aBuilder.IsReady())
- {
+ Standard_Integer ind =0;
+ for( i=1; i <= nbShapes && ind < nbShapes; i++) { //i+nbBases <= nbShapes
+ TopTools_SequenceOfShape usedBases;
+ Standard_Integer j = 1;
+ for( ; j <= nbBases ; j++) {
+ ind = i + (j-1)*step;
+ TopoDS_Shape aWireProf = aSeqBases.Value(ind);
+ usedBases.Append(aWireProf);
+ if(nbLocs) {
+ TopoDS_Shape aShapeLoc = aSeqLocs.Value(j);
+ TopoDS_Vertex aVert = TopoDS::Vertex(aShapeLoc);
+ aBuilder.Add(aWireProf,aVert,aWithContact,aWithCorrect);
+ }
+ else
+ aBuilder.Add(aWireProf,aWithContact,aWithCorrect);
+ }
+ if(!aBuilder.IsReady()) {
if(aCI) delete aCI;
Standard_ConstructionError::Raise("Invalid input data for building PIPE: bases are invalid");
}
aSeqFaces.Append(aShape);
for( j = 1; j <=usedBases.Length(); j++)
aBuilder.Delete(usedBases.Value(j));
- }
+ }
- //for case if section is face
- if(aSeqFaces.Length() >1)
- {
- BRep_Builder aB;
- TopoDS_Compound aComp;
- aB.MakeCompound(aComp);
- for( i = 1; i <= aSeqFaces.Length(); i++)
- aB.Add(aComp,aSeqFaces.Value(i));
- aShape = aComp;
+ //for case if section is face
+ if(aSeqFaces.Length() >1) {
+ BRep_Builder aB;
+ TopoDS_Compound aComp;
+ aB.MakeCompound(aComp);
+ for( i = 1; i <= aSeqFaces.Length(); i++)
+ aB.Add(aComp,aSeqFaces.Value(i));
+ aShape = aComp;
+ }
}
}
aShape = CreatePipeForShellSections(aWirePath,aCI);
}
+ //building pipe shell sections without path
+ else if (aType == PIPE_SHELLS_WITHOUT_PATH) {
+ aShape = CreatePipeShellsWithoutPath(aCI);
+ }
+
if (aShape.IsNull()) return 0;
BRepCheck_Analyzer ana (aShape, Standard_False);
--- /dev/null
+// GEOM GEOMGUI : GUI for Geometry component
+//
+// Copyright (C) 2003 OPEN CASCADE, EADS/CCR, LIP6, CEA/DEN,
+// CEDRAT, EDF R&D, LEG, PRINCIPIA R&D, BUREAU VERITAS
+//
+// This library is free software; you can redistribute it and/or
+// modify it under the terms of the GNU Lesser General Public
+// License as published by the Free Software Foundation; either
+// version 2.1 of the License.
+//
+// This library is distributed in the hope that it will be useful,
+// but WITHOUT ANY WARRANTY; without even the implied warranty of
+// MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the GNU
+// Lesser General Public License for more details.
+//
+// You should have received a copy of the GNU Lesser General Public
+// License along with this library; if not, write to the Free Software
+// Foundation, Inc., 59 Temple Place, Suite 330, Boston, MA 02111-1307 USA
+//
+// See http://www.salome-platform.org/ or email : webmaster.salome@opencascade.com
+//
+//
+//
+// File : MeasureGUI_NormaleDlg.cxx
+// Author : Julia DOROVSKIKH
+// Module : GEOM
+// $Header$
+
+#include "MeasureGUI_NormaleDlg.h"
+
+#include "SUIT_Session.h"
+#include "SalomeApp_Application.h"
+#include "LightApp_SelectionMgr.h"
+
+#include <qlabel.h>
+
+#include "GEOMImpl_Types.hxx"
+
+#include "utilities.h"
+
+//=================================================================================
+// class : MeasureGUI_NormaleDlg()
+// purpose : Constructs a MeasureGUI_NormaleDlg which is a child of 'parent', with the
+// name 'name' and widget flags set to 'f'.
+// The dialog will by default be modeless, unless you set 'modal' to
+// TRUE to construct a modal dialog.
+//=================================================================================
+MeasureGUI_NormaleDlg::MeasureGUI_NormaleDlg (GeometryGUI* theGeometryGUI, QWidget* parent,
+ const char* name, bool modal, WFlags fl)
+ :GEOMBase_Skeleton(theGeometryGUI, parent, name, modal, WStyle_Customize |
+ WStyle_NormalBorder | WStyle_Title | WStyle_SysMenu)
+{
+ SUIT_ResourceMgr* aResMgr = SUIT_Session::session()->resourceMgr();
+ QPixmap image0 (aResMgr->loadPixmap("GEOM", tr("ICON_DLG_NORMALE")));
+ QPixmap image1 (aResMgr->loadPixmap("GEOM", tr("ICON_SELECT")));
+
+ setCaption(tr("GEOM_NORMALE_TITLE"));
+
+ /***************************************************************/
+ GroupConstructors->setTitle(tr("GEOM_NORMALE"));
+ RadioButton1->setPixmap(image0);
+ RadioButton2->close(TRUE);
+ RadioButton3->close(TRUE);
+
+ GroupArgs = new DlgRef_2Sel_QTD (this, "GroupArgs");
+ GroupArgs->GroupBox1->setTitle(tr("GEOM_ARGUMENTS"));
+
+ GroupArgs->TextLabel1->setText(tr("GEOM_FACE"));
+ GroupArgs->TextLabel2->setText(tr("GEOM_POINT"));
+
+ GroupArgs->PushButton1->setPixmap(image1);
+ GroupArgs->PushButton2->setPixmap(image1);
+
+ Layout1->addWidget(GroupArgs, 2, 0);
+ /***************************************************************/
+
+ setHelpFileName("normale.htm");
+
+ Init();
+}
+
+//=================================================================================
+// function : ~MeasureGUI_NormaleDlg()
+// purpose : Destroys the object and frees any allocated resources
+//=================================================================================
+MeasureGUI_NormaleDlg::~MeasureGUI_NormaleDlg()
+{
+ // no need to delete child widgets, Qt does it all for us
+}
+
+//=================================================================================
+// function : Init()
+// purpose :
+//=================================================================================
+void MeasureGUI_NormaleDlg::Init()
+{
+ /* init variables */
+ GroupArgs->LineEdit1->setReadOnly(true);
+ GroupArgs->LineEdit2->setReadOnly(true);
+
+ myFace = GEOM::GEOM_Object::_nil();
+ myPoint = GEOM::GEOM_Object::_nil();
+
+ myEditCurrentArgument = GroupArgs->LineEdit1;
+ globalSelection(GEOM_FACE);
+
+ /* signals and slots connections */
+ connect(buttonOk, SIGNAL(clicked()), this, SLOT(ClickOnOk()));
+ connect(buttonApply, SIGNAL(clicked()), this, SLOT(ClickOnApply()));
+
+ connect(GroupArgs->PushButton1, SIGNAL(clicked()), this, SLOT(SetEditCurrentArgument()));
+ connect(GroupArgs->PushButton2, SIGNAL(clicked()), this, SLOT(SetEditCurrentArgument()));
+
+ connect(GroupArgs->LineEdit1, SIGNAL(returnPressed()), this, SLOT(LineEditReturnPressed()));
+ connect(GroupArgs->LineEdit2, SIGNAL(returnPressed()), this, SLOT(LineEditReturnPressed()));
+
+ connect(myGeomGUI->getApp()->selectionMgr(),
+ SIGNAL(currentSelectionChanged()), this, SLOT(SelectionIntoArgument()));
+
+ initName(tr("GEOM_VECTOR_NORMALE"));
+
+ //ConstructorsClicked(0);
+ SelectionIntoArgument();
+
+ /* displays Dialog */
+ GroupArgs->show();
+ this->show();
+}
+
+//=================================================================================
+// function : ClickOnOk()
+// purpose :
+//=================================================================================
+void MeasureGUI_NormaleDlg::ClickOnOk()
+{
+ if (ClickOnApply())
+ ClickOnCancel();
+}
+
+//=================================================================================
+// function : ClickOnApply()
+// purpose :
+//=================================================================================
+bool MeasureGUI_NormaleDlg::ClickOnApply()
+{
+ if (!onAccept())
+ return false;
+
+ initName();
+ return true;
+}
+
+//=================================================================================
+// function : SelectionIntoArgument()
+// purpose : Called when selection as changed or other case
+//=================================================================================
+void MeasureGUI_NormaleDlg::SelectionIntoArgument()
+{
+ erasePreview();
+ myEditCurrentArgument->setText("");
+
+ if (myEditCurrentArgument == GroupArgs->LineEdit1) {
+ myFace = GEOM::GEOM_Object::_nil();
+ }
+ else if (myEditCurrentArgument == GroupArgs->LineEdit2) {
+ myPoint = GEOM::GEOM_Object::_nil();
+ }
+
+ if (IObjectCount() != 1)
+ return;
+
+ // nbSel == 1
+ Standard_Boolean testResult = Standard_False;
+ GEOM::GEOM_Object_var aSelectedObject =
+ GEOMBase::ConvertIOinGEOMObject(firstIObject(), testResult);
+
+ if (!testResult)
+ return;
+
+ if (myEditCurrentArgument == GroupArgs->LineEdit1) {
+ myFace = aSelectedObject;
+ }
+ else if (myEditCurrentArgument == GroupArgs->LineEdit2) {
+ myPoint = aSelectedObject;
+ }
+
+ myEditCurrentArgument->setText(GEOMBase::GetName(aSelectedObject));
+
+ displayPreview();
+}
+
+//=================================================================================
+// function : LineEditReturnPressed()
+// purpose :
+//=================================================================================
+void MeasureGUI_NormaleDlg::LineEditReturnPressed()
+{
+ QLineEdit* send = (QLineEdit*)sender();
+ if (send == GroupArgs->LineEdit1 ||
+ send == GroupArgs->LineEdit2)
+ {
+ myEditCurrentArgument = send;
+ GEOMBase_Skeleton::LineEditReturnPressed();
+ }
+}
+
+//=================================================================================
+// function : SetEditCurrentArgument()
+// purpose :
+//=================================================================================
+void MeasureGUI_NormaleDlg::SetEditCurrentArgument()
+{
+ QPushButton* send = (QPushButton*)sender();
+
+ if (send == GroupArgs->PushButton1) {
+ myEditCurrentArgument = GroupArgs->LineEdit1;
+ globalSelection(GEOM_FACE);
+ }
+ else if (send == GroupArgs->PushButton2) {
+ myEditCurrentArgument = GroupArgs->LineEdit2;
+ globalSelection(GEOM_POINT);
+ }
+
+ myEditCurrentArgument->setFocus();
+ SelectionIntoArgument();
+}
+
+//=================================================================================
+// function : ActivateThisDialog()
+// purpose :
+//=================================================================================
+void MeasureGUI_NormaleDlg::ActivateThisDialog()
+{
+ GEOMBase_Skeleton::ActivateThisDialog();
+
+ SelectionIntoArgument();
+}
+
+//=================================================================================
+// function : enterEvent()
+// purpose :
+//=================================================================================
+void MeasureGUI_NormaleDlg::enterEvent (QEvent* e)
+{
+ if (!GroupConstructors->isEnabled())
+ ActivateThisDialog();
+}
+
+//=================================================================================
+// function : createOperation
+// purpose :
+//=================================================================================
+GEOM::GEOM_IOperations_ptr MeasureGUI_NormaleDlg::createOperation()
+{
+ return getGeomEngine()->GetIMeasureOperations(getStudyId());
+}
+
+//=================================================================================
+// function : isValid
+// purpose :
+//=================================================================================
+bool MeasureGUI_NormaleDlg::isValid (QString&)
+{
+ //return !CORBA::is_nil(myFace) && !CORBA::is_nil(myPoint);
+ return !CORBA::is_nil(myFace);
+}
+
+//=================================================================================
+// function : execute
+// purpose :
+//=================================================================================
+bool MeasureGUI_NormaleDlg::execute (ObjectList& objects)
+{
+ GEOM::GEOM_Object_var anObj =
+ GEOM::GEOM_IMeasureOperations::_narrow(getOperation())->GetNormal(myFace, myPoint);
+
+ if (!anObj->_is_nil())
+ objects.push_back(anObj._retn());
+
+ return true;
+}