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 {
37
39 class Mesh
40 {
41 protected:
44 {
45 public:
46 int v1, v2;
47 std::vector<int> nodes_ids;
48 Eigen::MatrixXd nodes;
49 };
50
53 {
54 public:
55 int v1, v2, v3;
56 std::vector<int> nodes_ids;
57 Eigen::MatrixXd nodes;
58 };
59
62 {
63 public:
64 int v1, v2, v3, v4;
65 std::vector<int> nodes_ids;
66 Eigen::MatrixXd nodes;
67 };
68
69 public:
76 static std::unique_ptr<Mesh> create(const std::string &path, const bool non_conforming = false);
77
84 static std::unique_ptr<Mesh> create(GEO::Mesh &M, const bool non_conforming = false);
85
93 static std::unique_ptr<Mesh> create(const Eigen::MatrixXd &vertices, const Eigen::MatrixXi &cells, const bool non_conforming = false);
94
101 static std::unique_ptr<Mesh> create(const int dim, const bool non_conforming = false);
102
105 virtual std::unique_ptr<Mesh> copy() const = 0;
106
107 protected:
111 Mesh() = default;
112
113 public:
116 virtual ~Mesh() = default;
120 Mesh(Mesh &&) = default;
125 Mesh &operator=(Mesh &&) = default;
129 Mesh(const Mesh &) = default;
134 Mesh &operator=(const Mesh &) = default;
135
141 virtual void refine(const int n_refinement, const double t) = 0;
142
147 virtual bool is_volume() const = 0;
152 int dimension() const { return (is_volume() ? 3 : 2); }
157 virtual bool is_conforming() const = 0;
162 int n_elements() const { return (is_volume() ? n_cells() : n_faces()); }
167 int n_boundary_elements() const { return (is_volume() ? n_faces() : n_edges()); }
168
173 virtual int n_cells() const = 0;
178 virtual int n_faces() const = 0;
182 virtual int n_edges() const = 0;
186 virtual int n_vertices() const = 0;
187
192 virtual int n_face_vertices(const int f_id) const = 0;
197 virtual int n_cell_vertices(const int c_id) const = 0;
203 virtual int edge_vertex(const int e_id, const int lv_id) const = 0;
209 virtual int face_vertex(const int f_id, const int lv_id) const = 0;
215 virtual int cell_vertex(const int f_id, const int lv_id) const = 0;
221 int element_vertex(const int el_id, const int lv_id) const
222 {
223 return (is_volume() ? cell_vertex(el_id, lv_id) : face_vertex(el_id, lv_id));
224 }
225
230 std::vector<int> element_vertices(const int el_id) const
231 {
232 std::vector<int> res;
233 for (int i = 0; i < n_cell_vertices(el_id); ++i)
234 res.push_back(element_vertex(el_id, i));
235 std::sort(res.begin(), res.end());
236 return res;
237 }
238
239 int boundary_element_vertex(const int primitive_id, const int lv_id) const
240 {
241 return (is_volume() ? face_vertex(primitive_id, lv_id) : edge_vertex(primitive_id, lv_id));
242 }
243
248 virtual bool is_boundary_vertex(const int vertex_global_id) const = 0;
253 virtual bool is_boundary_edge(const int edge_global_id) const = 0;
258 virtual bool is_boundary_face(const int face_global_id) const = 0;
263 virtual bool is_boundary_element(const int element_global_id) const = 0;
264
265 virtual bool save(const std::string &path) const = 0;
266
267 private:
273 virtual bool build_from_matrices(const Eigen::MatrixXd &V, const Eigen::MatrixXi &F) = 0;
274
275 public:
280 virtual void attach_higher_order_nodes(const Eigen::MatrixXd &V, const std::vector<std::vector<int>> &nodes) = 0;
284 inline const Eigen::MatrixXi &orders() const { return orders_; }
288 inline bool is_rational() const { return is_rational_; }
292 inline void set_is_rational(const bool in_is_rational) { is_rational_ = in_is_rational; }
293
296 virtual void normalize() = 0;
297
299 virtual void compute_elements_tag() = 0;
301 virtual void update_elements_tag() { assert(false); }
302
307 virtual double edge_length(const int gid) const
308 {
309 assert(false);
310 return 0;
311 }
316 virtual double quad_area(const int gid) const
317 {
318 assert(false);
319 return 0;
320 }
325 virtual double tri_area(const int gid) const
326 {
327 assert(false);
328 return 0;
329 }
330
335 virtual RowVectorNd point(const int global_index) const = 0;
340 virtual void set_point(const int global_index, const RowVectorNd &p) = 0;
341
346 virtual RowVectorNd edge_barycenter(const int e) const = 0;
351 virtual RowVectorNd face_barycenter(const int f) const = 0;
356 virtual RowVectorNd cell_barycenter(const int c) const = 0;
357
361 void edge_barycenters(Eigen::MatrixXd &barycenters) const;
365 void face_barycenters(Eigen::MatrixXd &barycenters) const;
369 void cell_barycenters(Eigen::MatrixXd &barycenters) const;
373 virtual void compute_element_barycenters(Eigen::MatrixXd &barycenters) const = 0;
374
378 virtual void elements_boxes(std::vector<std::array<Eigen::Vector3d, 2>> &boxes) const = 0;
384 virtual void barycentric_coords(const RowVectorNd &p, const int el_id, Eigen::MatrixXd &coord) const = 0;
385
390 virtual void bounding_box(RowVectorNd &min, RowVectorNd &max) const = 0;
391
396 bool is_spline_compatible(const int el_id) const;
401 bool is_cube(const int el_id) const;
406 bool is_polytope(const int el_id) const;
411 bool is_simplex(const int el_id) const;
416 bool is_prism(const int el_id) const;
417
421 const std::vector<ElementType> &elements_tag() const { return elements_tag_; }
426 void set_tag(const int el, const ElementType type) { elements_tag_[el] = type; }
427
431 void compute_node_ids(const std::function<int(const size_t, const RowVectorNd &, bool)> &marker);
432
436 virtual void load_boundary_ids(const std::string &path);
437
441 virtual void compute_boundary_ids(const std::function<int(const size_t, const std::vector<int> &, const RowVectorNd &, bool)> &marker) = 0;
442
446 virtual void compute_body_ids(const std::function<int(const size_t, const std::vector<int> &, const RowVectorNd &)> &marker) = 0;
447
451 virtual void set_boundary_ids(const std::vector<int> &boundary_ids)
452 {
453 assert(boundary_ids.size() == n_boundary_elements());
454 boundary_ids_ = boundary_ids;
455 }
459 virtual void set_body_ids(const std::vector<int> &body_ids)
460 {
461 assert(body_ids.size() == n_elements());
462 body_ids_ = body_ids;
463 }
464
469 virtual int get_default_boundary_id(const int primitive) const
470 {
471 if (is_volume() ? is_boundary_face(primitive) : is_boundary_edge(primitive))
472 return std::numeric_limits<int>::max(); // default for no selected boundary
473 else
474 return -1; // default for no boundary
475 }
476
481 virtual int get_boundary_id(const int primitive) const
482 {
483 return has_boundary_ids() ? (boundary_ids_.at(primitive)) : get_default_boundary_id(primitive);
484 }
485
490 virtual int get_node_id(const int node_id) const
491 {
492 if (has_node_ids())
493 return node_ids_.at(node_id);
494 else
495 return -1; // default for no boundary
496 }
497
501 void update_nodes(const Eigen::VectorXi &in_node_to_node);
502
507 virtual int get_body_id(const int primitive) const
508 {
509 if (has_body_ids())
510 return body_ids_.at(primitive);
511 else
512 return 0;
513 }
516 virtual const std::vector<int> &get_body_ids() const
517 {
518 return body_ids_;
519 }
523 bool has_node_ids() const { return !node_ids_.empty(); }
527 bool has_boundary_ids() const { return !boundary_ids_.empty(); }
531 virtual bool has_body_ids() const { return !body_ids_.empty(); }
532
537 virtual void get_edges(Eigen::MatrixXd &p0, Eigen::MatrixXd &p1) const = 0;
543 virtual void get_edges(Eigen::MatrixXd &p0, Eigen::MatrixXd &p1, const std::vector<bool> &valid_elements) const = 0;
544
545 // /// @brief generate a triangular representation of every face
546 // ///
547 // /// @param[out] tris triangles connectivity
548 // /// @param[out] pts triangles vertices
549 // /// @param[out] ranges connection to original faces
550 // virtual void triangulate_faces(Eigen::MatrixXi &tris, Eigen::MatrixXd &pts, std::vector<int> &ranges) const = 0;
551
556 const std::vector<double> &cell_weights(const int cell_index) const { return cell_weights_[cell_index]; }
560 void set_cell_weights(const std::vector<std::vector<double>> &in_cell_weights) { cell_weights_ = in_cell_weights; }
561
564 virtual void prepare_mesh() {};
565
569 bool has_poly() const
570 {
571 for (int i = 0; i < n_elements(); ++i)
572 {
573 if (is_polytope(i))
574 return true;
575 }
576
577 return false;
578 }
579
583 bool has_prism() const
584 {
585 for (int i = 0; i < n_elements(); ++i)
586 {
587 if (is_prism(i))
588 return true;
589 }
590
591 return false;
592 }
593
597 bool is_simplicial() const
598 {
599 for (int i = 0; i < n_elements(); ++i)
600 {
601 if (!is_simplex(i))
602 return false;
603 }
604
605 return true;
606 }
607
611 inline bool is_linear() const { return orders_.size() == 0 || orders_.maxCoeff() == 1; }
612
616 std::vector<std::pair<int, int>> edges() const;
620 std::vector<std::vector<int>> faces() const;
621
625 std::unordered_map<std::pair<int, int>, size_t, polyfem::utils::HashPair> edges_to_ids() const;
629 std::unordered_map<std::vector<int>, size_t, polyfem::utils::HashVector> faces_to_ids() const;
630
634 inline const Eigen::VectorXi &in_ordered_vertices() const { return in_ordered_vertices_; }
638 inline const Eigen::MatrixXi &in_ordered_edges() const { return in_ordered_edges_; }
642 inline const Eigen::MatrixXi &in_ordered_faces() const { return in_ordered_faces_; }
643
647 virtual void append(const Mesh &mesh);
648
652 void append(const std::unique_ptr<Mesh> &mesh)
653 {
654 if (mesh != nullptr)
655 append(*mesh);
656 }
657
661 void apply_affine_transformation(const MatrixNd &A, const VectorNd &b);
662
663 protected:
668 virtual bool load(const std::string &path) = 0;
673 virtual bool load(const GEO::Mesh &M) = 0;
674
676 std::vector<ElementType> elements_tag_;
678 std::vector<int> node_ids_;
680 std::vector<int> boundary_ids_;
682 std::vector<int> body_ids_;
684 Eigen::MatrixXi orders_;
686 bool is_rational_ = false;
687
689 std::vector<EdgeNodes> edge_nodes_;
691 std::vector<FaceNodes> face_nodes_;
693 std::vector<CellNodes> cell_nodes_;
695 std::vector<std::vector<double>> cell_weights_;
696
698 Eigen::VectorXi in_ordered_vertices_;
700 Eigen::MatrixXi in_ordered_edges_;
702 Eigen::MatrixXi in_ordered_faces_;
703 };
704 } // namespace mesh
705} // namespace polyfem
int V
Class to store the high-order cells nodes.
Definition Mesh.hpp:62
Eigen::MatrixXd nodes
Definition Mesh.hpp:66
std::vector< int > nodes_ids
Definition Mesh.hpp:65
Class to store the high-order edge nodes.
Definition Mesh.hpp:44
Eigen::MatrixXd nodes
Definition Mesh.hpp:48
std::vector< int > nodes_ids
Definition Mesh.hpp:47
Class to store the high-order face nodes.
Definition Mesh.hpp:53
std::vector< int > nodes_ids
Definition Mesh.hpp:56
Eigen::MatrixXd nodes
Definition Mesh.hpp:57
Abstract mesh class to capture 2d/3d conforming and non-conforming meshes.
Definition Mesh.hpp:40
int n_elements() const
utitlity to return the number of elements, cells or faces in 3d and 2d
Definition Mesh.hpp:162
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:507
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:307
void set_cell_weights(const std::vector< std::vector< double > > &in_cell_weights)
Set the cell weights for rational polynomial meshes.
Definition Mesh.hpp:560
const Eigen::MatrixXi & in_ordered_edges() const
Order of the input edges.
Definition Mesh.hpp:638
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:684
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:464
bool is_rational() const
check if curved mesh has rational polynomials elements
Definition Mesh.hpp:288
Mesh()=default
Construct a new Mesh object.
std::vector< ElementType > elements_tag_
list of element types
Definition Mesh.hpp:676
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:221
bool is_rational_
stores if the mesh is rational
Definition Mesh.hpp:686
bool has_boundary_ids() const
checks if surface selections are available
Definition Mesh.hpp:527
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:325
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:597
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:301
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:523
virtual void set_body_ids(const std::vector< int > &body_ids)
Set the volume sections.
Definition Mesh.hpp:459
virtual RowVectorNd point(const int global_index) const =0
point coordinates
const Eigen::MatrixXi & orders() const
order of each element
Definition Mesh.hpp:284
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:702
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:481
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 simplex
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:316
virtual bool has_body_ids() const
checks if volumes selections are available
Definition Mesh.hpp:531
bool has_prism() const
checks if the mesh has prisms
Definition Mesh.hpp:583
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:564
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:292
Mesh & operator=(Mesh &&)=default
Copy constructor.
std::vector< int > boundary_ids_
list of surface labels
Definition Mesh.hpp:680
bool is_prism(const int el_id) const
checks if element is a prism
Definition Mesh.cpp:427
bool is_linear() const
check if the mesh is linear
Definition Mesh.hpp:611
void apply_affine_transformation(const MatrixNd &A, const VectorNd &b)
Apply an affine transformation to the vertex positions .
Definition Mesh.cpp:637
std::vector< int > node_ids_
list of node labels
Definition Mesh.hpp:678
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:480
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:693
std::vector< std::vector< double > > cell_weights_
weights associates to cells for rational polynomail meshes
Definition Mesh.hpp:695
const std::vector< double > & cell_weights(const int cell_index) const
weights for rational polynomial meshes
Definition Mesh.hpp:556
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:432
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:652
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:569
std::vector< int > element_vertices(const int el_id) const
list of vids of an element
Definition Mesh.hpp:230
const Eigen::VectorXi & in_ordered_vertices() const
Order of the input vertices.
Definition Mesh.hpp:634
std::vector< int > body_ids_
list of volume labels
Definition Mesh.hpp:682
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:469
int dimension() const
utily for dimension
Definition Mesh.hpp:152
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:516
std::vector< FaceNodes > face_nodes_
high-order nodes associates to faces
Definition Mesh.hpp:691
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:421
std::vector< EdgeNodes > edge_nodes_
high-order nodes associates to edges
Definition Mesh.hpp:689
std::vector< std::vector< int > > faces() const
list of sorted faces.
Definition Mesh.cpp:448
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:167
Eigen::MatrixXi in_ordered_edges_
Order of the input edges.
Definition Mesh.hpp:700
void set_tag(const int el, const ElementType type)
changes the element type
Definition Mesh.hpp:426
virtual void append(const Mesh &mesh)
appends a new mesh to the end of this
Definition Mesh.cpp:499
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:642
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:451
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:698
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:490
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:239
ElementType
Type of Element, check [Poly-Spline Finite Element Method] for a complete description.
Definition Mesh.hpp:23
@ REGULAR_INTERIOR_CUBE
Triangle/tet element.
@ 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