|
| class | AdvectionSolver2 |
| | Abstract based class for 2-D grid-based advection solver. More...
|
| |
| class | AdvectionSolver3 |
| | Abstract based class for 3-D grid-based advection solver. More...
|
| |
| class | Animation |
| | Abstract base class for animation-related class. More...
|
| |
| class | AnisotropicPointsToImplicit2 |
| | 2-D points-to-implicit converter using Anisotropic kernels. More...
|
| |
| class | AnisotropicPointsToImplicit3 |
| | 3-D points-to-implicit converter using Anisotropic kernels. More...
|
| |
| class | ApicSolver2 |
| | 2-D Affine Particle-in-Cell (APIC) implementation More...
|
| |
| class | ApicSolver3 |
| | 3-D Affine Particle-in-Cell (APIC) implementation More...
|
| |
| class | Array |
| | Generic N-dimensional array class interface. More...
|
| |
| class | Array< T, 1 > |
| | 1-D array class. More...
|
| |
| class | Array< T, 2 > |
| | 2-D array class. More...
|
| |
| class | Array< T, 3 > |
| | 3-D array class. More...
|
| |
| class | ArrayAccessor |
| | Generic N-dimensional array accessor class interface. More...
|
| |
| class | ArrayAccessor< T, 1 > |
| | 1-D array accessor class. More...
|
| |
| class | ArrayAccessor< T, 2 > |
| | 2-D array accessor class. More...
|
| |
| class | ArrayAccessor< T, 3 > |
| | 3-D array accessor class. More...
|
| |
| class | BccLatticePointGenerator |
| | Body-centered lattice points generator. More...
|
| |
| struct | Blas |
| | Generic BLAS operator wrapper class. More...
|
| |
| class | BoundingBox |
| | Generic N-D axis-aligned bounding box class. More...
|
| |
| class | BoundingBox< T, 2 > |
| | 2-D axis-aligned bounding box class. More...
|
| |
| class | BoundingBox< T, 3 > |
| | 3-D axis-aligned bounding box class. More...
|
| |
| struct | BoundingBoxRayIntersection2 |
| | 2-D box-ray intersection result. More...
|
| |
| struct | BoundingBoxRayIntersection3 |
| | 3-D box-ray intersection result. More...
|
| |
| class | Box2 |
| | 2-D box geometry. More...
|
| |
| class | Box3 |
| | 3-D box geometry. More...
|
| |
| class | Bvh2 |
| | Bounding Volume Hierarchy (BVH) in 2D. More...
|
| |
| class | Bvh3 |
| | Bounding Volume Hierarchy (BVH) in 3D. More...
|
| |
| class | CellCenteredScalarGrid2 |
| | 2-D Cell-centered scalar grid structure. More...
|
| |
| class | CellCenteredScalarGrid3 |
| | 3-D Cell-centered scalar grid structure. More...
|
| |
| class | CellCenteredVectorGrid2 |
| | 2-D Cell-centered vector grid structure. More...
|
| |
| class | CellCenteredVectorGrid3 |
| | 3-D Cell-centered vector grid structure. More...
|
| |
| struct | ClosestIntersectionQueryResult2 |
| | Closest intersection query result. More...
|
| |
| struct | ClosestIntersectionQueryResult3 |
| | Closest intersection query result. More...
|
| |
| class | Collider2 |
| | Abstract base class for generic collider object. More...
|
| |
| class | Collider3 |
| | Abstract base class for generic collider object. More...
|
| |
| class | ColliderSet2 |
| | Collection of 2-D colliders. More...
|
| |
| class | ColliderSet3 |
| | Collection of 3-D colliders. More...
|
| |
| class | CollocatedVectorGrid2 |
| | Abstract base class for 2-D collocated vector grid structure. More...
|
| |
| class | CollocatedVectorGrid3 |
| | Abstract base class for 3-D collocated vector grid structure. More...
|
| |
| class | ConstantScalarField2 |
| | 2-D constant scalar field. More...
|
| |
| class | ConstantScalarField3 |
| | 3-D constant scalar field. More...
|
| |
| class | ConstantVectorField2 |
| | 2-D constant vector field. More...
|
| |
| class | ConstantVectorField3 |
| | 3-D constant vector field. More...
|
| |
| class | ConstArrayAccessor |
| | Generic N-dimensional read-only array accessor class interface. More...
|
| |
| class | ConstArrayAccessor< T, 1 > |
| | 1-D read-only array accessor class. More...
|
| |
| class | ConstArrayAccessor< T, 2 > |
| | 2-D read-only array accessor class. More...
|
| |
| class | ConstArrayAccessor< T, 3 > |
| | 3-D read-only array accessor class. More...
|
| |
| class | CubicArraySampler |
| | Generic N-D cubic array sampler class. More...
|
| |
| class | CubicArraySampler< T, R, 1 > |
| | 1-D cubic array sampler class. More...
|
| |
| class | CubicArraySampler< T, R, 2 > |
| | 2-D cubic array sampler class. More...
|
| |
| class | CubicArraySampler< T, R, 3 > |
| | 3-D cubic array sampler class. More...
|
| |
| class | CubicSemiLagrangian2 |
| | Implementation of 2-D cubic semi-Lagrangian advection solver. More...
|
| |
| class | CubicSemiLagrangian3 |
| | Implementation of 3-D cubic semi-Lagrangian advection solver. More...
|
| |
| class | CustomImplicitSurface2 |
| | Custom 2-D implicit surface using arbitrary function. More...
|
| |
| class | CustomImplicitSurface3 |
| | Custom 3-D implicit surface using arbitrary function. More...
|
| |
| class | CustomScalarField2 |
| | 2-D scalar field with custom field function. More...
|
| |
| class | CustomScalarField3 |
| | 3-D scalar field with custom field function. More...
|
| |
| class | CustomVectorField2 |
| | 2-D vector field with custom field function. More...
|
| |
| class | CustomVectorField3 |
| | 3-D vector field with custom field function. More...
|
| |
| class | Cylinder3 |
| | 3-D cylinder geometry. More...
|
| |
| class | EnoLevelSetSolver2 |
| | Two-dimensional third-order ENO-based iterative level set solver. More...
|
| |
| class | EnoLevelSetSolver3 |
| | Three-dimensional third-order ENO-based iterative level set solver. More...
|
| |
| class | FaceCenteredGrid2 |
| | 2-D face-centered (a.k.a MAC or staggered) grid. More...
|
| |
| class | FaceCenteredGrid3 |
| | 3-D face-centered (a.k.a MAC or staggered) grid. More...
|
| |
| class | FccLatticePointGenerator |
| | Face-centered lattice points generator. More...
|
| |
| struct | FdmBlas2 |
| | BLAS operator wrapper for 2-D finite differencing. More...
|
| |
| struct | FdmBlas3 |
| | BLAS operator wrapper for 3-D finite differencing. More...
|
| |
| class | FdmCgSolver2 |
| | 2-D finite difference-type linear system solver using conjugate gradient. More...
|
| |
| class | FdmCgSolver3 |
| | 3-D finite difference-type linear system solver using conjugate gradient. More...
|
| |
| struct | FdmCompressedBlas2 |
| | BLAS operator wrapper for compressed 2-D finite differencing. More...
|
| |
| struct | FdmCompressedBlas3 |
| | BLAS operator wrapper for compressed 3-D finite differencing. More...
|
| |
| struct | FdmCompressedLinearSystem2 |
| | Compressed linear system (Ax=b) for 2-D finite differencing. More...
|
| |
| struct | FdmCompressedLinearSystem3 |
| | Compressed linear system (Ax=b) for 3-D finite differencing. More...
|
| |
| class | FdmGaussSeidelSolver2 |
| | 2-D finite difference-type linear system solver using Gauss-Seidel method. More...
|
| |
| class | FdmGaussSeidelSolver3 |
| | 3-D finite difference-type linear system solver using Gauss-Seidel method. More...
|
| |
| class | FdmIccgSolver2 |
| | 2-D finite difference-type linear system solver using incomplete Cholesky conjugate gradient (ICCG). More...
|
| |
| class | FdmIccgSolver3 |
| | 3-D finite difference-type linear system solver using incomplete Cholesky conjugate gradient (ICCG). More...
|
| |
| class | FdmJacobiSolver2 |
| | 2-D finite difference-type linear system solver using Jacobi method. More...
|
| |
| class | FdmJacobiSolver3 |
| | 3-D finite difference-type linear system solver using Jacobi method. More...
|
| |
| struct | FdmLinearSystem2 |
| | Linear system (Ax=b) for 2-D finite differencing. More...
|
| |
| struct | FdmLinearSystem3 |
| | Linear system (Ax=b) for 3-D finite differencing. More...
|
| |
| class | FdmLinearSystemSolver2 |
| | Abstract base class for 2-D finite difference-type linear system solver. More...
|
| |
| class | FdmLinearSystemSolver3 |
| | Abstract base class for 3-D finite difference-type linear system solver. More...
|
| |
| struct | FdmMatrixRow2 |
| | The row of FdmMatrix2 where row corresponds to (i, j) grid point. More...
|
| |
| struct | FdmMatrixRow3 |
| | The row of FdmMatrix3 where row corresponds to (i, j, k) grid point. More...
|
| |
| struct | FdmMgLinearSystem2 |
| | Multigrid-syle 2-D linear system. More...
|
| |
| struct | FdmMgLinearSystem3 |
| | Multigrid-syle 3-D linear system. More...
|
| |
| class | FdmMgpcgSolver2 |
| | 2-D finite difference-type linear system solver using Multigrid Preconditioned conjugate gradient (MGPCG). More...
|
| |
| class | FdmMgpcgSolver3 |
| | 3-D finite difference-type linear system solver using Multigrid Preconditioned conjugate gradient (MGPCG). More...
|
| |
| class | FdmMgSolver2 |
| | 2-D finite difference-type linear system solver using Multigrid. More...
|
| |
| class | FdmMgSolver3 |
| | 3-D finite difference-type linear system solver using Multigrid. More...
|
| |
| class | FdmMgUtils2 |
| | Multigrid utilities for 2-D FDM system. More...
|
| |
| class | FdmMgUtils3 |
| | Multigrid utilities for 2-D FDM system. More...
|
| |
| class | Field2 |
| | Abstract base class for 2-D fields. More...
|
| |
| class | Field3 |
| | Abstract base class for 3-D fields. More...
|
| |
| class | FlipSolver2 |
| | 2-D Fluid-Implicit Particle (FLIP) implementation. More...
|
| |
| class | FlipSolver3 |
| | 3-D Fluid-Implicit Particle (FLIP) implementation. More...
|
| |
| class | FmmLevelSetSolver2 |
| | Two-dimensional fast marching method (FMM) implementation. More...
|
| |
| class | FmmLevelSetSolver3 |
| | Three-dimensional fast marching method (FMM) implementation. More...
|
| |
| struct | Frame |
| | Representation of an animation frame. More...
|
| |
| class | Grid2 |
| | Abstract base class for 2-D cartesian grid structure. More...
|
| |
| class | Grid3 |
| | Abstract base class for 3-D cartesian grid structure. More...
|
| |
| class | GridBackwardEulerDiffusionSolver2 |
| | 2-D grid-based backward Euler diffusion solver. More...
|
| |
| class | GridBackwardEulerDiffusionSolver3 |
| | 3-D grid-based backward Euler diffusion solver. More...
|
| |
| class | GridBlockedBoundaryConditionSolver2 |
| | Blocked 2-D boundary condition solver for grids. More...
|
| |
| class | GridBlockedBoundaryConditionSolver3 |
| | Blocked 3-D boundary condition solver for grids. More...
|
| |
| class | GridBoundaryConditionSolver2 |
| | Abstract base class for 2-D boundary condition solver for grids. More...
|
| |
| class | GridBoundaryConditionSolver3 |
| | Abstract base class for 3-D boundary condition solver for grids. More...
|
| |
| class | GridDiffusionSolver2 |
| | Abstract base class for 2-D grid-based diffusion equation solver. More...
|
| |
| class | GridDiffusionSolver3 |
| | Abstract base class for 3-D grid-based diffusion equation solver. More...
|
| |
| class | GridEmitter2 |
| | Abstract base class for 2-D grid-based emitters. More...
|
| |
| class | GridEmitter3 |
| | Abstract base class for 3-D grid-based emitters. More...
|
| |
| class | GridEmitterSet2 |
| | 2-D grid-based emitter set. More...
|
| |
| class | GridEmitterSet3 |
| | 3-D grid-based emitter set. More...
|
| |
| class | GridFluidSolver2 |
| | Abstract base class for grid-based 2-D fluid solver. More...
|
| |
| class | GridFluidSolver3 |
| | Abstract base class for grid-based 3-D fluid solver. More...
|
| |
| class | GridFluidSolverBuilderBase2 |
| | Base class for grid-based fluid solver builder. More...
|
| |
| class | GridFluidSolverBuilderBase3 |
| | Base class for grid-based fluid solver builder. More...
|
| |
| class | GridForwardEulerDiffusionSolver2 |
| | 2-D grid-based forward Euler diffusion solver. More...
|
| |
| class | GridForwardEulerDiffusionSolver3 |
| | 3-D grid-based forward Euler diffusion solver. More...
|
| |
| class | GridFractionalBoundaryConditionSolver2 |
| | Fractional 2-D boundary condition solver for grids. More...
|
| |
| class | GridFractionalBoundaryConditionSolver3 |
| | Fractional 3-D boundary condition solver for grids. More...
|
| |
| class | GridFractionalSinglePhasePressureSolver2 |
| | 2-D fractional single-phase pressure solver. More...
|
| |
| class | GridFractionalSinglePhasePressureSolver3 |
| | 3-D fractional single-phase pressure solver. More...
|
| |
| class | GridPointGenerator2 |
| | 2-D regular-grid point generator. More...
|
| |
| class | GridPointGenerator3 |
| | 3-D regular-grid point generator. More...
|
| |
| class | GridPressureSolver2 |
| | Abstract base class for 2-D grid-based pressure solver. More...
|
| |
| class | GridPressureSolver3 |
| | Abstract base class for 3-D grid-based pressure solver. More...
|
| |
| class | GridSinglePhasePressureSolver2 |
| | 2-D single-phase pressure solver. More...
|
| |
| class | GridSinglePhasePressureSolver3 |
| | 3-D single-phase pressure solver. More...
|
| |
| class | GridSmokeSolver2 |
| | 2-D grid-based smoke solver. More...
|
| |
| class | GridSmokeSolver3 |
| | 3-D grid-based smoke solver. More...
|
| |
| class | GridSystemData2 |
| | 2-D grid system data. More...
|
| |
| class | GridSystemData3 |
| | 3-D grid system data. More...
|
| |
| class | ImplicitSurface2 |
| | Abstract base class for 2-D implicit surface. More...
|
| |
| class | ImplicitSurface3 |
| | Abstract base class for 3-D implicit surface. More...
|
| |
| class | ImplicitSurfaceSet2 |
| | 2-D implicit surface set. More...
|
| |
| class | ImplicitSurfaceSet3 |
| | 3-D implicit surface set. More...
|
| |
| class | ImplicitTriangleMesh3 |
| | TriangleMesh3 to ImplicitSurface3 converter. More...
|
| |
| class | IntersectionQueryEngine2 |
| | Abstract base class for 2-D intersection test query engine. More...
|
| |
| class | IntersectionQueryEngine3 |
| | Abstract base class for 3-D intersection test query engine. More...
|
| |
| class | IterativeLevelSetSolver2 |
| | Abstract base class for 2-D PDE-based iterative level set solver. More...
|
| |
| class | IterativeLevelSetSolver3 |
| | Abstract base class for 3-D PDE-based iterative level set solver. More...
|
| |
| class | KdTree |
| | Generic k-d tree structure. More...
|
| |
| class | LevelSetLiquidSolver2 |
| | Level set based 2-D liquid solver. More...
|
| |
| class | LevelSetLiquidSolver3 |
| | Level set based 3-D liquid solver. More...
|
| |
| class | LevelSetSolver2 |
| | Abstract base class for 2-D level set solver. More...
|
| |
| class | LevelSetSolver3 |
| | Abstract base class for 3-D level set solver. More...
|
| |
| class | LinearArraySampler |
| | Generic N-D linear array sampler class. More...
|
| |
| class | LinearArraySampler< T, R, 1 > |
| | 1-D linear array sampler class. More...
|
| |
| class | LinearArraySampler< T, R, 2 > |
| | 2-D linear array sampler class. More...
|
| |
| class | LinearArraySampler< T, R, 3 > |
| | 2-D linear array sampler class. More...
|
| |
| class | ListQueryEngine2 |
| | Ad-hoc list-based 2-D intersection/nearest-neighbor query engine. More...
|
| |
| class | ListQueryEngine3 |
| | Ad-hoc list-based 3-D intersection/nearest-neighbor query engine. More...
|
| |
| class | Logger |
| | Super simple logger implementation. More...
|
| |
| class | Logging |
| | Helper class for logging. More...
|
| |
| class | Matrix |
| | Static-sized M x N matrix class. More...
|
| |
| class | Matrix< T, 2, 2 > |
| | 2-D matrix class. More...
|
| |
| class | Matrix< T, 3, 3 > |
| | 3-D matrix class. More...
|
| |
| class | Matrix< T, 4, 4 > |
| | 4-D matrix class. More...
|
| |
| class | MatrixBinaryOp |
| | Matrix expression for binary operation. More...
|
| |
| class | MatrixConstant |
| | Constant matrix expression. More...
|
| |
| class | MatrixCsr |
| | Compressed Sparse Row (CSR) matrix class. More...
|
| |
| class | MatrixCsrMatrixMul |
| | Matrix expression for CSR matrix-matrix multiplication. More...
|
| |
| class | MatrixCsrVectorMul |
| | Vector expression for CSR matrix-vector multiplication. More...
|
| |
| class | MatrixDiagonal |
| | Diagonal matrix expression. More...
|
| |
| class | MatrixExpression |
| | Base class for matrix expression. More...
|
| |
| class | MatrixIdentity |
| | Identity matrix expression. More...
|
| |
| class | MatrixMul |
| | Matrix expression for matrix-matrix multiplication. More...
|
| |
| class | MatrixMxN |
| | M x N matrix class. More...
|
| |
| class | MatrixScalarBinaryOp |
| | Matrix expression for matrix-scalar binary operation. More...
|
| |
| class | MatrixTriangular |
| | Triangular matrix expression. More...
|
| |
| class | MatrixUnaryOp |
| | Matrix expression for unary operation. More...
|
| |
| class | MatrixVectorMul |
| | Vector expression for matrix-vector multiplication. More...
|
| |
| struct | MgMatrix |
| | Multigrid matrix wrapper. More...
|
| |
| struct | MgParameters |
| | Multigrid input parameter set. More...
|
| |
| struct | MgResult |
| | Multigrid result type. More...
|
| |
| struct | MgVector |
| | Multigrid vector wrapper. More...
|
| |
| class | NearestArraySampler |
| | Generic N-D nearest array sampler class. More...
|
| |
| class | NearestArraySampler< T, R, 1 > |
| | 1-D nearest array sampler class. More...
|
| |
| class | NearestArraySampler< T, R, 2 > |
| | 2-D nearest array sampler class. More...
|
| |
| class | NearestArraySampler< T, R, 3 > |
| | 3-D nearest array sampler class. More...
|
| |
| class | NearestNeighborQueryEngine2 |
| | Abstract base class for 2-D nearest neigbor query engine. More...
|
| |
| class | NearestNeighborQueryEngine3 |
| | Abstract base class for 3-D nearest neigbor query engine. More...
|
| |
| struct | NearestNeighborQueryResult2 |
| | Nearest neighbor query result. More...
|
| |
| struct | NearestNeighborQueryResult3 |
| | Nearest neighbor query result. More...
|
| |
| struct | NullCgPreconditioner |
| | No-op preconditioner for conjugate gradient. More...
|
| |
| class | Octree |
| | Generic octree data structure. More...
|
| |
| class | ParticleEmitter2 |
| | Abstract base class for 2-D particle emitter. More...
|
| |
| class | ParticleEmitter3 |
| | Abstract base class for 3-D particle emitter. More...
|
| |
| class | ParticleEmitterSet2 |
| | 2-D particle-based emitter set. More...
|
| |
| class | ParticleEmitterSet3 |
| | 3-D particle-based emitter set. More...
|
| |
| class | ParticleSystemData2 |
| | 2-D particle system data. More...
|
| |
| class | ParticleSystemData3 |
| | 3-D particle system data. More...
|
| |
| class | ParticleSystemSolver2 |
| | Basic 2-D particle system solver. More...
|
| |
| class | ParticleSystemSolver3 |
| | Basic 3-D particle system solver. More...
|
| |
| class | ParticleSystemSolverBuilderBase2 |
| | Base class for particle-based solver builder. More...
|
| |
| class | ParticleSystemSolverBuilderBase3 |
| | Base class for particle-based solver builder. More...
|
| |
| class | PciSphSolver2 |
| | 2-D PCISPH solver. More...
|
| |
| class | PciSphSolver3 |
| | 3-D PCISPH solver. More...
|
| |
| class | PhysicsAnimation |
| | Abstract base class for physics-based animation. More...
|
| |
| class | PicSolver2 |
| | 2-D Particle-in-Cell (PIC) implementation. More...
|
| |
| class | PicSolver3 |
| | 3-D Particle-in-Cell (PIC) implementation. More...
|
| |
| class | Plane2 |
| | 2-D plane geometry. More...
|
| |
| class | Plane3 |
| | 3-D plane geometry. More...
|
| |
| class | Point |
| | Generic N-D point class. More...
|
| |
| class | Point< T, 2 > |
| | 2-D point class. More...
|
| |
| class | Point< T, 3 > |
| | 3-D point class. More...
|
| |
| class | PointGenerator2 |
| | Abstract base class for 2-D point generator. More...
|
| |
| class | PointGenerator3 |
| | Abstract base class for 3-D point generator. More...
|
| |
| class | PointHashGridSearcher2 |
| | Hash grid-based 2-D point searcher. More...
|
| |
| class | PointHashGridSearcher3 |
| | Hash grid-based 3-D point searcher. More...
|
| |
| class | PointKdTreeSearcher2 |
| | KdTree-based 2-D point searcher. More...
|
| |
| class | PointKdTreeSearcher3 |
| | KdTree-based 3-D point searcher. More...
|
| |
| class | PointNeighborSearcher2 |
| | Abstract base class for 2-D neighbor point searcher. More...
|
| |
| class | PointNeighborSearcher3 |
| | Abstract base class for 3-D neighbor point searcher. More...
|
| |
| class | PointNeighborSearcherBuilder2 |
| | Abstract base class for 2-D point neighbor searcher builders. More...
|
| |
| class | PointNeighborSearcherBuilder3 |
| | Abstract base class for 3-D point neighbor searcher builders. More...
|
| |
| class | PointParallelHashGridSearcher2 |
| | Parallel version of hash grid-based 2-D point searcher. More...
|
| |
| class | PointParallelHashGridSearcher3 |
| | Parallel version of hash grid-based 3-D point searcher. More...
|
| |
| class | PointParticleEmitter2 |
| | 2-D point particle emitter. More...
|
| |
| class | PointParticleEmitter3 |
| | 3-D point particle emitter. More...
|
| |
| class | PointSimpleListSearcher2 |
| | Simple ad-hoc 2-D point searcher. More...
|
| |
| class | PointSimpleListSearcher3 |
| | Simple ad-hoc 3-D point searcher. More...
|
| |
| class | PointsToImplicit2 |
| | Abstract base class for 2-D points-to-implicit converters. More...
|
| |
| class | PointsToImplicit3 |
| | Abstract base class for 3-D points-to-implicit converters. More...
|
| |
| class | Quadtree |
| | Generic quadtree data structure. More...
|
| |
| class | Quaternion |
| | Quaternion class defined as q = w + xi + yj + zk. More...
|
| |
| class | Ray |
| | Class for ray. More...
|
| |
| class | Ray< T, 2 > |
| | Class for 2-D ray. More...
|
| |
| class | Ray< T, 3 > |
| | Class for 2-D ray. More...
|
| |
| struct | RDivides |
| | Reverse divides operator. More...
|
| |
| class | RigidBodyCollider2 |
| | 2-D rigid body collider class. More...
|
| |
| class | RigidBodyCollider3 |
| | 3-D rigid body collider class. More...
|
| |
| struct | RMinus |
| | Reverse minus operator. More...
|
| |
| class | ScalarField2 |
| | Abstract base class for 2-D scalar field. More...
|
| |
| class | ScalarField3 |
| | Abstract base class for 3-D scalar field. More...
|
| |
| class | ScalarGrid2 |
| | Abstract base class for 2-D scalar grid structure. More...
|
| |
| class | ScalarGrid3 |
| | Abstract base class for 3-D scalar grid structure. More...
|
| |
| class | ScalarGridBuilder2 |
| | Abstract base class for 2-D scalar grid builder. More...
|
| |
| class | ScalarGridBuilder3 |
| | Abstract base class for 3-D scalar grid builder. More...
|
| |
| struct | ScalarType |
| | Returns the type of the value itself. More...
|
| |
| struct | ScalarType< Vector2< T > > |
| | Returns the type of the value itself. More...
|
| |
| struct | ScalarType< Vector3< T > > |
| | Returns the type of the value itself. More...
|
| |
| struct | ScalarType< Vector4< T > > |
| | Returns the type of the value itself. More...
|
| |
| struct | ScalarType< Vector< T, N > > |
| | Returns the type of the value. More...
|
| |
| class | SemiLagrangian2 |
| | Implementation of 2-D semi-Lagrangian advection solver. More...
|
| |
| class | SemiLagrangian3 |
| | Implementation of 3-D semi-Lagrangian advection solver. More...
|
| |
| class | Serializable |
| | Abstract base class for any serializable class. More...
|
| |
| class | Size2 |
| | 2-D size class. More...
|
| |
| class | Size3 |
| | 3-D size class. More...
|
| |
| class | Sphere2 |
| | 2-D sphere geometry. More...
|
| |
| class | Sphere3 |
| | 3-D sphere geometry. More...
|
| |
| class | SphericalPointsToImplicit2 |
| | 2-D points-to-implicit converter based on simple sphere model. More...
|
| |
| class | SphericalPointsToImplicit3 |
| | 3-D points-to-implicit converter based on simple sphere model. More...
|
| |
| class | SphPointsToImplicit2 |
| | 2-D points-to-implicit converter based on standard SPH kernel. More...
|
| |
| class | SphPointsToImplicit3 |
| | 3-D points-to-implicit converter based on standard SPH kernel. More...
|
| |
| class | SphSolver2 |
| | 2-D SPH solver. More...
|
| |
| class | SphSolver3 |
| | 3-D SPH solver. More...
|
| |
| class | SphSolverBuilderBase2 |
| | Base class for SPH-based fluid solver builder. More...
|
| |
| class | SphSolverBuilderBase3 |
| | Base class for SPH-based fluid solver builder. More...
|
| |
| struct | SphSpikyKernel2 |
| | Spiky 2-D SPH kernel function object. More...
|
| |
| struct | SphSpikyKernel3 |
| | Spiky 3-D SPH kernel function object. More...
|
| |
| struct | SphStdKernel2 |
| | Standard 2-D SPH kernel function object. More...
|
| |
| struct | SphStdKernel3 |
| | Standard 3-D SPH kernel function object. More...
|
| |
| class | SphSystemData2 |
| | 2-D SPH particle system data. More...
|
| |
| class | SphSystemData3 |
| | 3-D SPH particle system data. More...
|
| |
| class | Surface2 |
| | Abstract base class for 2-D surface. More...
|
| |
| class | Surface3 |
| | Abstract base class for 3-D surface. More...
|
| |
| class | SurfaceBuilderBase2 |
| | Base class for 2-D surface builder. More...
|
| |
| class | SurfaceBuilderBase3 |
| | Base class for 3-D surface builder. More...
|
| |
| struct | SurfaceRayIntersection2 |
| | Struct that represents ray-surface intersection point. More...
|
| |
| struct | SurfaceRayIntersection3 |
| | Struct that represents ray-surface intersection point. More...
|
| |
| class | SurfaceSet2 |
| | 2-D surface set. More...
|
| |
| class | SurfaceSet3 |
| | 3-D surface set. More...
|
| |
| class | SurfaceToImplicit2 |
| | 2-D implicit surface wrapper for generic Surface2 instance. More...
|
| |
| class | SurfaceToImplicit3 |
| | 3-D implicit surface wrapper for generic Surface3 instance. More...
|
| |
| class | Timer |
| | Simple timer class. More...
|
| |
| class | Transform2 |
| | Represents 2-D rigid body transform. More...
|
| |
| class | Transform3 |
| | Represents 3-D rigid body transform. More...
|
| |
| class | Triangle3 |
| | 3-D triangle geometry. More...
|
| |
| class | TriangleMesh3 |
| | 3-D triangle mesh geometry. More...
|
| |
| class | TrianglePointGenerator |
| | Right triangle point generator. More...
|
| |
| struct | TypeCast |
| | Type casting operator. More...
|
| |
| class | UpwindLevelSetSolver2 |
| | Two-dimensional first-order upwind-based iterative level set solver. More...
|
| |
| class | UpwindLevelSetSolver3 |
| | Three-dimensional first-order upwind-based iterative level set solver. More...
|
| |
| class | Vector |
| | Generic statically-sized N-D vector class. More...
|
| |
| class | Vector< T, 2 > |
| | 2-D vector class. More...
|
| |
| class | Vector< T, 3 > |
| | 3-D vector class. More...
|
| |
| class | Vector< T, 4 > |
| | 4-D vector class. More...
|
| |
| class | VectorBinaryOp |
| | Vector expression for binary operation. More...
|
| |
| class | VectorExpression |
| | Base class for vector expression. More...
|
| |
| class | VectorField2 |
| | Abstract base class for 2-D vector field. More...
|
| |
| class | VectorField3 |
| | Abstract base class for 3-D vector field. More...
|
| |
| class | VectorGrid2 |
| | Abstract base class for 2-D vector grid structure. More...
|
| |
| class | VectorGrid3 |
| | Abstract base class for 3-D vector grid structure. More...
|
| |
| class | VectorGridBuilder2 |
| | Abstract base class for 2-D vector grid builder. More...
|
| |
| class | VectorGridBuilder3 |
| | Abstract base class for 3-D vector grid builder. More...
|
| |
| class | VectorN |
| | General purpose dynamically-sizedN-D vector class. More...
|
| |
| class | VectorScalarBinaryOp |
| | Vector expression for matrix-scalar binary operation. More...
|
| |
| class | VectorUnaryOp |
| | Vector expression for unary operation. More...
|
| |
| class | VertexCenteredScalarGrid2 |
| | 2-D Vertex-centered scalar grid structure. More...
|
| |
| class | VertexCenteredScalarGrid3 |
| | 3-D Vertex-centered scalar grid structure. More...
|
| |
| class | VertexCenteredVectorGrid2 |
| | 2-D Vertex-centered vector grid structure. More...
|
| |
| class | VertexCenteredVectorGrid3 |
| | 3-D Vertex-centered vector grid structure. More...
|
| |
| class | VolumeGridEmitter2 |
| | 2-D grid-based volumetric emitter. More...
|
| |
| class | VolumeGridEmitter3 |
| | 3-D grid-based volumetric emitter. More...
|
| |
| class | VolumeParticleEmitter2 |
| | 2-D volumetric particle emitter. More...
|
| |
| class | VolumeParticleEmitter3 |
| | 3-D volumetric particle emitter. More...
|
| |
| class | ZhuBridsonPointsToImplicit2 |
| | 2-D points-to-implicit converter based on Zhu and Bridson's method. More...
|
| |
| class | ZhuBridsonPointsToImplicit3 |
| | 3-D points-to-implicit converter based on Zhu and Bridson's method. More...
|
| |
|
| typedef std::shared_ptr< AdvectionSolver2 > | AdvectionSolver2Ptr |
| | Shared pointer type for the 2-D advection solver. More...
|
| |
| typedef std::shared_ptr< AdvectionSolver3 > | AdvectionSolver3Ptr |
| | Shared pointer type for the 3-D advection solver. More...
|
| |
| typedef std::shared_ptr< Animation > | AnimationPtr |
| | Shared pointer for the Animation type. More...
|
| |
| typedef std::shared_ptr< AnisotropicPointsToImplicit2 > | AnisotropicPointsToImplicit2Ptr |
| | Shared pointer for the AnisotropicPointsToImplicit2 type. More...
|
| |
| typedef std::shared_ptr< AnisotropicPointsToImplicit3 > | AnisotropicPointsToImplicit3Ptr |
| | Shared pointer for the AnisotropicPointsToImplicit3 type. More...
|
| |
| typedef std::shared_ptr< ApicSolver2 > | ApicSolver2Ptr |
| | Shared pointer type for the ApicSolver2. More...
|
| |
| typedef std::shared_ptr< ApicSolver3 > | ApicSolver3Ptr |
| | Shared pointer type for the ApicSolver3. More...
|
| |
| template<typename T > |
| using | Array1 = Array< T, 1 > |
| | Type alias for 1-D array. More...
|
| |
| template<typename T > |
| using | Array2 = Array< T, 2 > |
| | Type alias for 2-D array. More...
|
| |
| template<typename T > |
| using | Array3 = Array< T, 3 > |
| | Type alias for 3-D array. More...
|
| |
| template<typename T > |
| using | ArrayAccessor1 = ArrayAccessor< T, 1 > |
| | Type alias for 1-D array accessor. More...
|
| |
| template<typename T > |
| using | ConstArrayAccessor1 = ConstArrayAccessor< T, 1 > |
| | Type alias for 1-D const array accessor. More...
|
| |
| template<typename T > |
| using | ArrayAccessor2 = ArrayAccessor< T, 2 > |
| | Type alias for 2-D array accessor. More...
|
| |
| template<typename T > |
| using | ConstArrayAccessor2 = ConstArrayAccessor< T, 2 > |
| | Type alias for 2-D const array accessor. More...
|
| |
| template<typename T > |
| using | ArrayAccessor3 = ArrayAccessor< T, 3 > |
| | Type alias for 3-D array accessor. More...
|
| |
| template<typename T > |
| using | ConstArrayAccessor3 = ConstArrayAccessor< T, 3 > |
| | Type alias for 3-D const array accessor. More...
|
| |
| template<typename T , typename R > |
| using | NearestArraySampler1 = NearestArraySampler< T, R, 1 > |
| | Type alias for 1-D nearest array sampler. More...
|
| |
| template<typename T , typename R > |
| using | LinearArraySampler1 = LinearArraySampler< T, R, 1 > |
| | Type alias for 1-D linear array sampler. More...
|
| |
| template<typename T , typename R > |
| using | CubicArraySampler1 = CubicArraySampler< T, R, 1 > |
| | Type alias for 1-D cubic array sampler. More...
|
| |
| template<typename T , typename R > |
| using | NearestArraySampler2 = NearestArraySampler< T, R, 2 > |
| | Type alias for 2-D nearest array sampler. More...
|
| |
| template<typename T , typename R > |
| using | LinearArraySampler2 = LinearArraySampler< T, R, 2 > |
| | Type alias for 2-D linear array sampler. More...
|
| |
| template<typename T , typename R > |
| using | CubicArraySampler2 = CubicArraySampler< T, R, 2 > |
| | Type alias for 2-D cubic array sampler. More...
|
| |
| template<typename T , typename R > |
| using | NearestArraySampler3 = NearestArraySampler< T, R, 3 > |
| | Type alias for 3-D nearest array sampler. More...
|
| |
| template<typename T , typename R > |
| using | LinearArraySampler3 = LinearArraySampler< T, R, 3 > |
| | Type alias for 3-D linear array sampler. More...
|
| |
| template<typename T , typename R > |
| using | CubicArraySampler3 = CubicArraySampler< T, R, 3 > |
| | Type alias for 3-D cubic array sampler. More...
|
| |
| typedef std::shared_ptr< BccLatticePointGenerator > | BccLatticePointGeneratorPtr |
| | Shared pointer type for the BccLatticePointGenerator. More...
|
| |
| template<typename T > |
| using | BoundingBox2 = BoundingBox< T, 2 > |
| | Type alias for 2-D BoundingBox. More...
|
| |
| typedef BoundingBox2< float > | BoundingBox2F |
| | Float-type 2-D BoundingBox. More...
|
| |
| typedef BoundingBox2< double > | BoundingBox2D |
| | Double-type 2-D BoundingBox. More...
|
| |
| typedef BoundingBoxRayIntersection2< float > | BoundingBoxRayIntersection2F |
| | Float-type 2-D box-ray intersection result. More...
|
| |
| typedef BoundingBoxRayIntersection2< double > | BoundingBoxRayIntersection2D |
| | Double-type 2-D box-ray intersection result. More...
|
| |
| template<typename T > |
| using | BoundingBox3 = BoundingBox< T, 3 > |
| | Type alias for 3-D BoundingBox. More...
|
| |
| typedef BoundingBox3< float > | BoundingBox3F |
| | Float-type 3-D BoundingBox. More...
|
| |
| typedef BoundingBox3< double > | BoundingBox3D |
| | Double-type 3-D BoundingBox. More...
|
| |
| typedef BoundingBoxRayIntersection3< float > | BoundingBoxRayIntersection3F |
| | Float-type 3-D box-ray intersection result. More...
|
| |
| typedef BoundingBoxRayIntersection3< double > | BoundingBoxRayIntersection3D |
| | Double-type 3-D box-ray intersection result. More...
|
| |
| typedef std::shared_ptr< Box2 > | Box2Ptr |
| | Shared pointer type for the Box2. More...
|
| |
| typedef std::shared_ptr< Box3 > | Box3Ptr |
| | Shared pointer type for the Box3. More...
|
| |
| typedef std::shared_ptr< CellCenteredScalarGrid2 > | CellCenteredScalarGrid2Ptr |
| | Shared pointer for the CellCenteredScalarGrid2 type. More...
|
| |
| typedef std::shared_ptr< CellCenteredScalarGrid3 > | CellCenteredScalarGrid3Ptr |
| | Shared pointer for the CellCenteredScalarGrid3 type. More...
|
| |
| typedef std::shared_ptr< CellCenteredVectorGrid2 > | CellCenteredVectorGrid2Ptr |
| | Shared pointer for the CellCenteredVectorGrid2 type. More...
|
| |
| typedef std::shared_ptr< CellCenteredVectorGrid3 > | CellCenteredVectorGrid3Ptr |
| | Shared pointer for the CellCenteredVectorGrid3 type. More...
|
| |
| typedef std::shared_ptr< Collider2 > | Collider2Ptr |
| | Shared pointer type for the Collider2. More...
|
| |
| typedef std::shared_ptr< Collider3 > | Collider3Ptr |
| | Shared pointer type for the Collider2. More...
|
| |
| typedef std::shared_ptr< ColliderSet2 > | ColliderSet2Ptr |
| | Shared pointer for the ColliderSet2 type. More...
|
| |
| typedef std::shared_ptr< ColliderSet3 > | ColliderSet3Ptr |
| | Shared pointer for the ColliderSet3 type. More...
|
| |
| typedef std::shared_ptr< CollocatedVectorGrid2 > | CollocatedVectorGrid2Ptr |
| | Shared pointer for the CollocatedVectorGrid2 type. More...
|
| |
| typedef std::shared_ptr< CollocatedVectorGrid3 > | CollocatedVectorGrid3Ptr |
| | Shared pointer for the CollocatedVectorGrid3 type. More...
|
| |
| typedef std::shared_ptr< ConstantScalarField2 > | ConstantScalarField2Ptr |
| | Shared pointer for the ConstantScalarField2 type. More...
|
| |
| typedef std::shared_ptr< ConstantScalarField3 > | ConstantScalarField3Ptr |
| | Shared pointer for the ConstantScalarField3 type. More...
|
| |
| typedef std::shared_ptr< ConstantVectorField2 > | ConstantVectorField2Ptr |
| | Shared pointer for the ConstantVectorField2 type. More...
|
| |
| typedef std::shared_ptr< ConstantVectorField3 > | ConstantVectorField3Ptr |
| | Shared pointer for the ConstantVectorField3 type. More...
|
| |
| typedef std::shared_ptr< CubicSemiLagrangian2 > | CubicSemiLagrangian2Ptr |
| |
| typedef std::shared_ptr< CubicSemiLagrangian3 > | CubicSemiLagrangian3Ptr |
| |
| typedef std::shared_ptr< CustomImplicitSurface2 > | CustomImplicitSurface2Ptr |
| | Shared pointer type for the CustomImplicitSurface2. More...
|
| |
| typedef std::shared_ptr< CustomImplicitSurface3 > | CustomImplicitSurface3Ptr |
| | Shared pointer type for the CustomImplicitSurface3. More...
|
| |
| typedef std::shared_ptr< CustomScalarField2 > | CustomScalarField2Ptr |
| | Shared pointer type for the CustomScalarField2. More...
|
| |
| typedef std::shared_ptr< CustomScalarField3 > | CustomScalarField3Ptr |
| | Shared pointer type for the CustomScalarField3. More...
|
| |
| typedef std::shared_ptr< CustomVectorField2 > | CustomVectorField2Ptr |
| | Shared pointer type for the CustomVectorField2. More...
|
| |
| typedef std::shared_ptr< CustomVectorField3 > | CustomVectorField3Ptr |
| | Shared pointer type for the CustomVectorField3. More...
|
| |
| typedef std::shared_ptr< Cylinder3 > | Cylinder3Ptr |
| | Shared pointer type for the Cylinder3. More...
|
| |
| typedef std::shared_ptr< EnoLevelSetSolver2 > | EnoLevelSetSolver2Ptr |
| |
| typedef std::shared_ptr< EnoLevelSetSolver3 > | EnoLevelSetSolver3Ptr |
| |
| typedef std::shared_ptr< FaceCenteredGrid2 > | FaceCenteredGrid2Ptr |
| | Shared pointer type for the FaceCenteredGrid2. More...
|
| |
| typedef std::shared_ptr< FaceCenteredGrid3 > | FaceCenteredGrid3Ptr |
| | Shared pointer type for the FaceCenteredGrid3. More...
|
| |
| typedef std::shared_ptr< FccLatticePointGenerator > | FccLatticePointGeneratorPtr |
| | Shared pointer type for the FccLatticePointGenerator. More...
|
| |
| typedef std::shared_ptr< FdmCgSolver2 > | FdmCgSolver2Ptr |
| | Shared pointer type for the FdmCgSolver2. More...
|
| |
| typedef std::shared_ptr< FdmCgSolver3 > | FdmCgSolver3Ptr |
| | Shared pointer type for the FdmCgSolver3. More...
|
| |
| typedef std::shared_ptr< FdmGaussSeidelSolver2 > | FdmGaussSeidelSolver2Ptr |
| | Shared pointer type for the FdmGaussSeidelSolver2. More...
|
| |
| typedef std::shared_ptr< FdmGaussSeidelSolver3 > | FdmGaussSeidelSolver3Ptr |
| | Shared pointer type for the FdmGaussSeidelSolver3. More...
|
| |
| typedef std::shared_ptr< FdmIccgSolver2 > | FdmIccgSolver2Ptr |
| | Shared pointer type for the FdmIccgSolver2. More...
|
| |
| typedef std::shared_ptr< FdmIccgSolver3 > | FdmIccgSolver3Ptr |
| | Shared pointer type for the FdmIccgSolver3. More...
|
| |
| typedef std::shared_ptr< FdmJacobiSolver2 > | FdmJacobiSolver2Ptr |
| | Shared pointer type for the FdmJacobiSolver2. More...
|
| |
| typedef std::shared_ptr< FdmJacobiSolver3 > | FdmJacobiSolver3Ptr |
| | Shared pointer type for the FdmJacobiSolver3. More...
|
| |
| typedef Array2< double > | FdmVector2 |
| | Vector type for 2-D finite differencing. More...
|
| |
| typedef Array2< FdmMatrixRow2 > | FdmMatrix2 |
| | Matrix type for 2-D finite differencing. More...
|
| |
| typedef Array3< double > | FdmVector3 |
| | Vector type for 3-D finite differencing. More...
|
| |
| typedef Array3< FdmMatrixRow3 > | FdmMatrix3 |
| | Matrix type for 3-D finite differencing. More...
|
| |
| typedef std::shared_ptr< FdmLinearSystemSolver2 > | FdmLinearSystemSolver2Ptr |
| | Shared pointer type for the FdmLinearSystemSolver2. More...
|
| |
| typedef std::shared_ptr< FdmLinearSystemSolver3 > | FdmLinearSystemSolver3Ptr |
| | Shared pointer type for the FdmLinearSystemSolver3. More...
|
| |
| typedef MgMatrix< FdmBlas2 > | FdmMgMatrix2 |
| | Multigrid-style 2-D FDM matrix. More...
|
| |
| typedef MgVector< FdmBlas2 > | FdmMgVector2 |
| | Multigrid-style 2-D FDM vector. More...
|
| |
| typedef MgMatrix< FdmBlas3 > | FdmMgMatrix3 |
| | Multigrid-style 3-D FDM matrix. More...
|
| |
| typedef MgVector< FdmBlas3 > | FdmMgVector3 |
| | Multigrid-style 3-D FDM vector. More...
|
| |
| typedef std::shared_ptr< FdmMgSolver2 > | FdmMgSolver2Ptr |
| | Shared pointer type for the FdmMgSolver2. More...
|
| |
| typedef std::shared_ptr< FdmMgSolver3 > | FdmMgSolver3Ptr |
| | Shared pointer type for the FdmMgSolver3. More...
|
| |
| typedef std::shared_ptr< FdmMgpcgSolver2 > | FdmMgpcgSolver2Ptr |
| | Shared pointer type for the FdmMgpcgSolver2. More...
|
| |
| typedef std::shared_ptr< FdmMgpcgSolver3 > | FdmMgpcgSolver3Ptr |
| | Shared pointer type for the FdmMgpcgSolver3. More...
|
| |
| typedef std::shared_ptr< Field2 > | Field2Ptr |
| |
| typedef std::shared_ptr< Field3 > | Field3Ptr |
| |
| typedef std::shared_ptr< FlipSolver2 > | FlipSolver2Ptr |
| | Shared pointer type for the FlipSolver2. More...
|
| |
| typedef std::shared_ptr< FlipSolver3 > | FlipSolver3Ptr |
| | Shared pointer type for the FlipSolver3. More...
|
| |
| typedef std::shared_ptr< FmmLevelSetSolver2 > | FmmLevelSetSolver2Ptr |
| | Shared pointer type for the FmmLevelSetSolver2. More...
|
| |
| typedef std::shared_ptr< FmmLevelSetSolver3 > | FmmLevelSetSolver3Ptr |
| | Shared pointer type for the FmmLevelSetSolver3. More...
|
| |
| typedef std::shared_ptr< Grid2 > | Grid2Ptr |
| |
| typedef std::shared_ptr< Grid3 > | Grid3Ptr |
| |
| typedef std::shared_ptr< GridBackwardEulerDiffusionSolver2 > | GridBackwardEulerDiffusionSolver2Ptr |
| | Shared pointer type for the GridBackwardEulerDiffusionSolver2. More...
|
| |
| typedef std::shared_ptr< GridBackwardEulerDiffusionSolver3 > | GridBackwardEulerDiffusionSolver3Ptr |
| | Shared pointer type for the GridBackwardEulerDiffusionSolver3. More...
|
| |
| typedef std::shared_ptr< GridBlockedBoundaryConditionSolver2 > | GridBlockedBoundaryConditionSolver2Ptr |
| | Shared pointer type for the GridBlockedBoundaryConditionSolver2. More...
|
| |
| typedef std::shared_ptr< GridBlockedBoundaryConditionSolver3 > | GridBlockedBoundaryConditionSolver3Ptr |
| | Shared pointer type for the GridBlockedBoundaryConditionSolver3. More...
|
| |
| typedef std::shared_ptr< GridBoundaryConditionSolver2 > | GridBoundaryConditionSolver2Ptr |
| | Shared pointer type for the GridBoundaryConditionSolver2. More...
|
| |
| typedef std::shared_ptr< GridBoundaryConditionSolver3 > | GridBoundaryConditionSolver3Ptr |
| | Shared pointer type for the GridBoundaryConditionSolver3. More...
|
| |
| typedef std::shared_ptr< GridDiffusionSolver2 > | GridDiffusionSolver2Ptr |
| | Shared pointer type for the GridDiffusionSolver2. More...
|
| |
| typedef std::shared_ptr< GridDiffusionSolver3 > | GridDiffusionSolver3Ptr |
| | Shared pointer type for the GridDiffusionSolver3. More...
|
| |
| typedef std::shared_ptr< GridEmitter2 > | GridEmitter2Ptr |
| | Shared pointer type for the GridEmitter2. More...
|
| |
| typedef std::shared_ptr< GridEmitter3 > | GridEmitter3Ptr |
| | Shared pointer type for the GridEmitter3. More...
|
| |
| typedef std::shared_ptr< GridEmitterSet2 > | GridEmitterSet2Ptr |
| | Shared pointer type for the GridEmitterSet2. More...
|
| |
| typedef std::shared_ptr< GridEmitterSet3 > | GridEmitterSet3Ptr |
| | Shared pointer type for the GridEmitterSet3. More...
|
| |
| typedef std::shared_ptr< GridFluidSolver2 > | GridFluidSolver2Ptr |
| | Shared pointer type for the GridFluidSolver2. More...
|
| |
| typedef std::shared_ptr< GridFluidSolver3 > | GridFluidSolver3Ptr |
| | Shared pointer type for the GridFluidSolver3. More...
|
| |
| typedef std::shared_ptr< GridForwardEulerDiffusionSolver2 > | GridForwardEulerDiffusionSolver2Ptr |
| | Shared pointer type for the GridForwardEulerDiffusionSolver2. More...
|
| |
| typedef std::shared_ptr< GridForwardEulerDiffusionSolver3 > | GridForwardEulerDiffusionSolver3Ptr |
| | Shared pointer type for the GridForwardEulerDiffusionSolver3. More...
|
| |
| typedef std::shared_ptr< GridFractionalBoundaryConditionSolver2 > | GridFractionalBoundaryConditionSolver2Ptr |
| | Shared pointer type for the GridFractionalBoundaryConditionSolver2. More...
|
| |
| typedef std::shared_ptr< GridFractionalBoundaryConditionSolver3 > | GridFractionalBoundaryConditionSolver3Ptr |
| | Shared pointer type for the GridFractionalBoundaryConditionSolver3. More...
|
| |
| typedef std::shared_ptr< GridFractionalSinglePhasePressureSolver2 > | GridFractionalSinglePhasePressureSolver2Ptr |
| | Shared pointer type for the GridFractionalSinglePhasePressureSolver2. More...
|
| |
| typedef std::shared_ptr< GridFractionalSinglePhasePressureSolver3 > | GridFractionalSinglePhasePressureSolver3Ptr |
| | Shared pointer type for the GridFractionalSinglePhasePressureSolver3. More...
|
| |
| typedef std::shared_ptr< GridPointGenerator2 > | GridPointGenerator2Ptr |
| | Shared pointer type for the GridPointGenerator2. More...
|
| |
| typedef std::shared_ptr< GridPointGenerator3 > | GridPointGenerator3Ptr |
| | Shared pointer type for the GridPointGenerator3. More...
|
| |
| typedef std::shared_ptr< GridPressureSolver2 > | GridPressureSolver2Ptr |
| | Shared pointer type for the GridPressureSolver2. More...
|
| |
| typedef std::shared_ptr< GridPressureSolver3 > | GridPressureSolver3Ptr |
| | Shared pointer type for the GridPressureSolver3. More...
|
| |
| typedef std::shared_ptr< GridSinglePhasePressureSolver2 > | GridSinglePhasePressureSolver2Ptr |
| | Shared pointer type for the GridSinglePhasePressureSolver2. More...
|
| |
| typedef std::shared_ptr< GridSinglePhasePressureSolver3 > | GridSinglePhasePressureSolver3Ptr |
| | Shared pointer type for the GridSinglePhasePressureSolver3. More...
|
| |
| typedef std::shared_ptr< GridSmokeSolver2 > | GridSmokeSolver2Ptr |
| | Shared pointer type for the GridSmokeSolver2. More...
|
| |
| typedef std::shared_ptr< GridSmokeSolver3 > | GridSmokeSolver3Ptr |
| | Shared pointer type for the GridSmokeSolver3. More...
|
| |
| typedef std::shared_ptr< GridSystemData2 > | GridSystemData2Ptr |
| | Shared pointer type of GridSystemData2. More...
|
| |
| typedef std::shared_ptr< GridSystemData3 > | GridSystemData3Ptr |
| | Shared pointer type of GridSystemData3. More...
|
| |
| typedef std::shared_ptr< ImplicitSurface2 > | ImplicitSurface2Ptr |
| | Shared pointer type for the ImplicitSurface2. More...
|
| |
| typedef std::shared_ptr< ImplicitSurface3 > | ImplicitSurface3Ptr |
| | Shared pointer type for the ImplicitSurface3. More...
|
| |
| typedef std::shared_ptr< ImplicitSurfaceSet2 > | ImplicitSurfaceSet2Ptr |
| | Shared pointer type for the ImplicitSurfaceSet2. More...
|
| |
| typedef std::shared_ptr< ImplicitSurfaceSet3 > | ImplicitSurfaceSet3Ptr |
| | Shared pointer type for the ImplicitSurfaceSet3. More...
|
| |
| typedef std::shared_ptr< ImplicitTriangleMesh3 > | ImplicitTriangleMesh3Ptr |
| | Shared pointer for the ImplicitTriangleMesh3 type. More...
|
| |
| template<typename T > |
| using | ClosestIntersectionDistanceFunc2 = std::function< double(const T &, const Vector2D &)> |
| | Closest intersection distance measure function. More...
|
| |
| template<typename T > |
| using | BoxIntersectionTestFunc2 = std::function< bool(const T &, const BoundingBox2D &)> |
| | Box-item intersection test function. More...
|
| |
| template<typename T > |
| using | RayIntersectionTestFunc2 = std::function< bool(const T &, const Ray2D &)> |
| | Ray-item intersection test function. More...
|
| |
| template<typename T > |
| using | GetRayIntersectionFunc2 = std::function< double(const T &, const Ray2D &)> |
| | Ray-item closest intersection evaluation function. More...
|
| |
| template<typename T > |
| using | IntersectionVisitorFunc2 = std::function< void(const T &)> |
| | Visitor function which is invoked for each intersecting item. More...
|
| |
| template<typename T > |
| using | ClosestIntersectionDistanceFunc3 = std::function< double(const T &, const Vector3D &)> |
| | Closest intersection distance measure function. More...
|
| |
| template<typename T > |
| using | BoxIntersectionTestFunc3 = std::function< bool(const T &, const BoundingBox3D &)> |
| | Box-item intersection test function. More...
|
| |
| template<typename T > |
| using | RayIntersectionTestFunc3 = std::function< bool(const T &, const Ray3D &)> |
| | Ray-item intersection test function. More...
|
| |
| template<typename T > |
| using | GetRayIntersectionFunc3 = std::function< double(const T &, const Ray3D &)> |
| | Ray-item closest intersection evaluation function. More...
|
| |
| template<typename T > |
| using | IntersectionVisitorFunc3 = std::function< void(const T &)> |
| | Visitor function which is invoked for each intersecting item. More...
|
| |
| typedef std::shared_ptr< IterativeLevelSetSolver2 > | IterativeLevelSetSolver2Ptr |
| |
| typedef std::shared_ptr< IterativeLevelSetSolver3 > | IterativeLevelSetSolver3Ptr |
| |
| typedef std::shared_ptr< LevelSetLiquidSolver2 > | LevelSetLiquidSolver2Ptr |
| | Shared pointer type for the LevelSetLiquidSolver2. More...
|
| |
| typedef std::shared_ptr< LevelSetLiquidSolver3 > | LevelSetLiquidSolver3Ptr |
| | Shared pointer type for the LevelSetLiquidSolver3. More...
|
| |
| typedef std::shared_ptr< LevelSetSolver2 > | LevelSetSolver2Ptr |
| | Shared pointer type for the LevelSetSolver2. More...
|
| |
| typedef std::shared_ptr< LevelSetSolver3 > | LevelSetSolver3Ptr |
| | Shared pointer type for the LevelSetSolver3. More...
|
| |
| template<typename T > |
| using | Matrix2x2 = Matrix< T, 2, 2 > |
| | Type alias for 2x2 matrix. More...
|
| |
| typedef Matrix2x2< float > | Matrix2x2F |
| | Float-type 2x2 matrix. More...
|
| |
| typedef Matrix2x2< double > | Matrix2x2D |
| | Double-type 2x2 matrix. More...
|
| |
| template<typename T > |
| using | Matrix3x3 = Matrix< T, 3, 3 > |
| | Type alias for 3x3 matrix. More...
|
| |
| typedef Matrix3x3< float > | Matrix3x3F |
| | Float-type 3x3 matrix. More...
|
| |
| typedef Matrix3x3< double > | Matrix3x3D |
| | Double-type 3x3 matrix. More...
|
| |
| template<typename T > |
| using | Matrix4x4 = Matrix< T, 4, 4 > |
| | Type alias for 4x4 matrix. More...
|
| |
| typedef Matrix4x4< float > | Matrix4x4F |
| | Float-type 4x4 matrix. More...
|
| |
| typedef Matrix4x4< double > | Matrix4x4D |
| | Double-type 4x4 matrix. More...
|
| |
| typedef MatrixCsr< float > | MatrixCsrF |
| | Float-type CSR matrix. More...
|
| |
| typedef MatrixCsr< double > | MatrixCsrD |
| | Double-type CSR matrix. More...
|
| |
| template<typename T , typename E , typename U > |
| using | MatrixTypeCast = MatrixUnaryOp< T, E, TypeCast< U, T > > |
| | Matrix expression for type casting. More...
|
| |
| template<typename T , typename E1 , typename E2 > |
| using | MatrixAdd = MatrixBinaryOp< T, E1, E2, std::plus< T > > |
| | Matrix-matrix addition expression. More...
|
| |
| template<typename T , typename E > |
| using | MatrixScalarAdd = MatrixScalarBinaryOp< T, E, std::plus< T > > |
| | Matrix-scalar addition expression. More...
|
| |
| template<typename T , typename E1 , typename E2 > |
| using | MatrixSub = MatrixBinaryOp< T, E1, E2, std::minus< T > > |
| | Matrix-matrix subtraction expression. More...
|
| |
| template<typename T , typename E > |
| using | MatrixScalarSub = MatrixScalarBinaryOp< T, E, std::minus< T > > |
| | Matrix-scalar subtraction expression. More...
|
| |
| template<typename T , typename E > |
| using | MatrixScalarRSub = MatrixScalarBinaryOp< T, E, RMinus< T > > |
| | Matrix-matrix subtraction expression with inversed order. More...
|
| |
| template<typename T , typename E > |
| using | MatrixScalarMul = MatrixScalarBinaryOp< T, E, std::multiplies< T > > |
| | Matrix-scalar multiplication expression. More...
|
| |
| template<typename T , typename E > |
| using | MatrixScalarDiv = MatrixScalarBinaryOp< T, E, std::divides< T > > |
| | Matrix-scalar division expression. More...
|
| |
| template<typename T , typename E > |
| using | MatrixScalarRDiv = MatrixScalarBinaryOp< T, E, RDivides< T > > |
| | Matrix-scalar division expression with inversed order. More...
|
| |
| typedef MatrixMxN< float > | MatrixMxNF |
| | Float-type M x N matrix. More...
|
| |
| typedef MatrixMxN< double > | MatrixMxND |
| | Double-type M x N matrix. More...
|
| |
| template<typename BlasType > |
| using | MgRelaxFunc = std::function< void(const typename BlasType::MatrixType &A, const typename BlasType::VectorType &b, unsigned int numberOfIterations, double maxTolerance, typename BlasType::VectorType *x, typename BlasType::VectorType *buffer)> |
| | Multigrid relax function type. More...
|
| |
| template<typename BlasType > |
| using | MgRestrictFunc = std::function< void(const typename BlasType::VectorType &finer, typename BlasType::VectorType *coarser)> |
| | Multigrid restriction function type. More...
|
| |
| template<typename BlasType > |
| using | MgCorrectFunc = std::function< void(const typename BlasType::VectorType &coarser, typename BlasType::VectorType *finer)> |
| | Multigrid correction function type. More...
|
| |
| template<typename T > |
| using | NearestNeighborDistanceFunc2 = std::function< double(const T &, const Vector2D &)> |
| | Nearest neighbor distance measure function. More...
|
| |
| template<typename T > |
| using | NearestNeighborDistanceFunc3 = std::function< double(const T &, const Vector3D &)> |
| | Nearest neighbor distance measure function. More...
|
| |
| typedef std::shared_ptr< ParticleEmitter2 > | ParticleEmitter2Ptr |
| | Shared pointer for the ParticleEmitter2 type. More...
|
| |
| typedef std::shared_ptr< ParticleEmitter3 > | ParticleEmitter3Ptr |
| | Shared pointer for the ParticleEmitter3 type. More...
|
| |
| typedef std::shared_ptr< ParticleEmitterSet2 > | ParticleEmitterSet2Ptr |
| | Shared pointer type for the ParticleEmitterSet2. More...
|
| |
| typedef std::shared_ptr< ParticleEmitterSet3 > | ParticleEmitterSet3Ptr |
| | Shared pointer type for the ParticleEmitterSet3. More...
|
| |
| typedef std::shared_ptr< ParticleSystemData2 > | ParticleSystemData2Ptr |
| | Shared pointer type of ParticleSystemData2. More...
|
| |
| typedef std::shared_ptr< ParticleSystemData3 > | ParticleSystemData3Ptr |
| | Shared pointer type of ParticleSystemData3. More...
|
| |
| typedef std::shared_ptr< ParticleSystemSolver2 > | ParticleSystemSolver2Ptr |
| | Shared pointer type for the ParticleSystemSolver2. More...
|
| |
| typedef std::shared_ptr< ParticleSystemSolver3 > | ParticleSystemSolver3Ptr |
| | Shared pointer type for the ParticleSystemSolver3. More...
|
| |
| typedef std::shared_ptr< PciSphSolver2 > | PciSphSolver2Ptr |
| | Shared pointer type for the PciSphSolver2. More...
|
| |
| typedef std::shared_ptr< PciSphSolver3 > | PciSphSolver3Ptr |
| | Shared pointer type for the PciSphSolver3. More...
|
| |
| typedef std::shared_ptr< PhysicsAnimation > | PhysicsAnimationPtr |
| |
| typedef std::shared_ptr< PicSolver2 > | PicSolver2Ptr |
| | Shared pointer type for the PicSolver2. More...
|
| |
| typedef std::shared_ptr< PicSolver3 > | PicSolver3Ptr |
| | Shared pointer type for the PicSolver3. More...
|
| |
| typedef std::shared_ptr< Plane2 > | Plane2Ptr |
| | Shared pointer for the Plane2 type. More...
|
| |
| typedef std::shared_ptr< Plane3 > | Plane3Ptr |
| | Shared pointer for the Plane3 type. More...
|
| |
| template<typename T > |
| using | Point2 = Point< T, 2 > |
| | Type alias for two dimensional point. More...
|
| |
| typedef Point2< float > | Point2F |
| | Float-type 2D point. More...
|
| |
| typedef Point2< double > | Point2D |
| | Double-type 2D point. More...
|
| |
| typedef Point2< ssize_t > | Point2I |
| | Integer-type 2D point. More...
|
| |
| typedef Point2< size_t > | Point2UI |
| | Unsigned integer-type 2D point. More...
|
| |
| template<typename T > |
| using | Point3 = Point< T, 3 > |
| | Type alias for three dimensional point. More...
|
| |
| typedef Point3< float > | Point3F |
| | Float-type 3D point. More...
|
| |
| typedef Point3< double > | Point3D |
| | Double-type 3D point. More...
|
| |
| typedef Point3< ssize_t > | Point3I |
| | Integer-type 3D point. More...
|
| |
| typedef Point3< size_t > | Point3UI |
| | Unsigned integer-type 3D point. More...
|
| |
| typedef std::shared_ptr< PointGenerator2 > | PointGenerator2Ptr |
| | Shared pointer for the PointGenerator2 type. More...
|
| |
| typedef std::shared_ptr< PointGenerator3 > | PointGenerator3Ptr |
| | Shared pointer for the PointGenerator3 type. More...
|
| |
| typedef std::shared_ptr< PointHashGridSearcher2 > | PointHashGridSearcher2Ptr |
| | Shared pointer for the PointHashGridSearcher2 type. More...
|
| |
| typedef std::shared_ptr< PointHashGridSearcher3 > | PointHashGridSearcher3Ptr |
| | Shared pointer for the PointHashGridSearcher3 type. More...
|
| |
| typedef std::shared_ptr< PointKdTreeSearcher2 > | PointKdTreeSearcher2Ptr |
| | Shared pointer for the PointKdTreeSearcher2 type. More...
|
| |
| typedef std::shared_ptr< PointKdTreeSearcher3 > | PointKdTreeSearcher3Ptr |
| | Shared pointer for the PointKdTreeSearcher3 type. More...
|
| |
| typedef std::shared_ptr< PointNeighborSearcher2 > | PointNeighborSearcher2Ptr |
| | Shared pointer for the PointNeighborSearcher2 type. More...
|
| |
| typedef std::shared_ptr< PointNeighborSearcherBuilder2 > | PointNeighborSearcherBuilder2Ptr |
| | Shared pointer for the PointNeighborSearcherBuilder2 type. More...
|
| |
| typedef std::shared_ptr< PointNeighborSearcher3 > | PointNeighborSearcher3Ptr |
| | Shared pointer for the PointNeighborSearcher3 type. More...
|
| |
| typedef std::shared_ptr< PointNeighborSearcherBuilder3 > | PointNeighborSearcherBuilder3Ptr |
| | Shared pointer for the PointNeighborSearcherBuilder3 type. More...
|
| |
| typedef std::shared_ptr< PointParallelHashGridSearcher2 > | PointParallelHashGridSearcher2Ptr |
| | Shared pointer for the PointParallelHashGridSearcher2 type. More...
|
| |
| typedef std::shared_ptr< PointParallelHashGridSearcher3 > | PointParallelHashGridSearcher3Ptr |
| | Shared pointer for the PointParallelHashGridSearcher3 type. More...
|
| |
| typedef std::shared_ptr< PointParticleEmitter2 > | PointParticleEmitter2Ptr |
| | Shared pointer for the PointParticleEmitter2 type. More...
|
| |
| typedef std::shared_ptr< PointParticleEmitter3 > | PointParticleEmitter3Ptr |
| | Shared pointer for the PointParticleEmitter3 type. More...
|
| |
| typedef std::shared_ptr< PointSimpleListSearcher2 > | PointSimpleListSearcher2Ptr |
| | Shared pointer for the PointSimpleListSearcher2 type. More...
|
| |
| typedef std::shared_ptr< PointSimpleListSearcher3 > | PointSimpleListSearcher3Ptr |
| | Shared pointer for the PointSimpleListSearcher3 type. More...
|
| |
| typedef std::shared_ptr< PointsToImplicit2 > | PointsToImplicit2Ptr |
| | Shared pointer for the PointsToImplicit2 type. More...
|
| |
| typedef std::shared_ptr< PointsToImplicit3 > | PointsToImplicit3Ptr |
| | Shared pointer for the PointsToImplicit3 type. More...
|
| |
| typedef Quaternion< float > | QuaternionF |
| | Float-type quaternion. More...
|
| |
| typedef Quaternion< double > | QuaternionD |
| | Double-type quaternion. More...
|
| |
| template<typename T > |
| using | Ray2 = Ray< T, 2 > |
| | Type alias for 2-D ray. More...
|
| |
| typedef Ray2< float > | Ray2F |
| | Float-type 2-D ray. More...
|
| |
| typedef Ray2< double > | Ray2D |
| | Double-type 2-D ray. More...
|
| |
| template<typename T > |
| using | Ray3 = Ray< T, 3 > |
| | Type alias for 3-D ray. More...
|
| |
| typedef Ray3< float > | Ray3F |
| | Float-type 3-D ray. More...
|
| |
| typedef Ray3< double > | Ray3D |
| | Double-type 3-D ray. More...
|
| |
| typedef std::shared_ptr< RigidBodyCollider2 > | RigidBodyCollider2Ptr |
| | Shared pointer for the RigidBodyCollider2 type. More...
|
| |
| typedef std::shared_ptr< RigidBodyCollider3 > | RigidBodyCollider3Ptr |
| | Shared pointer for the RigidBodyCollider3 type. More...
|
| |
| typedef std::shared_ptr< ScalarField2 > | ScalarField2Ptr |
| | Shared pointer for the ScalarField2 type. More...
|
| |
| typedef std::shared_ptr< ScalarField3 > | ScalarField3Ptr |
| | Shared pointer for the ScalarField3 type. More...
|
| |
| typedef std::shared_ptr< ScalarGrid2 > | ScalarGrid2Ptr |
| | Shared pointer for the ScalarGrid2 type. More...
|
| |
| typedef std::shared_ptr< ScalarGridBuilder2 > | ScalarGridBuilder2Ptr |
| | Shared pointer for the ScalarGridBuilder2 type. More...
|
| |
| typedef std::shared_ptr< ScalarGrid3 > | ScalarGrid3Ptr |
| | Shared pointer for the ScalarGrid3 type. More...
|
| |
| typedef std::shared_ptr< ScalarGridBuilder3 > | ScalarGridBuilder3Ptr |
| | Shared pointer for the ScalarGridBuilder3 type. More...
|
| |
| typedef std::shared_ptr< SemiLagrangian2 > | SemiLagrangian2Ptr |
| |
| typedef std::shared_ptr< SemiLagrangian3 > | SemiLagrangian3Ptr |
| |
| template<size_t N> |
| using | Size = Point< size_t, N > |
| | N-D size type. More...
|
| |
| typedef std::shared_ptr< SphPointsToImplicit2 > | SphPointsToImplicit2Ptr |
| | Shared pointer type for SphPointsToImplicit2 class. More...
|
| |
| typedef std::shared_ptr< SphPointsToImplicit3 > | SphPointsToImplicit3Ptr |
| | Shared pointer type for SphPointsToImplicit3 class. More...
|
| |
| typedef std::shared_ptr< SphSolver2 > | SphSolver2Ptr |
| | Shared pointer type for the SphSolver2. More...
|
| |
| typedef std::shared_ptr< SphSolver3 > | SphSolver3Ptr |
| | Shared pointer type for the SphSolver3. More...
|
| |
| typedef std::shared_ptr< SphSystemData2 > | SphSystemData2Ptr |
| | Shared pointer for the SphSystemData2 type. More...
|
| |
| typedef std::shared_ptr< SphSystemData3 > | SphSystemData3Ptr |
| | Shared pointer for the SphSystemData3 type. More...
|
| |
| typedef std::shared_ptr< Sphere2 > | Sphere2Ptr |
| | Shared pointer for the Sphere2 type. More...
|
| |
| typedef std::shared_ptr< Sphere3 > | Sphere3Ptr |
| | Shared pointer for the Sphere3 type. More...
|
| |
| typedef std::shared_ptr< SphericalPointsToImplicit2 > | SphericalPointsToImplicit2Ptr |
| | Shared pointer type for SphericalPointsToImplicit2. More...
|
| |
| typedef std::shared_ptr< SphericalPointsToImplicit3 > | SphericalPointsToImplicit3Ptr |
| | Shared pointer type for SphericalPointsToImplicit3. More...
|
| |
| typedef std::shared_ptr< Surface2 > | Surface2Ptr |
| | Shared pointer for the Surface2 type. More...
|
| |
| typedef std::shared_ptr< Surface3 > | Surface3Ptr |
| | Shared pointer for the Surface3 type. More...
|
| |
| typedef std::shared_ptr< SurfaceSet2 > | SurfaceSet2Ptr |
| | Shared pointer for the SurfaceSet2 type. More...
|
| |
| typedef std::shared_ptr< SurfaceSet3 > | SurfaceSet3Ptr |
| | Shared pointer for the SurfaceSet3 type. More...
|
| |
| typedef std::shared_ptr< SurfaceToImplicit2 > | SurfaceToImplicit2Ptr |
| | Shared pointer for the SurfaceToImplicit2 type. More...
|
| |
| typedef std::shared_ptr< SurfaceToImplicit3 > | SurfaceToImplicit3Ptr |
| | Shared pointer for the SurfaceToImplicit3 type. More...
|
| |
| typedef std::shared_ptr< Triangle3 > | Triangle3Ptr |
| | Shared pointer for the Triangle3 type. More...
|
| |
| typedef std::shared_ptr< TriangleMesh3 > | TriangleMesh3Ptr |
| | Shared pointer for the TriangleMesh3 type. More...
|
| |
| typedef std::shared_ptr< TrianglePointGenerator > | TrianglePointGeneratorPtr |
| |
| typedef std::shared_ptr< UpwindLevelSetSolver2 > | UpwindLevelSetSolver2Ptr |
| |
| typedef std::shared_ptr< UpwindLevelSetSolver3 > | UpwindLevelSetSolver3Ptr |
| |
| template<typename T > |
| using | Vector2 = Vector< T, 2 > |
| | Type alias for two dimensional vector. More...
|
| |
| typedef Vector2< float > | Vector2F |
| | Float-type 2D vector. More...
|
| |
| typedef Vector2< double > | Vector2D |
| | Double-type 2D vector. More...
|
| |
| template<typename T > |
| using | Vector3 = Vector< T, 3 > |
| | Type alias for three dimensional vector. More...
|
| |
| typedef Vector3< float > | Vector3F |
| | Float-type 3D vector. More...
|
| |
| typedef Vector3< double > | Vector3D |
| | Double-type 3D vector. More...
|
| |
| template<typename T > |
| using | Vector4 = Vector< T, 4 > |
| | Type alias for four dimensional vector. More...
|
| |
| typedef Vector4< float > | Vector4F |
| | Float-type 4D vector. More...
|
| |
| typedef Vector4< double > | Vector4D |
| | Double-type 4D vector. More...
|
| |
| template<typename T , typename E , typename U > |
| using | VectorTypeCast = VectorUnaryOp< T, E, TypeCast< U, T > > |
| | Matrix expression for type casting. More...
|
| |
| template<typename T , typename E1 , typename E2 > |
| using | VectorAdd = VectorBinaryOp< T, E1, E2, std::plus< T > > |
| | Vector-vector addition expression. More...
|
| |
| template<typename T , typename E > |
| using | VectorScalarAdd = VectorScalarBinaryOp< T, E, std::plus< T > > |
| | Vector-scalar addition expression. More...
|
| |
| template<typename T , typename E1 , typename E2 > |
| using | VectorSub = VectorBinaryOp< T, E1, E2, std::minus< T > > |
| | Vector-vector addition expression. More...
|
| |
| template<typename T , typename E > |
| using | VectorScalarSub = VectorScalarBinaryOp< T, E, std::minus< T > > |
| | Vector-scalar subtraction expression. More...
|
| |
| template<typename T , typename E > |
| using | VectorScalarRSub = VectorScalarBinaryOp< T, E, RMinus< T > > |
| | Scalar-vector subtraction expression. More...
|
| |
| template<typename T , typename E1 , typename E2 > |
| using | VectorMul = VectorBinaryOp< T, E1, E2, std::multiplies< T > > |
| | Element-wise vector-vector multiplication expression. More...
|
| |
| template<typename T , typename E > |
| using | VectorScalarMul = VectorScalarBinaryOp< T, E, std::multiplies< T > > |
| | Vector-scalar multiplication expression. More...
|
| |
| template<typename T , typename E1 , typename E2 > |
| using | VectorDiv = VectorBinaryOp< T, E1, E2, std::divides< T > > |
| | Element-wise vector-vector division expression. More...
|
| |
| template<typename T , typename E > |
| using | VectorScalarDiv = VectorScalarBinaryOp< T, E, std::divides< T > > |
| | Vector-scalar division expression. More...
|
| |
| template<typename T , typename E > |
| using | VectorScalarRDiv = VectorScalarBinaryOp< T, E, RDivides< T > > |
| | Scalar-vector division expression. More...
|
| |
| typedef std::shared_ptr< VectorField2 > | VectorField2Ptr |
| | Shared pointer for the VectorField2 type. More...
|
| |
| typedef std::shared_ptr< VectorField3 > | VectorField3Ptr |
| | Shared pointer for the VectorField3 type. More...
|
| |
| typedef std::shared_ptr< VectorGrid2 > | VectorGrid2Ptr |
| | Shared pointer for the VectorGrid2 type. More...
|
| |
| typedef std::shared_ptr< VectorGridBuilder2 > | VectorGridBuilder2Ptr |
| | Shared pointer for the VectorGridBuilder2 type. More...
|
| |
| typedef std::shared_ptr< VectorGrid3 > | VectorGrid3Ptr |
| | Shared pointer for the VectorGrid3 type. More...
|
| |
| typedef std::shared_ptr< VectorGridBuilder3 > | VectorGridBuilder3Ptr |
| | Shared pointer for the VectorGridBuilder3 type. More...
|
| |
| typedef VectorN< float > | VectorNF |
| | Float-type N-D vector. More...
|
| |
| typedef VectorN< double > | VectorND |
| | Double-type N-D vector. More...
|
| |
| typedef std::shared_ptr< VertexCenteredScalarGrid2 > | VertexCenteredScalarGrid2Ptr |
| | Shared pointer for the VertexCenteredScalarGrid2 type. More...
|
| |
| typedef std::shared_ptr< VertexCenteredScalarGrid3 > | VertexCenteredScalarGrid3Ptr |
| | Shared pointer for the VertexCenteredScalarGrid3 type. More...
|
| |
| typedef std::shared_ptr< VertexCenteredVectorGrid2 > | VertexCenteredVectorGrid2Ptr |
| | Shared pointer for the VertexCenteredVectorGrid2 type. More...
|
| |
| typedef std::shared_ptr< VertexCenteredVectorGrid3 > | VertexCenteredVectorGrid3Ptr |
| | Shared pointer for the VertexCenteredVectorGrid3 type. More...
|
| |
| typedef std::shared_ptr< VolumeGridEmitter2 > | VolumeGridEmitter2Ptr |
| | Shared pointer type for the VolumeGridEmitter2. More...
|
| |
| typedef std::shared_ptr< VolumeGridEmitter3 > | VolumeGridEmitter3Ptr |
| | Shared pointer type for the VolumeGridEmitter3. More...
|
| |
| typedef std::shared_ptr< VolumeParticleEmitter2 > | VolumeParticleEmitter2Ptr |
| | Shared pointer for the VolumeParticleEmitter2 type. More...
|
| |
| typedef std::shared_ptr< VolumeParticleEmitter3 > | VolumeParticleEmitter3Ptr |
| | Shared pointer for the VolumeParticleEmitter3 type. More...
|
| |
| typedef std::shared_ptr< ZhuBridsonPointsToImplicit2 > | ZhuBridsonPointsToImplicit2Ptr |
| | Shared pointer type for ZhuBridsonPointsToImplicit2 class. More...
|
| |
| typedef std::shared_ptr< ZhuBridsonPointsToImplicit3 > | ZhuBridsonPointsToImplicit3Ptr |
| | Shared pointer type for ZhuBridsonPointsToImplicit3 class. More...
|
| |
|
| template<typename ArrayType , typename T > |
| void | setRange1 (size_t size, const T &value, ArrayType *output) |
| | Assigns value to 1-D array output with size. More...
|
| |
| template<typename ArrayType , typename T > |
| void | setRange1 (size_t begin, size_t end, const T &value, ArrayType *output) |
| | Assigns value to 1-D array output from begin to end. More...
|
| |
| template<typename ArrayType1 , typename ArrayType2 > |
| void | copyRange1 (const ArrayType1 &input, size_t size, ArrayType2 *output) |
| | Copies input array to output array with size. More...
|
| |
| template<typename ArrayType1 , typename ArrayType2 > |
| void | copyRange1 (const ArrayType1 &input, size_t begin, size_t end, ArrayType2 *output) |
| | Copies input array to output array from begin to end. More...
|
| |
| template<typename ArrayType1 , typename ArrayType2 > |
| void | copyRange2 (const ArrayType1 &input, size_t sizeX, size_t sizeY, ArrayType2 *output) |
| | Copies 2-D input array to output array with sizeX and sizeY. More...
|
| |
| template<typename ArrayType1 , typename ArrayType2 > |
| void | copyRange2 (const ArrayType1 &input, size_t beginX, size_t endX, size_t beginY, size_t endY, ArrayType2 *output) |
| | Copies 2-D input array to output array from (beginX, beginY) to (endX, endY). More...
|
| |
| template<typename ArrayType1 , typename ArrayType2 > |
| void | copyRange3 (const ArrayType1 &input, size_t sizeX, size_t sizeY, size_t sizeZ, ArrayType2 *output) |
| | Copies 3-D input array to output array with sizeX and sizeY. More...
|
| |
| template<typename ArrayType1 , typename ArrayType2 > |
| void | copyRange3 (const ArrayType1 &input, size_t beginX, size_t endX, size_t beginY, size_t endY, size_t beginZ, size_t endZ, ArrayType2 *output) |
| | Copies 3-D input array to output array from (beginX, beginY, beginZ) to (endX, endY, endZ). More...
|
| |
| template<typename T > |
| void | extrapolateToRegion (const ConstArrayAccessor2< T > &input, const ConstArrayAccessor2< char > &valid, unsigned int numberOfIterations, ArrayAccessor2< T > output) |
| | Extrapolates 2-D input data from 'valid' (1) to 'invalid' (0) region. More...
|
| |
| template<typename T > |
| void | extrapolateToRegion (const ConstArrayAccessor3< T > &input, const ConstArrayAccessor3< char > &valid, unsigned int numberOfIterations, ArrayAccessor3< T > output) |
| | Extrapolates 3-D input data from 'valid' (1) to 'invalid' (0) region. More...
|
| |
| template<typename ArrayType > |
| void | convertToCsv (const ArrayType &data, std::ostream *strm) |
| | Converts 2-D array to Comma Separated Value (CSV) stream. More...
|
| |
| template<typename BlasType > |
| void | cg (const typename BlasType::MatrixType &A, const typename BlasType::VectorType &b, unsigned int maxNumberOfIterations, double tolerance, typename BlasType::VectorType *x, typename BlasType::VectorType *r, typename BlasType::VectorType *d, typename BlasType::VectorType *q, typename BlasType::VectorType *s, unsigned int *lastNumberOfIterations, double *lastResidualNorm) |
| | Solves conjugate gradient. More...
|
| |
| template<typename BlasType , typename PrecondType > |
| void | pcg (const typename BlasType::MatrixType &A, const typename BlasType::VectorType &b, unsigned int maxNumberOfIterations, double tolerance, PrecondType *M, typename BlasType::VectorType *x, typename BlasType::VectorType *r, typename BlasType::VectorType *d, typename BlasType::VectorType *q, typename BlasType::VectorType *s, unsigned int *lastNumberOfIterations, double *lastResidualNorm) |
| | Solves pre-conditioned conjugate gradient. More...
|
| |
| template<typename T > |
| constexpr T | zero () |
| | Zero for type T. More...
|
| |
| template<> |
| constexpr float | zero< float > () |
| | Zero for float. More...
|
| |
| template<> |
| constexpr double | zero< double > () |
| | Zero for double. More...
|
| |
| template<typename T > |
| constexpr T | one () |
| | One for type T. More...
|
| |
| template<> |
| constexpr float | one< float > () |
| | One for float. More...
|
| |
| template<> |
| constexpr double | one< double > () |
| | One for double. More...
|
| |
| template<typename T > |
| constexpr T | pi () |
| | Pi for type T. More...
|
| |
| template<> |
| constexpr float | pi< float > () |
| | Pi for float. More...
|
| |
| template<> |
| constexpr double | pi< double > () |
| | Pi for double. More...
|
| |
| template<typename T > |
| constexpr T | halfPi () |
| | Pi/2 for type T. More...
|
| |
| template<> |
| constexpr float | halfPi< float > () |
| | Pi/2 for float. More...
|
| |
| template<> |
| constexpr double | halfPi< double > () |
| | Pi/2 for double. More...
|
| |
| template<typename T > |
| constexpr T | quarterPi () |
| | Pi/4 for type T. More...
|
| |
| template<> |
| constexpr float | quarterPi< float > () |
| | Pi/2 for float. More...
|
| |
| template<> |
| constexpr double | quarterPi< double > () |
| | Pi/2 for double. More...
|
| |
| template<typename T > |
| constexpr T | twoPi () |
| | 2*pi for type T. More...
|
| |
| template<> |
| constexpr float | twoPi< float > () |
| | 2*pi for float. More...
|
| |
| template<> |
| constexpr double | twoPi< double > () |
| | 2*pi for double. More...
|
| |
| template<typename T > |
| constexpr T | fourPi () |
| | 4*pi for type T. More...
|
| |
| template<> |
| constexpr float | fourPi< float > () |
| | 4*pi for float. More...
|
| |
| template<> |
| constexpr double | fourPi< double > () |
| | 4*pi for double. More...
|
| |
| template<typename T > |
| constexpr T | invPi () |
| | 1/pi for type T. More...
|
| |
| template<> |
| constexpr float | invPi< float > () |
| | 1/pi for float. More...
|
| |
| template<> |
| constexpr double | invPi< double > () |
| | 1/pi for double. More...
|
| |
| template<typename T > |
| constexpr T | invTwoPi () |
| | 1/2*pi for type T. More...
|
| |
| template<> |
| constexpr float | invTwoPi< float > () |
| | 1/2*pi for float. More...
|
| |
| template<> |
| constexpr double | invTwoPi< double > () |
| | 1/2*pi for double. More...
|
| |
| template<typename T > |
| constexpr T | invFourPi () |
| | 1/4*pi for type T. More...
|
| |
| template<> |
| constexpr float | invFourPi< float > () |
| | 1/4*pi for float. More...
|
| |
| template<> |
| constexpr double | invFourPi< double > () |
| | 1/4*pi for double. More...
|
| |
| template<class ForwardIt , class T , class Compare = std::less<T>> |
| ForwardIt | binaryFind (ForwardIt first, ForwardIt last, const T &value, Compare comp={}) |
| |
| Vector2D | gradient2 (const ConstArrayAccessor2< double > &data, const Vector2D &gridSpacing, size_t i, size_t j) |
| | Returns 2-D gradient vector from given 2-D scalar grid-like array data, gridSpacing, and array index (i, j). More...
|
| |
| std::array< Vector2D, 2 > | gradient2 (const ConstArrayAccessor2< Vector2D > &data, const Vector2D &gridSpacing, size_t i, size_t j) |
| | Returns 2-D gradient vectors from given 2-D vector grid-like array data, gridSpacing, and array index (i, j). More...
|
| |
| Vector3D | gradient3 (const ConstArrayAccessor3< double > &data, const Vector3D &gridSpacing, size_t i, size_t j, size_t k) |
| | Returns 3-D gradient vector from given 3-D scalar grid-like array data, gridSpacing, and array index (i, j, k). More...
|
| |
| std::array< Vector3D, 3 > | gradient3 (const ConstArrayAccessor3< Vector3D > &data, const Vector3D &gridSpacing, size_t i, size_t j, size_t k) |
| | Returns 3-D gradient vectors from given 3-D vector grid-like array data, gridSpacing, and array index (i, j, k). More...
|
| |
| double | laplacian2 (const ConstArrayAccessor2< double > &data, const Vector2D &gridSpacing, size_t i, size_t j) |
| | Returns Laplacian value from given 2-D scalar grid-like array data, gridSpacing, and array index (i, j). More...
|
| |
| Vector2D | laplacian2 (const ConstArrayAccessor2< Vector2D > &data, const Vector2D &gridSpacing, size_t i, size_t j) |
| | Returns 2-D Laplacian vectors from given 2-D vector grid-like array data, gridSpacing, and array index (i, j). More...
|
| |
| double | laplacian3 (const ConstArrayAccessor3< double > &data, const Vector3D &gridSpacing, size_t i, size_t j, size_t k) |
| | Returns Laplacian value from given 3-D scalar grid-like array data, gridSpacing, and array index (i, j, k). More...
|
| |
| Vector3D | laplacian3 (const ConstArrayAccessor3< Vector3D > &data, const Vector3D &gridSpacing, size_t i, size_t j, size_t k) |
| | Returns 3-D Laplacian vectors from given 3-D vector grid-like array data, gridSpacing, and array index (i, j, k). More...
|
| |
| template<typename T > |
| bool | isInsideSdf (T phi) |
| | Returns true if phi is inside the implicit surface (< 0). More...
|
| |
| template<typename T > |
| T | smearedHeavisideSdf (T phi) |
| | Returns smeared Heaviside function. More...
|
| |
| template<typename T > |
| T | smearedDeltaSdf (T phi) |
| | Returns smeared delta function. More...
|
| |
| template<typename T > |
| T | fractionInsideSdf (T phi0, T phi1) |
| | Returns the fraction occupied by the implicit surface. More...
|
| |
| template<typename T > |
| T | fractionInside (T phiBottomLeft, T phiBottomRight, T phiTopLeft, T phiTopRight) |
| | Returns the fraction occupied by the implicit surface. More...
|
| |
| void | marchingCubes (const ConstArrayAccessor3< double > &grid, const Vector3D &gridSize, const Vector3D &origin, TriangleMesh3 *mesh, double isoValue=0, int bndClose=kDirectionAll, int bndConnectivity=kDirectionNone) |
| | Computes marching cubes and extract triangle mesh from grid. More...
|
| |
| template<typename T > |
| bool | similar (T x, T y, T eps=std::numeric_limits< T >::epsilon()) |
| | Returns true if x and y are similar. More...
|
| |
| template<typename T > |
| T | sign (T x) |
| | Returns the sign of the value. More...
|
| |
| template<typename T > |
| T | min3 (T x, T y, T z) |
| | Returns the minimum value among three inputs. More...
|
| |
| template<typename T > |
| T | max3 (T x, T y, T z) |
| | Returns the maximum value among three inputs. More...
|
| |
| template<typename T > |
| T | minn (const T *x, size_t n) |
| | Returns minimum among n-elements. More...
|
| |
| template<typename T > |
| T | maxn (const T *x, size_t n) |
| | Returns maximum among n-elements. More...
|
| |
| template<typename T > |
| T | absmin (T x, T y) |
| | Returns the absolute minimum value among the two inputs. More...
|
| |
| template<typename T > |
| T | absmax (T x, T y) |
| | Returns the absolute maximum value among the two inputs. More...
|
| |
| template<typename T > |
| T | absminn (const T *x, size_t n) |
| | Returns absolute minimum among n-elements. More...
|
| |
| template<typename T > |
| T | absmaxn (const T *x, size_t n) |
| | Returns absolute maximum among n-elements. More...
|
| |
| template<typename T > |
| size_t | argmin2 (T x, T y) |
| |
| template<typename T > |
| size_t | argmax2 (T x, T y) |
| |
| template<typename T > |
| size_t | argmin3 (T x, T y, T z) |
| |
| template<typename T > |
| size_t | argmax3 (T x, T y, T z) |
| |
| template<typename T > |
| T | square (T x) |
| | Returns the square of x. More...
|
| |
| template<typename T > |
| T | cubic (T x) |
| | Returns the cubic of x. More...
|
| |
| template<typename T > |
| T | clamp (T val, T low, T high) |
| | Returns the clamped value. More...
|
| |
| template<typename T > |
| T | degreesToRadians (T angleInDegrees) |
| | Converts degrees to radians. More...
|
| |
| template<typename T > |
| T | radiansToDegrees (T angleInRadians) |
| | Converts radians to degrees. More...
|
| |
| template<class T > |
| void | getBarycentric (T x, ssize_t iLow, ssize_t iHigh, ssize_t *i, T *t) |
| | Gets the barycentric coordinate. More...
|
| |
| template<typename S , typename T > |
| S | lerp (const S &f0, const S &f1, T t) |
| | Computes linear interpolation. More...
|
| |
| template<typename S , typename T > |
| S | bilerp (const S &f00, const S &f10, const S &f01, const S &f11, T tx, T ty) |
| | Computes bilinear interpolation. More...
|
| |
| template<typename S , typename T > |
| S | trilerp (const S &f000, const S &f100, const S &f010, const S &f110, const S &f001, const S &f101, const S &f011, const S &f111, T tx, T ty, T tz) |
| | Computes trilinear interpolation. More...
|
| |
| template<typename S , typename T > |
| S | catmullRom (const S &f0, const S &f1, const S &f2, const S &f3, T t) |
| | Computes Catmull-Rom interpolation. More...
|
| |
| template<typename T > |
| T | monotonicCatmullRom (const T &f0, const T &f1, const T &f2, const T &f3, T t) |
| | Computes monotonic Catmull-Rom interpolation. More...
|
| |
| template<typename T > |
| Matrix2x2< T > | operator- (const Matrix2x2< T > &a) |
| | Returns a matrix with opposite sign. More...
|
| |
| template<typename T > |
| Matrix2x2< T > | operator+ (const Matrix2x2< T > &a, const Matrix2x2< T > &b) |
| | Returns a + b (element-size). More...
|
| |
| template<typename T > |
| Matrix2x2< T > | operator+ (const Matrix2x2< T > &a, const T &b) |
| | Returns a + b', where every element of matrix b' is b. More...
|
| |
| template<typename T > |
| Matrix2x2< T > | operator+ (const T &a, const Matrix2x2< T > &b) |
| | Returns a' + b, where every element of matrix a' is a. More...
|
| |
| template<typename T > |
| Matrix2x2< T > | operator- (const Matrix2x2< T > &a, const Matrix2x2< T > &b) |
| | Returns a - b (element-size). More...
|
| |
| template<typename T > |
| Matrix2x2< T > | operator- (const Matrix2x2< T > &a, T b) |
| | Returns a - b', where every element of matrix b' is b. More...
|
| |
| template<typename T > |
| Matrix2x2< T > | operator- (T a, const Matrix2x2< T > &b) |
| | Returns a' - b, where every element of matrix a' is a. More...
|
| |
| template<typename T > |
| Matrix2x2< T > | operator* (const Matrix2x2< T > &a, T b) |
| | Returns a * b', where every element of matrix b' is b. More...
|
| |
| template<typename T > |
| Matrix2x2< T > | operator* (T a, const Matrix2x2< T > &b) |
| | Returns a' * b, where every element of matrix a' is a. More...
|
| |
| template<typename T > |
| Vector2< T > | operator* (const Matrix2x2< T > &a, const Vector2< T > &b) |
| | Returns a * b. More...
|
| |
| template<typename T > |
| Matrix2x2< T > | operator* (const Matrix2x2< T > &a, const Matrix2x2< T > &b) |
| | Returns a * b. More...
|
| |
| template<typename T > |
| Matrix2x2< T > | operator/ (const Matrix2x2< T > &a, T b) |
| | Returns a' / b, where every element of matrix a' is a. More...
|
| |
| template<typename T > |
| Matrix2x2< T > | operator/ (const T &a, const Matrix2x2< T > &b) |
| | Returns a / b', where every element of matrix b' is b. More...
|
| |
| template<typename T > |
| Matrix3x3< T > | operator- (const Matrix3x3< T > &a) |
| | Returns a matrix with opposite sign. More...
|
| |
| template<typename T > |
| Matrix3x3< T > | operator+ (const Matrix3x3< T > &a, const Matrix3x3< T > &b) |
| | Returns a + b (element-size). More...
|
| |
| template<typename T > |
| Matrix3x3< T > | operator+ (const Matrix3x3< T > &a, T b) |
| | Returns a + b', where every element of matrix b' is b. More...
|
| |
| template<typename T > |
| Matrix3x3< T > | operator+ (T a, const Matrix3x3< T > &b) |
| | Returns a' + b, where every element of matrix a' is a. More...
|
| |
| template<typename T > |
| Matrix3x3< T > | operator- (const Matrix3x3< T > &a, const Matrix3x3< T > &b) |
| | Returns a - b (element-size). More...
|
| |
| template<typename T > |
| Matrix3x3< T > | operator- (const Matrix3x3< T > &a, T b) |
| | Returns a - b', where every element of matrix b' is b. More...
|
| |
| template<typename T > |
| Matrix3x3< T > | operator- (T a, const Matrix3x3< T > &b) |
| | Returns a' - b, where every element of matrix a' is a. More...
|
| |
| template<typename T > |
| Matrix3x3< T > | operator* (const Matrix3x3< T > &a, T b) |
| | Returns a * b', where every element of matrix b' is b. More...
|
| |
| template<typename T > |
| Matrix3x3< T > | operator* (T a, const Matrix3x3< T > &b) |
| | Returns a' * b, where every element of matrix a' is a. More...
|
| |
| template<typename T > |
| Vector3< T > | operator* (const Matrix3x3< T > &a, const Vector3< T > &b) |
| | Returns a * b. More...
|
| |
| template<typename T > |
| Matrix3x3< T > | operator* (const Matrix3x3< T > &a, const Matrix3x3< T > &b) |
| | Returns a * b. More...
|
| |
| template<typename T > |
| Matrix3x3< T > | operator/ (const Matrix3x3< T > &a, T b) |
| | Returns a' / b, where every element of matrix a' is a. More...
|
| |
| template<typename T > |
| Matrix3x3< T > | operator/ (T a, const Matrix3x3< T > &b) |
| | Returns a / b', where every element of matrix b' is b. More...
|
| |
| template<typename T > |
| Matrix4x4< T > | operator- (const Matrix4x4< T > &a) |
| | Returns a matrix with opposite sign. More...
|
| |
| template<typename T > |
| Matrix4x4< T > | operator+ (const Matrix4x4< T > &a, const Matrix4x4< T > &b) |
| | Returns a + b (element-size). More...
|
| |
| template<typename T > |
| Matrix4x4< T > | operator+ (const Matrix4x4< T > &a, T b) |
| | Returns a + b', where every element of matrix b' is b. More...
|
| |
| template<typename T > |
| Matrix4x4< T > | operator+ (T a, const Matrix4x4< T > &b) |
| | Returns a' + b, where every element of matrix a' is a. More...
|
| |
| template<typename T > |
| Matrix4x4< T > | operator- (const Matrix4x4< T > &a, const Matrix4x4< T > &b) |
| | Returns a - b (element-size). More...
|
| |
| template<typename T > |
| Matrix4x4< T > | operator- (const Matrix4x4< T > &a, T b) |
| | Returns a - b', where every element of matrix b' is b. More...
|
| |
| template<typename T > |
| Matrix4x4< T > | operator- (T a, const Matrix4x4< T > &b) |
| | Returns a' - b, where every element of matrix a' is a. More...
|
| |
| template<typename T > |
| Matrix4x4< T > | operator* (const Matrix4x4< T > &a, T b) |
| | Returns a * b', where every element of matrix b' is b. More...
|
| |
| template<typename T > |
| Matrix4x4< T > | operator* (T a, const Matrix4x4< T > &b) |
| | Returns a' * b, where every element of matrix a' is a. More...
|
| |
| template<typename T > |
| Vector3< T > | operator* (const Matrix4x4< T > &a, const Vector3< T > &b) |
| | Returns a * b. More...
|
| |
| template<typename T > |
| Vector4< T > | operator* (const Matrix4x4< T > &a, const Vector4< T > &b) |
| | Returns a * b. More...
|
| |
| template<typename T > |
| Matrix4x4< T > | operator* (const Matrix4x4< T > &a, const Matrix3x3< T > &b) |
| | Returns a * b. More...
|
| |
| template<typename T > |
| Matrix4x4< T > | operator* (const Matrix3x3< T > &a, const Matrix4x4< T > &b) |
| | Returns a * b. More...
|
| |
| template<typename T > |
| Matrix4x4< T > | operator* (const Matrix4x4< T > &a, const Matrix4x4< T > &b) |
| | Returns a * b. More...
|
| |
| template<typename T > |
| Matrix4x4< T > | operator/ (const Matrix4x4< T > &a, T b) |
| | Returns a' / b, where every element of matrix a' is a. More...
|
| |
| template<typename T > |
| Matrix4x4< T > | operator/ (const T &a, const Matrix4x4< T > &b) |
| | Returns a / b', where every element of matrix b' is b. More...
|
| |
| template<typename T , typename E > |
| MatrixScalarMul< T, E > | operator- (const MatrixExpression< T, E > &a) |
| | Returns a matrix with opposite sign. More...
|
| |
| template<typename T , typename E1 , typename E2 > |
| MatrixAdd< T, E1, E2 > | operator+ (const MatrixExpression< T, E1 > &a, const MatrixExpression< T, E2 > &b) |
| | Returns a + b (element-size). More...
|
| |
| template<typename T , typename E > |
| MatrixScalarAdd< T, E > | operator+ (const MatrixExpression< T, E > &a, T b) |
| | Returns a + b', where every element of matrix b' is b. More...
|
| |
| template<typename T , typename E > |
| MatrixScalarAdd< T, E > | operator+ (T a, const MatrixExpression< T, E > &b) |
| | Returns a' + b, where every element of matrix a' is a. More...
|
| |
| template<typename T , typename E1 , typename E2 > |
| MatrixSub< T, E1, E2 > | operator- (const MatrixExpression< T, E1 > &a, const MatrixExpression< T, E2 > &b) |
| | Returns a - b (element-size). More...
|
| |
| template<typename T , typename E > |
| MatrixScalarSub< T, E > | operator- (const MatrixExpression< T, E > &a, T b) |
| | Returns a - b', where every element of matrix b' is b. More...
|
| |
| template<typename T , typename E > |
| MatrixScalarRSub< T, E > | operator- (T a, const MatrixExpression< T, E > &b) |
| | Returns a' - b, where every element of matrix a' is a. More...
|
| |
| template<typename T , typename E > |
| MatrixScalarMul< T, E > | operator* (const MatrixExpression< T, E > &a, T b) |
| | Returns a * b', where every element of matrix b' is b. More...
|
| |
| template<typename T , typename E > |
| MatrixScalarMul< T, E > | operator* (T a, const MatrixExpression< T, E > &b) |
| | Returns a' * b, where every element of matrix a' is a. More...
|
| |
| template<typename T , typename ME , typename VE > |
| MatrixVectorMul< T, ME, VE > | operator* (const MatrixExpression< T, ME > &a, const VectorExpression< T, VE > &b) |
| | Returns a * b. More...
|
| |
| template<typename T , typename E1 , typename E2 > |
| MatrixMul< T, E1, E2 > | operator* (const MatrixExpression< T, E1 > &a, const MatrixExpression< T, E2 > &b) |
| | Returns a * b. More...
|
| |
| template<typename T , typename E > |
| MatrixScalarDiv< T, E > | operator/ (const MatrixExpression< T, E > &a, T b) |
| | Returns a' / b, where every element of matrix a' is a. More...
|
| |
| template<typename T , typename E > |
| MatrixScalarRDiv< T, E > | operator/ (T a, const MatrixExpression< T, E > &b) |
| | Returns a / b', where every element of matrix b' is b. More...
|
| |
| template<typename BlasType > |
| MgResult | mgVCycle (const MgMatrix< BlasType > &A, MgParameters< BlasType > params, MgVector< BlasType > *x, MgVector< BlasType > *b, MgVector< BlasType > *buffer) |
| | Performs Multigrid with V-cycle. More...
|
| |
| template<typename RandomIterator , typename T > |
| void | parallelFill (const RandomIterator &begin, const RandomIterator &end, const T &value, ExecutionPolicy policy=ExecutionPolicy::kParallel) |
| | Fills from begin to end with value in parallel. More...
|
| |
| template<typename IndexType , typename Function > |
| void | parallelFor (IndexType beginIndex, IndexType endIndex, const Function &function, ExecutionPolicy policy=ExecutionPolicy::kParallel) |
| | Makes a for-loop from beginIndex to endIndex in parallel. More...
|
| |
| template<typename IndexType , typename Function > |
| void | parallelRangeFor (IndexType beginIndex, IndexType endIndex, const Function &function, ExecutionPolicy policy=ExecutionPolicy::kParallel) |
| | Makes a range-loop from beginIndex to endIndex in parallel. More...
|
| |
| template<typename IndexType , typename Function > |
| void | parallelFor (IndexType beginIndexX, IndexType endIndexX, IndexType beginIndexY, IndexType endIndexY, const Function &function, ExecutionPolicy policy=ExecutionPolicy::kParallel) |
| | Makes a 2D nested for-loop in parallel. More...
|
| |
| template<typename IndexType , typename Function > |
| void | parallelRangeFor (IndexType beginIndexX, IndexType endIndexX, IndexType beginIndexY, IndexType endIndexY, const Function &function, ExecutionPolicy policy=ExecutionPolicy::kParallel) |
| | Makes a 2D nested range-loop in parallel. More...
|
| |
| template<typename IndexType , typename Function > |
| void | parallelFor (IndexType beginIndexX, IndexType endIndexX, IndexType beginIndexY, IndexType endIndexY, IndexType beginIndexZ, IndexType endIndexZ, const Function &function, ExecutionPolicy policy=ExecutionPolicy::kParallel) |
| | Makes a 3D nested for-loop in parallel. More...
|
| |
| template<typename IndexType , typename Function > |
| void | parallelRangeFor (IndexType beginIndexX, IndexType endIndexX, IndexType beginIndexY, IndexType endIndexY, IndexType beginIndexZ, IndexType endIndexZ, const Function &function, ExecutionPolicy policy=ExecutionPolicy::kParallel) |
| | Makes a 3D nested range-loop in parallel. More...
|
| |
| template<typename IndexType , typename Value , typename Function , typename Reduce > |
| Value | parallelReduce (IndexType beginIndex, IndexType endIndex, const Value &identity, const Function &func, const Reduce &reduce, ExecutionPolicy policy=ExecutionPolicy::kParallel) |
| | Performs reduce operation in parallel. More...
|
| |
| template<typename RandomIterator > |
| void | parallelSort (RandomIterator begin, RandomIterator end, ExecutionPolicy policy=ExecutionPolicy::kParallel) |
| | Sorts a container in parallel. More...
|
| |
| template<typename RandomIterator , typename CompareFunction > |
| void | parallelSort (RandomIterator begin, RandomIterator end, CompareFunction compare, ExecutionPolicy policy=ExecutionPolicy::kParallel) |
| | Sorts a container in parallel with a custom compare function. More...
|
| |
| void | setMaxNumberOfThreads (unsigned int numThreads) |
| | Sets maximum number of threads to use. More...
|
| |
| unsigned int | maxNumberOfThreads () |
| | Returns maximum number of threads to use. More...
|
| |
| template<typename T > |
| std::array< T, 2 > | upwind1 (T *D0, T dx) |
| | 1-st order upwind differencing. D0[1] is the origin. More...
|
| |
| template<typename T > |
| T | upwind1 (T *D0, T dx, bool isDirectionPositive) |
| | 1-st order upwind differencing. D0[1] is the origin. More...
|
| |
| template<typename T > |
| T | cd2 (T *D0, T dx) |
| | 2nd-order central differencing. D0[1] is the origin. More...
|
| |
| template<typename T > |
| std::array< T, 2 > | eno3 (T *D0, T dx) |
| | 3rd-order ENO. D0[3] is the origin. More...
|
| |
| template<typename T > |
| T | eno3 (T *D0, T dx, bool isDirectionPositive) |
| | 3rd-order ENO. D0[3] is the origin. More...
|
| |
| template<typename T > |
| std::array< T, 2 > | weno5 (T *v, T h, T eps=1.0e-8) |
| | 5th-order Weno. D0[3] is the origin. More...
|
| |
| template<typename T > |
| T | weno5 (T *v, T h, bool is_velocity_positive, T eps=1.0e-8) |
| | 5th-order Weno. D0[3] is the origin. More...
|
| |
| template<typename T > |
| Point< T, 2 > | operator+ (const Point< T, 2 > &a) |
| | Positive sign operator. More...
|
| |
| template<typename T > |
| Point2< T > | operator- (const Point2< T > &a) |
| | Negative sign operator. More...
|
| |
| template<typename T > |
| Point2< T > | operator+ (T a, const Point2< T > &b) |
| | Computes (a, a) + (b.x, b.y). More...
|
| |
| template<typename T > |
| Point2< T > | operator+ (const Point2< T > &a, const Point2< T > &b) |
| | Computes (a.x, a.y) + (b.x, b.y). More...
|
| |
| template<typename T > |
| Point2< T > | operator- (const Point2< T > &a, T b) |
| | Computes (a.x, a.y) - (b, b). More...
|
| |
| template<typename T > |
| Point2< T > | operator- (T a, const Point2< T > &b) |
| | Computes (a, a) - (b.x, b.y). More...
|
| |
| template<typename T > |
| Point2< T > | operator- (const Point2< T > &a, const Point2< T > &b) |
| | Computes (a.x, a.y) - (b.x, b.y). More...
|
| |
| template<typename T > |
| Point2< T > | operator* (const Point2< T > &a, T b) |
| | Computes (a.x, a.y) * (b, b). More...
|
| |
| template<typename T > |
| Point2< T > | operator* (T a, const Point2< T > &b) |
| | Computes (a, a) * (b.x, b.y). More...
|
| |
| template<typename T > |
| Point2< T > | operator* (const Point2< T > &a, const Point2< T > &b) |
| | Computes (a.x, a.y) * (b.x, b.y). More...
|
| |
| template<typename T > |
| Point2< T > | operator/ (const Point2< T > &a, T b) |
| | Computes (a.x, a.y) / (b, b). More...
|
| |
| template<typename T > |
| Point2< T > | operator/ (T a, const Point2< T > &b) |
| | Computes (a, a) / (b.x, b.y). More...
|
| |
| template<typename T > |
| Point2< T > | operator/ (const Point2< T > &a, const Point2< T > &b) |
| | Computes (a.x, a.y) / (b.x, b.y). More...
|
| |
| template<typename T > |
| Point2< T > | min (const Point2< T > &a, const Point2< T > &b) |
| | Returns element-wise min point: (min(a.x, b.x), min(a.y, b.y)). More...
|
| |
| template<typename T > |
| Point2< T > | max (const Point2< T > &a, const Point2< T > &b) |
| | Returns element-wise max point: (max(a.x, b.x), max(a.y, b.y)). More...
|
| |
| template<typename T > |
| Point2< T > | clamp (const Point2< T > &v, const Point2< T > &low, const Point2< T > &high) |
| | Returns element-wise clamped point. More...
|
| |
| template<typename T > |
| Point2< T > | ceil (const Point2< T > &a) |
| | Returns element-wise ceiled point. More...
|
| |
| template<typename T > |
| Point2< T > | floor (const Point2< T > &a) |
| | Returns element-wise floored point. More...
|
| |
| template<typename T > |
| Point< T, 3 > | operator+ (const Point< T, 3 > &a) |
| | Positive sign operator. More...
|
| |
| template<typename T > |
| Point3< T > | operator- (const Point3< T > &a) |
| | Negative sign operator. More...
|
| |
| template<typename T > |
| Point3< T > | operator+ (T a, const Point3< T > &b) |
| | Computes (a, a, a) + (b.x, b.y, b.z). More...
|
| |
| template<typename T > |
| Point3< T > | operator+ (const Point3< T > &a, const Point3< T > &b) |
| | Computes (a.x, a.y, a.z) + (b.x, b.y, b.z). More...
|
| |
| template<typename T > |
| Point3< T > | operator- (const Point3< T > &a, T b) |
| | Computes (a.x, a.y, a.z) - (b, b, b). More...
|
| |
| template<typename T > |
| Point3< T > | operator- (T a, const Point3< T > &b) |
| | Computes (a, a, a) - (b.x, b.y, b.z). More...
|
| |
| template<typename T > |
| Point3< T > | operator- (const Point3< T > &a, const Point3< T > &b) |
| | Computes (a.x, a.y, a.z) - (b.x, b.y, b.z). More...
|
| |
| template<typename T > |
| Point3< T > | operator* (const Point3< T > &a, T b) |
| | Computes (a.x, a.y, a.z) * (b, b, b). More...
|
| |
| template<typename T > |
| Point3< T > | operator* (T a, const Point3< T > &b) |
| | Computes (a, a, a) * (b.x, b.y, b.z). More...
|
| |
| template<typename T > |
| Point3< T > | operator* (const Point3< T > &a, const Point3< T > &b) |
| | Computes (a.x, a.y, a.z) * (b.x, b.y, b.z). More...
|
| |
| template<typename T > |
| Point3< T > | operator/ (const Point3< T > &a, T b) |
| | Computes (a.x, a.y, a.z) / (b, b, b). More...
|
| |
| template<typename T > |
| Point3< T > | operator/ (T a, const Point3< T > &b) |
| | Computes (a, a, a) / (b.x, b.y, b.z). More...
|
| |
| template<typename T > |
| Point3< T > | operator/ (const Point3< T > &a, const Point3< T > &b) |
| | Computes (a.x, a.y, a.z) / (b.x, b.y, b.z). More...
|
| |
| template<typename T > |
| Point3< T > | min (const Point3< T > &a, const Point3< T > &b) |
| | Returns element-wise min point. More...
|
| |
| template<typename T > |
| Point3< T > | max (const Point3< T > &a, const Point3< T > &b) |
| | Returns element-wise max point. More...
|
| |
| template<typename T > |
| Point3< T > | clamp (const Point3< T > &v, const Point3< T > &low, const Point3< T > &high) |
| | Returns element-wise clamped point. More...
|
| |
| template<typename T > |
| Point3< T > | ceil (const Point3< T > &a) |
| | Returns element-wise ceiled point. More...
|
| |
| template<typename T > |
| Point3< T > | floor (const Point3< T > &a) |
| | Returns element-wise floored point. More...
|
| |
| template<typename T > |
| Quaternion< T > | slerp (const Quaternion< T > &a, const Quaternion< T > &b, T t) |
| | Computes spherical linear interpolation. More...
|
| |
| template<typename T > |
| Vector< T, 3 > | operator* (const Quaternion< T > &q, const Vector< T, 3 > &v) |
| | Returns quaternion q * vector v. More...
|
| |
| template<typename T > |
| Quaternion< T > | operator* (const Quaternion< T > &a, const Quaternion< T > &b) |
| | Returns quaternion a times quaternion b. More...
|
| |
| template<typename T > |
| Vector3< T > | uniformSampleCone (T u1, T u2, const Vector3< T > &axis, T angle) |
| | Returns randomly sampled direction within a cone. More...
|
| |
| template<typename T > |
| Vector3< T > | uniformSampleHemisphere (T u1, T u2, const Vector3< T > &normal) |
| | Returns randomly sampled point within a unit hemisphere. More...
|
| |
| template<typename T > |
| Vector3< T > | cosineWeightedSampleHemisphere (T u1, T u2, const Vector3< T > &normal) |
| | Returns weighted sampled point on a hemisphere. More...
|
| |
| template<typename T > |
| Vector3< T > | uniformSampleSphere (T u1, T u2) |
| | Returns randomly a point on a sphere. More...
|
| |
| template<typename T > |
| Vector2< T > | uniformSampleDisk (T u1, T u2) |
| | Returns randomly a point on a disk. More...
|
| |
| template<typename RandomIterator , typename T > |
| void | serialFill (const RandomIterator &begin, const RandomIterator &end, const T &value) |
| | Fills from begin to end with value. More...
|
| |
| template<typename IndexType , typename Function > |
| void | serialFor (IndexType beginIndex, IndexType endIndex, const Function &function) |
| | Makes a for-loop from beginIndex to endIndex. More...
|
| |
| template<typename IndexType , typename Function > |
| void | serialFor (IndexType beginIndexX, IndexType endIndexX, IndexType beginIndexY, IndexType endIndexY, const Function &function) |
| | Makes a 2D nested for-loop. More...
|
| |
| template<typename IndexType , typename Function > |
| void | serialFor (IndexType beginIndexX, IndexType endIndexX, IndexType beginIndexY, IndexType endIndexY, IndexType beginIndexZ, IndexType endIndexZ, const Function &function) |
| | Makes a 3D nested for-loop. More...
|
| |
| template<typename RandomIterator > |
| void | serialSort (RandomIterator begin, RandomIterator end) |
| | Sorts a container. More...
|
| |
| template<typename RandomIterator , typename SortingFunction > |
| void | serialSort (RandomIterator begin, RandomIterator end, const SortingFunction &sortingFunction) |
| | Sorts a container with a custom compare function. More...
|
| |
| void | serialize (const Serializable *serializable, std::vector< uint8_t > *buffer) |
| | Serializes serializable object. More...
|
| |
| void | serialize (const uint8_t *data, size_t size, std::vector< uint8_t > *buffer) |
| | Serializes data chunk using common schema. More...
|
| |
| template<typename T > |
| void | serialize (const ConstArrayAccessor1< T > &array, std::vector< uint8_t > *buffer) |
| | Serializes data chunk using common schema. More...
|
| |
| void | deserialize (const std::vector< uint8_t > &buffer, Serializable *serializable) |
| | Deserializes buffer to serializable object. More...
|
| |
| void | deserialize (const std::vector< uint8_t > &buffer, std::vector< uint8_t > *data) |
| | Deserializes buffer to data chunk using common schema. More...
|
| |
| template<typename T > |
| void | deserialize (const std::vector< uint8_t > &buffer, Array1< T > *array) |
| | Deserializes buffer to data chunk using common schema. More...
|
| |
| Size2 | operator+ (const Size2 &a) |
| | Positive sign operator. More...
|
| |
| Size2 | operator- (const Size2 &a) |
| | Negative sign operator. More...
|
| |
| Size2 | operator+ (size_t a, const Size2 &b) |
| | Computes (a, a) + (b.x, b.y). More...
|
| |
| Size2 | operator+ (const Size2 &a, const Size2 &b) |
| | Computes (a.x, a.y) + (b.x, b.y). More...
|
| |
| Size2 | operator- (const Size2 &a, size_t b) |
| | Computes (a.x, a.y) - (b, b). More...
|
| |
| Size2 | operator- (size_t a, const Size2 &b) |
| | Computes (a, a) - (b.x, b.y). More...
|
| |
| Size2 | operator- (const Size2 &a, const Size2 &b) |
| | Computes (a.x, a.y) - (b.x, b.y). More...
|
| |
| Size2 | operator* (const Size2 &a, size_t b) |
| | Computes (a.x, a.y) * (b, b). More...
|
| |
| Size2 | operator* (size_t a, const Size2 &b) |
| | Computes (a, a) * (b.x, b.y). More...
|
| |
| Size2 | operator* (const Size2 &a, const Size2 &b) |
| | Computes (a.x, a.y) * (b.x, b.y). More...
|
| |
| Size2 | operator/ (const Size2 &a, size_t b) |
| | Computes (a.x, a.y) / (b, b). More...
|
| |
| Size2 | operator/ (size_t a, const Size2 &b) |
| | Computes (a, a) / (b.x, b.y). More...
|
| |
| Size2 | operator/ (const Size2 &a, const Size2 &b) |
| | Computes (a.x, a.y) / (b.x, b.y). More...
|
| |
| Size2 | min (const Size2 &a, const Size2 &b) |
| | Returns element-wise min size: (min(a.x, b.x), min(a.y, b.y)). More...
|
| |
| Size2 | max (const Size2 &a, const Size2 &b) |
| | Returns element-wise max size: (max(a.x, b.x), max(a.y, b.y)). More...
|
| |
| Size2 | clamp (const Size2 &v, const Size2 &low, const Size2 &high) |
| | Returns element-wise clamped size. More...
|
| |
| Size2 | ceil (const Size2 &a) |
| | Returns element-wise ceiled size. More...
|
| |
| Size2 | floor (const Size2 &a) |
| | Returns element-wise floored size. More...
|
| |
| Size3 | operator+ (const Size3 &a) |
| | Positive sign operator. More...
|
| |
| Size3 | operator- (const Size3 &a) |
| | Negative sign operator. More...
|
| |
| Size3 | operator+ (size_t a, const Size3 &b) |
| | Computes (a, a, a) + (b.x, b.y, b.z). More...
|
| |
| Size3 | operator+ (const Size3 &a, const Size3 &b) |
| | Computes (a.x, a.y, a.z) + (b.x, b.y, b.z). More...
|
| |
| Size3 | operator- (const Size3 &a, size_t b) |
| | Computes (a.x, a.y, a.z) - (b, b, b). More...
|
| |
| Size3 | operator- (size_t a, const Size3 &b) |
| | Computes (a, a, a) - (b.x, b.y, b.z). More...
|
| |
| Size3 | operator- (const Size3 &a, const Size3 &b) |
| | Computes (a.x, a.y, a.z) - (b.x, b.y, b.z). More...
|
| |
| Size3 | operator* (const Size3 &a, size_t b) |
| | Computes (a.x, a.y, a.z) * (b, b, b). More...
|
| |
| Size3 | operator* (size_t a, const Size3 &b) |
| | Computes (a, a, a) * (b.x, b.y, b.z). More...
|
| |
| Size3 | operator* (const Size3 &a, const Size3 &b) |
| | Computes (a.x, a.y, a.z) * (b.x, b.y, b.z). More...
|
| |
| Size3 | operator/ (const Size3 &a, size_t b) |
| | Computes (a.x, a.y, a.z) / (b, b, b). More...
|
| |
| Size3 | operator/ (size_t a, const Size3 &b) |
| | Computes (a, a, a) / (b.x, b.y, b.z). More...
|
| |
| Size3 | operator/ (const Size3 &a, const Size3 &b) |
| | Computes (a.x, a.y, a.z) / (b.x, b.y, b.z). More...
|
| |
| Size3 | min (const Size3 &a, const Size3 &b) |
| | Returns element-wise min size. More...
|
| |
| Size3 | max (const Size3 &a, const Size3 &b) |
| | Returns element-wise max size. More...
|
| |
| Size3 | clamp (const Size3 &v, const Size3 &low, const Size3 &high) |
| | Returns element-wise clamped size. More...
|
| |
| Size3 | ceil (const Size3 &a) |
| | Returns element-wise ceiled size. More...
|
| |
| Size3 | floor (const Size3 &a) |
| | Returns element-wise floored size. More...
|
| |
| template<typename T > |
| void | svd (const MatrixMxN< T > &a, MatrixMxN< T > &u, VectorN< T > &w, MatrixMxN< T > &v) |
| | Singular value decomposition (SVD). More...
|
| |
| template<typename T , size_t M, size_t N> |
| void | svd (const Matrix< T, M, N > &a, Matrix< T, M, N > &u, Vector< T, N > &w, Matrix< T, N, N > &v) |
| | Singular value decomposition (SVD). More...
|
| |
| void | triangleMeshToSdf (const TriangleMesh3 &mesh, ScalarGrid3 *sdf, const unsigned int exactBand=1) |
| | Generates signed-distance field out of given triangle mesh. More...
|
| |
| template<typename T > |
| Vector2< T > | operator+ (const Vector2< T > &a) |
| | Positive sign operator. More...
|
| |
| template<typename T > |
| Vector2< T > | operator- (const Vector2< T > &a) |
| | Negative sign operator. More...
|
| |
| template<typename T > |
| Vector2< T > | operator+ (T a, const Vector2< T > &b) |
| | Computes (a, a) + (b.x, b.y). More...
|
| |
| template<typename T > |
| Vector2< T > | operator+ (const Vector2< T > &a, const Vector2< T > &b) |
| | Computes (a.x, a.y) + (b.x, b.y). More...
|
| |
| template<typename T > |
| Vector2< T > | operator- (const Vector2< T > &a, T b) |
| | Computes (a.x, a.y) - (b, b). More...
|
| |
| template<typename T > |
| Vector2< T > | operator- (T a, const Vector2< T > &b) |
| | Computes (a, a) - (b.x, b.y). More...
|
| |
| template<typename T > |
| Vector2< T > | operator- (const Vector2< T > &a, const Vector2< T > &b) |
| | Computes (a.x, a.y) - (b.x, b.y). More...
|
| |
| template<typename T > |
| Vector2< T > | operator* (const Vector2< T > &a, T b) |
| | Computes (a.x, a.y) * (b, b). More...
|
| |
| template<typename T > |
| Vector2< T > | operator* (T a, const Vector2< T > &b) |
| | Computes (a, a) * (b.x, b.y). More...
|
| |
| template<typename T > |
| Vector2< T > | operator* (const Vector2< T > &a, const Vector2< T > &b) |
| | Computes (a.x, a.y) * (b.x, b.y). More...
|
| |
| template<typename T > |
| Vector2< T > | operator/ (const Vector2< T > &a, T b) |
| | Computes (a.x, a.y) / (b, b). More...
|
| |
| template<typename T > |
| Vector2< T > | operator/ (T a, const Vector2< T > &b) |
| | Computes (a, a) / (b.x, b.y). More...
|
| |
| template<typename T > |
| Vector2< T > | operator/ (const Vector2< T > &a, const Vector2< T > &b) |
| | Computes (a.x, a.y) / (b.x, b.y). More...
|
| |
| template<typename T > |
| Vector2< T > | min (const Vector2< T > &a, const Vector2< T > &b) |
| | Returns element-wise min vector: (min(a.x, b.x), min(a.y, b.y)). More...
|
| |
| template<typename T > |
| Vector2< T > | max (const Vector2< T > &a, const Vector2< T > &b) |
| | Returns element-wise max vector: (max(a.x, b.x), max(a.y, b.y)). More...
|
| |
| template<typename T > |
| Vector2< T > | clamp (const Vector2< T > &v, const Vector2< T > &low, const Vector2< T > &high) |
| | Returns element-wise clamped vector. More...
|
| |
| template<typename T > |
| Vector2< T > | ceil (const Vector2< T > &a) |
| | Returns element-wise ceiled vector. More...
|
| |
| template<typename T > |
| Vector2< T > | floor (const Vector2< T > &a) |
| | Returns element-wise floored vector. More...
|
| |
| template<> |
| constexpr Vector2F | zero< Vector2F > () |
| | Returns float-type zero vector. More...
|
| |
| template<> |
| constexpr Vector2D | zero< Vector2D > () |
| | Returns double-type zero vector. More...
|
| |
| template<typename T > |
| Vector2< T > | monotonicCatmullRom (const Vector2< T > &v0, const Vector2< T > &v1, const Vector2< T > &v2, const Vector2< T > &v3, T f) |
| | Computes monotonic Catmull-Rom interpolation. More...
|
| |
| template<typename T > |
| Vector3< T > | operator+ (const Vector3< T > &a) |
| | Positive sign operator. More...
|
| |
| template<typename T > |
| Vector3< T > | operator- (const Vector3< T > &a) |
| | Negative sign operator. More...
|
| |
| template<typename T > |
| Vector3< T > | operator+ (T a, const Vector3< T > &b) |
| | Computes (a, a, a) + (b.x, b.y, b.z). More...
|
| |
| template<typename T > |
| Vector3< T > | operator+ (const Vector3< T > &a, const Vector3< T > &b) |
| | Computes (a.x, a.y, a.z) + (b.x, b.y, b.z). More...
|
| |
| template<typename T > |
| Vector3< T > | operator- (const Vector3< T > &a, T b) |
| | Computes (a.x, a.y, a.z) - (b, b, b). More...
|
| |
| template<typename T > |
| Vector3< T > | operator- (T a, const Vector3< T > &b) |
| | Computes (a, a, a) - (b.x, b.y, b.z). More...
|
| |
| template<typename T > |
| Vector3< T > | operator- (const Vector3< T > &a, const Vector3< T > &b) |
| | Computes (a.x, a.y, a.z) - (b.x, b.y, b.z). More...
|
| |
| template<typename T > |
| Vector3< T > | operator* (const Vector3< T > &a, T b) |
| | Computes (a.x, a.y, a.z) * (b, b, b). More...
|
| |
| template<typename T > |
| Vector3< T > | operator* (T a, const Vector3< T > &b) |
| | Computes (a, a, a) * (b.x, b.y, b.z). More...
|
| |
| template<typename T > |
| Vector3< T > | operator* (const Vector3< T > &a, const Vector3< T > &b) |
| | Computes (a.x, a.y, a.z) * (b.x, b.y, b.z). More...
|
| |
| template<typename T > |
| Vector3< T > | operator/ (const Vector3< T > &a, T b) |
| | Computes (a.x, a.y, a.z) / (b, b, b). More...
|
| |
| template<typename T > |
| Vector3< T > | operator/ (T a, const Vector3< T > &b) |
| | Computes (a, a, a) / (b.x, b.y, b.z). More...
|
| |
| template<typename T > |
| Vector3< T > | operator/ (const Vector3< T > &a, const Vector3< T > &b) |
| | Computes (a.x, a.y, a.z) / (b.x, b.y, b.z). More...
|
| |
| template<typename T > |
| Vector3< T > | min (const Vector3< T > &a, const Vector3< T > &b) |
| | Returns element-wise min vector. More...
|
| |
| template<typename T > |
| Vector3< T > | max (const Vector3< T > &a, const Vector3< T > &b) |
| | Returns element-wise max vector. More...
|
| |
| template<typename T > |
| Vector3< T > | clamp (const Vector3< T > &v, const Vector3< T > &low, const Vector3< T > &high) |
| | Returns element-wise clamped vector. More...
|
| |
| template<typename T > |
| Vector3< T > | ceil (const Vector3< T > &a) |
| | Returns element-wise ceiled vector. More...
|
| |
| template<typename T > |
| Vector3< T > | floor (const Vector3< T > &a) |
| | Returns element-wise floored vector. More...
|
| |
| template<> |
| constexpr Vector3F | zero< Vector3F > () |
| | Returns float-type zero vector. More...
|
| |
| template<> |
| constexpr Vector3D | zero< Vector3D > () |
| | Returns double-type zero vector. More...
|
| |
| template<typename T > |
| Vector3< T > | monotonicCatmullRom (const Vector3< T > &v0, const Vector3< T > &v1, const Vector3< T > &v2, const Vector3< T > &v3, T f) |
| | Computes monotonic Catmull-Rom interpolation. More...
|
| |
| template<typename T > |
| Vector4< T > | operator+ (const Vector4< T > &a) |
| | Positive sign operator. More...
|
| |
| template<typename T > |
| Vector4< T > | operator- (const Vector4< T > &a) |
| | Negative sign operator. More...
|
| |
| template<typename T > |
| Vector4< T > | operator+ (T a, const Vector4< T > &b) |
| | Computes (a, a, a, a) + (b.x, b.y, b.z, b.w). More...
|
| |
| template<typename T > |
| Vector4< T > | operator+ (const Vector4< T > &a, T b) |
| | Computes (a.x, a.y, a.z, a.w) + (b, b, b, b). More...
|
| |
| template<typename T > |
| Vector4< T > | operator+ (const Vector4< T > &a, const Vector4< T > &b) |
| | Computes (a.x, a.y, a.z, a.w) + (b.x, b.y, b.z, b.w). More...
|
| |
| template<typename T > |
| Vector4< T > | operator- (const Vector4< T > &a, T b) |
| | Computes (a.x, a.y, a.z, a.w) - (b, b, b, b). More...
|
| |
| template<typename T > |
| Vector4< T > | operator- (T a, const Vector4< T > &b) |
| | Computes (a, a, a, a) - (b.x, b.y, b.z, b.w). More...
|
| |
| template<typename T > |
| Vector4< T > | operator- (const Vector4< T > &a, const Vector4< T > &b) |
| | Computes (a.x, a.y, a.z, a.w) - (b.x, b.y, b.z, b.w). More...
|
| |
| template<typename T > |
| Vector4< T > | operator* (const Vector4< T > &a, T b) |
| | Computes (a.x, a.y, a.z, a.w) * (b, b, b, b). More...
|
| |
| template<typename T > |
| Vector4< T > | operator* (T a, const Vector4< T > &b) |
| | Computes (a, a, a, a) * (b.x, b.y, b.z, b.w). More...
|
| |
| template<typename T > |
| Vector4< T > | operator* (const Vector4< T > &a, const Vector4< T > &b) |
| | Computes (a.x, a.y, a.z, a.w) * (b.x, b.y, b.z, b.w). More...
|
| |
| template<typename T > |
| Vector4< T > | operator/ (const Vector4< T > &a, T b) |
| | Computes (a.x, a.y, a.z, a.w) / (b, b, b, b). More...
|
| |
| template<typename T > |
| Vector4< T > | operator/ (T a, const Vector4< T > &b) |
| | Computes (a, a, a, a) / (b.x, b.y, b.z, b.w). More...
|
| |
| template<typename T > |
| Vector4< T > | operator/ (const Vector4< T > &a, const Vector4< T > &b) |
| | Computes (a.x, a.y, a.z, a.w) / (b.x, b.y, b.z, b.w). More...
|
| |
| template<typename T > |
| Vector4< T > | min (const Vector4< T > &a, const Vector4< T > &b) |
| | Returns element-wise min vector. More...
|
| |
| template<typename T > |
| Vector4< T > | max (const Vector4< T > &a, const Vector4< T > &b) |
| | Returns element-wise max vector. More...
|
| |
| template<typename T > |
| Vector4< T > | clamp (const Vector4< T > &v, const Vector4< T > &low, const Vector4< T > &high) |
| | Returns element-wise clamped vector. More...
|
| |
| template<typename T > |
| Vector4< T > | ceil (const Vector4< T > &a) |
| | Returns element-wise ceiled vector. More...
|
| |
| template<typename T > |
| Vector4< T > | floor (const Vector4< T > &a) |
| | Returns element-wise floored vector. More...
|
| |
| template<> |
| constexpr Vector4F | zero< Vector4F > () |
| | Returns float-type zero vector. More...
|
| |
| template<> |
| constexpr Vector4D | zero< Vector4D > () |
| | Returns double-type zero vector. More...
|
| |
| template<typename T > |
| Vector4< T > | monotonicCatmullRom (const Vector4< T > &v0, const Vector4< T > &v1, const Vector4< T > &v2, const Vector4< T > &v3, T f) |
| | Computes monotonic Catmull-Rom interpolation. More...
|
| |
| template<typename T , typename E > |
| VectorScalarAdd< T, E > | operator+ (const T &a, const VectorExpression< T, E > &b) |
| | Scalar-vector addition operation. More...
|
| |
| template<typename T , typename E > |
| VectorScalarAdd< T, E > | operator+ (const VectorExpression< T, E > &a, const T &b) |
| | Vector-scalar addition operation. More...
|
| |
| template<typename T , typename E1 , typename E2 > |
| VectorAdd< T, E1, E2 > | operator+ (const VectorExpression< T, E1 > &a, const VectorExpression< T, E2 > &b) |
| | Vector-vector addition operation. More...
|
| |
| template<typename T , typename E > |
| VectorScalarRSub< T, E > | operator- (const T &a, const VectorExpression< T, E > &b) |
| | Scalar-vector subtraction operation. More...
|
| |
| template<typename T , typename E > |
| VectorScalarSub< T, E > | operator- (const VectorExpression< T, E > &a, const T &b) |
| | Scalar-vector addition operation. More...
|
| |
| template<typename T , typename E1 , typename E2 > |
| VectorSub< T, E1, E2 > | operator- (const VectorExpression< T, E1 > &a, const VectorExpression< T, E2 > &b) |
| | Vector-vector addition operation. More...
|
| |
| template<typename T , typename E > |
| VectorScalarMul< T, E > | operator* (const T &a, const VectorExpression< T, E > &b) |
| | Scalar-vector multiplication operation. More...
|
| |
| template<typename T , typename E > |
| VectorScalarMul< T, E > | operator* (const VectorExpression< T, E > &a, const T &b) |
| | Vector-scalar multiplication operation. More...
|
| |
| template<typename T , typename E1 , typename E2 > |
| VectorMul< T, E1, E2 > | operator* (const VectorExpression< T, E1 > &a, const VectorExpression< T, E2 > &b) |
| | Element-wise vector-vector multiplication operation. More...
|
| |
| template<typename T , typename E > |
| VectorScalarRDiv< T, E > | operator/ (const T &a, const VectorExpression< T, E > &b) |
| | Scalar-vector division operation. More...
|
| |
| template<typename T , typename E > |
| VectorScalarDiv< T, E > | operator/ (const VectorExpression< T, E > &a, const T &b) |
| | Vector-scalar division operation. More...
|
| |
| template<typename T , typename E1 , typename E2 > |
| VectorDiv< T, E1, E2 > | operator/ (const VectorExpression< T, E1 > &a, const VectorExpression< T, E2 > &b) |
| | Element-wise vector-vector division operation. More...
|
| |