PolyFEM
Loading...
Searching...
No Matches
Mesh.hpp
Go to the documentation of this file.
1#pragma once
2
3#include <polyfem/Common.hpp>
8
9#include <Eigen/Dense>
10#include <geogram/mesh/mesh.h>
11
12#include <memory>
13
14namespace polyfem
15{
16 namespace mesh
17 {
36
38 class Mesh
39 {
40 protected:
43 {
44 public:
45 int v1, v2;
46 std::vector<int> nodes_ids;
47 Eigen::MatrixXd nodes;
48 };
49
52 {
53 public:
54 int v1, v2, v3;
55 std::vector<int> nodes_ids;
56 Eigen::MatrixXd nodes;
57 };
58
61 {
62 public:
63 int v1, v2, v3, v4;
64 std::vector<int> nodes_ids;
65 Eigen::MatrixXd nodes;
66 };
67
68 public:
75 static std::unique_ptr<Mesh> create(const std::string &path, const bool non_conforming = false);
76
83 static std::unique_ptr<Mesh> create(GEO::Mesh &M, const bool non_conforming = false);
84
92 static std::unique_ptr<Mesh> create(const Eigen::MatrixXd &vertices, const Eigen::MatrixXi &cells, const bool non_conforming = false);
93
100 static std::unique_ptr<Mesh> create(const int dim, const bool non_conforming = false);
101
104 virtual std::unique_ptr<Mesh> copy() const = 0;
105
106 protected:
110 Mesh() = default;
111
112 public:
115 virtual ~Mesh() = default;
119 Mesh(Mesh &&) = default;
124 Mesh &operator=(Mesh &&) = default;
128 Mesh(const Mesh &) = default;
133 Mesh &operator=(const Mesh &) = default;
134
140 virtual void refine(const int n_refinement, const double t) = 0;
141
146 virtual bool is_volume() const = 0;
151 int dimension() const { return (is_volume() ? 3 : 2); }
156 virtual bool is_conforming() const = 0;
161 int n_elements() const { return (is_volume() ? n_cells() : n_faces()); }
166 int n_boundary_elements() const { return (is_volume() ? n_faces() : n_edges()); }
167
172 virtual int n_cells() const = 0;
177 virtual int n_faces() const = 0;
181 virtual int n_edges() const = 0;
185 virtual int n_vertices() const = 0;
186
191 virtual int n_face_vertices(const int f_id) const = 0;
196 virtual int n_cell_vertices(const int c_id) const = 0;
202 virtual int edge_vertex(const int e_id, const int lv_id) const = 0;
208 virtual int face_vertex(const int f_id, const int lv_id) const = 0;
214 virtual int cell_vertex(const int f_id, const int lv_id) const = 0;
220 int element_vertex(const int el_id, const int lv_id) const
221 {
222 return (is_volume() ? cell_vertex(el_id, lv_id) : face_vertex(el_id, lv_id));
223 }
224
229 std::vector<int> element_vertices(const int el_id) const
230 {
231 std::vector<int> res;
232 for (int i = 0; i < n_cell_vertices(el_id); ++i)
233 res.push_back(element_vertex(el_id, i));
234 std::sort(res.begin(), res.end());
235 return res;
236 }
237
238 int boundary_element_vertex(const int primitive_id, const int lv_id) const
239 {
240 return (is_volume() ? face_vertex(primitive_id, lv_id) : edge_vertex(primitive_id, lv_id));
241 }
242
247 virtual bool is_boundary_vertex(const int vertex_global_id) const = 0;
252 virtual bool is_boundary_edge(const int edge_global_id) const = 0;
257 virtual bool is_boundary_face(const int face_global_id) const = 0;
262 virtual bool is_boundary_element(const int element_global_id) const = 0;
263
264 virtual bool save(const std::string &path) const = 0;
265
266 private:
272 virtual bool build_from_matrices(const Eigen::MatrixXd &V, const Eigen::MatrixXi &F) = 0;
273
274 public:
279 virtual void attach_higher_order_nodes(const Eigen::MatrixXd &V, const std::vector<std::vector<int>> &nodes) = 0;
283 inline const Eigen::MatrixXi &orders() const { return orders_; }
287 inline bool is_rational() const { return is_rational_; }
291 inline void set_is_rational(const bool in_is_rational) { is_rational_ = in_is_rational; }
292
295 virtual void normalize() = 0;
296
298 virtual void compute_elements_tag() = 0;
300 virtual void update_elements_tag() { assert(false); }
301
306 virtual double edge_length(const int gid) const
307 {
308 assert(false);
309 return 0;
310 }
315 virtual double quad_area(const int gid) const
316 {
317 assert(false);
318 return 0;
319 }
324 virtual double tri_area(const int gid) const
325 {
326 assert(false);
327 return 0;
328 }
329
334 virtual RowVectorNd point(const int global_index) const = 0;
339 virtual void set_point(const int global_index, const RowVectorNd &p) = 0;
340
345 virtual RowVectorNd edge_barycenter(const int e) const = 0;
350 virtual RowVectorNd face_barycenter(const int f) const = 0;
355 virtual RowVectorNd cell_barycenter(const int c) const = 0;
356
360 void edge_barycenters(Eigen::MatrixXd &barycenters) const;
364 void face_barycenters(Eigen::MatrixXd &barycenters) const;
368 void cell_barycenters(Eigen::MatrixXd &barycenters) const;
372 virtual void compute_element_barycenters(Eigen::MatrixXd &barycenters) const = 0;
373
377 virtual void elements_boxes(std::vector<std::array<Eigen::Vector3d, 2>> &boxes) const = 0;
383 virtual void barycentric_coords(const RowVectorNd &p, const int el_id, Eigen::MatrixXd &coord) const = 0;
384
389 virtual void bounding_box(RowVectorNd &min, RowVectorNd &max) const = 0;
390
395 bool is_spline_compatible(const int el_id) const;
400 bool is_cube(const int el_id) const;
405 bool is_polytope(const int el_id) const;
410 bool is_simplex(const int el_id) const;
411
415 const std::vector<ElementType> &elements_tag() const { return elements_tag_; }
420 void set_tag(const int el, const ElementType type) { elements_tag_[el] = type; }
421
425 void compute_node_ids(const std::function<int(const size_t, const RowVectorNd &, bool)> &marker);
426
430 virtual void load_boundary_ids(const std::string &path);
431
435 virtual void compute_boundary_ids(const std::function<int(const size_t, const std::vector<int> &, const RowVectorNd &, bool)> &marker) = 0;
436
440 virtual void compute_body_ids(const std::function<int(const size_t, const std::vector<int> &, const RowVectorNd &)> &marker) = 0;
441
445 virtual void set_boundary_ids(const std::vector<int> &boundary_ids)
446 {
447 assert(boundary_ids.size() == n_boundary_elements());
448 boundary_ids_ = boundary_ids;
449 }
453 virtual void set_body_ids(const std::vector<int> &body_ids)
454 {
455 assert(body_ids.size() == n_elements());
456 body_ids_ = body_ids;
457 }
458
463 virtual int get_default_boundary_id(const int primitive) const
464 {
465 if (is_volume() ? is_boundary_face(primitive) : is_boundary_edge(primitive))
466 return std::numeric_limits<int>::max(); // default for no selected boundary
467 else
468 return -1; // default for no boundary
469 }
470
475 virtual int get_boundary_id(const int primitive) const
476 {
477 return has_boundary_ids() ? (boundary_ids_.at(primitive)) : get_default_boundary_id(primitive);
478 }
479
484 virtual int get_node_id(const int node_id) const
485 {
486 if (has_node_ids())
487 return node_ids_.at(node_id);
488 else
489 return -1; // default for no boundary
490 }
491
495 void update_nodes(const Eigen::VectorXi &in_node_to_node);
496
501 virtual int get_body_id(const int primitive) const
502 {
503 if (has_body_ids())
504 return body_ids_.at(primitive);
505 else
506 return 0;
507 }
510 virtual const std::vector<int> &get_body_ids() const
511 {
512 return body_ids_;
513 }
517 bool has_node_ids() const { return !node_ids_.empty(); }
521 bool has_boundary_ids() const { return !boundary_ids_.empty(); }
525 virtual bool has_body_ids() const { return !body_ids_.empty(); }
526
531 virtual void get_edges(Eigen::MatrixXd &p0, Eigen::MatrixXd &p1) const = 0;
537 virtual void get_edges(Eigen::MatrixXd &p0, Eigen::MatrixXd &p1, const std::vector<bool> &valid_elements) const = 0;
538
539 // /// @brief generate a triangular representation of every face
540 // ///
541 // /// @param[out] tris triangles connectivity
542 // /// @param[out] pts triangles vertices
543 // /// @param[out] ranges connection to original faces
544 // virtual void triangulate_faces(Eigen::MatrixXi &tris, Eigen::MatrixXd &pts, std::vector<int> &ranges) const = 0;
545
550 const std::vector<double> &cell_weights(const int cell_index) const { return cell_weights_[cell_index]; }
554 void set_cell_weights(const std::vector<std::vector<double>> &in_cell_weights) { cell_weights_ = in_cell_weights; }
555
558 virtual void prepare_mesh() {};
559
563 bool has_poly() const
564 {
565 for (int i = 0; i < n_elements(); ++i)
566 {
567 if (is_polytope(i))
568 return true;
569 }
570
571 return false;
572 }
573
577 bool is_simplicial() const
578 {
579 for (int i = 0; i < n_elements(); ++i)
580 {
581 if (!is_simplex(i))
582 return false;
583 }
584
585 return true;
586 }
587
591 inline bool is_linear() const { return orders_.size() == 0 || orders_.maxCoeff() == 1; }
592
596 std::vector<std::pair<int, int>> edges() const;
600 std::vector<std::vector<int>> faces() const;
601
605 std::unordered_map<std::pair<int, int>, size_t, polyfem::utils::HashPair> edges_to_ids() const;
609 std::unordered_map<std::vector<int>, size_t, polyfem::utils::HashVector> faces_to_ids() const;
610
614 inline const Eigen::VectorXi &in_ordered_vertices() const { return in_ordered_vertices_; }
618 inline const Eigen::MatrixXi &in_ordered_edges() const { return in_ordered_edges_; }
622 inline const Eigen::MatrixXi &in_ordered_faces() const { return in_ordered_faces_; }
623
627 virtual void append(const Mesh &mesh);
628
632 void append(const std::unique_ptr<Mesh> &mesh)
633 {
634 if (mesh != nullptr)
635 append(*mesh);
636 }
637
641 void apply_affine_transformation(const MatrixNd &A, const VectorNd &b);
642
643 protected:
648 virtual bool load(const std::string &path) = 0;
653 virtual bool load(const GEO::Mesh &M) = 0;
654
656 std::vector<ElementType> elements_tag_;
658 std::vector<int> node_ids_;
660 std::vector<int> boundary_ids_;
662 std::vector<int> body_ids_;
664 Eigen::MatrixXi orders_;
666 bool is_rational_ = false;
667
669 std::vector<EdgeNodes> edge_nodes_;
671 std::vector<FaceNodes> face_nodes_;
673 std::vector<CellNodes> cell_nodes_;
675 std::vector<std::vector<double>> cell_weights_;
676
678 Eigen::VectorXi in_ordered_vertices_;
680 Eigen::MatrixXi in_ordered_edges_;
682 Eigen::MatrixXi in_ordered_faces_;
683 };
684 } // namespace mesh
685} // namespace polyfem
int V
Class to store the high-order cells nodes.
Definition Mesh.hpp:61
Eigen::MatrixXd nodes
Definition Mesh.hpp:65
std::vector< int > nodes_ids
Definition Mesh.hpp:64
Class to store the high-order edge nodes.
Definition Mesh.hpp:43
Eigen::MatrixXd nodes
Definition Mesh.hpp:47
std::vector< int > nodes_ids
Definition Mesh.hpp:46
Class to store the high-order face nodes.
Definition Mesh.hpp:52
std::vector< int > nodes_ids
Definition Mesh.hpp:55
Eigen::MatrixXd nodes
Definition Mesh.hpp:56
Abstract mesh class to capture 2d/3d conforming and non-conforming meshes.
Definition Mesh.hpp:39
int n_elements() const
utitlity to return the number of elements, cells or faces in 3d and 2d
Definition Mesh.hpp:161
virtual int n_vertices() const =0
number of vertices
virtual int get_body_id(const int primitive) const
Get the volume selection of an element (cell in 3d, face in 2d)
Definition Mesh.hpp:501
virtual void compute_element_barycenters(Eigen::MatrixXd &barycenters) const =0
utility for 2d/3d.
virtual double edge_length(const int gid) const
edge length
Definition Mesh.hpp:306
void set_cell_weights(const std::vector< std::vector< double > > &in_cell_weights)
Set the cell weights for rational polynomial meshes.
Definition Mesh.hpp:554
const Eigen::MatrixXi & in_ordered_edges() const
Order of the input edges.
Definition Mesh.hpp:618
bool is_polytope(const int el_id) const
checks if element is polygon compatible
Definition Mesh.cpp:365
Eigen::MatrixXi orders_
list of geometry orders, one per cell
Definition Mesh.hpp:664
std::unordered_map< std::pair< int, int >, size_t, polyfem::utils::HashPair > edges_to_ids() const
map from edge (pair of v id) to the id of the edge
Definition Mesh.cpp:459
bool is_rational() const
check if curved mesh has rational polynomials elements
Definition Mesh.hpp:287
Mesh()=default
Construct a new Mesh object.
std::vector< ElementType > elements_tag_
list of element types
Definition Mesh.hpp:656
virtual RowVectorNd edge_barycenter(const int e) const =0
edge barycenter
virtual void get_edges(Eigen::MatrixXd &p0, Eigen::MatrixXd &p1) const =0
Get all the edges.
int element_vertex(const int el_id, const int lv_id) const
id of the vertex of a element
Definition Mesh.hpp:220
bool is_rational_
stores if the mesh is rational
Definition Mesh.hpp:666
bool has_boundary_ids() const
checks if surface selections are available
Definition Mesh.hpp:521
virtual void compute_boundary_ids(const std::function< int(const size_t, const std::vector< int > &, const RowVectorNd &, bool)> &marker)=0
computes boundary selections based on a function
virtual double tri_area(const int gid) const
area of a tri face of a tet mesh
Definition Mesh.hpp:324
void cell_barycenters(Eigen::MatrixXd &barycenters) const
all cells barycenters
Definition Mesh.cpp:320
virtual void get_edges(Eigen::MatrixXd &p0, Eigen::MatrixXd &p1, const std::vector< bool > &valid_elements) const =0
Get all the edges according to valid_elements selection.
bool is_simplicial() const
checks if the mesh is simplicial
Definition Mesh.hpp:577
virtual bool is_conforming() const =0
if the mesh is conforming
virtual void bounding_box(RowVectorNd &min, RowVectorNd &max) const =0
computes the bbox of the mesh
virtual void barycentric_coords(const RowVectorNd &p, const int el_id, Eigen::MatrixXd &coord) const =0
constructs barycentric coodiantes for a point p.
virtual RowVectorNd face_barycenter(const int f) const =0
face barycenter
virtual void update_elements_tag()
Update elements types.
Definition Mesh.hpp:300
Mesh & operator=(const Mesh &)=default
virtual void compute_elements_tag()=0
compute element types, see ElementType
virtual bool build_from_matrices(const Eigen::MatrixXd &V, const Eigen::MatrixXi &F)=0
build a mesh from matrices
virtual void set_point(const int global_index, const RowVectorNd &p)=0
Set the point.
bool is_cube(const int el_id) const
checks if element is cube compatible
Definition Mesh.cpp:352
bool has_node_ids() const
checks if points selections are available
Definition Mesh.hpp:517
virtual void set_body_ids(const std::vector< int > &body_ids)
Set the volume sections.
Definition Mesh.hpp:453
virtual RowVectorNd point(const int global_index) const =0
point coordinates
const Eigen::MatrixXi & orders() const
order of each element
Definition Mesh.hpp:283
virtual bool is_boundary_face(const int face_global_id) const =0
is face boundary
Eigen::MatrixXi in_ordered_faces_
Order of the input faces, TODO: change to std::vector of Eigen::Vector.
Definition Mesh.hpp:682
void compute_node_ids(const std::function< int(const size_t, const RowVectorNd &, bool)> &marker)
computes boundary selections based on a function
Definition Mesh.cpp:387
virtual int get_boundary_id(const int primitive) const
Get the boundary selection of an element (face in 3d, edge in 2d)
Definition Mesh.hpp:475
virtual bool is_boundary_vertex(const int vertex_global_id) const =0
is vertex boundary
bool is_simplex(const int el_id) const
checks if element is simples compatible
Definition Mesh.cpp:422
void face_barycenters(Eigen::MatrixXd &barycenters) const
all face barycenters
Definition Mesh.cpp:311
virtual double quad_area(const int gid) const
area of a quad face of an hex mesh
Definition Mesh.hpp:315
virtual bool has_body_ids() const
checks if volumes selections are available
Definition Mesh.hpp:525
virtual void normalize()=0
normalize the mesh
bool is_spline_compatible(const int el_id) const
checks if element is spline compatible
Definition Mesh.cpp:332
virtual void prepare_mesh()
method used to finalize the mesh.
Definition Mesh.hpp:558
virtual void load_boundary_ids(const std::string &path)
loads the boundary selections for a file
Definition Mesh.cpp:399
void set_is_rational(const bool in_is_rational)
Set the is rational object.
Definition Mesh.hpp:291
Mesh & operator=(Mesh &&)=default
Copy constructor.
std::vector< int > boundary_ids_
list of surface labels
Definition Mesh.hpp:660
bool is_linear() const
check if the mesh is linear
Definition Mesh.hpp:591
void apply_affine_transformation(const MatrixNd &A, const VectorNd &b)
Apply an affine transformation to the vertex positions .
Definition Mesh.cpp:632
std::vector< int > node_ids_
list of node labels
Definition Mesh.hpp:658
std::unordered_map< std::vector< int >, size_t, polyfem::utils::HashVector > faces_to_ids() const
map from face (tuple of v id) to the id of the face
Definition Mesh.cpp:475
virtual void refine(const int n_refinement, const double t)=0
refine the mesh
std::vector< CellNodes > cell_nodes_
high-order nodes associates to cells
Definition Mesh.hpp:673
std::vector< std::vector< double > > cell_weights_
weights associates to cells for rational polynomail meshes
Definition Mesh.hpp:675
const std::vector< double > & cell_weights(const int cell_index) const
weights for rational polynomial meshes
Definition Mesh.hpp:550
virtual bool load(const GEO::Mesh &M)=0
loads a mesh from a geo mesh
virtual bool is_volume() const =0
checks if mesh is volume
std::vector< std::pair< int, int > > edges() const
list of sorted edges.
Definition Mesh.cpp:427
void update_nodes(const Eigen::VectorXi &in_node_to_node)
Update the node ids to reorder them.
Definition Mesh.cpp:371
virtual int edge_vertex(const int e_id, const int lv_id) const =0
id of the edge vertex
virtual std::unique_ptr< Mesh > copy() const =0
Create a copy of the mesh.
void append(const std::unique_ptr< Mesh > &mesh)
appends a new mesh to the end of this, utility that takes pointer, calls other one
Definition Mesh.hpp:632
virtual bool is_boundary_edge(const int edge_global_id) const =0
is edge boundary
bool has_poly() const
checks if the mesh has polytopes
Definition Mesh.hpp:563
std::vector< int > element_vertices(const int el_id) const
list of vids of an element
Definition Mesh.hpp:229
const Eigen::VectorXi & in_ordered_vertices() const
Order of the input vertices.
Definition Mesh.hpp:614
std::vector< int > body_ids_
list of volume labels
Definition Mesh.hpp:662
static std::unique_ptr< Mesh > create(const std::string &path, const bool non_conforming=false)
factory to build the proper mesh
Definition Mesh.cpp:173
virtual int get_default_boundary_id(const int primitive) const
Get the default boundary selection of an element (face in 3d, edge in 2d)
Definition Mesh.hpp:463
int dimension() const
utily for dimension
Definition Mesh.hpp:151
virtual int n_cells() const =0
number of cells
virtual const std::vector< int > & get_body_ids() const
Get the volume selection of all elements (cells in 3d, faces in 2d)
Definition Mesh.hpp:510
std::vector< FaceNodes > face_nodes_
high-order nodes associates to faces
Definition Mesh.hpp:671
virtual bool load(const std::string &path)=0
loads a mesh from the path
virtual int n_faces() const =0
number of faces
const std::vector< ElementType > & elements_tag() const
Returns the elements types.
Definition Mesh.hpp:415
std::vector< EdgeNodes > edge_nodes_
high-order nodes associates to edges
Definition Mesh.hpp:669
std::vector< std::vector< int > > faces() const
list of sorted faces.
Definition Mesh.cpp:443
virtual void attach_higher_order_nodes(const Eigen::MatrixXd &V, const std::vector< std::vector< int > > &nodes)=0
attach high order nodes
int n_boundary_elements() const
utitlity to return the number of boundary elements, faces or edges in 3d and 2d
Definition Mesh.hpp:166
Eigen::MatrixXi in_ordered_edges_
Order of the input edges.
Definition Mesh.hpp:680
void set_tag(const int el, const ElementType type)
changes the element type
Definition Mesh.hpp:420
virtual void append(const Mesh &mesh)
appends a new mesh to the end of this
Definition Mesh.cpp:494
Mesh(Mesh &&)=default
Construct a new Mesh object.
virtual bool save(const std::string &path) const =0
virtual RowVectorNd cell_barycenter(const int c) const =0
cell barycenter
const Eigen::MatrixXi & in_ordered_faces() const
Order of the input edges.
Definition Mesh.hpp:622
virtual int n_edges() const =0
number of edges
virtual void set_boundary_ids(const std::vector< int > &boundary_ids)
Set the boundary selection from a vector.
Definition Mesh.hpp:445
virtual void compute_body_ids(const std::function< int(const size_t, const std::vector< int > &, const RowVectorNd &)> &marker)=0
computes boundary selections based on a function
void edge_barycenters(Eigen::MatrixXd &barycenters) const
all edges barycenters
Definition Mesh.cpp:302
virtual int cell_vertex(const int f_id, const int lv_id) const =0
id of the vertex of a cell
virtual int n_face_vertices(const int f_id) const =0
number of vertices of a face
virtual void elements_boxes(std::vector< std::array< Eigen::Vector3d, 2 > > &boxes) const =0
constructs a box around every element (3d cell, 2d face)
Eigen::VectorXi in_ordered_vertices_
Order of the input vertices.
Definition Mesh.hpp:678
virtual bool is_boundary_element(const int element_global_id) const =0
is cell boundary
virtual int n_cell_vertices(const int c_id) const =0
number of vertices of a cell
virtual int get_node_id(const int node_id) const
Get the boundary selection of a node.
Definition Mesh.hpp:484
virtual ~Mesh()=default
Destroy the Mesh object.
virtual int face_vertex(const int f_id, const int lv_id) const =0
id of the face vertex
Mesh(const Mesh &)=default
Construct a new Mesh object.
int boundary_element_vertex(const int primitive_id, const int lv_id) const
Definition Mesh.hpp:238
ElementType
Type of Element, check [Poly-Spline Finite Element Method] for a complete description.
Definition Mesh.hpp:23
@ REGULAR_INTERIOR_CUBE
Triangle/tet element.
@ UNDEFINED
Boundary polytope.
@ REGULAR_BOUNDARY_CUBE
Quad/Hex incident to more than 1 singular vertices (should not happen in 2D)
@ MULTI_SINGULAR_BOUNDARY_CUBE
Quad incident to exactly 1 singular vertex (in 2D); hex incident to exactly 1 singular interior edge,...
@ MULTI_SINGULAR_INTERIOR_CUBE
Quad/hex incident to exactly 1 singular vertex (in 2D) or edge (in 3D)
@ SIMPLE_SINGULAR_INTERIOR_CUBE
Regular quad/hex inside a 3^n patch.
@ INTERFACE_CUBE
Boundary hex that is not regular nor SimpleSingularBoundaryCube.
@ INTERIOR_POLYTOPE
Quad/hex that is at the interface with a polytope (if a cube has both external boundary and and inter...
@ SIMPLE_SINGULAR_BOUNDARY_CUBE
Boundary quad/hex, where all boundary vertices/edges are incident to at most 2 quads/hexes.
@ BOUNDARY_POLYTOPE
Interior polytope.
Eigen::Matrix< double, Eigen::Dynamic, 1, 0, 3, 1 > VectorNd
Definition Types.hpp:11
Eigen::Matrix< double, Eigen::Dynamic, Eigen::Dynamic, Eigen::ColMajor, 3, 3 > MatrixNd
Definition Types.hpp:14
Eigen::Matrix< double, 1, Eigen::Dynamic, Eigen::RowMajor, 1, 3 > RowVectorNd
Definition Types.hpp:13