PhysicsBasedAnimationToolkit 0.0.10
Cross-platform C++20 library of algorithms and data structures commonly used in computer graphics research on physically-based simulation.
Loading...
Searching...
No Matches
Class Hierarchy
This inheritance list is sorted roughly, but not completely, alphabetically:
[detail level 12]
 Cpbat::gpu::geometry::AabbGPU axis-aligned bounding box (AABB) buffer public API
 Cpbat::gpu::impl::geometry::Aabb< kDims >
 Cpbat::geometry::AabbKdTreeHierarchy< Dims >Axis-aligned k-D tree hierarchy of axis-aligned bounding boxes
 Cpbat::geometry::AabbRadixTreeHierarchy< Dims >Axis-aligned radix tree hierarchy of axis-aligned bounding boxes
 Cpbat::math::linalg::mini::Absolute< TMatrix >
 CEigen::AlignedBox
 Cpbat::io::ArchiveArchive class for reading and writing data to HDF5 files
 Cpbat::math::optimization::BackTrackingLineSearch< TScalar >
 Cpbat::gpu::impl::vbd::kernels::BackwardEulerMinimizationDevice-side BFD1 minimization problem
 Cpbat::sim::integration::Bdf< TScalar, TIndex >BDF (Backward Differentiation Formula) time integration scheme for a system of ODEs for an initial value problem (IVP)
 Cpbat::geometry::sdf::BinaryNodeBase struct for all binary nodes
 Cpbat::common::BinaryRadixTree< TIndex >Binary radix tree implementation
 Cpbat::gpu::impl::math::Blas
 Cpbat::geometry::BoundingVolumeHierarchy< TDerived, TBoundingVolume, TPrimitive, Dims >CRTP base class for BVHs
 Cpbat::geometry::BoundingVolumeHierarchy< TetrahedralAabbHierarchy, AxisAlignedBoundingBox< 3 >, IndexVector< 4 >, 3 >
 Cpbat::geometry::BoundingVolumeHierarchy< TriangleAabbHierarchy2D, AxisAlignedBoundingBox< 2 >, IndexVector< 3 >, 2 >
 Cpbat::geometry::BoundingVolumeHierarchy< TriangleAabbHierarchy3D, AxisAlignedBoundingBox< 3 >, IndexVector< 3 >, 3 >
 Cpbat::graph::BreadthFirstSearch< TIndex >
 Cpbat::common::BruteSet< T, kCapacity >Fixed-size brute-force set implementation
 Cpbat::gpu::common::Buffer1- or 2-dimensional GPU buffer of numeric types
 Cpbat::gpu::impl::common::Buffer< T, D >
 Cpbat::gpu::geometry::BvhGPU linear BVH [6] public API
 Cpbat::gpu::impl::geometry::BvhRadix-tree linear BVH
 Cpbat::math::linalg::mini::CastView< TMatrix, NewType >
 Cpbat::geometry::sdf::Composite< TScalar >Composite signed distance function represented as a forest of SDFs
 Cpbat::sim::algorithm::newton::ConfigNewton integrator configuration
 Cpbat::math::linalg::mini::ConstDiagonal< TMatrix >
 Cpbat::math::linalg::mini::ConstEigenMatrixWrapper< TDerived >
 Cpbat::math::linalg::mini::ConstSubMatrix< TMatrix, M, N >
 Cpbat::math::linalg::mini::ConstTransposeSubMatrix< TMatrix, M, N >
 Cpbat::math::linalg::mini::ConstTransposeView< TMatrix >
 Cpbat::gpu::impl::vbd::kernels::ContactPenalty< kMaxContacts >Penalty rescaler for mesh independent contact response
 Cpbat::math::linalg::mini::CrossProduct< TLhsMatrix, TRhsMatrix >
 Cpbat::sim::vbd::DataVBD simulation configuration
 Cpbat::sim::xpbd::Data
 Cpbat::graph::DepthFirstSearch< TIndex >
 Cpbat::gpu::impl::common::DeviceSynchronizedList< T >
 Cpbat::math::linalg::mini::Diagonal< TMatrix >
 Cpbat::graph::DisjointSetUnionFind< TIndex >Disjoint Set Union-Find data structure
 Cpbat::math::polynomial::detail::DivergenceFreeBasis< Dims, Order >
 Cpbat::math::DynamicQuadrature< Dims, Order >Quadrature rule with variable points and weights
 Cpbat::sim::contact::MultibodyMeshMixedCcdDcd::EdgeEdgeContactEdge-edge contact pair
 CEigen::EigenBase
 Cpbat::math::linalg::mini::EigenMatrixWrapper< TDerived >
 CEnum
 Cpbat::sim::contact::Environment< TScalar >Static environment geometry for contact simulation
 Cpbat::sim::dynamics::FemElastoDynamics< TElement, Dims, THyperElasticEnergy, TScalar, TIndex >Finite Element Elasto-Dynamics initial value problem with Dirichlet boundary conditions using BDF (backward differentiation formula) as the time discretization
 Cpbat::gpu::impl::geometry::kernels::FGenerateHierarchy
 Cpbat::math::FixedSizeVariableQuadrature< Quad >Represents a quadrature scheme that can be constructed via existing quadrature schemes
 Cpbat::math::linalg::mini::FlatView< TMatrix >
 Cpbat::geometry::sdf::Forest< TScalar >CPU storage for a forest (of SDFs)
 Cstd::hash< pair< pbat::Index, pbat::Index > >Hash function for pair of Index
 Cstd::hash< pbat::IndexVector< 2 > >Hash function for pbat::IndexVector<2>
 Cstd::hash< pbat::IndexVector< 3 > >Hash function for pbat::IndexVector<3>
 Cstd::hash< tuple< pbat::Index, pbat::Index > >Hash function for 2-tuple of Index
 Cstd::hash< tuple< pbat::Index, pbat::Index, pbat::Index > >Hash function for 3-tuple of Index
 Cpbat::geometry::HashGrid< Dims, TScalar, TIndex >HashGrid is a spatial partitioning data structure that divides 3D space into a sparse grid of cells, allowing for efficient querying of point neighbours within a certain region
 Cpbat::common::Heap< T, Less, kCapacity >Fixed-size max heap
 Cpbat::geometry::HierarchicalHashGrid< Dims, TScalar, TIndex >Spatial partitioning data structure that divides 3D space into a set of sparse grids. Allowing for efficient querying of point neighbours within a certain region. Implements [4]
 Cpbat::sim::vbd::multigrid::Hierarchy
 Cpbat::math::linalg::mini::HorizontalStack< TLhsMatrix, TRhsMatrix >
 Cpbat::sim::vbd::multigrid::HyperReduction
 Cpbat::math::linalg::mini::Identity< TScalar, M, N >
 Cpbat::gpu::impl::vbd::IntegratorVBD integrator [2]
 Cpbat::gpu::impl::xpbd::Integrator
 Cpbat::gpu::vbd::IntegratorThe VBD public API wrapper around the VBD integrator implementation. [2]
 Cpbat::gpu::xpbd::IntegratorPublic API of the GPU XPBD integrator
 Cpbat::sim::algorithm::newton::IntegratorNewton dynamics integrator
 Cpbat::sim::vbd::Integrator
 Cpbat::sim::vbd::multigrid::Integrator
 Cpbat::sim::xpbd::Integrator
 Cpbat::geometry::KdTree< Dims >KDTree class
 Cpbat::geometry::KdTreeNodeNode of a KDTree
 Cpbat::sim::vbd::multigrid::Level
 Cpbat::gpu::impl::math::LinearSolver
 Cpbat::gpu::impl::math::Matrix< T >
 Cpbat::math::linalg::mini::MatrixMatrixPredicate< TLhsMatrix, TRhsMatrix, Compare >
 Cpbat::math::linalg::mini::MatrixScalarPredicate< TMatrix, Compare >
 Cpbat::gpu::impl::math::MatrixView< T >
 Cpbat::math::linalg::mini::Maximum< TLhsMatrix, TRhsMatrix >
 Cpbat::fem::Mesh< TElement, Dims, TScalar, TIndex >A generic stateful finite element mesh representation
 Cpbat::sim::contact::MeshVertexTetrahedronDcdDiscrete contact detection system for vertex-tetrahedron contacts between multiple tetrahedral meshes
 Cpbat::math::linalg::mini::Minimum< TLhsMatrix, TRhsMatrix >
 Cpbat::math::polynomial::detail::MonomialBasis< Dims, Order >
 Cpbat::gpu::impl::geometry::Morton
 Cpbat::sim::contact::MultibodyMeshMixedCcdDcdMultibody triangle mesh continuous collision detection system
 Cpbat::sim::contact::MultibodyTetrahedralMeshSystem< TIndex, TScalar >Multibody Tetrahedral Mesh System
 Cpbat::math::optimization::Newton< TScalar >Newton's method for optimization
 Cpbat::math::linalg::mini::Ones< TScalar, M, N >
 Cpbat::math::polynomial::detail::OrthonormalBasis< Dims, Order >
 Cpbat::math::OverflowChecked< Integer >Wrapper around integer types that throws when integer overflow is detected
 Cpbat::graph::PartitioningOptionsOptions for graph partitioning
 Cpbat::sim::algorithm::newton::PreconditionerCholesky preconditioner
 Cpbat::sim::algorithm::newton::PreconditionerOperatorPreconditioner operator Non-owning view over stateful preconditioner, to use with Eigen's matrix-free solvers
 Cpbat::geometry::sdf::PrimitiveBase struct for all primitive shapes
 Cpbat::math::linalg::mini::Product< TLhsMatrix, TRhsMatrix >
 Cpython.pbatoolkit.py.profiling.Profiler
 Cpbat::common::Queue< T, kCapacity >Fixed-size queue implementation
 Cpbat::gpu::impl::geometry::kernels::FGenerateHierarchy::Range
 Cpbat::math::RationalFixed size rational number \( \frac{a}{b} \) using std::int64_t for numerator and denominator
 Cpbat::math::linalg::mini::Reciprocal< TLhsMatrix >
 Cpbat::physics::SaintVenantKirchhoffEnergy< Dims >
 Cpbat::physics::SaintVenantKirchhoffEnergy< 1 >Saint-Venant Kirchhoff hyperelastic energy for 1D
 Cpbat::physics::SaintVenantKirchhoffEnergy< 2 >Saint-Venant Kirchhoff hyperelastic energy for 2D
 Cpbat::physics::SaintVenantKirchhoffEnergy< 3 >Saint-Venant Kirchhoff hyperelastic energy for 3D
 Cpbat::math::linalg::mini::Scale< TMatrix >
 Cpbat::math::linalg::mini::SMatrix< TScalar, M, N >
 Cpbat::sim::vbd::multigrid::SMatrix< TScalar, M, N >
 Cpbat::math::linalg::mini::SMatrixView< TScalar, M, N >
 Cpbat::sim::vbd::multigrid::Smoother
 Cpbat::math::linalg::SparsityPattern< TIndex, Options >Sparsity pattern precomputer to accelerate sparse matrix assembly
 Cpbat::math::linalg::mini::Square< TMatrix >
 Cpbat::physics::StableNeoHookeanEnergy< Dims >
 Cpbat::physics::StableNeoHookeanEnergy< 1 >Stable Neo-Hookean hyperelastic energy for 1D
 Cpbat::physics::StableNeoHookeanEnergy< 2 >Stable Neo-Hookean hyperelastic energy for 2D
 Cpbat::physics::StableNeoHookeanEnergy< 3 >Stable Neo-Hookean hyperelastic energy for 3D
 Cpbat::common::Stack< T, kCapacity >Fixed-size stack implementation
 Cpbat::math::linalg::mini::SubMatrix< TMatrix, M, N >
 Cpbat::math::linalg::mini::Subtraction< TLhsMatrix, TRhsMatrix >
 Cpbat::math::linalg::mini::SubtractionScalar< TLhsMatrix >
 Cpbat::math::linalg::mini::Sum< TLhsMatrix, TRhsMatrix >
 Cpbat::math::linalg::mini::SumScalar< TLhsMatrix >
 Cpbat::gpu::geometry::SweepAndPruneGPU Sweep and Prune public API
 Cpbat::gpu::impl::geometry::SweepAndPruneSingle-axis parallel sweep and prune algorithm for detecting overlapping bounding boxes
 Cpbat::gpu::impl::common::SynchronizedList< T >
 Cpbat::math::linalg::mini::TiledView< TMatrix, RepeatRows, RepeatCols >
 Cpbat::geometry::sdf::Transform< TScalar >A 3D rigid transform
 Cpbat::math::linalg::mini::TransposeSubMatrix< TMatrix, M, N >
 Cpbat::math::linalg::mini::TransposeView< TMatrix >
 CTs...
 Cpbat::geometry::sdf::UnaryNodeBase struct for all unary nodes
 Cpbat::gpu::impl::common::Var< T >
 Cpbat::gpu::impl::vbd::kernels::VbdIterationTraits< kBlockThreads >Traits for VBD iteration kernel
 Cpbat::gpu::impl::math::Vector< T >
 Cpbat::gpu::impl::math::VectorView< T >
 Cpbat::sim::contact::MultibodyMeshMixedCcdDcd::VertexTriangleContactVertex-triangle contact pair (i,f)
 Cpbat::gpu::contact::VertexTriangleMixedCcdDcdPublic API of vertex-triangle mixed continuous collision detection (CCD) and discrete collision detection system on the GPU
 Cpbat::gpu::impl::contact::VertexTriangleMixedCcdDcdVertex-triangle contact detection using a mixed CCD/DCD approach
 Cpbat::math::linalg::mini::VerticalStack< TLhsMatrix, TRhsMatrix >
 Cpbat::graph::WeightedEdgeTraits< TWeightedEdge >Traits for WeightedEdge
 Cpbat::math::linalg::mini::Zeros< TScalar, M, N >
 Cpbat::sim::vbd::multigrid::Zeros< TScalar, M, N >
 Cpbat::gpu::profiling::ZoneRAII class wrapping Tracy zones for CUDA host code