Skip to content
Snippets Groups Projects
Commit c6376f6c authored by Jean-François Remacle's avatar Jean-François Remacle
Browse files

*** empty log message ***

parent 771aad0e
Branches
Tags
No related merge requests found
// $Id: 2D_Mesh.cpp,v 1.73 2005-01-20 19:05:09 geuzaine Exp $ // $Id: 2D_Mesh.cpp,v 1.74 2005-04-15 14:32:40 remacle Exp $
// //
// Copyright (C) 1997-2005 C. Geuzaine, J.-F. Remacle // Copyright (C) 1997-2005 C. Geuzaine, J.-F. Remacle
// //
...@@ -914,7 +914,7 @@ void Maillage_Surface(void *data, void *dum) ...@@ -914,7 +914,7 @@ void Maillage_Surface(void *data, void *dum)
delete_NXE(tnxe); delete_NXE(tnxe);
} }
if(s->Recombine){ if(s->Recombine && CTX.mesh.algo_recombine ==1 ){
Msg(STATUS3, "Recombining surface %d", s->Num); Msg(STATUS3, "Recombining surface %d", s->Num);
Recombine(s->Vertices, s->Simplexes, s->Quadrangles, s->RecombineAngle); Recombine(s->Vertices, s->Simplexes, s->Quadrangles, s->RecombineAngle);
} }
...@@ -947,4 +947,11 @@ void Maillage_Surface(void *data, void *dum) ...@@ -947,4 +947,11 @@ void Maillage_Surface(void *data, void *dum)
ReOrientSurfaceMesh(s); ReOrientSurfaceMesh(s);
} }
if(CTX.mesh.algo_recombine ==2 )
{
printf("coucou\n");
Recombine_All (THEM);
}
} }
// $Id: 2D_Recombine.cpp,v 1.22 2005-01-01 19:35:30 geuzaine Exp $ // $Id: 2D_Recombine.cpp,v 1.23 2005-04-15 14:32:40 remacle Exp $
// //
// Copyright (C) 1997-2005 C. Geuzaine, J.-F. Remacle // Copyright (C) 1997-2005 C. Geuzaine, J.-F. Remacle
// //
...@@ -166,3 +166,109 @@ int Recombine(Tree_T * Vertices, Tree_T * Simplexes, Tree_T * Quadrangles, ...@@ -166,3 +166,109 @@ int Recombine(Tree_T * Vertices, Tree_T * Simplexes, Tree_T * Quadrangles,
return ntot; return ntot;
} }
/*
This function recombines EVERYTHING.
First, all characteristic lengths are divided by 2.
This is done in 3 steps.
-) the previous technique is applied to every surface
-) remainder triangles are split into 3 quads and all recombined quads
are split into 4 quads
-) Enhancements are performned on the quad mesh.
*/
int Recombine_All (Mesh *THEM)
{
if(Tree_Nbr(THEM->Surfaces))
{
// recombine all surfaces
List_T *surfaces = Tree2List(THEM->Surfaces);
for(int i = 0; i < List_Nbr(surfaces); i++){
Surface *s;
List_Read(surfaces, i, &s);
if(s->Recombine){
Msg(STATUS3, "Recombining surface %d", s->Num);
Recombine(s->Vertices, s->Simplexes, s->Quadrangles, s->RecombineAngle);
}
}
// add 2nd order nodes to all elements
Degre2(2);
// then split everybody
for(int i = 0; i < List_Nbr(surfaces); i++)
{
Surface *s;
List_Read(surfaces, i, &s);
List_T *Quadrangles = Tree2List ( s->Quadrangles );
for (int j=0 ; j<List_Nbr (Quadrangles); j++)
{
Quadrangle *q;
List_Read (Quadrangles, j, &q);
Quadrangle *q1 = Create_Quadrangle(q->V[0], q->VSUP[0], q->VSUP[4], q->VSUP[3]);
Quadrangle *q2 = Create_Quadrangle(q->V[1], q->VSUP[1], q->VSUP[4], q->VSUP[0]);
Quadrangle *q3 = Create_Quadrangle(q->V[2], q->VSUP[2], q->VSUP[4], q->VSUP[1]);
Quadrangle *q4 = Create_Quadrangle(q->V[3], q->VSUP[3], q->VSUP[4], q->VSUP[2]);
Tree_Add ( s->Quadrangles, &q1);
Tree_Add ( s->Quadrangles, &q2);
Tree_Add ( s->Quadrangles, &q3);
Tree_Add ( s->Quadrangles, &q4);
Tree_Suppress (s->Quadrangles, &q);
}
List_Delete(Quadrangles);
List_T *Triangles = Tree2List ( s->Simplexes );
if(s->Recombine)
{
for (int j=0 ; j<List_Nbr (Triangles); j++)
{
Simplex *t;
List_Read (Triangles, j, &t);
Vertex *c = Create_Vertex(++THEM->MaxPointNum,
(t->V[0]->Pos.X+t->V[1]->Pos.X+t->V[2]->Pos.X)/3.,
(t->V[0]->Pos.Y+t->V[1]->Pos.Y+t->V[2]->Pos.Y)/3.,
(t->V[0]->Pos.Z+t->V[1]->Pos.Z+t->V[2]->Pos.Z)/3.,
(t->V[0]->lc+t->V[1]->lc+t->V[2]->lc)/3.,
(t->V[0]->u+t->V[1]->u+t->V[2]->u)/3.);
Quadrangle *q1 = Create_Quadrangle(t->V[0], t->VSUP[0], c, t->VSUP[2]);
Quadrangle *q2 = Create_Quadrangle(t->V[1], t->VSUP[1], c, t->VSUP[0]);
Quadrangle *q3 = Create_Quadrangle(t->V[2], t->VSUP[2], c, t->VSUP[1]);
Tree_Add ( s->Quadrangles, &q1);
Tree_Add ( s->Quadrangles, &q2);
Tree_Add ( s->Quadrangles, &q3);
Tree_Suppress (s->Simplexes, &t);
Free_Simplex(&t,0);
}
}
else
{
for (int j=0 ; j<List_Nbr (Triangles); j++)
{
Simplex *t;
List_Read (Triangles, j, &t);
Simplex *t1 = Create_Simplex(t->V[0], t->VSUP[0],t->VSUP[2],0);
Simplex *t2 = Create_Simplex(t->V[1], t->VSUP[1],t->VSUP[0],0);
Simplex *t3 = Create_Simplex(t->V[2], t->VSUP[2],t->VSUP[1],0);
Simplex *t4 = Create_Simplex(t->VSUP[0], t->VSUP[1],t->VSUP[2],0);
Tree_Add ( s->Simplexes, &t1);
Tree_Add ( s->Simplexes, &t2);
Tree_Add ( s->Simplexes, &t3);
Tree_Add ( s->Simplexes, &t4);
Tree_Suppress (s->Simplexes, &t);
Free_Simplex(&t,0);
}
}
List_Delete(Triangles);
}
List_Delete(surfaces);
Degre1();
}
return 1;
}
This diff is collapsed.
...@@ -4,13 +4,15 @@ ...@@ -4,13 +4,15 @@
// default values are 0,0,1 // default values are 0,0,1
#include <set> #include <set>
#include <map>
#include <list> #include <list>
#include <math.h>
class BDS_GeomEntity class BDS_GeomEntity
{ {
public: public:
int classif_degree;
int classif_tag; int classif_tag;
int classif_degree;
inline bool operator < ( const BDS_GeomEntity & other ) const inline bool operator < ( const BDS_GeomEntity & other ) const
{ {
if (classif_degree < other.classif_degree)return true; if (classif_degree < other.classif_degree)return true;
...@@ -19,7 +21,7 @@ public: ...@@ -19,7 +21,7 @@ public:
return false; return false;
} }
BDS_GeomEntity (int a, int b) BDS_GeomEntity (int a, int b)
: classif_degree (a),classif_tag(b) : classif_tag (a),classif_degree(b)
{ {
} }
}; };
...@@ -27,20 +29,69 @@ public: ...@@ -27,20 +29,69 @@ public:
class BDS_Edge; class BDS_Edge;
class BDS_Triangle; class BDS_Triangle;
class BDS_Mesh;
class BDS_Vector
{
public:
double x,y,z;
BDS_Vector operator + (const BDS_Vector &v)
{
return BDS_Vector (x+v.x,y+v.y,z+v.z);
}
BDS_Vector& operator += (const BDS_Vector &v)
{
x+=v.x;
y+=v.y;
z+=v.z;
return *this;
}
BDS_Vector operator / (const double &v)
{
return BDS_Vector (x/v,y/v,z/v);
}
BDS_Vector operator * (const double &v)
{
return BDS_Vector (x*v,y*v,z*v);
}
BDS_Vector (double ix=0, double iy=0, double iz=0)
// : x(ix),(iy),z(iz)
{
x=ix;
y=iy;
z=iz;
}
};
class BDS_Point class BDS_Point
{ {
public: public:
int iD; int iD;
BDS_GeomEntity *g;
double X,Y,Z; double X,Y,Z;
BDS_GeomEntity *g;
std::list<BDS_Edge*> edges; std::list<BDS_Edge*> edges;
inline bool operator < ( const BDS_Point & other ) const inline bool operator < ( const BDS_Point & other ) const
{ {
return iD < other.iD; return iD < other.iD;
} }
inline void del (BDS_Edge *e)
{
std::list<BDS_Edge*>::iterator it = edges.begin();
std::list<BDS_Edge*>::iterator ite = edges.end();
while(it!=ite)
{
if (*it == e)
{
edges.erase(it);
break;
}
++it;
}
}
void getTriangles (std::list<BDS_Triangle *> &t);
BDS_Point ( int id, double x=0, double y=0, double z=0 ) BDS_Point ( int id, double x=0, double y=0, double z=0 )
: iD(id),g(0),X(x),Y(y),Z(z) : iD(id),X(x),Y(y),Z(z),g(0)
{ {
} }
}; };
...@@ -48,9 +99,14 @@ public: ...@@ -48,9 +99,14 @@ public:
class BDS_Edge class BDS_Edge
{ {
public: public:
bool deleted;
BDS_Point *p1,*p2; BDS_Point *p1,*p2;
BDS_GeomEntity *g; BDS_GeomEntity *g;
BDS_Triangle*faces[2]; BDS_Triangle*faces[2];
inline double length () const
{
return sqrt ((p1->X-p2->X)*(p1->X-p2->X)+(p1->Y-p2->Y)*(p1->Y-p2->Y)+(p1->Z-p2->Z)*(p1->Z-p2->Z));
}
inline int numfaces ( ) const inline int numfaces ( ) const
{ {
if (faces[1]) return 2; if (faces[1]) return 2;
...@@ -59,6 +115,11 @@ public: ...@@ -59,6 +115,11 @@ public:
} }
inline void addface ( BDS_Triangle *f) inline void addface ( BDS_Triangle *f)
{ {
if (faces[1])
{
printf("Non Manifold model not done yet\n");
throw 1;
}
if(faces [0])faces[1] = f; if(faces [0])faces[1] = f;
else faces[0] = f; else faces[0] = f;
} }
...@@ -75,8 +136,24 @@ public: ...@@ -75,8 +136,24 @@ public:
if (f == faces[1]) return faces[0]; if (f == faces[1]) return faces[0];
throw; throw;
} }
inline void del (BDS_Triangle *t)
{
if (faces[0] == t)
{
faces[0] = faces[1];
}
else if (faces[1]!=t)
{
printf("edge with faces %p %p : cannot delete %p\n",faces[0],faces[1],t);
throw;
}
faces [1] = 0;
}
inline void oppositeof (BDS_Point * oface[2]) const;
BDS_Edge ( BDS_Point *A, BDS_Point *B ) BDS_Edge ( BDS_Point *A, BDS_Point *B )
: g(0) : deleted(false), g(0)
{ {
faces[0] = faces[1] = 0; faces[0] = faces[1] = 0;
if (*A < *B) if (*A < *B)
...@@ -97,90 +174,122 @@ public: ...@@ -97,90 +174,122 @@ public:
class BDS_Triangle class BDS_Triangle
{ {
public: public:
bool deleted;
int ori_first_edge;
BDS_Edge *e1,*e2,*e3; BDS_Edge *e1,*e2,*e3;
BDS_Vector N() const ;
BDS_GeomEntity *g; BDS_GeomEntity *g;
double NX,NY,NZ; inline void getNodes (BDS_Point *n[3]) const
inline bool operator < ( const BDS_Triangle & other ) const
{
if (*other.e1 < *e1) return true;
if (*e1 < *other.e1) return false;
if (*other.e2 < *e2) return true;
if (*e2 < *other.e2) return false;
if (*other.e3 < *e3) return true;
return false;
}
BDS_Triangle ( BDS_Edge *A, BDS_Edge *B, BDS_Edge *C , double nx=0, double ny=0, double nz=0)
: g(0),NX(nx),NY(ny),NZ(nz)
{
if (*A < *B && *A < *C)
{ {
if (*B < *C) if (ori_first_edge == 1)
{ {
e1=A; n[0] = e1->p1;
e2=B; n[1] = e1->p2;
e3=C;
} }
else else
{ {
e1=A; n[0] = e1->p2;
e2=C; n[1] = e1->p1;
e3=B;
} }
if (e2->p1 != n[0] && e2->p1 != n[1])n[2] = e2->p1;
else n[2] = e2->p2;
} }
else if (*B < *A && *B < *C) BDS_Triangle ( BDS_Edge *A, BDS_Edge *B, BDS_Edge *C, BDS_Point *first_vertex)
{ : deleted (false) , e1(A),e2(B),e3(C),g(0)
if (*A < *C)
{ {
e1=B; if (first_vertex == A->p1)
e2=A; ori_first_edge = 1;
e3=C; else if (first_vertex == A->p2)
} ori_first_edge = -1;
else else
{ throw;
e1=B; e1->addface(this);
e2=C; e2->addface(this);
e3=A; e3->addface(this);
}
} }
else };
class GeomLessThan
{ {
if (*A < *B) public:
bool operator()(const BDS_GeomEntity* ent1, const BDS_GeomEntity* ent2) const
{ {
e1=C; return *ent1 < *ent2;
e2=A;
e3=B;
} }
else };
class PointLessThan
{
public:
bool operator()(const BDS_Point* ent1, const BDS_Point* ent2) const
{ {
e1=C; return *ent1 < *ent2;
e2=B;
e3=A;
} }
};
class EdgeLessThan
{
public:
bool operator()(const BDS_Edge* ent1, const BDS_Edge* ent2) const
{
return *ent1 < *ent2;
} }
e1->addface(this); };
e2->addface(this);
e3->addface(this); class BDS_Projector
{
public:
virtual bool project ( const double &X, const double &Y, const double &Z, const BDS_Vector & n,
double &Xp, double &Yp, double &Zp ) const = 0;
};
class BDS_NoProjector : public BDS_Projector
{
public:
bool project ( const double &X, const double &Y, const double &Z, const BDS_Vector & n,
double &Xp, double &Yp, double &Zp ) const
{
Xp = X;
Yp = Y;
Zp = Z;
return true;
} }
}; };
class BDS_BDSProjector : public BDS_Projector
{
BDS_Mesh &m;
public:
BDS_BDSProjector (BDS_Mesh &_m) : m(_m){}
bool project ( const double &X, const double &Y, const double &Z, const BDS_Vector & n,
double &Xp, double &Yp, double &Zp ) const;
};
class BDS_Mesh class BDS_Mesh
{ {
int MAXPOINTNUMBER;
public: public:
std::set<BDS_GeomEntity> geom; std::set<BDS_GeomEntity*,GeomLessThan> geom;
std::set<BDS_Point> points; std::set<BDS_Point*,PointLessThan> points;
std::set<BDS_Edge> edges; std::set<BDS_Edge*, EdgeLessThan> edges;
std::set<BDS_Triangle> triangles; std::set<BDS_Edge*> edges_to_delete;
void add_point (int num , double x, double y,double z); std::list<BDS_Triangle*> triangles;
void add_edge (int p1, int p2); BDS_Point * add_point (int num , double x, double y,double z);
BDS_Edge * add_edge (int p1, int p2);
void del_edge (BDS_Edge *e);
void add_triangle (int p1, int p2, int p3); void add_triangle (int p1, int p2, int p3);
void del_triangle (BDS_Triangle *t);
void add_triangle (int p1, int p2, int p3, double nx, double ny, double nz); void add_triangle (int p1, int p2, int p3, double nx, double ny, double nz);
void add_geom (int degree, int tag); void add_geom (int degree, int tag);
BDS_Point *find_point (int num); BDS_Point *find_point (int num);
BDS_Edge *find_edge (int p1, int p2); BDS_Edge *find_edge (int p1, int p2);
BDS_Edge *find_edge (BDS_Point *p1, BDS_Point *p2, BDS_Triangle *t)const;
BDS_GeomEntity *get_geom (int p1, int p2); BDS_GeomEntity *get_geom (int p1, int p2);
// bool swap_edge ( BDS_Edge *); bool swap_edge ( BDS_Edge *);
// bool collapse_edge ( BDS_Edge *); bool collapse_edge ( BDS_Edge *, BDS_Point*, const BDS_Projector &);
// bool split_edge ( BDS_Edge *, double coord); bool smooth_point ( BDS_Point*, const BDS_Projector &);
bool split_edge ( BDS_Edge *, double coord, const BDS_Projector &);
void save_gmsh_format (const char *filename); void save_gmsh_format (const char *filename);
void classify ( double angle); void classify ( double angle);
BDS_Mesh() : MAXPOINTNUMBER (0){}
virtual ~BDS_Mesh ();
void adapt_mesh(double, const BDS_Projector &);
void cleanup();
}; };
// $Id: DiscreteSurface.cpp,v 1.7 2005-04-11 08:53:15 remacle Exp $ // $Id: DiscreteSurface.cpp,v 1.8 2005-04-15 14:32:40 remacle Exp $
// //
// Copyright (C) 1997-2005 C. Geuzaine, J.-F. Remacle // Copyright (C) 1997-2005 C. Geuzaine, J.-F. Remacle
// //
...@@ -169,6 +169,7 @@ void Mesh_To_BDS(Surface *s, BDS_Mesh *m) ...@@ -169,6 +169,7 @@ void Mesh_To_BDS(Surface *s, BDS_Mesh *m)
void POLY_rep_To_Mesh(POLY_rep *prep, Surface *s) void POLY_rep_To_Mesh(POLY_rep *prep, Surface *s)
{ {
printf ("compareposition : %22.15e\n",CTX.lc);
VertexBound = Tree_Create(sizeof(Vertex *), comparePosition); VertexBound = Tree_Create(sizeof(Vertex *), comparePosition);
Tree_Action(THEM->Vertices, InsertInVertexBound); Tree_Action(THEM->Vertices, InsertInVertexBound);
...@@ -379,6 +380,7 @@ void STLEndSolid() ...@@ -379,6 +380,7 @@ void STLEndSolid()
Tree_Add(THEM->Surfaces, &STL_Surf); Tree_Add(THEM->Surfaces, &STL_Surf);
Tree_Action(VertexBound, Free_Vertex); Tree_Action(VertexBound, Free_Vertex);
} }
Tree_Delete(VertexBound); Tree_Delete(VertexBound);
} }
...@@ -545,6 +547,7 @@ double SetLC(Vertex *v1, Vertex *v2, double factor) ...@@ -545,6 +547,7 @@ double SetLC(Vertex *v1, Vertex *v2, double factor)
void SEGM_rep_To_Mesh(SEGM_rep *srep, Curve *c) void SEGM_rep_To_Mesh(SEGM_rep *srep, Curve *c)
{ {
VertexBound = Tree_Create(sizeof(Vertex *), comparePosition); VertexBound = Tree_Create(sizeof(Vertex *), comparePosition);
Tree_Action(THEM->Vertices, InsertInVertexBound); Tree_Action(THEM->Vertices, InsertInVertexBound);
...@@ -610,8 +613,24 @@ int MeshDiscreteSurface(Surface *s) ...@@ -610,8 +613,24 @@ int MeshDiscreteSurface(Surface *s)
// hope for the best. // hope for the best.
POLY_rep_To_Mesh(s->thePolyRep, s); POLY_rep_To_Mesh(s->thePolyRep, s);
BDS_Mesh bds; BDS_Mesh bds;
BDS_NoProjector nop;
Mesh_To_BDS(s,&bds); Mesh_To_BDS(s,&bds);
bds.classify ( M_PI / 9 ); bds.save_gmsh_format ( "1.msh" );
bds.classify ( M_PI / 6 );
bds.save_gmsh_format ( "2.msh" );
try{
for (int i=0;i<15;i++)
{
bds.adapt_mesh (CTX.lc/30 , nop );
printf("%d \n",i);
}
}
catch(...)
{
printf("coucou\n");
}
bds.save_gmsh_format ( "3.msh" );
return 1; return 1;
} }
else if(s->Typ == MSH_SURF_DISCRETE){ else if(s->Typ == MSH_SURF_DISCRETE){
......
# $Id: Makefile,v 1.81 2005-04-12 17:05:39 geuzaine Exp $ # $Id: Makefile,v 1.82 2005-04-15 14:32:40 remacle Exp $
# #
# Copyright (C) 1997-2005 C. Geuzaine, J.-F. Remacle # Copyright (C) 1997-2005 C. Geuzaine, J.-F. Remacle
# #
...@@ -83,7 +83,7 @@ ${LIB}: ${OBJ} ...@@ -83,7 +83,7 @@ ${LIB}: ${OBJ}
${RANLIB} ${LIB} ${RANLIB} ${LIB}
.cpp.o: .cpp.o:
${CXX} ${CFLAGS} -c $< ${CXX} ${CFLAGS} -c -pg $<
# Don't optimize 3D_Mesh: it sometimes mysteriously crashes on Linux # Don't optimize 3D_Mesh: it sometimes mysteriously crashes on Linux
3D_Mesh.o: 3D_Mesh.o:
...@@ -114,8 +114,8 @@ depend: ...@@ -114,8 +114,8 @@ depend:
../Geo/CAD.h ../Mesh/Mesh.h ../Mesh/Vertex.h ../Mesh/Element.h \ ../Geo/CAD.h ../Mesh/Mesh.h ../Mesh/Vertex.h ../Mesh/Element.h \
../Mesh/Simplex.h ../Mesh/Face.h ../Mesh/Edge.h ../Geo/ExtrudeParams.h \ ../Mesh/Simplex.h ../Mesh/Face.h ../Mesh/Edge.h ../Geo/ExtrudeParams.h \
../Mesh/DiscreteSurface.h ../Common/VertexArray.h \ ../Mesh/DiscreteSurface.h ../Common/VertexArray.h \
../Common/SmoothNormals.h ../Mesh/Metric.h ../Mesh/Matrix.h Utils.h \ ../Common/SmoothNormals.h ../Mesh/Metric.h ../Mesh/Matrix.h Mesh.h \
Create.h 2D_Mesh.h ../Common/Context.h Interpolation.h Utils.h Vertex.h Create.h 2D_Mesh.h ../Common/Context.h Interpolation.h
2D_Transfinite.o: 2D_Transfinite.cpp ../Common/Gmsh.h ../Common/Message.h \ 2D_Transfinite.o: 2D_Transfinite.cpp ../Common/Gmsh.h ../Common/Message.h \
../DataStr/Malloc.h ../DataStr/List.h ../DataStr/Tree.h \ ../DataStr/Malloc.h ../DataStr/List.h ../DataStr/Tree.h \
../DataStr/avl.h ../DataStr/Tools.h ../Geo/Geo.h Mesh.h Vertex.h \ ../DataStr/avl.h ../DataStr/Tools.h ../Geo/Geo.h Mesh.h Vertex.h \
...@@ -128,7 +128,7 @@ depend: ...@@ -128,7 +128,7 @@ depend:
../Geo/CAD.h ../Mesh/Mesh.h ../Mesh/Vertex.h ../Mesh/Element.h \ ../Geo/CAD.h ../Mesh/Mesh.h ../Mesh/Vertex.h ../Mesh/Element.h \
../Mesh/Simplex.h ../Mesh/Face.h ../Mesh/Edge.h ../Geo/ExtrudeParams.h \ ../Mesh/Simplex.h ../Mesh/Face.h ../Mesh/Edge.h ../Geo/ExtrudeParams.h \
../Mesh/DiscreteSurface.h ../Common/VertexArray.h \ ../Mesh/DiscreteSurface.h ../Common/VertexArray.h \
../Common/SmoothNormals.h ../Mesh/Metric.h ../Mesh/Matrix.h ../Common/SmoothNormals.h ../Mesh/Metric.h ../Mesh/Matrix.h Mesh.h
2D_BGMesh.o: 2D_BGMesh.cpp ../Common/Gmsh.h ../Common/Message.h \ 2D_BGMesh.o: 2D_BGMesh.cpp ../Common/Gmsh.h ../Common/Message.h \
../DataStr/Malloc.h ../DataStr/List.h ../DataStr/Tree.h \ ../DataStr/Malloc.h ../DataStr/List.h ../DataStr/Tree.h \
../DataStr/avl.h ../DataStr/Tools.h ../Numeric/Numeric.h Mesh.h \ ../DataStr/avl.h ../DataStr/Tools.h ../Numeric/Numeric.h Mesh.h \
...@@ -196,21 +196,22 @@ depend: ...@@ -196,21 +196,22 @@ depend:
../Mesh/Simplex.h ../Mesh/Face.h ../Mesh/Edge.h ../Geo/ExtrudeParams.h \ ../Mesh/Simplex.h ../Mesh/Face.h ../Mesh/Edge.h ../Geo/ExtrudeParams.h \
../Mesh/DiscreteSurface.h ../Common/VertexArray.h \ ../Mesh/DiscreteSurface.h ../Common/VertexArray.h \
../Common/SmoothNormals.h ../Mesh/Metric.h ../Mesh/Matrix.h \ ../Common/SmoothNormals.h ../Mesh/Metric.h ../Mesh/Matrix.h \
Interpolation.h 2D_Mesh.h Create.h ../Common/Context.h Interpolation.h Vertex.h Mesh.h 2D_Mesh.h Create.h ../Common/Context.h
2D_Mesh_Aniso.o: 2D_Mesh_Aniso.cpp ../Common/Gmsh.h ../Common/Message.h \ 2D_Mesh_Aniso.o: 2D_Mesh_Aniso.cpp ../Common/Gmsh.h ../Common/Message.h \
../DataStr/Malloc.h ../DataStr/List.h ../DataStr/Tree.h \ ../DataStr/Malloc.h ../DataStr/List.h ../DataStr/Tree.h \
../DataStr/avl.h ../DataStr/Tools.h ../Numeric/Numeric.h ../Geo/Geo.h \ ../DataStr/avl.h ../DataStr/Tools.h ../Numeric/Numeric.h ../Geo/Geo.h \
../Geo/CAD.h ../Mesh/Mesh.h ../Mesh/Vertex.h ../Mesh/Element.h \ ../Geo/CAD.h ../Mesh/Mesh.h ../Mesh/Vertex.h ../Mesh/Element.h \
../Mesh/Simplex.h ../Mesh/Face.h ../Mesh/Edge.h ../Geo/ExtrudeParams.h \ ../Mesh/Simplex.h ../Mesh/Face.h ../Mesh/Edge.h ../Geo/ExtrudeParams.h \
../Mesh/DiscreteSurface.h ../Common/VertexArray.h \ ../Mesh/DiscreteSurface.h ../Common/VertexArray.h \
../Common/SmoothNormals.h ../Mesh/Metric.h ../Mesh/Matrix.h \ ../Common/SmoothNormals.h ../Mesh/Metric.h ../Mesh/Matrix.h Mesh.h \
Interpolation.h Create.h ../Common/Context.h Interpolation.h Vertex.h Create.h ../Common/Context.h
2D_Mesh_Triangle.o: 2D_Mesh_Triangle.cpp ../Common/Gmsh.h \ 2D_Mesh_Triangle.o: 2D_Mesh_Triangle.cpp ../Common/Gmsh.h \
../Common/Message.h ../DataStr/Malloc.h ../DataStr/List.h \ ../Common/Message.h ../DataStr/Malloc.h ../DataStr/List.h \
../DataStr/Tree.h ../DataStr/avl.h ../DataStr/Tools.h Mesh.h Vertex.h \ ../DataStr/Tree.h ../DataStr/avl.h ../DataStr/Tools.h Mesh.h Vertex.h \
Element.h Simplex.h Face.h Edge.h ../Geo/ExtrudeParams.h \ Element.h Simplex.h Face.h Edge.h ../Geo/ExtrudeParams.h \
DiscreteSurface.h ../Common/VertexArray.h ../Common/SmoothNormals.h \ DiscreteSurface.h ../Common/VertexArray.h ../Common/SmoothNormals.h \
Metric.h Matrix.h ../Numeric/Numeric.h ../Common/Context.h Metric.h Matrix.h ../Numeric/Numeric.h ../Common/Context.h \
../Triangle/triangle.h
3D_Mesh.o: 3D_Mesh.cpp ../Common/Gmsh.h ../Common/Message.h \ 3D_Mesh.o: 3D_Mesh.cpp ../Common/Gmsh.h ../Common/Message.h \
../DataStr/Malloc.h ../DataStr/List.h ../DataStr/Tree.h \ ../DataStr/Malloc.h ../DataStr/List.h ../DataStr/Tree.h \
../DataStr/avl.h ../DataStr/Tools.h ../Numeric/Numeric.h Mesh.h \ ../DataStr/avl.h ../DataStr/Tools.h ../Numeric/Numeric.h Mesh.h \
...@@ -237,16 +238,16 @@ depend: ...@@ -237,16 +238,16 @@ depend:
../Geo/CAD.h ../Mesh/Mesh.h ../Mesh/Vertex.h ../Mesh/Element.h \ ../Geo/CAD.h ../Mesh/Mesh.h ../Mesh/Vertex.h ../Mesh/Element.h \
../Mesh/Simplex.h ../Mesh/Face.h ../Mesh/Edge.h ../Geo/ExtrudeParams.h \ ../Mesh/Simplex.h ../Mesh/Face.h ../Mesh/Edge.h ../Geo/ExtrudeParams.h \
../Mesh/DiscreteSurface.h ../Common/VertexArray.h \ ../Mesh/DiscreteSurface.h ../Common/VertexArray.h \
../Common/SmoothNormals.h ../Mesh/Metric.h ../Mesh/Matrix.h \ ../Common/SmoothNormals.h ../Mesh/Metric.h ../Mesh/Matrix.h Mesh.h \
../Common/Context.h Create.h ../Common/Context.h Create.h Vertex.h
3D_Extrude_Old.o: 3D_Extrude_Old.cpp ../Common/Gmsh.h ../Common/Message.h \ 3D_Extrude_Old.o: 3D_Extrude_Old.cpp ../Common/Gmsh.h ../Common/Message.h \
../DataStr/Malloc.h ../DataStr/List.h ../DataStr/Tree.h \ ../DataStr/Malloc.h ../DataStr/List.h ../DataStr/Tree.h \
../DataStr/avl.h ../DataStr/Tools.h ../Numeric/Numeric.h ../Geo/Geo.h \ ../DataStr/avl.h ../DataStr/Tools.h ../Numeric/Numeric.h ../Geo/Geo.h \
../Geo/CAD.h ../Mesh/Mesh.h ../Mesh/Vertex.h ../Mesh/Element.h \ ../Geo/CAD.h ../Mesh/Mesh.h ../Mesh/Vertex.h ../Mesh/Element.h \
../Mesh/Simplex.h ../Mesh/Face.h ../Mesh/Edge.h ../Geo/ExtrudeParams.h \ ../Mesh/Simplex.h ../Mesh/Face.h ../Mesh/Edge.h ../Geo/ExtrudeParams.h \
../Mesh/DiscreteSurface.h ../Common/VertexArray.h \ ../Mesh/DiscreteSurface.h ../Common/VertexArray.h \
../Common/SmoothNormals.h ../Mesh/Metric.h ../Mesh/Matrix.h \ ../Common/SmoothNormals.h ../Mesh/Metric.h ../Mesh/Matrix.h Mesh.h \
../Common/Context.h Create.h ../Common/Context.h Create.h Vertex.h
3D_Coherence.o: 3D_Coherence.cpp ../Common/Gmsh.h ../Common/Message.h \ 3D_Coherence.o: 3D_Coherence.cpp ../Common/Gmsh.h ../Common/Message.h \
../DataStr/Malloc.h ../DataStr/List.h ../DataStr/Tree.h \ ../DataStr/Malloc.h ../DataStr/List.h ../DataStr/Tree.h \
../DataStr/avl.h ../DataStr/Tools.h ../Numeric/Numeric.h ../Geo/Geo.h \ ../DataStr/avl.h ../DataStr/Tools.h ../Numeric/Numeric.h ../Geo/Geo.h \
...@@ -270,8 +271,9 @@ depend: ...@@ -270,8 +271,9 @@ depend:
../DataStr/avl.h ../DataStr/Tools.h Mesh.h Vertex.h Element.h Simplex.h \ ../DataStr/avl.h ../DataStr/Tools.h Mesh.h Vertex.h Element.h Simplex.h \
Face.h Edge.h ../Geo/ExtrudeParams.h DiscreteSurface.h \ Face.h Edge.h ../Geo/ExtrudeParams.h DiscreteSurface.h \
../Common/VertexArray.h ../Common/SmoothNormals.h Metric.h Matrix.h \ ../Common/VertexArray.h ../Common/SmoothNormals.h Metric.h Matrix.h \
Create.h ../Numeric/Numeric.h ../Common/Context.h Create.h ../Numeric/Numeric.h ../Common/Context.h \
BDS.o: BDS.cpp BDS.h ../Netgen/libsrc/interface/nglib.h ../Netgen/nglib_addon.h
BDS.o: BDS.cpp BDS.h ../Numeric/Numeric.h
MeshQuality.o: MeshQuality.cpp ../Common/Gmsh.h ../Common/Message.h \ MeshQuality.o: MeshQuality.cpp ../Common/Gmsh.h ../Common/Message.h \
../DataStr/Malloc.h ../DataStr/List.h ../DataStr/Tree.h \ ../DataStr/Malloc.h ../DataStr/List.h ../DataStr/Tree.h \
../DataStr/avl.h ../DataStr/Tools.h ../Numeric/Numeric.h Mesh.h \ ../DataStr/avl.h ../DataStr/Tools.h ../Numeric/Numeric.h Mesh.h \
...@@ -284,8 +286,8 @@ Create.o: Create.cpp ../Common/Gmsh.h ../Common/Message.h \ ...@@ -284,8 +286,8 @@ Create.o: Create.cpp ../Common/Gmsh.h ../Common/Message.h \
../Geo/CAD.h ../Mesh/Mesh.h ../Mesh/Vertex.h ../Mesh/Element.h \ ../Geo/CAD.h ../Mesh/Mesh.h ../Mesh/Vertex.h ../Mesh/Element.h \
../Mesh/Simplex.h ../Mesh/Face.h ../Mesh/Edge.h ../Geo/ExtrudeParams.h \ ../Mesh/Simplex.h ../Mesh/Face.h ../Mesh/Edge.h ../Geo/ExtrudeParams.h \
../Mesh/DiscreteSurface.h ../Common/VertexArray.h \ ../Mesh/DiscreteSurface.h ../Common/VertexArray.h \
../Common/SmoothNormals.h ../Mesh/Metric.h ../Mesh/Matrix.h Utils.h \ ../Common/SmoothNormals.h ../Mesh/Metric.h ../Mesh/Matrix.h Mesh.h \
../Common/Context.h Create.h Utils.h Vertex.h ../Common/Context.h Create.h
Generator.o: Generator.cpp ../Common/Gmsh.h ../Common/Message.h \ Generator.o: Generator.cpp ../Common/Gmsh.h ../Common/Message.h \
../DataStr/Malloc.h ../DataStr/List.h ../DataStr/Tree.h \ ../DataStr/Malloc.h ../DataStr/List.h ../DataStr/Tree.h \
../DataStr/avl.h ../DataStr/Tools.h ../Numeric/Numeric.h Mesh.h \ ../DataStr/avl.h ../DataStr/Tools.h ../Numeric/Numeric.h Mesh.h \
...@@ -300,23 +302,24 @@ Print_Mesh.o: Print_Mesh.cpp ../Common/Gmsh.h ../Common/Message.h \ ...@@ -300,23 +302,24 @@ Print_Mesh.o: Print_Mesh.cpp ../Common/Gmsh.h ../Common/Message.h \
../Geo/CAD.h ../Mesh/Mesh.h ../Mesh/Vertex.h ../Mesh/Element.h \ ../Geo/CAD.h ../Mesh/Mesh.h ../Mesh/Vertex.h ../Mesh/Element.h \
../Mesh/Simplex.h ../Mesh/Face.h ../Mesh/Edge.h ../Geo/ExtrudeParams.h \ ../Mesh/Simplex.h ../Mesh/Face.h ../Mesh/Edge.h ../Geo/ExtrudeParams.h \
../Mesh/DiscreteSurface.h ../Common/VertexArray.h \ ../Mesh/DiscreteSurface.h ../Common/VertexArray.h \
../Common/SmoothNormals.h ../Mesh/Metric.h ../Mesh/Matrix.h Create.h \ ../Common/SmoothNormals.h ../Mesh/Metric.h ../Mesh/Matrix.h Mesh.h \
../Common/Context.h Create.h Vertex.h ../Common/Context.h
Read_Mesh.o: Read_Mesh.cpp ../Common/Gmsh.h ../Common/Message.h \ Read_Mesh.o: Read_Mesh.cpp ../Common/Gmsh.h ../Common/Message.h \
../DataStr/Malloc.h ../DataStr/List.h ../DataStr/Tree.h \ ../DataStr/Malloc.h ../DataStr/List.h ../DataStr/Tree.h \
../DataStr/avl.h ../DataStr/Tools.h ../Geo/Geo.h ../Geo/CAD.h \ ../DataStr/avl.h ../DataStr/Tools.h ../Geo/Geo.h ../Geo/CAD.h \
../Mesh/Mesh.h ../Mesh/Vertex.h ../Mesh/Element.h ../Mesh/Simplex.h \ ../Mesh/Mesh.h ../Mesh/Vertex.h ../Mesh/Element.h ../Mesh/Simplex.h \
../Mesh/Face.h ../Mesh/Edge.h ../Geo/ExtrudeParams.h \ ../Mesh/Face.h ../Mesh/Edge.h ../Geo/ExtrudeParams.h \
../Mesh/DiscreteSurface.h ../Common/VertexArray.h \ ../Mesh/DiscreteSurface.h ../Common/VertexArray.h \
../Common/SmoothNormals.h ../Mesh/Metric.h ../Mesh/Matrix.h 3D_Mesh.h \ ../Common/SmoothNormals.h ../Mesh/Metric.h ../Mesh/Matrix.h Mesh.h \
Create.h ../Geo/MinMax.h ../Common/Context.h 3D_Mesh.h Create.h Vertex.h ../Geo/MinMax.h ../Common/Context.h
DiscreteSurface.o: DiscreteSurface.cpp ../Common/Gmsh.h \ DiscreteSurface.o: DiscreteSurface.cpp ../Common/Gmsh.h \
../Common/Message.h ../DataStr/Malloc.h ../DataStr/List.h \ ../Common/Message.h ../DataStr/Malloc.h ../DataStr/List.h \
../DataStr/Tree.h ../DataStr/avl.h ../DataStr/Tools.h \ ../DataStr/Tree.h ../DataStr/avl.h ../DataStr/Tools.h \
../Numeric/Numeric.h Mesh.h Vertex.h Element.h Simplex.h Face.h Edge.h \ ../Numeric/Numeric.h Mesh.h Vertex.h Element.h Simplex.h Face.h Edge.h \
../Geo/ExtrudeParams.h DiscreteSurface.h ../Common/VertexArray.h \ ../Geo/ExtrudeParams.h DiscreteSurface.h ../Common/VertexArray.h \
../Common/SmoothNormals.h Metric.h Matrix.h ../Geo/CAD.h ../Geo/Geo.h \ ../Common/SmoothNormals.h Metric.h Matrix.h ../Geo/CAD.h ../Mesh/Mesh.h \
Create.h Interpolation.h ../Common/Context.h BDS.h ../Mesh/Vertex.h ../Geo/Geo.h Create.h Interpolation.h \
../Common/Context.h BDS.h
SwapEdge.o: SwapEdge.cpp ../Common/Gmsh.h ../Common/Message.h \ SwapEdge.o: SwapEdge.cpp ../Common/Gmsh.h ../Common/Message.h \
../DataStr/Malloc.h ../DataStr/List.h ../DataStr/Tree.h \ ../DataStr/Malloc.h ../DataStr/List.h ../DataStr/Tree.h \
../DataStr/avl.h ../DataStr/Tools.h ../Numeric/Numeric.h Mesh.h \ ../DataStr/avl.h ../DataStr/Tools.h ../Numeric/Numeric.h Mesh.h \
...@@ -329,29 +332,30 @@ Utils.o: Utils.cpp ../Common/Gmsh.h ../Common/Message.h \ ...@@ -329,29 +332,30 @@ Utils.o: Utils.cpp ../Common/Gmsh.h ../Common/Message.h \
../Geo/CAD.h ../Mesh/Mesh.h ../Mesh/Vertex.h ../Mesh/Element.h \ ../Geo/CAD.h ../Mesh/Mesh.h ../Mesh/Vertex.h ../Mesh/Element.h \
../Mesh/Simplex.h ../Mesh/Face.h ../Mesh/Edge.h ../Geo/ExtrudeParams.h \ ../Mesh/Simplex.h ../Mesh/Face.h ../Mesh/Edge.h ../Geo/ExtrudeParams.h \
../Mesh/DiscreteSurface.h ../Common/VertexArray.h \ ../Mesh/DiscreteSurface.h ../Common/VertexArray.h \
../Common/SmoothNormals.h ../Mesh/Metric.h ../Mesh/Matrix.h \ ../Common/SmoothNormals.h ../Mesh/Metric.h ../Mesh/Matrix.h Mesh.h \
Interpolation.h ../Common/Context.h Interpolation.h Vertex.h ../Common/Context.h
Metric.o: Metric.cpp ../Common/Gmsh.h ../Common/Message.h \ Metric.o: Metric.cpp ../Common/Gmsh.h ../Common/Message.h \
../DataStr/Malloc.h ../DataStr/List.h ../DataStr/Tree.h \ ../DataStr/Malloc.h ../DataStr/List.h ../DataStr/Tree.h \
../DataStr/avl.h ../DataStr/Tools.h ../Numeric/Numeric.h ../Geo/Geo.h \ ../DataStr/avl.h ../DataStr/Tools.h ../Numeric/Numeric.h ../Geo/Geo.h \
../Geo/CAD.h ../Mesh/Mesh.h ../Mesh/Vertex.h ../Mesh/Element.h \ ../Geo/CAD.h ../Mesh/Mesh.h ../Mesh/Vertex.h ../Mesh/Element.h \
../Mesh/Simplex.h ../Mesh/Face.h ../Mesh/Edge.h ../Geo/ExtrudeParams.h \ ../Mesh/Simplex.h ../Mesh/Face.h ../Mesh/Edge.h ../Geo/ExtrudeParams.h \
../Mesh/DiscreteSurface.h ../Common/VertexArray.h \ ../Mesh/DiscreteSurface.h ../Common/VertexArray.h \
../Common/SmoothNormals.h ../Mesh/Metric.h ../Mesh/Matrix.h \ ../Common/SmoothNormals.h ../Mesh/Metric.h ../Mesh/Matrix.h Mesh.h \
Interpolation.h Matrix.h Interpolation.h Vertex.h
Nurbs.o: Nurbs.cpp ../Common/Gmsh.h ../Common/Message.h \ Nurbs.o: Nurbs.cpp ../Common/Gmsh.h ../Common/Message.h \
../DataStr/Malloc.h ../DataStr/List.h ../DataStr/Tree.h \ ../DataStr/Malloc.h ../DataStr/List.h ../DataStr/Tree.h \
../DataStr/avl.h ../DataStr/Tools.h Nurbs.h Vertex.h Mesh.h Element.h \ ../DataStr/avl.h ../DataStr/Tools.h Nurbs.h Vertex.h Mesh.h Element.h \
Simplex.h Face.h Edge.h ../Geo/ExtrudeParams.h DiscreteSurface.h \ Simplex.h Face.h Edge.h ../Geo/ExtrudeParams.h DiscreteSurface.h \
../Common/VertexArray.h ../Common/SmoothNormals.h Metric.h Matrix.h \ ../Common/VertexArray.h ../Common/SmoothNormals.h Metric.h Matrix.h \
../Geo/Geo.h ../Geo/GeoUtils.h Create.h ../Geo/CAD.h ../Geo/Geo.h ../Geo/GeoUtils.h ../Mesh/Mesh.h Create.h ../Geo/CAD.h \
../Mesh/Vertex.h
Interpolation.o: Interpolation.cpp ../Common/Gmsh.h ../Common/Message.h \ Interpolation.o: Interpolation.cpp ../Common/Gmsh.h ../Common/Message.h \
../DataStr/Malloc.h ../DataStr/List.h ../DataStr/Tree.h \ ../DataStr/Malloc.h ../DataStr/List.h ../DataStr/Tree.h \
../DataStr/avl.h ../DataStr/Tools.h ../Numeric/Numeric.h ../Geo/Geo.h \ ../DataStr/avl.h ../DataStr/Tools.h ../Numeric/Numeric.h ../Geo/Geo.h \
Nurbs.h Vertex.h Mesh.h Element.h Simplex.h Face.h Edge.h \ Nurbs.h Vertex.h Mesh.h Element.h Simplex.h Face.h Edge.h \
../Geo/ExtrudeParams.h DiscreteSurface.h ../Common/VertexArray.h \ ../Geo/ExtrudeParams.h DiscreteSurface.h ../Common/VertexArray.h \
../Common/SmoothNormals.h Metric.h Matrix.h ../Geo/CAD.h Utils.h \ ../Common/SmoothNormals.h Metric.h Matrix.h ../Geo/CAD.h ../Mesh/Mesh.h \
Interpolation.h ../Mesh/Vertex.h Utils.h Interpolation.h
SecondOrder.o: SecondOrder.cpp ../Common/Gmsh.h ../Common/Message.h \ SecondOrder.o: SecondOrder.cpp ../Common/Gmsh.h ../Common/Message.h \
../DataStr/Malloc.h ../DataStr/List.h ../DataStr/Tree.h \ ../DataStr/Malloc.h ../DataStr/List.h ../DataStr/Tree.h \
../DataStr/avl.h ../DataStr/Tools.h ../Geo/Geo.h Mesh.h Vertex.h \ ../DataStr/avl.h ../DataStr/Tools.h ../Geo/Geo.h Mesh.h Vertex.h \
......
0% Loading or .
You are about to add 0 people to the discussion. Proceed with caution.
Please register or to comment