Class List
Here are the classes, structs, unions and interfaces with brief descriptions:
[detail level 123]
▶NCubbyFlow | |
CAdvectionSolver2 | Abstract based class for 2-D grid-based advection solver |
CAdvectionSolver3 | Abstract based class for 3-D grid-based advection solver |
CAnimation | Abstract base class for animation-related class |
CAnisotropicPointsToImplicit2 | 2-D points-to-implicit converter using Anisotropic kernels |
CAnisotropicPointsToImplicit3 | 3-D points-to-implicit converter using Anisotropic kernels |
▶CAPICSolver2 | 2-D Affine Particle-in-Cell (APIC) implementation |
CBuilder | Front-end to create APICSolver2 objects step by step |
▶CAPICSolver3 | 3-D Affine Particle-in-Cell (APIC) implementation |
CBuilder | Front-end to create APICSolver3 objects step by step |
CArray | Generic N-dimensional array class interface |
CArray< T, 1 > | 1-D array class |
CArray< T, 2 > | 2-D array class |
CArray< T, 3 > | 3-D array class |
CArrayAccessor | Generic N-dimensional array accessor class interface |
CArrayAccessor< T, 1 > | 1-D array accessor class |
CArrayAccessor< T, 2 > | 2-D array accessor class |
CArrayAccessor< T, 3 > | 3-D array accessor class |
CBccLatticePointGenerator | Body-centered lattice points generator |
CBLAS | Generic BLAS operator wrapper class |
CBoundingBox | Generic N-D axis-aligned bounding box class |
CBoundingBox< T, 2 > | 2-D axis-aligned bounding box class |
CBoundingBox< T, 3 > | 3-D axis-aligned bounding box class |
CBoundingBoxRayIntersection2 | 2-D box-ray intersection result |
CBoundingBoxRayIntersection3 | 3-D box-ray intersection result |
▶CBox2 | 2-D box geometry |
CBuilder | Front-end to create Box2 objects step by step |
▶CBox3 | 3-D box geometry |
CBuilder | Front-end to create Box3 objects step by step |
CBVH2 | Bounding Volume Hierarchy (BVH) in 2D |
CBVH3 | Bounding Volume Hierarchy (BVH) in 3D |
▶CCellCenteredScalarGrid2 | 2-D Cell-centered scalar grid structure |
CBuilder | Front-end to create CellCenteredScalarGrid2 objects step by step |
▶CCellCenteredScalarGrid3 | 3-D Cell-centered scalar grid structure |
CBuilder | Front-end to create CellCenteredScalarGrid3 objects step by step |
▶CCellCenteredVectorGrid2 | 2-D Cell-centered vector grid structure |
CBuilder | Front-end to create CellCenteredVectorGrid2 objects step by step |
▶CCellCenteredVectorGrid3 | 3-D Cell-centered vector grid structure |
CBuilder | Front-end to create CellCenteredVectorGrid3 objects step by step |
CClosestIntersectionQueryResult2 | Closest intersection query result |
CClosestIntersectionQueryResult3 | Closest intersection query result |
▶CCollider2 | Abstract base class for generic collider object |
CColliderQueryResult | Internal query result structure |
▶CCollider3 | Abstract base class for generic collider object |
CColliderQueryResult | Internal query result structure |
▶CColliderSet2 | Collection of 2-D colliders |
CBuilder | Front-end to create ColliderSet2 objects step by step |
▶CColliderSet3 | Collection of 3-D colliders |
CBuilder | Front-end to create ColliderSet3 objects step by step |
CCollocatedVectorGrid2 | Abstract base class for 2-D collocated vector grid structure |
CCollocatedVectorGrid3 | Abstract base class for 3-D collocated vector grid structure |
▶CConstantScalarField2 | 2-D constant scalar field |
CBuilder | Front-end to create ConstantScalarField2 objects step by step |
▶CConstantScalarField3 | 3-D constant scalar field |
CBuilder | Front-end to create ConstantScalarField3 objects step by step |
▶CConstantVectorField2 | 2-D constant vector field |
CBuilder | Front-end to create ConstantVectorField2 objects step by step |
▶CConstantVectorField3 | 3-D constant vector field |
CBuilder | Front-end to create ConstantVectorField3 objects step by step |
CConstArrayAccessor | Generic N-dimensional read-only array accessor class interface |
CConstArrayAccessor< T, 1 > | 1-D read-only array accessor class |
CConstArrayAccessor< T, 2 > | 2-D read-only array accessor class |
CConstArrayAccessor< T, 3 > | 3-D read-only array accessor class |
CCubicArraySampler | Generic N-D cubic array sampler class |
CCubicArraySampler< T, R, 1 > | 1-D cubic array sampler class |
CCubicArraySampler< T, R, 2 > | 2-D cubic array sampler class |
CCubicArraySampler< T, R, 3 > | 3-D cubic array sampler class |
CCubicSemiLagrangian2 | Implementation of 2-D cubic semi-Lagrangian advection solver |
CCubicSemiLagrangian3 | Implementation of 3-D cubic semi-Lagrangian advection solver |
▶CCustomImplicitSurface2 | Custom 2-D implicit surface using arbitrary function |
CBuilder | Front-end to create CustomImplicitSurface2 objects step by step |
▶CCustomImplicitSurface3 | Custom 3-D implicit surface using arbitrary function |
CBuilder | Front-end to create CustomImplicitSurface3 objects step by step |
▶CCustomScalarField2 | 2-D scalar field with custom field function |
CBuilder | Front-end to create CustomScalarField2 objects step by step |
▶CCustomScalarField3 | 3-D scalar field with custom field function |
CBuilder | Front-end to create CustomScalarField3 objects step by step |
▶CCustomVectorField2 | 2-D vector field with custom field function |
CBuilder | Front-end to create CustomVectorField2 objects step by step |
▶CCustomVectorField3 | 3-D vector field with custom field function |
CBuilder | Front-end to create CustomVectorField3 objects step by step |
▶CCylinder3 | 3-D cylinder geometry |
CBuilder | Front-end to create Cylinder3 objects step by step |
CENOLevelSetSolver2 | Two-dimensional third-order ENO-based iterative level set solver |
CENOLevelSetSolver3 | Three-dimensional third-order ENO-based iterative level set solver |
▶CFaceCenteredGrid2 | 2-D face-centered (a.k.a MAC or staggered) grid |
CBuilder | Front-end to create FaceCenteredGrid2 objects step by step |
▶CFaceCenteredGrid3 | 3-D face-centered (a.k.a MAC or staggered) grid |
CBuilder | Front-end to create CellCenteredScalarGrid3 objects step by step |
CFactory | |
CFDMBLAS2 | BLAS operator wrapper for 2-D finite differencing |
CFDMBLAS3 | BLAS operator wrapper for 3-D finite differencing |
CFDMCGSolver2 | 2-D finite difference-type linear system solver using conjugate gradient |
CFDMCGSolver3 | 3-D finite difference-type linear system solver using conjugate gradient |
CFDMCompressedBLAS2 | BLAS operator wrapper for compressed 2-D finite differencing |
CFDMCompressedBLAS3 | BLAS operator wrapper for compressed 3-D finite differencing |
CFDMCompressedLinearSystem2 | Compressed linear system (Ax=b) for 2-D finite differencing |
CFDMCompressedLinearSystem3 | Compressed linear system (Ax=b) for 3-D finite differencing |
CFDMGaussSeidelSolver2 | 2-D finite difference-type linear system solver using Gauss-Seidel method |
CFDMGaussSeidelSolver3 | 3-D finite difference-type linear system solver using Gauss-Seidel method |
CFDMICCGSolver2 | 2-D finite difference-type linear system solver using incomplete Cholesky conjugate gradient (ICCG) |
CFDMICCGSolver3 | 3-D finite difference-type linear system solver using incomplete Cholesky conjugate gradient (ICCG) |
CFDMJacobiSolver2 | 2-D finite difference-type linear system solver using Jacobi method |
CFDMJacobiSolver3 | 3-D finite difference-type linear system solver using Jacobi method |
CFDMLinearSystem2 | Linear system (Ax=b) for 2-D finite differencing |
CFDMLinearSystem3 | Linear system (Ax=b) for 3-D finite differencing |
CFDMLinearSystemSolver2 | Abstract base class for 2-D finite difference-type linear system solver |
CFDMLinearSystemSolver3 | Abstract base class for 3-D finite difference-type linear system solver |
CFDMMatrixRow2 | The row of FDMMatrix2 where row corresponds to (i, j) grid point |
CFDMMatrixRow3 | The row of FDMMatrix3 where row corresponds to (i, j, k) grid point |
CFDMMGLinearSystem2 | Multigrid-syle 2-D linear system |
CFDMMGLinearSystem3 | Multigrid-syle 3-D linear system |
CFDMMGPCGSolver2 | 2-D finite difference-type linear system solver using Multigrid Preconditioned conjugate gradient (MGPCG) |
CFDMMGPCGSolver3 | 3-D finite difference-type linear system solver using Multigrid Preconditioned conjugate gradient (MGPCG) |
CFDMMGSolver2 | 2-D finite difference-type linear system solver using Multigrid |
CFDMMGSolver3 | 3-D finite difference-type linear system solver using Multigrid |
CFDMMGUtils2 | Multigrid utilities for 2-D FDM system |
CFDMMGUtils3 | Multigrid utilities for 2-D FDM system |
CField2 | Abstract base class for 2-D fields |
CField3 | Abstract base class for 3-D fields |
▶CFLIPSolver2 | 2-D Fluid-Implicit Particle (FLIP) implementation |
CBuilder | Front-end to create FLIPSolver2 objects step by step |
▶CFLIPSolver3 | 3-D Fluid-Implicit Particle (FLIP) implementation |
CBuilder | Front-end to create FLIPSolver3 objects step by step |
CFMMLevelSetSolver2 | Two-dimensional fast marching method (FMM) implementation |
CFMMLevelSetSolver3 | Three-dimensional fast marching method (FMM) implementation |
CFrame | Representation of an animation frame |
CGrid2 | Abstract base class for 2-D cartesian grid structure |
CGrid3 | Abstract base class for 3-D cartesian grid structure |
CGridBackwardEulerDiffusionSolver2 | 2-D grid-based backward Euler diffusion solver |
CGridBackwardEulerDiffusionSolver3 | 3-D grid-based backward Euler diffusion solver |
CGridBlockedBoundaryConditionSolver2 | Blocked 2-D boundary condition solver for grids |
CGridBlockedBoundaryConditionSolver3 | Blocked 3-D boundary condition solver for grids |
CGridBoundaryConditionSolver2 | Abstract base class for 2-D boundary condition solver for grids |
CGridBoundaryConditionSolver3 | Abstract base class for 3-D boundary condition solver for grids |
CGridDiffusionSolver2 | Abstract base class for 2-D grid-based diffusion equation solver |
CGridDiffusionSolver3 | Abstract base class for 3-D grid-based diffusion equation solver |
CGridEmitter2 | Abstract base class for 2-D grid-based emitters |
CGridEmitter3 | Abstract base class for 3-D grid-based emitters |
▶CGridEmitterSet2 | 2-D grid-based emitter set |
CBuilder | Front-end to create GridEmitterSet2 objects step by step |
▶CGridEmitterSet3 | 3-D grid-based emitter set |
CBuilder | Front-end to create GridEmitterSet3 objects step by step |
▶CGridFluidSolver2 | Abstract base class for grid-based 2-D fluid solver |
CBuilder | Front-end to create GridFluidSolver2 objects step by step |
▶CGridFluidSolver3 | Abstract base class for grid-based 3-D fluid solver |
CBuilder | Front-end to create GridFluidSolver3 objects step by step |
CGridFluidSolverBuilderBase2 | Base class for grid-based fluid solver builder |
CGridFluidSolverBuilderBase3 | Base class for grid-based fluid solver builder |
CGridForwardEulerDiffusionSolver2 | 2-D grid-based forward Euler diffusion solver |
CGridForwardEulerDiffusionSolver3 | 3-D grid-based forward Euler diffusion solver |
CGridFractionalBoundaryConditionSolver2 | Fractional 2-D boundary condition solver for grids |
CGridFractionalBoundaryConditionSolver3 | Fractional 3-D boundary condition solver for grids |
CGridFractionalSinglePhasePressureSolver2 | 2-D fractional single-phase pressure solver |
CGridFractionalSinglePhasePressureSolver3 | 3-D fractional single-phase pressure solver |
CGridPointGenerator2 | 2-D regular-grid point generator |
CGridPointGenerator3 | 3-D regular-grid point generator |
CGridPressureSolver2 | Abstract base class for 2-D grid-based pressure solver |
CGridPressureSolver3 | Abstract base class for 2-D grid-based pressure solver |
CGridSinglePhasePressureSolver2 | 2-D single-phase pressure solver |
CGridSinglePhasePressureSolver3 | 3-D single-phase pressure solver |
▶CGridSmokeSolver2 | 2-D grid-based smoke solver |
CBuilder | Front-end to create GridSmokeSolver2 objects step by step |
▶CGridSmokeSolver3 | 3-D grid-based smoke solver |
CBuilder | Front-end to create GridSmokeSolver3 objects step by step |
CGridSystemData2 | 2-D grid system data |
CGridSystemData3 | 3-D grid system data |
CImplicitSurface2 | Abstract base class for 2-D implicit surface |
CImplicitSurface3 | Abstract base class for 3-D implicit surface |
▶CImplicitSurfaceSet2 | 2-D implicit surface set |
CBuilder | Front-end to create ImplicitSurfaceSet2 objects step by step |
▶CImplicitSurfaceSet3 | 3-D implicit surface set |
CBuilder | Front-end to create ImplicitSurfaceSet3 objects step by step |
▶CImplicitTriangleMesh3 | TriangleMesh3 to ImplicitSurface3 converter |
CBuilder | Front-end to create ImplicitTriangleMesh3 objects step by step |
CIntersectionQueryEngine2 | Abstract base class for 2-D intersection test query engine |
CIntersectionQueryEngine3 | Abstract base class for 3-D intersection test query engine |
CIterativeLevelSetSolver2 | Abstract base class for 2-D PDE-based iterative level set solver |
CIterativeLevelSetSolver3 | Abstract base class for 3-D PDE-based iterative level set solver |
▶CKdTree | Generic k-d tree structure |
CNode | Simple K-d tree node |
▶CLevelSetLiquidSolver2 | Level set based 2-D liquid solver |
CBuilder | Front-end to create LevelSetLiquidSolver2 objects step by step |
▶CLevelSetLiquidSolver3 | Level set based 3-D liquid solver |
CBuilder | Front-end to create LevelSetLiquidSolver3 objects step by step |
CLevelSetSolver2 | Abstract base class for 2-D level set solver |
CLevelSetSolver3 | Abstract base class for 3-D level set solver |
CLinearArraySampler | Generic N-D linear array sampler class |
CLinearArraySampler< T, R, 1 > | 1-D linear array sampler class |
CLinearArraySampler< T, R, 2 > | 2-D linear array sampler class |
CLinearArraySampler< T, R, 3 > | 3-D linear array sampler class |
CListQueryEngine2 | Ad-hoc list-based 2-D intersection/nearest-neighbor query engine |
CListQueryEngine3 | Ad-hoc list-based 3-D intersection/nearest-neighbor query engine |
CLogger | Super simple logger implementation |
CLogging | Helper class for logging |
CMatrix | Static-sized M x N matrix class |
CMatrix< T, 2, 2 > | 2-D matrix class |
CMatrix< T, 3, 3 > | 3-D matrix class |
CMatrix< T, 4, 4 > | 4-D matrix class |
CMatrixBinaryOp | Matrix expression for binary operation |
CMatrixConstant | Constant matrix expression |
▶CMatrixCSR | Compressed Sparse Row (CSR) matrix class |
CElement | |
CMatrixCSRMatrixMul | Matrix expression for CSR matrix-matrix multiplication |
CMatrixCSRVectorMul | Vector expression for CSR matrix-vector multiplication |
CMatrixDiagonal | Diagonal matrix expression |
CMatrixExpression | Base class for matrix expression |
CMatrixIdentity | Identity matrix expression |
CMatrixMul | Matrix expression for matrix-matrix multiplication |
CMatrixMxN | M x N matrix class |
CMatrixScalarBinaryOp | Matrix expression for matrix-scalar binary operation |
CMatrixTriangular | Triangular matrix expression |
CMatrixUnaryOp | Matrix expression for unary operation |
CMatrixVectorMul | Vector expression for matrix-vector multiplication |
CMGMatrix | Multi-grid matrix wrapper |
CMGParameters | Multi-grid input parameter set |
CMGResult | Multi-grid result type |
CMGVector | Multi-grid vector wrapper |
CNearestArraySampler | Generic N-D nearest array sampler class |
CNearestArraySampler< T, R, 1 > | 1-D nearest array sampler class |
CNearestArraySampler< T, R, 2 > | 2-D nearest array sampler class |
CNearestArraySampler< T, R, 3 > | 3-D nearest array sampler class |
CNearestNeighborQueryEngine2 | Abstract base class for 2-D nearest neighbor query engine |
CNearestNeighborQueryEngine3 | Abstract base class for 3-D nearest neighbor query engine |
CNearestNeighborQueryResult2 | Nearest neighbor query result |
CNearestNeighborQueryResult3 | Nearest neighbor query result |
CNullCGPreconditioner | No-op pre-conditioner for conjugate gradient |
COctree | Generic octree data structure |
CParticleEmitter2 | Abstract base class for 2-D particle emitter |
CParticleEmitter3 | Abstract base class for 3-D particle emitter |
▶CParticleEmitterSet2 | 2-D particle-based emitter set |
CBuilder | Front-end to create ParticleEmitterSet2 objects step by step |
▶CParticleEmitterSet3 | 3-D particle-based emitter set |
CBuilder | Front-end to create ParticleEmitterSet3 objects step by step |
CParticleSystemData2 | 2-D particle system data |
CParticleSystemData3 | 3-D particle system data |
▶CParticleSystemSolver2 | Basic 2-D particle system solver |
CBuilder | Front-end to create ParticleSystemSolver2 objects step by step |
▶CParticleSystemSolver3 | Basic 3-D particle system solver |
CBuilder | Front-end to create ParticleSystemSolver3 objects step by step |
CParticleSystemSolverBuilderBase2 | Base class for particle-based solver builder |
CParticleSystemSolverBuilderBase3 | Base class for particle-based solver builder |
▶CPCISPHSolver2 | 2-D PCISPH solver |
CBuilder | Front-end to create PCISPHSolver2 objects step by step |
▶CPCISPHSolver3 | 3-D PCISPH solver |
CBuilder | Front-end to create PCISPHSolver3 objects step by step |
CPhysicsAnimation | Abstract base class for physics-based animation |
▶CPICSolver2 | 2-D Particle-in-Cell (PIC) implementation |
CBuilder | Front-end to create PICSolver2 objects step by step |
▶CPICSolver3 | 3-D Particle-in-Cell (PIC) implementation |
CBuilder | Front-end to create PICSolver3 objects step by step |
▶CPlane2 | 2-D plane geometry |
CBuilder | Front-end to create Plane2 objects step by step |
▶CPlane3 | 3-D plane geometry |
CBuilder | Front-end to create Plane3 objects step by step |
CPoint | Generic N-D point class |
CPoint< T, 2 > | 2-D point class |
CPoint< T, 3 > | 3-D point class |
CPointGenerator2 | Abstract base class for 2-D point generator |
CPointGenerator3 | Abstract base class for 3-D point generator |
▶CPointHashGridSearcher2 | Hash grid-based 2-D point searcher |
CBuilder | Front-end to create PointHashGridSearcher2 objects step by step |
▶CPointHashGridSearcher3 | Hash grid-based 3-D point searcher |
CBuilder | Front-end to create PointHashGridSearcher3 objects step by step |
▶CPointKdTreeSearcher2 | KdTree-based 2-D point searcher |
CBuilder | Front-end to create PointKdTreeSearcher2 objects step by step |
▶CPointKdTreeSearcher3 | KdTree-based 3-D point searcher |
CBuilder | Front-end to create PointKdTreeSearcher3 objects step by step |
CPointNeighborSearcher2 | Abstract base class for 2-D neighbor point searcher |
CPointNeighborSearcher3 | Abstract base class for 3-D neighbor point searcher |
CPointNeighborSearcherBuilder2 | Abstract base class for 2-D point neighbor searcher builders |
CPointNeighborSearcherBuilder3 | Abstract base class for 3-D point neighbor searcher builders |
▶CPointParallelHashGridSearcher2 | Parallel version of hash grid-based 2-D point searcher |
CBuilder | Front-end to create PointParallelHashGridSearcher2 objects step by step |
▶CPointParallelHashGridSearcher3 | Parallel version of hash grid-based 3-D point searcher |
CBuilder | Front-end to create PointParallelHashGridSearcher3 objects step by step |
▶CPointParticleEmitter2 | 2-D point particle emitter |
CBuilder | Front-end to create PointParticleEmitter2 objects step by step |
▶CPointParticleEmitter3 | 3-D point particle emitter |
CBuilder | Front-end to create PointParticleEmitter3 objects step by step |
▶CPointSimpleListSearcher2 | Simple ad-hoc 2-D point searcher |
CBuilder | Front-end to create PointSimpleListSearcher2 objects step by step |
▶CPointSimpleListSearcher3 | Simple ad-hoc 3-D point searcher |
CBuilder | Front-end to create PointSimpleListSearcher3 objects step by step |
CPointsToImplicit2 | Abstract base class for 2-D points-to-implicit converters |
CPointsToImplicit3 | Abstract base class for 3-D points-to-implicit converters |
CQuadtree | Generic quadtree data structure |
CQuaternion | Quaternion class defined as q = w + xi + yj + zk |
CRay | Class for ray |
CRay< T, 2 > | Class for 2-D ray |
CRay< T, 3 > | Class for 3-D ray |
CRDivides | Reverse divides operator |
▶CRigidBodyCollider2 | 2-D rigid body collider class |
CBuilder | Front-end to create RigidBodyCollider2 objects step by step |
▶CRigidBodyCollider3 | 3-D rigid body collider class |
CBuilder | Front-end to create RigidBodyCollider3 objects step by step |
CRMinus | Reverse minus operator |
CScalarField2 | Abstract base class for 2-D scalar field |
CScalarField3 | Abstract base class for 3-D scalar field |
CScalarGrid2 | Abstract base class for 2-D scalar grid structure |
CScalarGrid3 | Abstract base class for 3-D scalar grid structure |
CScalarGridBuilder2 | Abstract base class for 2-D scalar grid builder |
CScalarGridBuilder3 | Abstract base class for 3-D scalar grid builder |
CScalarType | Returns the type of the value itself |
CScalarType< Vector< T, 2 > > | Returns the type of the value itself |
CScalarType< Vector< T, 3 > > | Returns the type of the value itself |
CScalarType< Vector< T, 4 > > | Returns the type of the value itself |
CScalarType< Vector< T, N > > | Returns the type of the value |
CSemiLagrangian2 | Implementation of 2-D semi-Lagrangian advection solver |
CSemiLagrangian3 | Implementation of 3-D semi-Lagrangian advection solver |
CSerializable | Abstract base class for any serializable class |
▶CSphere2 | 2-D sphere geometry |
CBuilder | Front-end to create Sphere2 objects step by step |
▶CSphere3 | 3-D sphere geometry |
CBuilder | Front-end to create Sphere3 objects step by step |
CSphericalPointsToImplicit2 | 2-D points-to-implicit converter based on simple sphere model |
CSphericalPointsToImplicit3 | 3-D points-to-implicit converter based on simple sphere model |
CSPHPointsToImplicit2 | 2-D points-to-implicit converter based on standard SPH kernel |
CSPHPointsToImplicit3 | 3-D points-to-implicit converter based on standard SPH kernel |
▶CSPHSolver2 | 2-D SPH solver |
CBuilder | Front-end to create SPHSolver2 objects step by step |
▶CSPHSolver3 | 3-D SPH solver |
CBuilder | Front-end to create SPHSolver3 objects step by step |
CSPHSolverBuilderBase2 | Base class for SPH-based fluid solver builder |
CSPHSolverBuilderBase3 | Base class for SPH-based fluid solver builder |
CSPHSpikyKernel2 | Spiky 2-D SPH kernel function object |
CSPHSpikyKernel3 | Spiky 3-D SPH kernel function object |
CSPHStdKernel2 | Standard 2-D SPH kernel function object |
CSPHStdKernel3 | Standard 3-D SPH kernel function object |
CSPHSystemData2 | 2-D SPH particle system data |
CSPHSystemData3 | 3-D SPH particle system data |
CSurface2 | Abstract base class for 2-D surface |
CSurface3 | Abstract base class for 3-D surface |
CSurfaceBuilderBase2 | Base class for 2-D surface builder |
CSurfaceBuilderBase3 | Base class for 3-D surface builder |
CSurfaceRayIntersection2 | Structure that represents ray-surface intersection point |
CSurfaceRayIntersection3 | Structure that represents ray-surface intersection point |
▶CSurfaceSet2 | 2-D surface set |
CBuilder | Front-end to create SurfaceSet2 objects step by step |
▶CSurfaceSet3 | 3-D surface set |
CBuilder | Front-end to create SurfaceSet3 objects step by step |
▶CSurfaceToImplicit2 | 2-D implicit surface wrapper for generic Surface2 instance |
CBuilder | Front-end to create SurfaceToImplicit2 objects step by step |
▶CSurfaceToImplicit3 | 3-D implicit surface wrapper for generic Surface3 instance |
CBuilder | Front-end to create SurfaceToImplicit3 objects step by step |
CTimer | Simple timer class |
CTransform2 | Represents 2-D rigid body transform |
CTransform3 | Represents 3-D rigid body transform |
▶CTriangle3 | 3-D triangle geometry |
CBuilder | Front-end to create Triangle3 objects step by step |
▶CTriangleMesh3 | 3-D triangle mesh geometry |
CBuilder | Front-end to create TriangleMesh3 objects step by step |
CTrianglePointGenerator | Right triangle point generator |
CTypeCast | Type casting operator |
CUpwindLevelSetSolver2 | |
CUpwindLevelSetSolver3 | Three-dimensional first-order upwind-based iterative level set solver |
CVector | Generic statically-sized N-D vector class |
CVector< T, 2 > | 2-D vector class |
CVector< T, 3 > | 3-D vector class |
CVector< T, 4 > | 4-D vector class |
CVectorBinaryOp | Vector expression for binary operation |
CVectorExpression | Base class for vector expression |
CVectorField2 | Abstract base class for 2-D vector field |
CVectorField3 | Abstract base class for 3-D vector field |
CVectorGrid2 | Abstract base class for 2-D vector grid structure |
CVectorGrid3 | Abstract base class for 3-D vector grid structure |
CVectorGridBuilder2 | Abstract base class for 2-D vector grid builder |
CVectorGridBuilder3 | Abstract base class for 3-D vector grid builder |
CVectorN | General purpose dynamically-sizedN-D vector class |
CVectorScalarBinaryOp | Vector expression for matrix-scalar binary operation |
CVectorUnaryOp | Vector expression for unary operation |
▶CVertexCenteredScalarGrid2 | 2-D Vertex-centered scalar grid structure |
CBuilder | A grid builder class that returns 2-D vertex-centered scalar grid |
▶CVertexCenteredScalarGrid3 | 3-D Vertex-centered scalar grid structure |
CBuilder | A grid builder class that returns 3-D vertex-centered scalar grid |
▶CVertexCenteredVectorGrid2 | 2-D Vertex-centered vector grid structure |
CBuilder | A grid builder class that returns 2-D vertex-centered Vector grid |
▶CVertexCenteredVectorGrid3 | 3-D Vertex-centered vector grid structure |
CBuilder | A grid builder class that returns 3-D vertex-centered Vector grid |
▶CVolumeGridEmitter2 | 2-D grid-based volumetric emitter |
CBuilder | Front-end to create VolumeGridEmitter2 objects step by step |
▶CVolumeGridEmitter3 | 3-D grid-based volumetric emitter |
CBuilder | Front-end to create VolumeGridEmitter3 objects step by step |
▶CVolumeParticleEmitter2 | 2-D volumetric particle emitter |
CBuilder | Front-end to create VolumeParticleEmitter2 objects step by step |
▶CVolumeParticleEmitter3 | 3-D volumetric particle emitter |
CBuilder | Front-end to create VolumeParticleEmitter3 objects step by step |
CZhuBridsonPointsToImplicit2 | 2-D points-to-implicit converter based on Zhu and Bridson's method |
CZhuBridsonPointsToImplicit3 | 3-D points-to-implicit converter based on Zhu and Bridson's method |
▶NCubbyFlowSharp | |
CAnimation | Abstract base class for animation-related class |
CFrame | Representation of an animation frame |