TTK
|
NdimensionReduction | |
Nripser | |
►Nttk | The Topology ToolKit |
Naxa | |
►Ncf | |
CArcRegion | |
CContourForests | |
CContourForestsTree | |
CExtendedUnionFind | |
CInterface | |
CMergeTree | |
CNode | |
CParallelData | |
CParallelParams | |
CParams | |
CRegion | |
CScalars | |
CSegment | |
CSegments | |
Csorted_iterator | |
CSuperArc | |
CTreeData | |
Cvertex | |
►Ncta | |
CAlignmentEdge | Basic data structure for an edge of an unrooted alignment tree |
CAlignmentNode | Basic data structure for a node of an unrooted alignment tree |
CAlignmentTree | Basic tree data structure for an alignment of two rooted binary trees |
CBinaryTree | Basic tree data structure for a rooted contour tree of degree 2 and rooted contour tree alignments of degree 2 |
CContourTree | Contour Tree Data Structure for an unrooted contour tree of unbounded degree for internal use from the ttk:ContourTreeAlignment module |
CCTEdge | Basic data structure for an edge of an unrooted contour tree |
CCTNode | Basic data structure for a node of an unrooted contour tree |
CTree | Basic tree data structure for a rooted contour tree of unbounded degree |
►Ndcg | |
CCell | |
CCellExt | Extended Cell structure for processLowerStars |
CDiscreteGradient | TTK discreteGradient processing package |
►Ndebug | |
Noutput | |
NDijkstra | |
►Nftm | |
CArcData | |
CArcRegion | |
CAtomicUF | |
CComparison | |
CCurrentState | |
CFTMTree | TTK processing package that efficiently computes the contour tree of scalar data and more (data segmentation, topological simplification, persistence diagrams, persistence curves, etc.) |
CFTMTree_CT | |
CFTMTree_MT | |
CFTMTreePP | |
CLocalFTM | |
CMergeTree | |
CNode | |
CNodeData | |
CParams | |
CRegion | |
CScalars | |
CSegment | |
CSegments | |
CSharedData | |
CSuperArc | |
CTreeData | |
CVertData | |
CWrapperData | |
►Nftr | |
CAllocable | |
CArcData | |
CAtomicUF | Union find compliant with parallel find and maintaining the current local propagation inspired by ttk::UnionFind |
CComp | |
CDynamicGraph | TTK fTRGraph dynamic graph tracking the evolution of level sets |
CDynGraphNode | Class representing a node of a tree and the link to its parent if not the root |
CDynGraphs | |
CFTRGraph | TTK FTRGraph processing package |
CGraph | TTK FTRGraph graph skeleton |
CLazy | TTK DynamicGraph laziness |
CLocalForest | |
CLocalForests | |
CMesh | TTK FTRGraph mesh related operations |
CNode | TTK FTRGraph node of the Graph |
CNodeData | |
CObjectData | |
CParams | |
CPropagation | TTK fTRGraph propagation management with Fibonacci heaps |
CPropagations | Manage propagations for FTR Graph |
CScalars | |
CSegment | TTK processing package that deal with segmentation of an arc in the Reeb Graph |
CSegmInfo | |
CStar | |
CSuperArc | TTK FTRGraph graph arc |
CTaskChunk | |
CTasks | TTK FTRGraph tasks management tools |
CtriScheme | |
CValences | |
CVert | |
CVertData | |
CVisit | |
CVisits | |
►NGeometry | |
CProjectionInput | Stores the findProjection() input |
CProjectionResult | Stores the findProjection() result |
►Nintgl | |
CIntegralLine | Struct containing the data of an integral line. trajectories: vector of identifiers of each vertex the integral line passes on distanceFromSeed: distance of each vertex for the integral line from the seed localVertexIdentifiers: vector of local vertex ids. It represents the number of the vertex in the integral line. seedIdentifier: identifier of the seed of the integral line forkIdentifier: identifier of the last fork the integral line encountered |
NLaplacian | |
►Nlts | |
CLocalizedTopologicalSimplification | |
CPropagation | Superlevel Set Component Propagation |
Nmth | |
Nmtu | |
Npcp | |
►NperiodicGhosts | |
CpartialGlobalBound | |
NStatistics | |
Nwae | |
CAbstractTriangulation | AbstractTriangulation is an interface class that defines an interface for efficient traversal methods on triangulations of piecewise linear manifolds |
CApproximateTopology | TTK processing package for progressive Topological Data Analysis |
CArc | |
CArrayLinkedList | This class describes a dynamic size data structure for thread safe computation. It is a linked list of arrays that also stores the current number of elements. Its key feature is that the addition of an element will never cause the moving of the data structure in memory, unlike an std::vector, making the access to an element thread safe even if another thread is adding elements |
CArrayPreconditioning | |
CAssignmentAuction | |
CAssignmentExhaustive | |
CAssignmentMunkres | |
CAssignmentSolver | |
CBarycentricSubdivision | Subdivise a triangulation according to triangle barycenter |
CBaseClass | TTK base package |
CBidder | |
CBottleneckDistance | |
►CBoundingVolumeHierarchy | Acceleration structure for native ray tracer. Based on implementation described in Physically Based Rendering: From Theory to Implementation by Matt Pharr, Wenzel Jakob and Greg Humphreys |
CNode | |
CTriangle | |
CBranchMappingDistance | |
CCellArray | CellArray generic array of cells |
CCinemaImaging | TTK modules that generates images of a dataset |
CCinemaImagingEmbree | TTK CinemaImagingEmbree processing package |
CCinemaImagingNative | Native renderer that uses a bounding volume hierarchy for accelerated raycasting |
CCinemaQuery | TTK cinemaQuery processing package |
CClusteringMetrics | |
►CCommandLineParser | Basic command line parsing |
CCommandLineArgument | |
CCompactTriangulation | CompactTriangulation is a class implemented based on the TopoCluster data structure, which is a localized data structure for simplicial meshes. The key idea of TopoCluster is to subdivide the simplicial mesh into clusters. Then, the connectivity information is computed locally for each cluster and discarded when it is no longer needed. The simplicial mesh needs to be subdivided before using TopoCluster, i.e., there has to be a scalar field named "ttkCompactTriangulationIndex" to denote the cluster index of each vertex. Note Topocluster will reindex the simplices based on the clustering input array. Related publications "TopoCluster: A Localized Data Structure for Topology-based Visualization" Guoxi Liu, Federico Iuricich, Riccardo Fellegara, and Leila De Floriani IEEE Transactions on Visualization and Computer Graphics, 2021 |
CCompactTriangulationPreconditioning | TTK processing package for mesh preprocessing before using TopoCluster |
CCompare | |
►CConnectedComponents | TTK connectedComponents processing package |
CComponent | |
CContinuousScatterPlot | TTK processing package that computes the continuous scatterplot of bivariate volumetric data |
CContourAroundPoint | TTK contourAroundPoint processing package |
CContourTree | TTK processing package that computes the contour tree of scalar data and more (data segmentation, topological simplification, persistence diagrams, persistence curves, etc.) |
CContourTreeAlignment | TTK contourTreeAlignment processing package |
CContourTreeSimplificationMetric | |
CcriticalPointPairComparison | Comparison between critical point pairs ( (Extremum,Saddle), dist(M,S) ) |
CCriticalVertex | Critical Vertex |
CDebug | Minimalist debugging class |
CDebugMemory | Legacy backward compatibility |
CDebugTimer | Legacy backward compatibility |
CDepthImageBasedGeometryApproximation | This module approximates the depicted geometry of a depth image |
CDimensionReduction | TTK VTK-filter that apply dimension reduction algorithms on input |
►CDiscreteMorseSandwich | TTK DiscreteMorseSandwich processing package |
CEdgeSimplex | Simplex adaptation for edges |
CGeneratorType | Type for exporting persistent generators |
CPersistencePair | Persistence pair struct as exported by DiscreteGradient |
CSimplex | Ad-hoc struct for sorting simplices |
CTetraSimplex | Simplex adaptation for tetrahedra |
CTriangleSimplex | Simplex adaptation for triangles |
CDistanceField | TTK processing package for distance field computation on PL manifolds |
CDistanceMatrixDistortion | |
CDynamicTree | Implements the Dynamic Tree data-structure (or ST-Tree) |
CDynTreeNode | Class representing a node of a tree and the link to its parent if not the root |
CEigenField | TTK processing package for computing eigenfunctions of a triangular mesh |
CExplicitTriangulation | ExplicitTriangulation is a class that provides time efficient traversal methods on triangulations of piecewise linear manifolds |
►CExTreeM | |
CBranch | A branch consists of the saddle vertices lying on the branch, and the parentbranch from which it splits / joins |
►CFiberSurface | TTK processing package that computes fiber surfaces |
CIntersectionTriangle | |
CTriangle | |
CVertex | |
►CFlatJaggedArray | Replacement for std::vector<std::vector<SimplexId>> |
CIterator | |
CSlice | |
CFTMAtomicVector | TTK processing package that manage a parallel vecrion of vector |
CFTRAtomicVector | TTK processing package that manage a parallel version of vector Same as in FTM: Common ? |
CGabowTarjan | |
CGaussianPointCloud | TTK gaussianPointCloud processing package that generates a 1D, 2D or 3D point cloud by randomly casting samples from a Gaussian distribution |
CGood | |
►CGraph | |
CEdge | |
CVertex | |
CHarmonicField | TTK processing package for the topological simplification of scalar data |
CHelloWorld | |
CIcosphere | |
CIdentifiers | |
CImplicitCluster | |
CImplicitNoPreconditions | Implicit Triangulation class without preconditioning |
CImplicitTriangulation | ImplicitTriangulation is a class that provides time and memory efficient traversal methods on triangulations of piecewise linear manifolds represented by regular grids |
CImplicitTriangulationCRTP | |
CImplicitWithPreconditions | Implicit Triangulation class with preconditioning |
CIntegralLines | TTK processing package for the computation of edge-based integral lines of the gradient of an input scalar field defined on a PL manifold |
CJacobiSet | TTK processing package for the computation of the Jacobi set of bivariate volumetric data |
CKDTree | TTK KD-Tree |
CLDistance | TTK lDistance processing package |
CLDistanceMatrix | |
CLegacyTopologicalSimplification | TTK processing package for the topological simplification of scalar data |
CLock | RAII wrapper around OpenMP lock |
►CLowestCommonAncestor | Class to answer the lowest common ancestor requests of pairs of nodes in a tree in constant time after a linear time preprocess |
CNode | |
CLRUCache | LRU cache implementation |
CMandatoryCriticalPoints | TTK processing package for the computation of mandatory critical points in uncertain scalar data |
CmandatorySaddleComparison | Comparison between mandatory saddles (Saddle id, Number of merged extrema) |
CManifoldCheck | TTK processing package for manifold checks |
CMarchingTetrahedra | TTK processing package for Marching Tetra/Triangles computations |
CMemory | |
CMergeTreeAutoencoder | |
CMergeTreeAutoencoderDecoding | |
CMergeTreeAxesAlgorithmBase | |
CMergeTreeBarycenter | |
CMergeTreeBase | |
CMergeTreeClustering | |
CMergeTreeDistance | |
CMergeTreeDistanceMatrix | |
►CMergeTreePrincipalGeodesics | |
CCompare | |
CMergeTreePrincipalGeodesicsBase | |
CMergeTreePrincipalGeodesicsDecoding | |
CMergeTreeTemporalReduction | |
CMergeTreeTemporalReductionDecoding | |
CMergeTreeVisualization | |
CMeshGraph | TTK meshGraph processing package |
CMetricDistortion | |
CMorphologicalOperators | TTK morphologicalOperators processing package |
►CMorseSmaleComplex | TTK processing package for the computation of Morse-Smale complexes |
COutput1Separatrices | 1-Separatrices point and cell data arrays |
COutput2Separatrices | 2-Separatrices point and cell data arrays |
COutputCriticalPoints | Critical points data arrays |
COutputManifold | Pointers to pre-allocated segmentation point data arrays |
CSeparatrix | |
CMorseSmaleQuadrangulation | TTK processing package for the topological simplification of scalar data |
►CMultiresTopology | TTK processing package for progressive Topological Data Analysis |
CPersistencePair | |
CMultiresTriangulation | MultiresTriangulation |
CNode | |
COneSkeleton | OneSkeleton processing package |
COsCall | Os-specifics |
CpairComparison | Comparison of the second member of a std::pair<int,double> |
►CPathCompression | TTK processing package for the computation of Morse-Smale segmentations using Path Compression |
COutputSegmentation | Pointers to pre-allocated segmentation point data arrays |
CPathMappingDistance | |
CPDBarycenter | |
CPDClustering | |
CPDFBounds | |
CPDFHistograms | |
CPeriodicImplicitTriangulation | TTK triangulation class for grids with periodic boundary conditions implemented in all directions |
CPeriodicImplicitTriangulationCRTP | |
CPeriodicNoPreconditions | Periodic implicit Triangulation class without preconditioning |
CPeriodicWithPreconditions | Periodic implicit Triangulation class with preconditioning |
CPersistenceCurve | TTK processing package for the computation of persistence curves |
CPersistenceDiagram | TTK processing package for the computation of persistence diagrams |
CPersistenceDiagramAuction | |
CPersistenceDiagramAuctionActor | |
CPersistenceDiagramBarycenter | |
CPersistenceDiagramClustering | TTK processing package for the computation of Wasserstein barycenters and K-Means clusterings of a set of persistence diagrams |
CPersistenceDiagramDistanceMatrix | |
CPersistenceMetric | |
CPersistencePair | Persistence Pair |
CPersistentGenerators | TTK PersistentGenerators processing package |
►CPersistentSimplexPairs | Textbook algorithm to find persistence pairs |
CPersistencePair | |
CPlanarGraphLayout | TTK planarGraphLayout processing package |
CProgram | |
CProgramBase | Base editor class for standalone programs. This class parses the the command line, execute the TTK module and takes care of the IO |
CProgressiveTopology | TTK processing package for progressive Topological Data Analysis |
CProjectionFromTable | |
CQuadrangulation | |
CQuadrangulationSubdivision | TTK processing package for the topological simplification of scalar data |
►CRangeDrivenOctree | TTK optional package for octree based range queries in bivariate volumetric data |
COctreeNode | |
CRangeMinimumQuery | Class to answer range minimum queries in an array in constant time after a linearithmic time preprocess |
CRay | Data structure for a ray |
►CReebSpace | TTK processing package that efficiently computes the Reeb space of bivariate volumetric data |
CSheet0 | |
CSheet1 | |
CSheet2 | |
CSheet3 | |
CRegularGridTriangulation | RegularGridTriangulation is an abstract subclass of ttk::AbstractTriangulation that exposes a common MPI API for triangulation on regular grids. The virtual methods in this class are meant to be implemented in ttk::ImplicitTriangulation and ttk::PeriodicImplicitTriangulation. This meta-class only holds an interface for MPI-related features for the moment but will maybe be enlarged in the future |
CRipsComplex | TTK VTK-filter that computes a Rips complex |
CRipsPersistenceDiagram | TTK base class that computes the persistence diagram of a Rips complex |
CScalarFieldCriticalPoints | TTK processing package for the computation of critical points in PL scalar fields defined on PL manifolds |
CScalarFieldSmoother | TTK processing package for scalar field smoothing |
CSignedDistanceField | This filter computes a signed distance field given a surface in input |
CSubLevelSetTree | |
CSuperArc | |
►CSurfaceGeometrySmoother | TTK VTK-filter for smoothing meshes on surfaces |
CPoint | |
CSweepCmp | |
CThreeSkeleton | ThreeSkeleton processing package |
CTimer | |
CTopologicalCompression | TTK topologicalCompression processing package |
CTopologicalOptimization | |
CTopologicalSimplification | TTK processing package for the topological simplification of scalar data |
CTopoMap | |
CTrackingFromFields | |
►CTrackingFromOverlap | TTK trackingFromOverlap processing package that tracks labeled point sets |
CCoordinateComparator | |
CNode | |
CTrackingFromPersistenceDiagrams | |
CTriangulation | Triangulation is a class that provides time and memory efficient traversal methods on triangulations of piecewise linear manifolds. It provides the following features: |
CttkCinemaImagingEmbree | |
CttkCinemaImagingNative | |
CttkCinemaImagingVTK | |
CTwoSkeleton | TwoSkeleton processing package |
CUncertainDataEstimator | TTK processing package that takes an input ensemble data set (represented by a list of scalar fields) and which computes various vertexwise statistics (PDF estimation, bounds, moments, etc.) |
CUnionFind | Union Find implementation for connectivity tracking |
CVisitedMask | Auto-cleaning re-usable graph propagations data structure |
►CWebSocketIO | |
CMessage | |
CWrapper | Wrapper class to wrap ttk code |
CZeroSkeleton | ZeroSkeleton processing package |