From 4006ca98a2bd133b51934c912ccdc53a30bb8a3f Mon Sep 17 00:00:00 2001 From: nbv Date: Wed, 31 Oct 2018 14:29:28 +0300 Subject: [PATCH] 0030322: Remove DRAW-command "mesh" as useless In fact, the DRAW-command "mesh" is duplicate of "incmesh". The difference is that the "mesh" creates DRAW-object MeshTest_DrawableMesh. However, this object is currently not applicable (e.g. we cannot display it). DRAW-commands "mesh", "addshape", "smooth", "edges", "vertices", "medge", "mvertex", "triangle", "dumpvertex", "dumpedge", "dumptriangle" and "onetriangulation" have been removed. The class MeshTest_DrawableMesh has been removed as useless. Testgrids "mesh standard_mesh" and "mesh advanced_mesh" have been removed. --- src/MeshTest/FILES | 2 - src/MeshTest/MeshTest.cxx | 784 +------------------------ src/MeshTest/MeshTest_DrawableMesh.cxx | 314 ---------- src/MeshTest/MeshTest_DrawableMesh.hxx | 73 --- tests/mesh/advanced_mesh/begin | 2 - tests/mesh/advanced_mesh/cases.list | 1 - tests/mesh/end | 16 +- tests/mesh/grids.list | 10 +- tests/mesh/standard_mesh/begin | 2 - tests/mesh/standard_mesh/cases.list | 1 - 10 files changed, 18 insertions(+), 1187 deletions(-) delete mode 100644 src/MeshTest/MeshTest_DrawableMesh.cxx delete mode 100644 src/MeshTest/MeshTest_DrawableMesh.hxx delete mode 100644 tests/mesh/advanced_mesh/begin delete mode 100644 tests/mesh/advanced_mesh/cases.list delete mode 100644 tests/mesh/standard_mesh/begin delete mode 100644 tests/mesh/standard_mesh/cases.list diff --git a/src/MeshTest/FILES b/src/MeshTest/FILES index 5ae491e3f3..9677102d34 100755 --- a/src/MeshTest/FILES +++ b/src/MeshTest/FILES @@ -2,7 +2,5 @@ MeshTest.cxx MeshTest.hxx MeshTest_CheckTopology.cxx MeshTest_CheckTopology.hxx -MeshTest_DrawableMesh.cxx -MeshTest_DrawableMesh.hxx MeshTest_PluginCommands.cxx MeshTest_Debug.cxx diff --git a/src/MeshTest/MeshTest.cxx b/src/MeshTest/MeshTest.cxx index fd6e23c518..404cdac376 100644 --- a/src/MeshTest/MeshTest.cxx +++ b/src/MeshTest/MeshTest.cxx @@ -14,75 +14,32 @@ // Alternatively, this file may be used under the terms of Open CASCADE // commercial license or contractual agreement. +#include + +#include -#include #include #include -#include #include #include #include #include #include #include -#include -#include -#include #include -#include -#include -#include #include #include #include -#include #include -#include #include -#include -#include -#include #include #include -#include -#include -#include -#include -#include -#include #include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include #include +#include +#include +#include -#include //epa Memory leaks test //OAN: for triepoints #ifdef _WIN32 @@ -92,8 +49,6 @@ Standard_IMPORT Draw_Viewer dout; #define MAX2(X, Y) ( Abs(X) > Abs(Y)? Abs(X) : Abs(Y) ) #define MAX3(X, Y, Z) ( MAX2 ( MAX2(X,Y) , Z) ) - - #define ONETHIRD 0.333333333333333333333333333333333333333333333333333333333333 #define TWOTHIRD 0.666666666666666666666666666666666666666666666666666666666666 @@ -398,7 +353,6 @@ static Standard_Integer tessellate (Draw_Interpretor& /*di*/, Standard_Integer n //function : MemLeakTest //purpose : //======================================================================= - static Standard_Integer MemLeakTest(Draw_Interpretor&, Standard_Integer /*nbarg*/, const char** /*argv*/) { for(int i=0;i<10000;i++) @@ -414,554 +368,6 @@ static Standard_Integer MemLeakTest(Draw_Interpretor&, Standard_Integer /*nbarg* return 0; } -//======================================================================= -//function : triangule -//purpose : -//======================================================================= - - -class BRepMesh_Couple -{ -public: - BRepMesh_Couple() { myI1 = myI2 = 0; } - BRepMesh_Couple(const Standard_Integer I1, - const Standard_Integer I2) - { myI1 = I1; myI2 = I2; } - - Standard_Integer myI1; - Standard_Integer myI2; -}; - -inline Standard_Boolean IsEqual(const BRepMesh_Couple& one, - const BRepMesh_Couple& other) -{ - if (one.myI1 == other.myI1 && - one.myI2 == other.myI2) return Standard_True; - else return Standard_False; -} - -inline Standard_Integer HashCode(const BRepMesh_Couple& one, - const Standard_Integer Upper) -{ - return ::HashCode((one.myI1+one.myI2), Upper); -} - -typedef NCollection_Map BRepMesh_MapOfCouple; - - -static void AddLink(BRepMesh_MapOfCouple& aMap, - Standard_Integer v1, - Standard_Integer v2) -{ - Standard_Integer i1 = v1; - Standard_Integer i2 = v2; - if(i1 > i2) { - i1 = v2; - i2 = v1; - } - aMap.Add(BRepMesh_Couple(i1,i2)); -} - -static void MeshStats(const TopoDS_Shape& theSape, - Standard_Integer& theNbTri, - Standard_Integer& theNbEdges, - Standard_Integer& theNbNodes) -{ - theNbTri = 0; - theNbEdges = 0; - theNbNodes = 0; - - Handle(Poly_Triangulation) T; - TopLoc_Location L; - - for ( TopExp_Explorer ex(theSape, TopAbs_FACE); ex.More(); ex.Next()) { - TopoDS_Face F = TopoDS::Face(ex.Current()); - T = BRep_Tool::Triangulation(F, L); - if (!T.IsNull()) { - theNbTri += T->NbTriangles(); - theNbNodes += T->NbNodes(); - - BRepMesh_MapOfCouple aMap; - //count number of links - Poly_Array1OfTriangle& Trian = T->ChangeTriangles(); - for(Standard_Integer i = 1; i<=Trian.Length();i++) { - Standard_Integer v1, v2, v3; - Trian(i).Get(v1,v2,v3); - - AddLink(aMap, v1, v2); - AddLink(aMap, v2, v3); - AddLink(aMap, v3, v1); - } - - theNbEdges+=aMap.Extent(); - } - } -} - -static Standard_Integer triangule(Draw_Interpretor& di, Standard_Integer nbarg, const char** argv) -{ - if (nbarg < 4) - return 1; - - const char *id1 = argv[2]; - TopoDS_Shape aShape = DBRep::Get(id1); - if (aShape.IsNull()) - return 1; - - di << argv[1] << " "; - - Standard_Real aDeflection = Draw::Atof(argv[3]); - if (aDeflection <= 0.) - { - di << " Incorrect value of deflection!\n"; - return 1; - } - - Handle(MeshTest_DrawableMesh) aDMesh = - new MeshTest_DrawableMesh(aShape, aDeflection); - - Draw::Set(argv[1], aDMesh); - - Standard_Integer nbn, nbl, nbe; - MeshStats(aShape, nbe, nbl, nbn); - - di<<"(Resultat ("<Mesh()->NbEdges(); iLi++) { - const BRepMesh_Edge& ed=DM->Mesh()->Edge(iLi); - if (ed.Movability()!=BRepMesh_Deleted) { - nbc=struc->ElemConnectedTo(iLi).Extent(); - if (nbc != 1 && nbc != 2) di <<"ERROR MAILLAGE Edge no "<< iLi<<"\n"; - } - }*/ - - - Bnd_Box aBox; - - TopExp_Explorer aFaceIt(aShape, TopAbs_FACE); - for (; aFaceIt.More(); aFaceIt.Next()) - { - const TopoDS_Face& aFace = TopoDS::Face(aFaceIt.Current()); - - TopLoc_Location aLoc = aFace.Location(); - Handle(Poly_Triangulation) aTriangulation = - BRep_Tool::Triangulation(aFace, aLoc); - - if (!aTriangulation.IsNull()) - { - const Standard_Integer aLength = aTriangulation->NbNodes(); - const TColgp_Array1OfPnt& aNodes = aTriangulation->Nodes(); - for (Standard_Integer i = 1; i <= aLength; ++i) - aBox.Add(aNodes(i)); - } - } - - Standard_Real aDelta = 0.; - if (!aBox.IsVoid()) - { - Standard_Real x, y, z, X, Y, Z; - aBox.Get(x, y, z, X, Y, Z); - - aDelta = Max(X - x, Max(Y - y, Z - z)); - if (aDelta > 0.0) - aDelta = aDeflection / aDelta; - } - - di << " Ratio between deflection and total shape size is " << aDelta << "\n"; - - return 0; -} - -//======================================================================= -//function : addshape -//purpose : -//======================================================================= - -Standard_Integer addshape(Draw_Interpretor&, Standard_Integer n, const char** a) -{ - if (n < 3) return 1; - Handle(MeshTest_DrawableMesh) D = - Handle(MeshTest_DrawableMesh)::DownCast(Draw::Get(a[1])); - if (D.IsNull()) return 1; - TopoDS_Shape S = DBRep::Get(a[2]); - if (S.IsNull()) return 1; - - D->Add(S); - Draw::Repaint(); - - return 0; -} - - -//======================================================================= -//function : smooth -//purpose : -//======================================================================= - -/*Standard_Integer smooth(Draw_Interpretor&, Standard_Integer n, const char** a) -{ -if (n < 2) return 1; -Handle(MeshTest_DrawableMesh) D = -Handle(MeshTest_DrawableMesh)::DownCast(Draw::Get(a[1])); -if (D.IsNull()) return 1; -Handle(BRepMesh_DataStructureOfDelaun) struc= -D->Mesh()->Result(); -BRepMesh_Array1OfVertexOfDelaun toto(1,1); -BRepMesh_Delaun trial(struc, -toto, -Standard_True); -trial.SmoothMesh(0.1); -Draw::Repaint(); -return 0; -} -*/ - -//======================================================================= -//function : edges -//purpose : -//======================================================================= - -/*static Standard_Integer edges (Draw_Interpretor&, Standard_Integer n, const char** a) -{ -if (n < 3) return 1; - -Handle(MeshTest_DrawableMesh) D = -Handle(MeshTest_DrawableMesh)::DownCast(Draw::Get(a[1])); -if (D.IsNull()) return 1; -TopoDS_Shape S = DBRep::Get(a[2]); -if (S.IsNull()) return 1; - -TopExp_Explorer ex; -TColStd_SequenceOfInteger& eseq = D->Edges(); -Handle(BRepMesh_FastDiscret) M = D->Mesh(); -Handle(BRepMesh_DataStructureOfDelaun) DS = M->Result(); -Standard_Integer e1, e2, e3, iTri; -Standard_Boolean o1, o2, o3; - -// the faces -for (ex.Init(S,TopAbs_FACE);ex.More();ex.Next()) { -const BRepMesh_MapOfInteger& elems = DS->ElemOfDomain(); -BRepMesh_MapOfInteger::Iterator it; -for (it.Initialize(elems); it.More(); it.Next()) { -iTri = it.Key(); -const BRepMesh_Triangle& triang = M->Triangle(iTri); -if (triang.Movability()!=BRepMesh_Deleted) { -triang.Edges(e1, e2, e3, o1, o2, o3); -eseq.Append(e1); -eseq.Append(e2); -eseq.Append(e3); -} -} -} - -// the edges -//for (ex.Init(S,TopAbs_EDGE,TopAbs_FACE);ex.More();ex.Next()) { -//} - -Draw::Repaint(); -return 0; -} -*/ - -//======================================================================= -//function : vertices -//purpose : -//======================================================================= -static Standard_Integer vertices( - Draw_Interpretor& /*di*/, - Standard_Integer /*argc*/, - const char** /*argv*/) -{ - return 0; - - // TODO: OAN re-implement this command according changes in BRepMesh - //if (argc < 3) - // return 1; - - //Handle(MeshTest_DrawableMesh) aDrawableMesh = - // Handle(MeshTest_DrawableMesh)::DownCast(Draw::Get(argv[1])); - //if (aDrawableMesh.IsNull()) - // return 1; - - //TopoDS_Shape aShape = DBRep::Get(argv[2]); - //if (aShape.IsNull()) - // return 1; - - //TColStd_SequenceOfInteger& aVertexSeq = aDrawableMesh->Vertices(); - //Handle(BRepMesh_FastDiscret) aMesh = aDrawableMesh->Mesh(); - - //TopExp_Explorer aFaceIt(aShape, TopAbs_FACE); - //for (; aFaceIt.More(); aFaceIt.Next()) - //{ - // const TopoDS_Face& aFace = TopoDS::Face(aFaceIt.Current()); - - // Handle(BRepMesh_FaceAttribute) aAttribute; - // if (aMesh->GetFaceAttribute(aFace, aAttribute)) - // { - // Handle(BRepMesh_DataStructureOfDelaun) aStructure = aAttribute->EditStructure(); - - // // Recuperate from the map of edges. - // const BRepMeshCol::MapOfInteger& aEdgeMap = aStructure->LinksOfDomain(); - - // // Iterator on edges. - // BRepMeshCol::MapOfInteger aVertices; - // BRepMeshCol::MapOfInteger::Iterator aEdgeIt(aEdgeMap); - // for (; aEdgeIt.More(); aEdgeIt.Next()) - // { - // const BRepMesh_Edge& aEdge = aStructure->GetLink(aEdgeIt.Key()); - // aVertices.Add(aEdge.FirstNode()); - // aVertices.Add(aEdge.LastNode()); - // } - - // BRepMeshCol::MapOfInteger::Iterator anIt(vtx); - // for ( ; anIt.More(); anIt.Next() ) - // aVertexSeq.Append(anIt.Key()); - // } - //} - - //Draw::Repaint(); - //return 0; -} - -//======================================================================= -//function : medge -//purpose : -//======================================================================= - -static Standard_Integer medge (Draw_Interpretor&, Standard_Integer n, const char** a) -{ - if (n < 3) return 1; - - Handle(MeshTest_DrawableMesh) D = - Handle(MeshTest_DrawableMesh)::DownCast(Draw::Get(a[1])); - if (D.IsNull()) return 1; - - Standard_Integer i,j,e; - TColStd_SequenceOfInteger& eseq = D->Edges(); - for (i = 2; i < n; i++) { - e = Draw::Atoi(a[i]); - if (e > 0) - eseq.Append(e); - else if (e < 0) { - e = -e; - j = 1; - while (j <= eseq.Length()) { - if (eseq(j) == e) - eseq.Remove(j); - else - j++; - } - } - else - eseq.Clear(); - } - - Draw::Repaint(); - return 0; -} - - -//======================================================================= -//function : mvertex -//purpose : -//======================================================================= - -static Standard_Integer mvertex (Draw_Interpretor&, Standard_Integer n, const char** a) -{ - if (n < 3) return 1; - - Handle(MeshTest_DrawableMesh) D = - Handle(MeshTest_DrawableMesh)::DownCast(Draw::Get(a[1])); - if (D.IsNull()) return 1; - - Standard_Integer i,j,v; - TColStd_SequenceOfInteger& vseq = D->Vertices(); - for (i = 2; i < n; i++) { - v = Draw::Atoi(a[i]); - if (v > 0) - vseq.Append(v); - else if (v < 0) { - v = -v; - j = 1; - while (j <= vseq.Length()) { - if (vseq(j) == v) - vseq.Remove(v); - else - j++; - } - } - else - vseq.Clear(); - } - Draw::Repaint(); - return 0; -} - - -//======================================================================= -//function : triangle -//purpose : -//======================================================================= - -static Standard_Integer triangle (Draw_Interpretor&, Standard_Integer n, const char** a) -{ - if (n < 3) return 1; - - Handle(MeshTest_DrawableMesh) D = - Handle(MeshTest_DrawableMesh)::DownCast(Draw::Get(a[1])); - if (D.IsNull()) return 1; - - Standard_Integer i,j,v; - TColStd_SequenceOfInteger& tseq = D->Triangles(); - for (i = 2; i < n; i++) { - v = Draw::Atoi(a[i]); - if (v > 0) - tseq.Append(v); - else if (v < 0) { - v = -v; - j = 1; - while (j <= tseq.Length()) { - if (tseq(j) == v) - tseq.Remove(v); - else - j++; - } - } - else - tseq.Clear(); - } - Draw::Repaint(); - return 0; -} - -//======================================================================= -//function : dumpvertex -//purpose : -//======================================================================= - -/* -Standard_Integer dumpvertex(Draw_Interpretor& di, Standard_Integer argc, const char** argv) -{ -if (argc < 2) return 1; - -Handle(MeshTest_DrawableMesh) D = -Handle(MeshTest_DrawableMesh)::DownCast(Draw::Get(argv[1])); -if (D.IsNull()) return 1; - -Handle(BRepMesh_DataStructureOfDelaun) struc = D->Mesh()->Result(); - -Standard_Integer in=1; -if (argc>=3) { -in=Draw::Atoi(argv[2]); -in=Max(1,in); -} -Standard_Integer nbn=in; -if (argc>=4) { -nbn=Draw::Atoi(argv[3]); -nbn=Min(nbn,struc->NbNodes()); -} - -for (; in<=nbn; in++) { -BRepMesh_Vertex nod=struc->GetNode(in); -di<<"(node "<LinkNeighboursOf(in)); -for (; tati.More(); tati.Next()) di<<" "<Mesh()->Result(); -Standard_Integer il=1; -if (argc>=3) { -il=Draw::Atoi(argv[2]); -il=Max(1, il); -} -Standard_Integer nbl=il; -if (argc>=4) { -nbl=Draw::Atoi(argv[3]); -nbl=Min(nbl, struc->NbLinks()); -} - -for (; il<=nbl; il++) { -BRepMesh_Edge edg=struc->GetLink(il); -di << "(edge "<ElemConnectedTo(il); -for (Standard_Integer j = 1, jn = pair.Extent(); j <= jn; j++) -di<<" "<Mesh()->Result(); -Standard_Integer ie=1; -if (argc>=3) { -ie=Draw::Atoi(argv[2]); -ie=Max(1, ie); -} -Standard_Integer nbe=ie; -if (argc>=4) { -nbe=Draw::Atoi(argv[3]); -nbe=Min(nbe, struc->NbElements()); -} - -Standard_Integer e1, e2, e3; -Standard_Boolean o1, o2, o3; - -for (; ie<=nbe; ie++) { -BRepMesh_Triangle tri=struc->GetElement(ie); -tri.Edges(e1, e2, e3, o1, o2, o3); -if (o1) e1=-e1; -if (o2) e2=-e2; -if (o3) e3=-e3; -di<<" (maille "<Nodes(); - const Poly_Array1OfTriangle& triangles = T->Triangles(); - - if (mapedges.IsBound(edge)) { - const TColStd_ListOfTransient& L = edges.Find(edge); - const Handle(Poly_PolygonOnTriangulation)& P = - *(Handle(Poly_PolygonOnTriangulation)*)&(L.First()); - const TColStd_Array1OfInteger& NOD = P->Nodes(); - - } - } - } - - Sprintf(name, "%s_%i", "tr", nbshell); - DrawTrSurf::Set(name, TFinale); - - } - - */ - return 0; -} - - -#if 0 - -//======================================================================= -//function : vb -//purpose : -//======================================================================= - -Standard_Integer vb(Draw_Interpretor& di, Standard_Integer nbarg, const char** argv) -{ - Standard_Integer NbPoints = 1, Deg = 1; - - for (Deg = 1; Deg <= 25; Deg++) { - for (NbPoints = 1; NbPoints <= 24; NbPoints++) { - - math_Vector GaussP(1, NbPoints), GaussW(1, NbPoints); - math_Vector TheWeights(1, NbPoints), VBParam(1, NbPoints); - math_Matrix VB(1, Deg+1, 1, NbPoints); - - math::GaussPoints(NbPoints, GaussP); - - Standard_Integer i, j, classe = Deg+1, cl1 = Deg; - - // calcul et mise en ordre des parametres et des poids: - for (i = 1; i <= NbPoints; i++) { - if (i <= (NbPoints+1)/2) { - VBParam(NbPoints-i+1) = 0.5*(1 + GaussP(i)); - } - else { - VBParam(i-(NbPoints+1)/2) = 0.5*(1 + GaussP(i)); - } - } - - - // Calcul du VB (Valeur des fonctions de Bernstein): - for (i = 1; i <= classe; i++) { - for (j = 1; j <= NbPoints; j++) { - VB(i,j)=PLib::Binomial(cl1,i-1)*Pow((1-VBParam(j)),classe-i)*Pow(VBParam(j),i-1); - } - } - - - for (i = 1; i <= classe; i++) { - for (j = 1; j <= NbPoints; j++) { - di<< VB(i, j) << ", "; - } - } - di << "\n\n"; - } - } - return 0; -} -//======================================================================= -//function : extrema -//purpose : -//======================================================================= - -Standard_Integer extrema(Draw_Interpretor& di, Standard_Integer nbarg, const char** argv) -{ - - - Handle(Geom_Curve) C = DrawTrSurf::GetCurve(argv[1]); - - Standard_Real X, Y, Z, U0; - X = Draw::Atof(argv[2]); - Y = Draw::Atof(argv[3]); - Z = Draw::Atof(argv[4]); - U0 = Draw::Atof(argv[5]); - - gp_Pnt P(X, Y, Z); - GeomAdaptor_Curve GC(C); - Standard_Real tol = 1.e-09; - Extrema_LocateExtPC ext(P, GC, U0, tol); - - if (ext.IsDone()) { - gp_Pnt P1 = ext.Point().Value(); - di <<"distance = "< -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include -#include - -IMPLEMENT_STANDARD_RTTIEXT(MeshTest_DrawableMesh,Draw_Drawable3D) - -typedef NCollection_Map BRepMesh_MapOfLinks; - -static inline void addLink(const Standard_Integer theIndex1, - const Standard_Integer theIndex2, - BRepMesh_MapOfLinks& theMap) -{ - BRepMesh_Edge anEdge(theIndex1, theIndex2, BRepMesh_Free); - theMap.Add(anEdge); -} - -//======================================================================= -//function : MeshTest_DrawableMesh -//purpose : -//======================================================================= -MeshTest_DrawableMesh::MeshTest_DrawableMesh() - : myDeflection(1.) -{ -} - -//======================================================================= -//function : MeshTest_DrawableMesh -//purpose : -//======================================================================= -MeshTest_DrawableMesh::MeshTest_DrawableMesh(const TopoDS_Shape& theShape, - const Standard_Real theDeflection) - : myDeflection(theDeflection) -{ - Add(theShape); -} - -//======================================================================= -//function : MeshTest_DrawableMesh -//purpose : -//======================================================================= -MeshTest_DrawableMesh::MeshTest_DrawableMesh( - const Handle(BRepMesh_IncrementalMesh)& theMesher) - : myDeflection(1.) -{ - myMesher = theMesher; - if (!myMesher.IsNull()) - myDeflection = myMesher->Parameters().Deflection; -} - -//======================================================================= -//function : MeshTest_DrawableMesh -//purpose : -//======================================================================= -void MeshTest_DrawableMesh::Add(const TopoDS_Shape& theShape) -{ - if (myMesher.IsNull()) - { - myMesher = new BRepMesh_IncrementalMesh; - myMesher->ChangeParameters().Deflection = myDeflection; - myMesher->ChangeParameters().Angle = 0.5; - } - - myMesher->SetShape(theShape); - myMesher->Perform(); -} - -//======================================================================= -//function : DrawOn -//purpose : -//======================================================================= - -void MeshTest_DrawableMesh::DrawOn(Draw_Display& /*D*/) const -{ - // should be reimplemented!! - /* Handle(BRepMesh_DataStructureOfDelaun) struc = myMesh->Result(); - Standard_Integer nbc; - D.SetColor(Draw_vert); - - for (Standard_Integer iLi=1; iLi<=myMesh->NbEdges(); iLi++) { - const BRepMesh_Edge& ed=myMesh->Edge(iLi); - if (ed.Movability()!=BRepMesh_Deleted) { - nbc=struc->ElemConnectedTo(iLi).Extent(); - if (nbc<=0) D.SetColor(Draw_bleu); - else if (nbc==1) D.SetColor(Draw_jaune); - else if (nbc==2) D.SetColor(Draw_vert); - else D.SetColor(Draw_corail); - D.MoveTo(myMesh->Pnt(ed.FirstNode())); - D.DrawTo(myMesh->Pnt(ed.LastNode())); - } - } - - - // highlighted triangles - D.SetColor(Draw_blanc); - Standard_Integer e1, e2, e3, i; - Standard_Boolean o1, o2, o3; - - for (i = 1; i <= myTriangles.Length(); i++) { - const BRepMesh_Triangle& tri=struc->GetElement(myTriangles(i)); - tri.Edges(e1, e2, e3, o1, o2, o3); - const BRepMesh_Edge& ed1=myMesh->Edge(e1); - if (ed1.Movability()!=BRepMesh_Deleted) { - D.MoveTo(myMesh->Pnt(ed1.FirstNode())); - D.DrawTo(myMesh->Pnt(ed1.LastNode())); - } - const BRepMesh_Edge& ed2=myMesh->Edge(e2); - if (ed2.Movability()!=BRepMesh_Deleted) { - D.MoveTo(myMesh->Pnt(ed2.FirstNode())); - D.DrawTo(myMesh->Pnt(ed2.LastNode())); - } - const BRepMesh_Edge& ed3=myMesh->Edge(e3); - if (ed3.Movability()!=BRepMesh_Deleted) { - D.MoveTo(myMesh->Pnt(ed3.FirstNode())); - D.DrawTo(myMesh->Pnt(ed3.LastNode())); - } - } - - // highlighted edges - D.SetColor(Draw_rouge); - for (i = 1; i <= myEdges.Length(); i++) { - const BRepMesh_Edge& ed=myMesh->Edge(myEdges(i)); - if (ed.Movability()!=BRepMesh_Deleted) { - D.MoveTo(myMesh->Pnt(ed.FirstNode())); - D.DrawTo(myMesh->Pnt(ed.LastNode())); - } - } - - // highlighted vertices - for (i = 1; i <= myVertices.Length(); i++) { - D.DrawMarker(myMesh->Pnt(myVertices(i)),Draw_Losange); - } - - */ - -} - -//======================================================================= -//function : Copy -//purpose : -//======================================================================= -Handle(Draw_Drawable3D) MeshTest_DrawableMesh::Copy() const -{ - return new MeshTest_DrawableMesh(myMesher); -} - -//======================================================================= -//function : Dump -//purpose : -//======================================================================= -void MeshTest_DrawableMesh::Dump(Standard_OStream&) const -{ - // Should be reimplemented - - /*Handle(BRepMesh_DataStructureOfDelaun) struc=myMesh->Result(); - Standard_Integer e1, e2, e3; - Standard_Boolean o1, o2, o3; - Standard_Integer in, il, ie; - Standard_Integer nbn=struc->NbNodes(); - Standard_Integer nbl=struc->NbLinks(); - Standard_Integer nbe=struc->NbElements(); - - for (in=1; in<=nbn; in++) { - BRepMesh_Vertex nod=struc->GetNode(in); - S<<"(node "<LinkNeighboursOf(in)); - for (; tati.More(); tati.Next()) S<<" "<GetLink(il); - S << "(edge "<ElemConnectedTo(il); - for (Standard_Integer j = 1, jn = pair.Extent(); j <= jn; j++) - S<<" "<GetElement(ie); - tri.Edges(e1, e2, e3, o1, o2, o3); - if (!o1) e1=-e1; - if (!o2) e2=-e2; - if (!o3) e3=-e3; - S<<" (maille "<Shape(); - - Standard_Integer aPointsNb = 0; - Standard_Integer aTrianglesNb = 0; - Standard_Integer aEdgesNb = 0; - - TopLoc_Location aLocation; - Handle(Poly_Triangulation) aTriangulation; - - TopExp_Explorer aFaceIt(aShape, TopAbs_FACE); - for (; aFaceIt.More(); aFaceIt.Next()) - { - const TopoDS_Face& aFace = TopoDS::Face(aFaceIt.Current()); - - aTriangulation = BRep_Tool::Triangulation(aFace, aLocation); - if (aTriangulation.IsNull()) - continue; - - // Count number of links - BRepMesh_MapOfLinks aMap; - const Poly_Array1OfTriangle& aTriangles = aTriangulation->Triangles(); - for (Standard_Integer i = 1, v[3]; i <= aTriangles.Length(); ++i) - { - aTriangles(i).Get(v[0], v[1], v[2]); - - addLink(v[0], v[1], aMap); - addLink(v[1], v[2], aMap); - addLink(v[2], v[0], aMap); - } - - aPointsNb += aTriangulation->NbNodes(); - aTrianglesNb += aTriangulation->NbTriangles(); - aEdgesNb += aMap.Extent(); - } - - theStream << " 3d mesh\n"; - theStream << " - Triangles : " << aTrianglesNb << "\n"; - theStream << " - Edges : " << aEdgesNb << "\n"; - theStream << " - Point3d : " << aPointsNb << "\n"; -} - -//======================================================================= -//function : Mesher -//purpose : -//======================================================================= -const Handle(BRepMesh_IncrementalMesh)& MeshTest_DrawableMesh::Mesher() const -{ - return myMesher; -} - - -//======================================================================= -//function : Edges -//purpose : -//======================================================================= -TColStd_SequenceOfInteger& MeshTest_DrawableMesh::Edges() -{ - return myEdges; -} - - -//======================================================================= -//function : Vertices -//purpose : -//======================================================================= -TColStd_SequenceOfInteger& MeshTest_DrawableMesh::Vertices() -{ - return myVertices; -} - -//======================================================================= -//function : Triangles -//purpose : -//======================================================================= -TColStd_SequenceOfInteger& MeshTest_DrawableMesh::Triangles() -{ - return myTriangles; -} - diff --git a/src/MeshTest/MeshTest_DrawableMesh.hxx b/src/MeshTest/MeshTest_DrawableMesh.hxx deleted file mode 100644 index c36a9c2fc1..0000000000 --- a/src/MeshTest/MeshTest_DrawableMesh.hxx +++ /dev/null @@ -1,73 +0,0 @@ -// Copyright (c) 2013-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. - -#ifndef _MeshTest_DrawableMesh_HeaderFile -#define _MeshTest_DrawableMesh_HeaderFile - -#include -#include -#include -#include -#include -#include -#include - -class TopoDS_Shape; -class Draw_Display; - -//! A drawable mesh. -//! Provides a mesh object inherited from Drawable3d to draw a triangulation. -//! It contains a sequence of highlighted edges and highlighted vertices.
-class MeshTest_DrawableMesh : public Draw_Drawable3D -{ -public: - - Standard_EXPORT MeshTest_DrawableMesh(); - - Standard_EXPORT MeshTest_DrawableMesh(const TopoDS_Shape& theShape, - const Standard_Real theDeflection); - - Standard_EXPORT MeshTest_DrawableMesh(const Handle(BRepMesh_IncrementalMesh)& theMesher); - - Standard_EXPORT void Add(const TopoDS_Shape& theShape); - - Standard_EXPORT TColStd_SequenceOfInteger& Edges(); - - Standard_EXPORT TColStd_SequenceOfInteger& Vertices(); - - Standard_EXPORT TColStd_SequenceOfInteger& Triangles(); - - Standard_EXPORT void DrawOn(Draw_Display& theDisplay) const Standard_OVERRIDE; - - Standard_EXPORT virtual Handle(Draw_Drawable3D) Copy() const Standard_OVERRIDE; - - Standard_EXPORT virtual void Dump(Standard_OStream& theStream) const Standard_OVERRIDE; - - Standard_EXPORT virtual void Whatis(Draw_Interpretor& theDi) const Standard_OVERRIDE; - - Standard_EXPORT const Handle(BRepMesh_IncrementalMesh)& Mesher() const; - - DEFINE_STANDARD_RTTIEXT(MeshTest_DrawableMesh,Draw_Drawable3D) - -private: - - Handle(BRepMesh_IncrementalMesh) myMesher; - Standard_Real myDeflection; - TColStd_SequenceOfInteger myEdges; - TColStd_SequenceOfInteger myVertices; - TColStd_SequenceOfInteger myTriangles; -}; - -DEFINE_STANDARD_HANDLE(MeshTest_DrawableMesh, Draw_Drawable3D) - -#endif diff --git a/tests/mesh/advanced_mesh/begin b/tests/mesh/advanced_mesh/begin deleted file mode 100644 index 088a4ed6fd..0000000000 --- a/tests/mesh/advanced_mesh/begin +++ /dev/null @@ -1,2 +0,0 @@ -set command mesh -set group advanced diff --git a/tests/mesh/advanced_mesh/cases.list b/tests/mesh/advanced_mesh/cases.list deleted file mode 100644 index a33547378f..0000000000 --- a/tests/mesh/advanced_mesh/cases.list +++ /dev/null @@ -1 +0,0 @@ -../data/advanced diff --git a/tests/mesh/end b/tests/mesh/end index c478b89802..9ee09492b4 100644 --- a/tests/mesh/end +++ b/tests/mesh/end @@ -39,10 +39,6 @@ if { [string compare $command "incmesh"] == 0 } { } } -if { [string compare $command "mesh"] == 0 } { - set ResultList [mesh res_mesh res ${Deflection}] -} - # Collect TODO for area if { [string compare $bug_area ""] != 0 } { # The difference between the area of a geometry surface and the area of mesh triangles should be less than rel_tol value. @@ -112,15 +108,9 @@ set nod 0 set def 0 # Collect number of triangles, number of nodes and deflection. -if { [string compare $command "mesh"] != 0 } { - set full [trinfo res] - regexp "(\[0-9\]+) +triangles.*\[^0-9]\(\[0-9\]+) +nodes.*deflection +(\[0-9\]|\.+)" $full reg_out tri nod def -} else { - set full [split $ResultList "()"] - set tri [lindex [lindex $full 2] 0] - set lin [lindex [lindex $full 4] 0] - set nod [lindex [lindex $full 6] 0] -} + +set full [trinfo res] +regexp "(\[0-9\]+) +triangles.*\[^0-9]\(\[0-9\]+) +nodes.*deflection +(\[0-9\]|\.+)" $full reg_out tri nod def if { $tri == 0 || $nod == 0 } { puts " " diff --git a/tests/mesh/grids.list b/tests/mesh/grids.list index 7c98613873..963f29d0d2 100644 --- a/tests/mesh/grids.list +++ b/tests/mesh/grids.list @@ -1,8 +1,6 @@ 001 standard_shading 002 standard_incmesh -003 standard_mesh -004 advanced_shading -005 advanced_incmesh -006 advanced_mesh -007 standard_incmesh_parallel -008 advanced_incmesh_parallel +003 advanced_shading +004 advanced_incmesh +005 standard_incmesh_parallel +006 advanced_incmesh_parallel diff --git a/tests/mesh/standard_mesh/begin b/tests/mesh/standard_mesh/begin deleted file mode 100644 index 6f80c7c3ef..0000000000 --- a/tests/mesh/standard_mesh/begin +++ /dev/null @@ -1,2 +0,0 @@ -set command mesh -set group standard diff --git a/tests/mesh/standard_mesh/cases.list b/tests/mesh/standard_mesh/cases.list deleted file mode 100644 index 36ba22824f..0000000000 --- a/tests/mesh/standard_mesh/cases.list +++ /dev/null @@ -1 +0,0 @@ -../data/standard