►NGudhi | |
►Nalpha_complex | |
CAlpha_complex | Alpha complex data structure |
CAlpha_complex_3d | Alpha complex data structure for 3d specific case |
CAlpha_kernel_d | Alpha complex kernel container |
CSimplicialComplexForAlpha | The concept SimplicialComplexForAlpha describes the requirements for a type to implement a simplicial complex, that can be created from a Alpha_complex |
CSimplicialComplexForAlpha3d | The concept SimplicialComplexForAlpha3d describes the requirements for a type to implement a simplicial complex, that can be created from a Alpha_complex_3d |
►Ncech_complex | |
CCech_complex | Cech complex class |
CSimplicialComplexForCech | The concept SimplicialComplexForCech describes the requirements for a type to implement a simplicial complex, that can be created from a Cech_complex |
►Ncontraction | |
CContraction_visitor | Interface for a visitor of the edge contraction process |
CContraction_visitor_remove_popable | Visitor to remove popable blockers after an edge contraction |
CCost_policy | Policy to specify the cost of contracting an edge |
CDummy_valid_contraction | Policy that accept all edge contraction |
CEdge_length_cost | Return a cost corresponding to the squared length of the edge |
CFirst_vertex_placement | Places the contracted point onto the first point of the edge |
CLink_condition_valid_contraction | Policy that only accept edges verifying the link condition (and therefore whose contraction preserving homotopy type) |
CPlacement_policy | Policy to specify where the merged point had to be placed after an edge contraction |
CSkeleton_blocker_contractor | Class that allows to contract iteratively edges of a simplicial complex |
CValid_contraction_policy | Policy to specify if an edge contraction is valid or not |
►Ncover_complex | |
CCover_complex | Cover complex data structure |
►Ncoxeter_triangulation | |
CCartesian_product | Constructs the function the zero-set of which is the Cartesian product of the zero-sets of some given functions |
CCell_complex | A class that constructs the cell complex from the output provided by the class Gudhi::coxeter_triangulation::Manifold_tracing |
CCoface_iterator | Iterator over the k-cofaces of a simplex given by its permutahedral representation |
CCombination_iterator | Class that allows the user to generate combinations of k elements in a set of n elements. Based on the algorithm by Mifsud |
CConstant_function | A class that encodes a constant function from R^d to R^k. This class does not have any implicit manifold in correspondence |
CCoxeter_triangulation | A class that stores Coxeter triangulation of type \(\tilde{A}_d\). This triangulation has the greatest simplex quality out of all linear transformations of the Freudenthal-Kuhn triangulation |
CEmbed_in_Rd | Embedding of an implicit manifold in a higher dimension |
CFace_iterator | Iterator over the k-faces of a simplex given by its permutahedral representation |
CFreudenthal_triangulation | A class that stores any affine transformation of the Freudenthal-Kuhn triangulation |
CFunction_affine_plane_in_Rd | A class for the function that defines an m-dimensional implicit affine plane embedded in d-dimensional Euclidean space |
CFunction_chair_in_R3 | A class that encodes the function, the zero-set of which is a so-called "chair" surface embedded in R^3 |
CFunction_iron_in_R3 | A class that encodes the function, the zero-set of which is a surface embedded in R^3 that ressembles an iron |
CFunction_lemniscate_revolution_in_R3 | A class that encodes the function, the zero-set of which is a surface of revolution around the x axis based on the lemniscate of Bernoulli embedded in R^3 |
CFunction_moment_curve_in_Rd | A class for the function that defines an implicit moment curve in the d-dimensional Euclidean space |
CFunction_Sm_in_Rd | A class for the function that defines an m-dimensional implicit sphere embedded in the d-dimensional Euclidean space |
CFunction_torus_in_R3 | A class that encodes the function, the zero-set of which is a torus surface embedded in R^3 |
CFunction_whitney_umbrella_in_R3 | A class that encodes the function, the zero-set of which is the Whitney umbrella surface embedded in R^3 |
CFunctionForImplicitManifold | The concept FunctionForImplicitManifold describes the requirements for a type to implement an implicit function class used for example in Manifold_tracing |
CImplicit_manifold_intersection_oracle | An oracle that supports the intersection query on an implicit manifold |
CInteger_combination_iterator | Class that allows the user to generate combinations of k elements in a set of n elements. Based on the algorithm by Mifsud |
CIntersectionOracle | The concept IntersectionOracle describes the requirements for a type to implement an intersection oracle class used for example in Manifold_tracing |
CLinear_transformation | Transforms the zero-set of the function by a given linear transformation. The underlying function corresponds to f(M*x), where M is the transformation matrix |
CManifold_tracing | A class that assembles methods for manifold tracing algorithm |
CMesh_medit | Structure to store a mesh that can be output in Medit .mesh file format using the output_meshes_to_medit method |
CNegation | Constructs the "minus" function. The zero-set is the same, but the values at other points are the negative of their original value |
COrdered_set_partition | Class that represents an ordered set partition of a set {0,...,n-1} in k parts as a pair of an unordered set partition given in lexicographic order and a permutation of the parts |
COrdered_set_partition_iterator | Class that allows the user to generate set partitions of a set {0,...,n-1} in k parts |
CPermutahedral_representation | A class that stores the permutahedral representation of a simplex in a Coxeter triangulation or a Freudenthal-Kuhn triangulation |
CPermutation_iterator | Class that allows the user to generate permutations. Based on the optimization of the Heap's algorithm by Sedgewick |
CPL_approximation | Constructs a piecewise-linear approximation of a function induced by an ambient triangulation |
CQuery_result | The result of a query by an oracle such as Implicit_manifold_intersection_oracle |
CSet_partition_iterator | Class that allows the user to generate set partitions of a set {0,...,n-1} in k parts |
CSimplex_comparator | A comparator class for Permutahedral_representation. The comparison is in lexicographic order first on vertices and then on ordered partitions with sorted parts. The lexicographic order forces that any face is larger than a coface |
CSimplexInCoxeterTriangulation | The concept SimplexInCoxeterTriangulation describes the requirements for a type to implement a representation of simplices in Freudenthal_triangulation or in Coxeter_triangulation |
CSize_iterator | Auxiliary iterator class for sizes of parts in an ordered set partition |
CTranslate | Translates the zero-set of the function by a vector. The underlying function corresponds to f(x-off), where off is the offset vector |
CTriangulationForManifoldTracing | The concept TriangulationForManifoldTracing describes the requirements for a type to implement a triangulation class used for example in Manifold_tracing |
CVertex_iterator | Iterator over the vertices of a simplex represented by its permutahedral representation |
►Ncubical_complex | |
►CBitmap_cubical_complex | Cubical complex represented as a bitmap |
CFiltration_simplex_range | Filtration_simplex_range provides the ranges for Filtration_simplex_iterator |
CSkeleton_simplex_range | Class needed for compatibility with Gudhi. Not useful for other purposes |
►CBitmap_cubical_complex_base | Cubical complex represented as a bitmap, class with basic implementation |
CAll_cells_iterator | Iterator through all cells in the complex (in order they appear in the structure – i.e. in lexicographical order) |
CAll_cells_range | All_cells_range class provides ranges for All_cells_iterator |
CTop_dimensional_cells_iterator | Iterator through top dimensional cells of the complex. The cells appear in order they are stored in the structure (i.e. in lexicographical order) |
CTop_dimensional_cells_range | Top_dimensional_cells_iterator_range class provides ranges for Top_dimensional_cells_iterator_range |
CBitmap_cubical_complex_periodic_boundary_conditions_base | Cubical complex with periodic boundary conditions represented as a bitmap |
Ccounter | This is an implementation of a counter being a vector of integers |
►NHasse_diagram | |
CHasse_diagram_cell | Data structure to store a cell in a Hasse diagram |
►Npersistence_diagram | |
CDiagramPoint | Concept of point in a persistence diagram. std::get<0>(point) must return the birth of the corresponding component and std::get<1>(point) its death. Both should be convertible to double . A valid implementation of this concept is std::pair<double,double>. Death should be larger than birth, death can be std::numeric_limits<double>::infinity() for components which stay alive |
CPersistenceDiagram | Concept of persistence diagram. It is a range of DiagramPoint . std::begin(diagram) and std::end(diagram) must return corresponding iterators |
►NPersistence_representations | |
Carc_tan_of_persistence_of_point | |
Cconstant_scaling_function | |
Cdistance_from_diagonal_scaling | |
CPersistence_heat_maps | A class implementing persistence heat maps |
CPersistence_intervals | |
CPersistence_landscape | A class implementing persistence landscapes data structures |
CPersistence_landscape_on_grid | A class implementing persistence landscapes by approximating them on a collection of grid points |
CPSSK | |
CReal_valued_topological_data | The concept Real_valued_topological_data describes the requirements for a type to implement a container that allows computations of its projections to R |
CSliced_Wasserstein | A class implementing the Sliced Wasserstein kernel |
Csquared_distance_from_diagonal_scaling | |
CTopological_data_with_averages | The concept Topological_data_with_averages describes the requirements for a type to implement a container that allows computations of averages. Note that the average object after being computed is stored in *this |
CTopological_data_with_distances | The concept Topological_data_with_distances describes the requirements for a type to implement a container that allows computations of distance to another contained of that type |
CTopological_data_with_scalar_product | The concept Topological_data_with_scalar_product describes the requirements for a type to implement a container that allows computations of scalar products |
CVector_distances_in_diagram | A class implementing persistence vectors |
CVectorized_topological_data | The concept Vectorized_topological_data describes the requirements for a type to implement a container that allows vectorization |
Cweight_by_setting_maximal_interval_to_have_length_one | |
►Npersistent_cohomology | |
CField_Zp | Structure representing the coefficient field \(\mathbb{Z}/p\mathbb{Z}\) |
CMulti_field | Structure representing coefficients in a set of finite fields simultaneously using the chinese remainder theorem |
CPersistent_cohomology | Computes the persistent cohomology of a filtered complex |
►Nrips_complex | |
CRips_complex | Rips complex data structure |
CSimplicialComplexForRips | The concept SimplicialComplexForRips describes the requirements for a type to implement a simplicial complex, that can be created from a Rips_complex . The only available model for the moment is the Simplex_tree |
CSparse_rips_complex | Sparse Rips complex data structure |
►Nskeleton_blocker | |
CBlocker_iterator_around_vertex_internal | Iterator through the blockers of a vertex |
CBlocker_iterator_internal | Iterator through the blockers of a vertex |
CDummy_complex_visitor | A dummy visitor of a simplicial complex that does nothing |
CEdge_iterator | Iterator on the edges of a simplicial complex |
CPrint_complex_visitor | A visitor that prints the visit information |
CSimplex_around_vertex_iterator | |
CSimplex_coboundary_iterator | |
CSkeleton_blocker_complex | Abstract Simplicial Complex represented with a skeleton/blockers pair |
CSkeleton_blocker_complex_visitor | Interface for a visitor of a simplicial complex |
CSkeleton_blocker_geometric_complex | Class that represents a geometric complex that can be simplified. The class allows access to points of vertices |
CSkeleton_blocker_link_complex | Class representing the link of a simplicial complex encoded by a skeleton/blockers pair. It inherits from Skeleton_blocker_sub_complex because such complex is a sub complex of a root complex |
CSkeleton_blocker_link_superior | Class representing the link of a simplicial complex encoded by a skeleton/blockers pair. It computes only vertices greater than the simplex used to build the link |
CSkeleton_blocker_off_flag_visitor_reader | Off reader visitor that can be passed to Off_reader to read a Skeleton_blocker_complex |
CSkeleton_blocker_off_reader | Class that allows to load a Skeleton_blocker_complex from an off file |
CSkeleton_blocker_off_visitor_reader | Off reader visitor that can be passed to Off_reader to read a Skeleton_blocker_complex |
►CSkeleton_blocker_simple_geometric_traits | Simple traits that is a model of SkeletonBlockerGeometricDS and can be passed as a template argument to Skeleton_blocker_geometric_complex |
CSimple_geometric_vertex | Vertex with a point attached |
►CSkeleton_blocker_simple_traits | Simple traits that is a model of SkeletonBlockerDS and can be passed as a template argument to Skeleton_blocker_complex |
CRoot_vertex_handle | Global and local handle similar to boost subgraphs. Vertices are stored in a vector. For the root simplicial complex, the local and global descriptors are the same. For a subcomplex L and one of its vertices 'v', the local descriptor of 'v' is its position in the vertex vector of the subcomplex L whereas its global descriptor is the position of 'v' in the vertex vector of the root simplicial complex |
CSkeleton_blocker_simplex | Abstract simplex used in Skeleton blockers data-structure |
CSkeleton_blocker_sub_complex | Simplicial subcomplex of a complex represented by a skeleton/blockers pair |
►CSkeletonBlockerDS | Concept for the template class passed for Skeleton_blocker_complex. Most importantly, it contains the nodes for vertices and edges (Graph_vertex and Graph_edge) that are stored in the simplicial complex. The user can redefine these classes to attach additional information to vertices and edges |
CGraph_edge | The type of edges that are stored the boost graph. An Edge must be Default Constructible and Equality Comparable |
CGraph_vertex | The type of vertices that are stored the boost graph. A Vertex must be Default Constructible and Equality Comparable |
CRoot_vertex_handle | Root_vertex_handle and Vertex_handle are similar to global and local vertex descriptor used in boost subgraphs and allow to localize a vertex of a subcomplex on its parent root complex |
CVertex_handle | |
►CSkeletonBlockerGeometricDS | Concept for template class of Skeleton_blocker_geometric_complex . It must specify a GeometryTrait which contains a Point definition |
CGraph_Edge | Edge that allows to access to an index. The indices of the edges are used to store heap information in the edge contraction algorithm |
CGraph_vertex | Vertex that stores a point |
CTriangle_around_vertex_iterator | Iterator over the triangles that are adjacent to a vertex of the simplicial complex |
CTriangle_iterator | Iterator over the triangles of the simplicial complex |
CVertex_iterator | Iterator on the vertices of a simplicial complex |
►Nspatial_searching | |
CKd_tree_search | Spatial tree data structure to perform (approximate) nearest and furthest neighbor search |
►Ntangential_complex | |
►CTangential_complex | Tangential complex data structure |
CFix_inconsistencies_info | Type returned by Tangential_complex::fix_inconsistencies_using_perturbation |
CNum_inconsistencies | Type returned by Tangential_complex::number_of_inconsistent_simplices |
►Nwitness_complex | |
CActive_witness | Class representing a list of nearest neighbors to a given witness |
CActive_witness_iterator | Iterator in the nearest landmark list |
CEuclidean_strong_witness_complex | Constructs strong witness complex for given sets of witnesses and landmarks in Euclidean space |
CEuclidean_witness_complex | Constructs (weak) witness complex for given sets of witnesses and landmarks in Euclidean space |
CSimplicialComplexForWitness | The concept SimplicialComplexForWitness describes the requirements for a type to implement a simplicial complex, used for example to build a Witness_complex or Strong_witness_complex |
CStrong_witness_complex | Constructs strong witness complex for a given table of nearest landmarks with respect to witnesses |
CWitness_complex | Constructs (weak) witness complex for a given table of nearest landmarks with respect to witnesses |
CEuclidean_distance | Compute the Euclidean distance between two Points given by a range of coordinates. The points are assumed to have the same dimension |
CLazy_toplex_map | Lazy toplex map data structure for representing unfiltered simplicial complexes |
Clinear_indexing_tag | Tag for a linear ordering of simplices |
CNull_output_iterator | |
COff_reader | OFF file reader top class visitor |
CPersistence_interval_common | |
CPoints_3D_off_reader | |
CPoints_3D_off_visitor_reader | OFF file visitor implementation according to Off_reader in order to read points from an OFF file |
CPoints_off_reader | OFF file reader implementation in order to read points from an OFF file |
CPoints_off_visitor_reader | OFF file visitor implementation according to Off_reader in order to read points from an OFF file |
CSimplex_tree | Simplex Tree data structure for representing simplicial complexes |
CSimplex_tree_boundary_opposite_vertex_simplex_iterator | Iterator over the simplices of the boundary of a simplex and their opposite vertices |
CSimplex_tree_boundary_simplex_iterator | Iterator over the simplices of the boundary of a simplex |
CSimplex_tree_complex_simplex_iterator | Iterator over the simplices of a simplicial complex |
CSimplex_tree_node_explicit_storage | Node of a simplex tree with filtration value and simplex key |
CSimplex_tree_options_fast_persistence | |
CSimplex_tree_options_full_featured | |
CSimplex_tree_siblings | Data structure to store a set of nodes in a SimplexTree sharing the same parent node |
CSimplex_tree_simplex_vertex_iterator | Iterator over the vertices of a simplex in a SimplexTree |
CSimplex_tree_skeleton_simplex_iterator | Iterator over the simplices of the skeleton of a given dimension of the simplicial complex |
CToplex_map | Toplex map data structure for representing unfiltered simplicial complexes |
CCoefficientField | Concept describing the requirements for a class to represent a field of coefficients to compute persistent homology |
CExtended_simplex_type | Extended simplex type data structure for representing the type of simplices in an extended filtration |
CFilteredComplex | The concept FilteredComplex describes the requirements for a type to implement a filtered cell complex, from which one can compute persistent homology via a model of the concept PersistentHomology |
CFiltrationValue | Value type for a filtration function on a cell complex |
CIndexingTag | Concept describing an indexing scheme (see FilteredComplex) for applying continuous maps to a cell complex, and compute its persistent homology |
CPersistentHomology | Concept describing the requirements for a class to compute persistent homology |
CSimplexKey | Key type used as simplex identifier |
CSimplexTreeOptions | Concept of the template parameter for the class Gudhi::Simplex_tree<SimplexTreeOptions> |
CVertexHandle | Handle type for the vertices of a cell complex |