►CCubbyFlow::AdvectionSolver2 | Abstract based class for 2-D grid-based advection solver |
►CCubbyFlow::SemiLagrangian2 | Implementation of 2-D semi-Lagrangian advection solver |
CCubbyFlow::CubicSemiLagrangian2 | Implementation of 2-D cubic semi-Lagrangian advection solver |
►CCubbyFlow::AdvectionSolver3 | Abstract based class for 3-D grid-based advection solver |
►CCubbyFlow::SemiLagrangian3 | Implementation of 3-D semi-Lagrangian advection solver |
CCubbyFlow::CubicSemiLagrangian3 | Implementation of 3-D cubic semi-Lagrangian advection solver |
CCubbyFlow::AngularVelocity< N > | |
CCubbyFlow::AngularVelocity< 2 > | |
CCubbyFlow::AngularVelocity< 3 > | |
►CCubbyFlow::Animation | Abstract base class for animation-related class |
►CCubbyFlow::PhysicsAnimation | Abstract base class for physics-based animation |
►CCubbyFlow::GridFluidSolver2 | Abstract base class for grid-based 2-D fluid solver |
CCubbyFlow::GridSmokeSolver2 | 2-D grid-based smoke solver |
CCubbyFlow::LevelSetLiquidSolver2 | Level set based 2-D liquid solver |
►CCubbyFlow::PICSolver2 | 2-D Particle-in-Cell (PIC) implementation |
CCubbyFlow::APICSolver2 | 2-D Affine Particle-in-Cell (APIC) implementation |
CCubbyFlow::FLIPSolver2 | 2-D Fluid-Implicit Particle (FLIP) implementation |
►CCubbyFlow::GridFluidSolver3 | Abstract base class for grid-based 3-D fluid solver |
CCubbyFlow::GridSmokeSolver3 | 3-D grid-based smoke solver |
CCubbyFlow::LevelSetLiquidSolver3 | Level set based 3-D liquid solver |
►CCubbyFlow::PICSolver3 | 3-D Particle-in-Cell (PIC) implementation |
CCubbyFlow::APICSolver3 | 3-D Affine Particle-in-Cell (APIC) implementation |
CCubbyFlow::FLIPSolver3 | 3-D Fluid-Implicit Particle (FLIP) implementation |
►CCubbyFlow::ParticleSystemSolver2 | Basic 2-D particle system solver |
►CCubbyFlow::SPHSolver2 | 2-D SPH solver |
CCubbyFlow::PCISPHSolver2 | 2-D PCISPH solver |
►CCubbyFlow::ParticleSystemSolver3 | Basic 3-D particle system solver |
►CCubbyFlow::SPHSolver3 | 3-D SPH solver |
CCubbyFlow::PCISPHSolver3 | 3-D PCISPH solver |
►CCubbyFlow::ArrayBase< T, N, DerivedArray > | |
CCubbyFlow::Array< char > | |
CCubbyFlow::Array< CubbyFlow::Array > | |
CCubbyFlow::Array< CubbyFlow::Array< size_t > > | |
CCubbyFlow::Array< CubbyFlow::BoundingBox< double, N > > | |
CCubbyFlow::Array< CubbyFlow::Matrix > | |
CCubbyFlow::Array< CubbyFlow::Matrix< double, N > > | |
CCubbyFlow::Array< CubbyFlow::Matrix< double, N >, N > | |
CCubbyFlow::Array< double > | |
CCubbyFlow::Array< double, N > | |
CCubbyFlow::Array< FDMMatrixRow2 > | |
CCubbyFlow::Array< FDMMatrixRow3 > | |
CCubbyFlow::Array< Node > | |
CCubbyFlow::Array< size_t > | |
CCubbyFlow::Array< std::shared_ptr< CubbyFlow::Collider< N > > > | |
CCubbyFlow::Array< std::shared_ptr< CubbyFlow::ImplicitSurface< N > > > | |
CCubbyFlow::Array< std::shared_ptr< CubbyFlow::Surface< N > > > | |
CCubbyFlow::Array< Vector3UZ > | |
►CCubbyFlow::ArrayBase< const CubbyFlow::Matrix< double, N >, N, ArrayView< const CubbyFlow::Matrix< double, N >, N > > | |
CCubbyFlow::ArrayView< const CubbyFlow::Matrix< double, N >, N > | |
►CCubbyFlow::ArrayBase< const double, N, ArrayView< const double, N > > | |
CCubbyFlow::ArrayView< const double, N > | |
►CCubbyFlow::ArrayBase< const T, N, ArrayView< const T, N > > | |
CCubbyFlow::ArrayView< const T, N > | |
►CCubbyFlow::ArrayBase< CubbyFlow::FDMMatrixRow2, N, ArrayView< CubbyFlow::FDMMatrixRow2, N > > | |
CCubbyFlow::ArrayView< CubbyFlow::FDMMatrixRow2 > | |
►CCubbyFlow::ArrayBase< CubbyFlow::FDMMatrixRow3, N, ArrayView< CubbyFlow::FDMMatrixRow3, N > > | |
CCubbyFlow::ArrayView< CubbyFlow::FDMMatrixRow3 > | |
►CCubbyFlow::ArrayBase< T, N, Array< T, N > > | |
CCubbyFlow::Array< T > | |
CCubbyFlow::Array< T, N > | |
►CCubbyFlow::ArrayBase< T, N, ArrayView< T, N > > | |
CCubbyFlow::ArrayView< T, N > | Generic N-dimensional array class interface |
CCubbyFlow::BLAS< S, V, M > | Generic BLAS operator wrapper class |
CCubbyFlow::BoundingBox< T, N > | N-D axis-aligned bounding box class |
CCubbyFlow::BoundingBox< double > | |
CCubbyFlow::BoundingBox< double, N > | |
CCubbyFlow::BoundingBoxRayIntersection< T > | Box-ray intersection result |
CCubbyFlow::ConstantScalarField< N >::Builder | Front-end to create ConstantScalarField objects step by step |
CCubbyFlow::ConstantVectorField< N >::Builder | Front-end to create ConstantVectorField objects step by step |
CCubbyFlow::GridEmitterSet3::Builder | Front-end to create GridEmitterSet3 objects step by step |
CCubbyFlow::ParticleEmitterSet2::Builder | Front-end to create ParticleEmitterSet2 objects step by step |
CCubbyFlow::CustomScalarField< N >::Builder | Front-end to create CustomScalarField objects step by step |
CCubbyFlow::CustomVectorField< N >::Builder | Front-end to create CustomVectorField objects step by step |
CCubbyFlow::ParticleEmitterSet3::Builder | Front-end to create ParticleEmitterSet3 objects step by step |
CCubbyFlow::PointParticleEmitter2::Builder | Front-end to create PointParticleEmitter2 objects step by step |
CCubbyFlow::PointParticleEmitter3::Builder | Front-end to create PointParticleEmitter3 objects step by step |
CCubbyFlow::VolumeGridEmitter2::Builder | Front-end to create VolumeGridEmitter2 objects step by step |
CCubbyFlow::VolumeGridEmitter3::Builder | Front-end to create VolumeGridEmitter3 objects step by step |
CCubbyFlow::ColliderSet< N >::Builder | Front-end to create ColliderSet objects step by step |
CCubbyFlow::VolumeParticleEmitter2::Builder | Front-end to create VolumeParticleEmitter2 objects step by step |
CCubbyFlow::VolumeParticleEmitter3::Builder | Front-end to create VolumeParticleEmitter3 objects step by step |
CCubbyFlow::GridEmitterSet2::Builder | Front-end to create GridEmitterSet2 objects step by step |
CCubbyFlow::RigidBodyCollider< N >::Builder | Front-end to create RigidBodyCollider objects step by step |
CCubbyFlow::ClosestIntersectionQueryResult< T, N > | N-D closest intersection query result |
►CCubbyFlow::Collider< N > | Abstract base class for generic collider object |
CCubbyFlow::ColliderSet< N > | Collection of N-D colliders |
CCubbyFlow::RigidBodyCollider< N > | N-D rigid body collider class |
CCubbyFlow::Collider< N >::ColliderQueryResult | Internal query result structure |
CCubbyFlow::Internal::Cubic< T, N, I > | |
CCubbyFlow::Internal::Cubic< T, N, 1 > | |
CCubbyFlow::CubicArraySampler< T, N, CubicInterpolationOp > | N-D cubic array sampler class |
CCubbyFlow::DoAbsMax< T > | Takes absolute maximum value |
CCubbyFlow::DoAbsMin< T > | Takes absolute minimum value |
CCubbyFlow::DoCatmullRom< T > | |
CCubbyFlow::DoCeil< T > | Performs std::ceil |
CCubbyFlow::DoClamp< T > | Clamps the input value with low/high |
CCubbyFlow::DoFloor< T > | Performs std::floor |
CCubbyFlow::DoMax< T > | Takes maximum value |
CCubbyFlow::DoMin< T > | Takes minimum value |
CCubbyFlow::DoMonotonicCatmullRom< T > | |
CCubbyFlow::Internal::DotProduct< M1, M2, J > | |
CCubbyFlow::Internal::DotProduct< M1, M2, 0 > | |
CCubbyFlow::MatrixCSR< T >::Element | |
CCubbyFlow::Factory | |
CCubbyFlow::FDMBLAS2 | BLAS operator wrapper for 2-D finite differencing |
CCubbyFlow::FDMBLAS3 | BLAS operator wrapper for 3-D finite differencing |
CCubbyFlow::FDMCompressedBLAS2 | BLAS operator wrapper for compressed 2-D finite differencing |
CCubbyFlow::FDMCompressedBLAS3 | BLAS operator wrapper for compressed 3-D finite differencing |
CCubbyFlow::FDMCompressedLinearSystem2 | Compressed linear system (Ax=b) for 2-D finite differencing |
CCubbyFlow::FDMCompressedLinearSystem3 | Compressed linear system (Ax=b) for 3-D finite differencing |
CCubbyFlow::FDMLinearSystem2 | Linear system (Ax=b) for 2-D finite differencing |
CCubbyFlow::FDMLinearSystem3 | Linear system (Ax=b) for 3-D finite differencing |
►CCubbyFlow::FDMLinearSystemSolver2 | Abstract base class for 2-D finite difference-type linear system solver |
CCubbyFlow::FDMCGSolver2 | 2-D finite difference-type linear system solver using conjugate gradient |
CCubbyFlow::FDMGaussSeidelSolver2 | 2-D finite difference-type linear system solver using Gauss-Seidel method |
CCubbyFlow::FDMICCGSolver2 | 2-D finite difference-type linear system solver using incomplete Cholesky conjugate gradient (ICCG) |
CCubbyFlow::FDMJacobiSolver2 | 2-D finite difference-type linear system solver using Jacobi method |
►CCubbyFlow::FDMMGSolver2 | 2-D finite difference-type linear system solver using Multigrid |
CCubbyFlow::FDMMGPCGSolver2 | 2-D finite difference-type linear system solver using Multigrid Preconditioned conjugate gradient (MGPCG) |
►CCubbyFlow::FDMLinearSystemSolver3 | Abstract base class for 3-D finite difference-type linear system solver |
CCubbyFlow::FDMCGSolver3 | 3-D finite difference-type linear system solver using conjugate gradient |
CCubbyFlow::FDMGaussSeidelSolver3 | 3-D finite difference-type linear system solver using Gauss-Seidel method |
CCubbyFlow::FDMICCGSolver3 | 3-D finite difference-type linear system solver using incomplete Cholesky conjugate gradient (ICCG) |
CCubbyFlow::FDMJacobiSolver3 | 3-D finite difference-type linear system solver using Jacobi method |
►CCubbyFlow::FDMMGSolver3 | 3-D finite difference-type linear system solver using Multigrid |
CCubbyFlow::FDMMGPCGSolver3 | 3-D finite difference-type linear system solver using Multigrid Preconditioned conjugate gradient (MGPCG) |
CCubbyFlow::FDMMatrixRow2 | The row of FDMMatrix2 where row corresponds to (i, j) grid point |
CCubbyFlow::FDMMatrixRow3 | The row of FDMMatrix3 where row corresponds to (i, j, k) grid point |
CCubbyFlow::FDMMGLinearSystem2 | Multigrid-syle 2-D linear system |
CCubbyFlow::FDMMGLinearSystem3 | Multigrid-syle 3-D linear system |
CCubbyFlow::FDMMGUtils2 | Multigrid utilities for 2-D FDM system |
CCubbyFlow::FDMMGUtils3 | Multigrid utilities for 2-D FDM system |
►CCubbyFlow::Field< N > | Abstract base class for N-D fields |
►CCubbyFlow::ScalarField< N > | Abstract base class for N-D scalar field |
CCubbyFlow::ConstantScalarField< N > | N-D constant scalar field |
CCubbyFlow::CustomScalarField< N > | N-D scalar field with custom field function |
►CCubbyFlow::ScalarGrid< N > | Abstract base class for N-D scalar grid structure |
CCubbyFlow::CellCenteredScalarGrid< N > | N-D Cell-centered scalar grid structure |
CCubbyFlow::VertexCenteredScalarGrid< N > | N-D Vertex-centered scalar grid structure |
►CCubbyFlow::VectorField< N > | Abstract base class for N-D vector field |
CCubbyFlow::ConstantVectorField< N > | N-D constant vector field |
CCubbyFlow::CustomVectorField< N > | N-D vector field with custom field function |
►CCubbyFlow::VectorGrid< N > | Abstract base class for N-D vector grid structure |
►CCubbyFlow::CollocatedVectorGrid< N > | Abstract base class for N-D collocated vector grid structure |
CCubbyFlow::CellCenteredVectorGrid< N > | N-D Cell-centered vector grid structure |
CCubbyFlow::VertexCenteredVectorGrid< N > | N-D Vertex-centered vector grid structure |
CCubbyFlow::FaceCenteredGrid< N > | N-D face-centered (a.k.a MAC or staggered) grid |
CCubbyFlow::Internal::FoldWithAnd< T, Rows, Cols, BinaryOperation, I > | |
CCubbyFlow::Internal::FoldWithAnd< T, Rows, Cols, BinaryOperation, 0 > | |
CCubbyFlow::Internal::ForEachIndex< IndexType, N, I > | |
CCubbyFlow::Internal::ForEachIndex< IndexType, N, 1 > | |
CCubbyFlow::Frame | Representation of an animation frame |
CCubbyFlow::Internal::GetCoordinatesAndGradientWeights< T, N, I > | |
CCubbyFlow::Internal::GetCoordinatesAndGradientWeights< T, N, 1 > | |
CCubbyFlow::Internal::GetCoordinatesAndWeights< T, N, I > | |
CCubbyFlow::Internal::GetCoordinatesAndWeights< T, N, 1 > | |
CCubbyFlow::GetCurl< N > | |
CCubbyFlow::GetCurl< 2 > | |
CCubbyFlow::GetCurl< 3 > | |
CCubbyFlow::GetFDMUtils< N > | |
CCubbyFlow::GetFDMUtils< 2 > | |
CCubbyFlow::GetFDMUtils< 3 > | |
CCubbyFlow::GetScalarType< T > | Returns the type of the value itself |
CCubbyFlow::GetScalarType< Matrix< T, Rows, Cols > > | |
CCubbyFlow::Internal::GetSizeAndInitVal< T, N, I > | |
CCubbyFlow::Internal::GetSizeAndInitVal< T, N, 0 > | |
CCubbyFlow::Internal::GetSizeFromInitList< T, N, I > | |
CCubbyFlow::Internal::GetSizeFromInitList< T, N, 1 > | |
CCubbyFlow::GetUnroll< ReturnType, N > | |
CCubbyFlow::GetUnroll< ReturnType, 1 > | |
CCubbyFlow::GetUnroll< ReturnType, 2 > | |
CCubbyFlow::GetUnroll< ReturnType, 3 > | |
CCubbyFlow::GetUnroll< void, 1 > | |
CCubbyFlow::GetUnroll< void, 2 > | |
CCubbyFlow::GetUnroll< void, 3 > | |
►CCubbyFlow::GridBoundaryConditionSolver2 | Abstract base class for 2-D boundary condition solver for grids |
►CCubbyFlow::GridFractionalBoundaryConditionSolver2 | Fractional 2-D boundary condition solver for grids |
CCubbyFlow::GridBlockedBoundaryConditionSolver2 | Blocked 2-D boundary condition solver for grids |
►CCubbyFlow::GridBoundaryConditionSolver3 | Abstract base class for 3-D boundary condition solver for grids |
►CCubbyFlow::GridFractionalBoundaryConditionSolver3 | Fractional 3-D boundary condition solver for grids |
CCubbyFlow::GridBlockedBoundaryConditionSolver3 | Blocked 3-D boundary condition solver for grids |
CCubbyFlow::GridDataPositionFunc< N > | |
►CCubbyFlow::GridDiffusionSolver2 | Abstract base class for 2-D grid-based diffusion equation solver |
CCubbyFlow::GridBackwardEulerDiffusionSolver2 | 2-D grid-based backward Euler diffusion solver |
CCubbyFlow::GridForwardEulerDiffusionSolver2 | 2-D grid-based forward Euler diffusion solver |
►CCubbyFlow::GridDiffusionSolver3 | Abstract base class for 3-D grid-based diffusion equation solver |
CCubbyFlow::GridBackwardEulerDiffusionSolver3 | 3-D grid-based backward Euler diffusion solver |
CCubbyFlow::GridForwardEulerDiffusionSolver3 | 3-D grid-based forward Euler diffusion solver |
►CCubbyFlow::GridEmitter2 | Abstract base class for 2-D grid-based emitters |
CCubbyFlow::GridEmitterSet2 | 2-D grid-based emitter set |
CCubbyFlow::VolumeGridEmitter2 | 2-D grid-based volumetric emitter |
►CCubbyFlow::GridEmitter3 | Abstract base class for 3-D grid-based emitters |
CCubbyFlow::GridEmitterSet3 | 3-D grid-based emitter set |
CCubbyFlow::VolumeGridEmitter3 | 3-D grid-based volumetric emitter |
CCubbyFlow::GridFluidSolverBuilderBase2< DerivedBuilder > | Base class for grid-based fluid solver builder |
►CCubbyFlow::GridFluidSolverBuilderBase2< Builder > | |
CCubbyFlow::APICSolver2::Builder | Front-end to create APICSolver2 objects step by step |
CCubbyFlow::FLIPSolver2::Builder | Front-end to create FLIPSolver2 objects step by step |
CCubbyFlow::GridFluidSolver2::Builder | Front-end to create GridFluidSolver2 objects step by step |
CCubbyFlow::GridSmokeSolver2::Builder | Front-end to create GridSmokeSolver2 objects step by step |
CCubbyFlow::LevelSetLiquidSolver2::Builder | Front-end to create LevelSetLiquidSolver2 objects step by step |
CCubbyFlow::PICSolver2::Builder | Front-end to create PICSolver2 objects step by step |
CCubbyFlow::GridFluidSolverBuilderBase3< DerivedBuilder > | Base class for grid-based fluid solver builder |
►CCubbyFlow::GridFluidSolverBuilderBase3< Builder > | |
CCubbyFlow::APICSolver3::Builder | Front-end to create APICSolver3 objects step by step |
CCubbyFlow::FLIPSolver3::Builder | Front-end to create FLIPSolver3 objects step by step |
CCubbyFlow::GridFluidSolver3::Builder | Front-end to create GridFluidSolver3 objects step by step |
CCubbyFlow::GridSmokeSolver3::Builder | Front-end to create GridSmokeSolver3 objects step by step |
CCubbyFlow::LevelSetLiquidSolver3::Builder | Front-end to create LevelSetLiquidSolver3 objects step by step |
CCubbyFlow::PICSolver3::Builder | Front-end to create PICSolver3 objects step by step |
►CCubbyFlow::GridPressureSolver2 | Abstract base class for 2-D grid-based pressure solver |
CCubbyFlow::GridFractionalSinglePhasePressureSolver2 | 2-D fractional single-phase pressure solver |
CCubbyFlow::GridSinglePhasePressureSolver2 | 2-D single-phase pressure solver |
►CCubbyFlow::GridPressureSolver3 | Abstract base class for 2-D grid-based pressure solver |
CCubbyFlow::GridFractionalSinglePhasePressureSolver3 | 3-D fractional single-phase pressure solver |
CCubbyFlow::GridSinglePhasePressureSolver3 | 3-D single-phase pressure solver |
►CCubbyFlow::IntersectionQueryEngine< T, N > | Abstract base class for N-D intersection test query engine |
CCubbyFlow::BVH< T, N > | Bounding Volume Hierarchy (BVH) in N-D |
CCubbyFlow::ListQueryEngine< T, N > | Ad-hoc list-based N-D intersection/nearest-neighbor query engine |
CCubbyFlow::Octree< T > | Generic octree data structure |
CCubbyFlow::Quadtree< T > | Generic quadtree data structure |
►CCubbyFlow::IntersectionQueryEngine< size_t, N > | |
CCubbyFlow::BVH< size_t > | |
►CCubbyFlow::IntersectionQueryEngine< std::shared_ptr< CubbyFlow::ImplicitSurface< N > >, N > | |
CCubbyFlow::BVH< std::shared_ptr< CubbyFlow::ImplicitSurface< N > >, N > | |
►CCubbyFlow::IntersectionQueryEngine< std::shared_ptr< CubbyFlow::Surface< N > >, N > | |
CCubbyFlow::BVH< std::shared_ptr< CubbyFlow::Surface< N > >, N > | |
CCubbyFlow::KdTree< T, K > | Generic k-d tree structure |
CCubbyFlow::KdTree< double, N > | |
CCubbyFlow::Internal::Lerp< T, N, I > | |
CCubbyFlow::Internal::Lerp< T, N, 1 > | |
►CCubbyFlow::LevelSetSolver2 | Abstract base class for 2-D level set solver |
CCubbyFlow::FMMLevelSetSolver2 | Two-dimensional fast marching method (FMM) implementation |
►CCubbyFlow::IterativeLevelSetSolver2 | Abstract base class for 2-D PDE-based iterative level set solver |
CCubbyFlow::ENOLevelSetSolver2 | Two-dimensional third-order ENO-based iterative level set solver |
CCubbyFlow::UpwindLevelSetSolver2 | |
►CCubbyFlow::LevelSetSolver3 | Abstract base class for 3-D level set solver |
CCubbyFlow::FMMLevelSetSolver3 | Three-dimensional fast marching method (FMM) implementation |
►CCubbyFlow::IterativeLevelSetSolver3 | Abstract base class for 3-D PDE-based iterative level set solver |
CCubbyFlow::ENOLevelSetSolver3 | Three-dimensional third-order ENO-based iterative level set solver |
CCubbyFlow::UpwindLevelSetSolver3 | Three-dimensional first-order upwind-based iterative level set solver |
CCubbyFlow::LinearArraySampler< T, N > | N-D array sampler using linear interpolation |
CCubbyFlow::LinearArraySampler< CubbyFlow::Matrix< double, N >, N > | |
CCubbyFlow::LinearArraySampler< double, N > | |
CCubbyFlow::Logger | Super simple logger implementation |
CCubbyFlow::Logging | Helper class for logging |
CCubbyFlow::Matrix< double >< T, MATRIX_SIZE_DYNAMIC, 1 > | |
►CCubbyFlow::MatrixDenseBase< T, Rows, Cols, Derived > | |
CCubbyFlow::Matrix< double > | |
CCubbyFlow::Matrix< double, N > | |
CCubbyFlow::Matrix< ScalarType, N > | |
CCubbyFlow::Matrix< size_t > | |
CCubbyFlow::Matrix< size_t, N > | |
CCubbyFlow::Matrix< ssize_t, N > | |
►CCubbyFlow::MatrixDenseBase< T, 1, 1, Matrix< T, 1, 1 > > | |
CCubbyFlow::Matrix< T, 1, 1 > | |
►CCubbyFlow::MatrixDenseBase< T, 2, 1, Matrix< T, 2, 1 > > | |
CCubbyFlow::Matrix< T, 2, 1 > | |
►CCubbyFlow::MatrixDenseBase< T, 3, 1, Matrix< T, 3, 1 > > | |
CCubbyFlow::Matrix< T, 3, 1 > | |
►CCubbyFlow::MatrixDenseBase< T, 4, 1, Matrix< T, 4, 1 > > | |
CCubbyFlow::Matrix< T, 4, 1 > | |
►CCubbyFlow::MatrixDenseBase< T, MATRIX_SIZE_DYNAMIC, 1, Matrix< T, MATRIX_SIZE_DYNAMIC, 1 > > | |
CCubbyFlow::Matrix< T, MATRIX_SIZE_DYNAMIC, 1 > | |
►CCubbyFlow::MatrixDenseBase< T, MATRIX_SIZE_DYNAMIC, MATRIX_SIZE_DYNAMIC, Matrix< T, MATRIX_SIZE_DYNAMIC, MATRIX_SIZE_DYNAMIC > > | |
CCubbyFlow::Matrix< T, MATRIX_SIZE_DYNAMIC, MATRIX_SIZE_DYNAMIC > | |
►CCubbyFlow::MatrixDenseBase< T, Rows, Cols, Matrix< T, Rows, Cols > > | |
CCubbyFlow::Matrix< T, Rows, Cols > | |
CCubbyFlow::Matrix< T, K > | |
CCubbyFlow::Matrix< T, N > | |
►CCubbyFlow::MatrixExpression< T, Rows, Cols, Derived > | Base class for matrix expression |
CCubbyFlow::Matrix< double > | |
CCubbyFlow::Matrix< double, N > | |
CCubbyFlow::Matrix< ScalarType, N > | |
CCubbyFlow::Matrix< size_t > | |
CCubbyFlow::Matrix< size_t, N > | |
CCubbyFlow::Matrix< ssize_t, N > | |
►CCubbyFlow::MatrixExpression< double, MATRIX_SIZE_DYNAMIC, MATRIX_SIZE_DYNAMIC, MatrixCSR< double > > | |
CCubbyFlow::MatrixCSR< double > | |
►CCubbyFlow::MatrixExpression< T, 1, 1, Matrix< T, 1, 1 > > | |
CCubbyFlow::Matrix< T, 1, 1 > | |
►CCubbyFlow::MatrixExpression< T, 2, 1, Matrix< T, 2, 1 > > | |
CCubbyFlow::Matrix< T, 2, 1 > | |
►CCubbyFlow::MatrixExpression< T, 3, 1, Matrix< T, 3, 1 > > | |
CCubbyFlow::Matrix< T, 3, 1 > | |
►CCubbyFlow::MatrixExpression< T, 4, 1, Matrix< T, 4, 1 > > | |
CCubbyFlow::Matrix< T, 4, 1 > | |
►CCubbyFlow::MatrixExpression< T, MATRIX_SIZE_DYNAMIC, 1, Matrix< T, MATRIX_SIZE_DYNAMIC, 1 > > | |
CCubbyFlow::Matrix< T, MATRIX_SIZE_DYNAMIC, 1 > | |
►CCubbyFlow::MatrixExpression< T, MATRIX_SIZE_DYNAMIC, MATRIX_SIZE_DYNAMIC, Matrix< T, MATRIX_SIZE_DYNAMIC, MATRIX_SIZE_DYNAMIC > > | |
CCubbyFlow::Matrix< T, MATRIX_SIZE_DYNAMIC, MATRIX_SIZE_DYNAMIC > | |
►CCubbyFlow::MatrixExpression< T, MATRIX_SIZE_DYNAMIC, MATRIX_SIZE_DYNAMIC, MatrixCSR< T > > | |
CCubbyFlow::MatrixCSR< T > | Compressed Sparse Row (CSR) matrix class |
►CCubbyFlow::MatrixExpression< T, MATRIX_SIZE_DYNAMIC, MATRIX_SIZE_DYNAMIC, MatrixCSRMatrixMul< T, ME > > | |
CCubbyFlow::MatrixCSRMatrixMul< T, ME > | Matrix expression for CSR matrix-matrix multiplication |
►CCubbyFlow::MatrixExpression< T, Rows, Cols, Matrix< T, Rows, Cols > > | |
CCubbyFlow::Matrix< T, Rows, Cols > | |
CCubbyFlow::Matrix< T, K > | |
CCubbyFlow::Matrix< T, N > | |
►CCubbyFlow::MatrixExpression< T, Rows, Cols, MatrixConstant< T, Rows, Cols > > | |
CCubbyFlow::MatrixConstant< T, Rows, Cols > | |
►CCubbyFlow::MatrixExpression< T, Rows, Cols, MatrixDiagonal< T, Rows, Cols, M1 > > | |
CCubbyFlow::MatrixDiagonal< T, Rows, Cols, M1 > | |
►CCubbyFlow::MatrixExpression< T, Rows, Cols, MatrixElemWiseBinaryOp< T, Rows, Cols, E1, E2, BinaryOperation > > | |
CCubbyFlow::MatrixElemWiseBinaryOp< T, Rows, Cols, E1, E2, BinaryOperation > | Matrix expression for element-wise binary operation |
►CCubbyFlow::MatrixExpression< T, Rows, Cols, MatrixMul< T, Rows, Cols, M1, M2 > > | |
CCubbyFlow::MatrixMul< T, Rows, Cols, M1, M2 > | |
►CCubbyFlow::MatrixExpression< T, Rows, Cols, MatrixOffDiagonal< T, Rows, Cols, M1 > > | |
CCubbyFlow::MatrixOffDiagonal< T, Rows, Cols, M1 > | |
►CCubbyFlow::MatrixExpression< T, Rows, Cols, MatrixScalarElemWiseBinaryOp< T, Rows, Cols, M1, BinaryOperation > > | |
CCubbyFlow::MatrixScalarElemWiseBinaryOp< T, Rows, Cols, M1, BinaryOperation > | |
►CCubbyFlow::MatrixExpression< T, Rows, Cols, MatrixTernaryOp< T, Rows, Cols, M1, M2, M3, TernaryOperation > > | |
CCubbyFlow::MatrixTernaryOp< T, Rows, Cols, M1, M2, M3, TernaryOperation > | |
►CCubbyFlow::MatrixExpression< T, Rows, Cols, MatrixTranspose< T, Rows, Cols, M1 > > | |
CCubbyFlow::MatrixTranspose< T, Rows, Cols, M1 > | |
►CCubbyFlow::MatrixExpression< T, Rows, Cols, MatrixTri< T, Rows, Cols, M1 > > | |
CCubbyFlow::MatrixTri< T, Rows, Cols, M1 > | |
►CCubbyFlow::MatrixExpression< T, Rows, Cols, MatrixUnaryOp< T, Rows, Cols, M1, UnaryOperation > > | |
CCubbyFlow::MatrixUnaryOp< T, Rows, Cols, M1, UnaryOperation > | |
►CCubbyFlow::MatrixExpression< T, Rows, Cols, ScalarMatrixElemWiseBinaryOp< T, Rows, Cols, M2, BinaryOperation > > | |
CCubbyFlow::ScalarMatrixElemWiseBinaryOp< T, Rows, Cols, M2, BinaryOperation > | |
CCubbyFlow::MGMatrix< BlasType > | Multi-grid matrix wrapper |
CCubbyFlow::MGMatrix< FDMBLAS2 > | |
CCubbyFlow::MGMatrix< FDMBLAS3 > | |
CCubbyFlow::MGParameters< BlasType > | Multi-grid input parameter set |
CCubbyFlow::MGParameters< CubbyFlow::FDMBLAS2 > | |
CCubbyFlow::MGParameters< CubbyFlow::FDMBLAS3 > | |
CCubbyFlow::MGResult | Multi-grid result type |
CCubbyFlow::MGVector< BlasType > | Multi-grid vector wrapper |
CCubbyFlow::MGVector< FDMBLAS2 > | |
CCubbyFlow::MGVector< FDMBLAS3 > | |
CCubbyFlow::NearestArraySampler< T, N > | N-D nearest array sampler class |
►CCubbyFlow::NearestNeighborQueryEngine< T, N > | Abstract base class for N-D nearest neighbor query engine |
CCubbyFlow::BVH< T, N > | Bounding Volume Hierarchy (BVH) in N-D |
CCubbyFlow::ListQueryEngine< T, N > | Ad-hoc list-based N-D intersection/nearest-neighbor query engine |
CCubbyFlow::Octree< T > | Generic octree data structure |
CCubbyFlow::Quadtree< T > | Generic quadtree data structure |
►CCubbyFlow::NearestNeighborQueryEngine< size_t, N > | |
CCubbyFlow::BVH< size_t > | |
►CCubbyFlow::NearestNeighborQueryEngine< std::shared_ptr< CubbyFlow::ImplicitSurface< N > >, N > | |
CCubbyFlow::BVH< std::shared_ptr< CubbyFlow::ImplicitSurface< N > >, N > | |
►CCubbyFlow::NearestNeighborQueryEngine< std::shared_ptr< CubbyFlow::Surface< N > >, N > | |
CCubbyFlow::BVH< std::shared_ptr< CubbyFlow::Surface< N > >, N > | |
CCubbyFlow::NearestNeighborQueryResult< T, N > | N-D nearest neighbor query result |
CCubbyFlow::NestedInitializerLists< T, N > | |
CCubbyFlow::NestedInitializerLists< T, 0 > | |
CCubbyFlow::KdTree< T, K >::Node | Simple K-d tree node |
CCubbyFlow::NoOp< T > | No-op operator |
CCubbyFlow::NullCGPreconditioner< BLASType > | No-op pre-conditioner for conjugate gradient |
CCubbyFlow::Orientation< N > | |
CCubbyFlow::Orientation< 2 > | |
CCubbyFlow::Orientation< 3 > | |
►CCubbyFlow::ParticleEmitter2 | Abstract base class for 2-D particle emitter |
CCubbyFlow::ParticleEmitterSet2 | 2-D particle-based emitter set |
CCubbyFlow::PointParticleEmitter2 | 2-D point particle emitter |
CCubbyFlow::VolumeParticleEmitter2 | 2-D volumetric particle emitter |
►CCubbyFlow::ParticleEmitter3 | Abstract base class for 3-D particle emitter |
CCubbyFlow::ParticleEmitterSet3 | 3-D particle-based emitter set |
CCubbyFlow::PointParticleEmitter3 | 3-D point particle emitter |
CCubbyFlow::VolumeParticleEmitter3 | 3-D volumetric particle emitter |
CCubbyFlow::ParticleSystemSolverBuilderBase2< DerivedBuilder > | Base class for particle-based solver builder |
►CCubbyFlow::ParticleSystemSolverBuilderBase2< Builder > | |
CCubbyFlow::ParticleSystemSolver2::Builder | Front-end to create ParticleSystemSolver2 objects step by step |
CCubbyFlow::ParticleSystemSolverBuilderBase3< DerivedBuilder > | Base class for particle-based solver builder |
►CCubbyFlow::ParticleSystemSolverBuilderBase3< Builder > | |
CCubbyFlow::ParticleSystemSolver3::Builder | Front-end to create ParticleSystemSolver3 objects step by step |
►CCubbyFlow::PointGenerator2 | Abstract base class for 2-D point generator |
CCubbyFlow::GridPointGenerator2 | 2-D regular-grid point generator |
CCubbyFlow::TrianglePointGenerator | Right triangle point generator |
►CCubbyFlow::PointGenerator3 | Abstract base class for 3-D point generator |
CCubbyFlow::BccLatticePointGenerator | Body-centered lattice points generator |
CCubbyFlow::GridPointGenerator3 | 3-D regular-grid point generator |
CCubbyFlow::PointHashGridUtils< N > | Hash grid common utilities for N-D point searchers |
►CCubbyFlow::PointNeighborSearcherBuilder< N > | Abstract base class for N-D point neighbor searcher builders |
CCubbyFlow::PointHashGridSearcher< N >::Builder | Front-end to create PointHashGridSearcher objects step by step |
CCubbyFlow::PointKdTreeSearcher< N >::Builder | Front-end to create PointKdTreeSearcher objects step by step |
CCubbyFlow::PointParallelHashGridSearcher< N >::Builder | Front-end to create PointParallelHashGridSearcher objects step by step |
CCubbyFlow::PointSimpleListSearcher< N >::Builder | Front-end to create PointSimpleListSearcher objects step by step |
►CCubbyFlow::PointsToImplicit2 | Abstract base class for 2-D points-to-implicit converters |
CCubbyFlow::AnisotropicPointsToImplicit2 | 2-D points-to-implicit converter using Anisotropic kernels |
CCubbyFlow::SphericalPointsToImplicit2 | 2-D points-to-implicit converter based on simple sphere model |
CCubbyFlow::SPHPointsToImplicit2 | 2-D points-to-implicit converter based on standard SPH kernel |
CCubbyFlow::ZhuBridsonPointsToImplicit2 | 2-D points-to-implicit converter based on Zhu and Bridson's method |
►CCubbyFlow::PointsToImplicit3 | Abstract base class for 3-D points-to-implicit converters |
CCubbyFlow::AnisotropicPointsToImplicit3 | 3-D points-to-implicit converter using Anisotropic kernels |
CCubbyFlow::SphericalPointsToImplicit3 | 3-D points-to-implicit converter based on simple sphere model |
CCubbyFlow::SPHPointsToImplicit3 | 3-D points-to-implicit converter based on standard SPH kernel |
CCubbyFlow::ZhuBridsonPointsToImplicit3 | 3-D points-to-implicit converter based on Zhu and Bridson's method |
CCubbyFlow::Quaternion< T > | Quaternion class defined as q = w + xi + yj + zk |
CCubbyFlow::Quaternion< double > | |
CCubbyFlow::Ray< T, N > | Class for N-D ray |
CCubbyFlow::RDivides< T > | Reverse divides operator |
CCubbyFlow::Internal::Reduce< T, Rows, Cols, ReduceOperation, UnaryOperation, I > | |
CCubbyFlow::Internal::Reduce< T, Rows, Cols, ReduceOperation, UnaryOperation, 0 > | |
CCubbyFlow::RMinus< T > | Reverse minus operator |
►CCubbyFlow::ScalarGridBuilder< N > | Abstract base class for N-D scalar grid builder |
CCubbyFlow::CellCenteredScalarGrid< N >::Builder | Front-end to create CellCenteredScalarGrid objects step by step |
CCubbyFlow::VertexCenteredScalarGrid< N >::Builder | Front-end to create VertexCenteredScalarGrid objects step by step |
►CCubbyFlow::Serializable | Abstract base class for any serializable class |
►CCubbyFlow::Grid< N > | Abstract base class for N-D cartesian grid structure |
CCubbyFlow::ScalarGrid< N > | Abstract base class for N-D scalar grid structure |
CCubbyFlow::VectorGrid< N > | Abstract base class for N-D vector grid structure |
CCubbyFlow::GridSystemData< N > | N-D grid system data |
►CCubbyFlow::ParticleSystemData< N > | N-D particle system data |
CCubbyFlow::SPHSystemData< N > | N-D SPH particle system data |
►CCubbyFlow::PointNeighborSearcher< N > | Abstract base class for N-D neighbor point searcher |
CCubbyFlow::PointHashGridSearcher< N > | Hash grid-based N-D point searcher |
CCubbyFlow::PointKdTreeSearcher< N > | KdTree-based N-D point searcher |
CCubbyFlow::PointParallelHashGridSearcher< N > | Parallel version of hash grid-based N-D point searcher |
CCubbyFlow::PointSimpleListSearcher< N > | Simple ad-hoc N-D point searcher |
CCubbyFlow::Internal::SetArrayFromInitList< T, N, I > | |
CCubbyFlow::Internal::SetArrayFromInitList< T, N, 1 > | |
CCubbyFlow::SimilarTo< T > | True if similar |
CCubbyFlow::SPHSolverBuilderBase2< DerivedBuilder > | Base class for SPH-based fluid solver builder |
►CCubbyFlow::SPHSolverBuilderBase2< Builder > | |
CCubbyFlow::PCISPHSolver2::Builder | Front-end to create PCISPHSolver2 objects step by step |
CCubbyFlow::SPHSolver2::Builder | Front-end to create SPHSolver2 objects step by step |
CCubbyFlow::SPHSolverBuilderBase3< DerivedBuilder > | Base class for SPH-based fluid solver builder |
►CCubbyFlow::SPHSolverBuilderBase3< Builder > | |
CCubbyFlow::PCISPHSolver3::Builder | Front-end to create PCISPHSolver3 objects step by step |
CCubbyFlow::SPHSolver3::Builder | Front-end to create SPHSolver3 objects step by step |
CCubbyFlow::SPHSpikyKernel< N > | Spiky N-D SPH kernel function object |
CCubbyFlow::SPHSpikyKernel< 2 > | |
CCubbyFlow::SPHSpikyKernel< 3 > | |
CCubbyFlow::SPHStdKernel< N > | Standard N-D SPH kernel function object |
CCubbyFlow::SPHStdKernel< 2 > | |
CCubbyFlow::SPHStdKernel< 3 > | |
►CCubbyFlow::Surface< N > | Abstract base class for N-D surface |
CCubbyFlow::Box< N > | N-D box geometry |
CCubbyFlow::Cylinder3 | 3-D cylinder geometry |
►CCubbyFlow::ImplicitSurface< N > | Abstract base class for N-D implicit surface |
CCubbyFlow::CustomImplicitSurface< N > | Custom N-D implicit surface using arbitrary function |
CCubbyFlow::ImplicitSurfaceSet< N > | N-D implicit surface set |
CCubbyFlow::ImplicitTriangleMesh3 | TriangleMesh3 to ImplicitSurface3 converter |
CCubbyFlow::SurfaceToImplicit< N > | N-D implicit surface wrapper for generic Surface instance |
CCubbyFlow::Plane< N > | N-D plane geometry |
CCubbyFlow::Sphere< N > | N-D sphere geometry |
CCubbyFlow::SurfaceSet< N > | N-D surface set |
CCubbyFlow::Triangle3 | 3-D triangle geometry |
CCubbyFlow::TriangleMesh3 | 3-D triangle mesh geometry |
►CCubbyFlow::SurfaceBuilderBase< N, DerivedBuilder > | Base class for N-D surface builder |
CCubbyFlow::Cylinder3::Builder | Front-end to create Cylinder3 objects step by step |
CCubbyFlow::ImplicitTriangleMesh3::Builder | Front-end to create ImplicitTriangleMesh3 objects step by step |
CCubbyFlow::Triangle3::Builder | Front-end to create Triangle3 objects step by step |
CCubbyFlow::TriangleMesh3::Builder | Front-end to create TriangleMesh3 objects step by step |
►CCubbyFlow::SurfaceBuilderBase< N, Box< N >::Builder > | |
CCubbyFlow::Box< N >::Builder | Front-end to create Box objects step by step |
►CCubbyFlow::SurfaceBuilderBase< N, CustomImplicitSurface< N >::Builder > | |
CCubbyFlow::CustomImplicitSurface< N >::Builder | Front-end to create CustomImplicitSurface objects step by step |
►CCubbyFlow::SurfaceBuilderBase< N, ImplicitSurfaceSet< N >::Builder > | |
CCubbyFlow::ImplicitSurfaceSet< N >::Builder | Front-end to create ImplicitSurfaceSet objects step by step |
►CCubbyFlow::SurfaceBuilderBase< N, Plane< N >::Builder > | |
CCubbyFlow::Plane< N >::Builder | Front-end to create Plane objects step by step |
►CCubbyFlow::SurfaceBuilderBase< N, Sphere< N >::Builder > | |
CCubbyFlow::Sphere< N >::Builder | Front-end to create Sphere objects step by step |
►CCubbyFlow::SurfaceBuilderBase< N, SurfaceSet< N >::Builder > | |
CCubbyFlow::SurfaceSet< N >::Builder | Front-end to create SurfaceSet objects step by step |
►CCubbyFlow::SurfaceBuilderBase< N, SurfaceToImplicit< N >::Builder > | |
CCubbyFlow::SurfaceToImplicit< N >::Builder | Front-end to create SurfaceToImplicit objects step by step |
CCubbyFlow::SurfaceRayIntersection< N > | Struct that represents ray-surface intersection point |
CCubbyFlow::Timer | Simple timer class |
CCubbyFlow::TraitIsMatrixSizeDynamic< Rows, Cols > | |
CCubbyFlow::TraitIsMatrixSizeSquare< Rows, Cols > | |
CCubbyFlow::TraitIsMatrixSizeStatic< Rows, Cols > | |
CCubbyFlow::Transform< N > | Represents N-D rigid body transform |
CCubbyFlow::TypeCast< T, U > | Type casting operator |
►CCubbyFlow::VectorGridBuilder< N > | Abstract base class for N-D vector grid builder |
CCubbyFlow::CellCenteredVectorGrid< N >::Builder | Front-end to create CellCenteredVectorGrid objects step by step |
CCubbyFlow::FaceCenteredGrid< N >::Builder | Front-end to create FaceCenteredGrid objects step by step |
CCubbyFlow::VertexCenteredVectorGrid< N >::Builder | A grid builder class that returns N-D vertex-centered vector grid |