OpenVDB  2.0.0
Class Hierarchy
This inheritance list is sorted roughly, but not completely, alphabetically:
[detail level 123]
oCABTransformThis class implements the Transformer functor interface (specifically, the isAffine(), transform() and invTransform() methods) for a transform that maps an A grid into a B grid's index space such that, after resampling, A's index space and transform match B's index space and transform
oCAdaptivePrimBuilder
oCArchiveGrid serializer/unserializer
oCBaseCameraAbstract base class for the perspective and orthographic cameras
oCRootNodeMask::BaseIterator
oCBaseMaskIterator< NodeMask >Base class for the bit mask iterators
oCBaseShaderAbstract base class for the shaders
oCBaseStencil< _GridType, StencilType >
oCBaseStencil< GridT, BoxStencil< GridT > >
oCBaseStencil< GridType, BoxStencil< GridType > >
oCBaseStencil< GridType, CurvatureStencil< GridType > >
oCBaseStencil< GridType, DenseStencil< GridType > >
oCBaseStencil< GridType, FourthOrderDenseStencil< GridType > >
oCBaseStencil< GridType, GradStencil< GridType > >
oCBaseStencil< GridType, NineteenPointStencil< GridType > >
oCBaseStencil< GridType, SecondOrderDenseStencil< GridType > >
oCBaseStencil< GridType, SevenPointStencil< GridType > >
oCBaseStencil< GridType, SixthOrderDenseStencil< GridType > >
oCBaseStencil< GridType, ThirteenPointStencil< GridType > >
oCBaseStencil< GridType, WenoStencil< GridType > >
oCBBox< Vec3T >Axis-aligned bounding box
oCBBox< Vec3d >
oCBIAS_SCHEME< bgs >
oCBIAS_SCHEME< FIRST_BIAS >
oCBIAS_SCHEME< HJWENO5_BIAS >
oCBIAS_SCHEME< SECOND_BIAS >
oCBIAS_SCHEME< THIRD_BIAS >
oCBIAS_SCHEME< WENO5_BIAS >
oCBlindData< VisibleT, BlindT >
oCBoxSampler
oCLeafNode< T, Log2Dim >::BufferStores the actual values in the LeafNode. Its dimension it fixed to 2^(3*Log2Dim)
oCLeafNode< bool, Log2Dim >::Buffer
oCCacheItem< TreeCacheT, NodeVecT, AtRoot >
oCCacheItem< TreeCacheT, NodeVecT, true >The tail of a compile-time list of cached node pointers, ordered from LeafNode to RootNode
oCCacheItem< ValueAccessor, SubtreeT, boost::mpl::size< SubtreeT >::value==1 >
oCLeafNode< T, Log2Dim >::ChildAll
oCInternalNode< _ChildNodeType, Log2Dim >::ChildAll
oCInternalNode< _ChildNodeType, Log2Dim >::ChildOff
oCLeafNode< T, Log2Dim >::ChildOff
oCInternalNode< _ChildNodeType, Log2Dim >::ChildOn
oCLeafNode< T, Log2Dim >::ChildOn
oCClosestPointDist< IntLeafT >
oCClosestPointProjector< CptGridT >
oCClosestSurfacePoint< GridT >Accelerated closest surface point queries for narrow band level sets. Supports queries that originate at arbitrary worldspace locations, is not confined to the narrow band region of the input volume geometry
oCCombineArgs< ValueType >This struct collects both input and output arguments to "grid combiner" functors used with the tree::TypedGrid::combineExtended() and combine2Extended() methods. ValueType is the value type of the two grids being combined
oCCombineOpAdapter< ValueT, CombineOp >Helper class to adapt a three-argument (a, b, result) CombineOp functor into a single-argument functor that accepts a CombineArgs struct
oCCompoundMap< T1, T2 >Creates the composition of two maps, each of which could be a composition. In the case that each component of the composition classified as linear an acceleration AffineMap is stored
oCCompReplaceOp< TreeT >
oCConstrainedPointAdvect< GridT, PointListT, StaggeredVelocity, CptGridType, InterrupterType >
oCContourTracer< FloatTreeT, InterruptT >TBB body object that partitions a volume into 2D slices that can be processed in parallel and marks the exterior contour of disjoint voxel sets in each slice
oCCoordSigned (x, y, z) 32-bit integer coordinates
oCCoordBBoxAxis-aligned bounding box of signed integer coordinates
oCCopyableOpApplier< IterT, OpT >
oCCopyableOpTransformer< InIterT, OutTreeT, OpT >
oCCopyConstness< FromType, ToType >
oCCopyConstness< const FromType, ToType >
oCCopyFromDense< _TreeT, _DenseT >Copy the values from a dense grid into an OpenVDB tree
oCCopyToDense< _TreeT, _DenseT >Copy an OpenVDB tree into an existing dense grid
oCCountPointsCounts the total number of points per leaf, accounts for cells with multiple points
oCCountRegions< IntTreeT >Counts the total number of points per collapsed region
oCCPT< MapType, DiffScheme >Compute the closest-point transform to a level set
oCCpt< InGridT, InterruptT >Compute the closest-point transform of a scalar grid
oCCPT_RANGE< MapType, DiffScheme >Compute the closest-point transform to a level set
oCCsgVisitorBase< TreeType >
oCCurl< MapType, DiffScheme >Compute the curl of a vector-valued grid using differencing of various orders in the space defined by the range of the map
oCCurl< GridT, InterruptT >Compute the curl of a scalar grid
oCCurl< UniformScaleMap, CD_2ND >
oCCurl< UniformScaleMap, DiffScheme >
oCCurl< UniformScaleTranslateMap, CD_2ND >
oCCurl< UniformScaleTranslateMap, DiffScheme >
oCD1< DiffScheme >
oCD1< BD_1ST >
oCD1< BD_2ND >
oCD1< BD_3RD >
oCD1< BD_HJWENO5 >
oCD1< BD_WENO5 >
oCD1< CD_2ND >
oCD1< CD_2NDT >
oCD1< CD_4TH >
oCD1< CD_6TH >
oCD1< FD_1ST >
oCD1< FD_2ND >
oCD1< FD_3RD >
oCD1< FD_HJWENO5 >
oCD1< FD_WENO5 >
oCD1Vec< DiffScheme >
oCD1Vec< CD_2ND >
oCD1Vec< CD_2NDT >
oCD1Vec< CD_4TH >
oCD1Vec< CD_6TH >
oCD2< DiffScheme >
oCD2< CD_FOURTH >
oCD2< CD_SECOND >
oCD2< CD_SIXTH >
oCDDA< RayT, Log2Dim >A Digital Differential Analyzer specialized for OpenVDB grids
oCDense< ValueT >Dense is a simple dense grid API used by the CopyToDense and CopyFromDense classes defined below
oCDimToWord< Log2Dim >Mapping from a Log2Dim to a data type of size 2^Log2Dim bits
oCDimToWord< 3 >
oCDimToWord< 4 >
oCDimToWord< 5 >
oCDimToWord< 6 >
oCDiscreteField< VelGridT, Interpolator >Thin wrapper class for a velocity grid
oCDivergence< MapType, DiffScheme >Compute the divergence of a vector-valued grid using differencing of various orders, the result defined with respect to the range-space of the map
oCDivergence< InGridT, InterruptT >Computes the Divergence of a scalar grid
oCDivergence< ScaleMap, CD_2ND >
oCDivergence< ScaleMap, DiffScheme >
oCDivergence< ScaleTranslateMap, CD_2ND >
oCDivergence< ScaleTranslateMap, DiffScheme >
oCDivergence< TranslationMap, DiffScheme >
oCDivergence< UniformScaleMap, CD_2ND >
oCDivergence< UniformScaleMap, DiffScheme >
oCDivergence< UniformScaleTranslateMap, CD_2ND >
oCDivergence< UniformScaleTranslateMap, DiffScheme >
oCMeshToVoxelEdgeData::EdgeDataInternal edge data type
oCEnrightField< ScalarT >Analytical, divergence-free and periodic vecloity field
oCexception
oCExpandNB< FloatTreeT >TBB body object to expand the level set narrow band
oCFilmA simple class that allows for concurrent writes to pixels in an image, background initialization of the image, and PPM or EXR file output
oCFilter< GridT, InterruptT >Filtering of VDB volumes
oCFlagUsedPoints
oCFogVolumeOp< ValueType >
oCFormattedInt< IntT >I/O manipulator that formats integer values with thousands separators
oCDivergence< InGridT, InterruptT >::Functor< DiffScheme >
oCGradient< InGridT, InterruptT >::Functor
oCLaplacian< GridT, InterruptT >::Functor
oCMeanCurvature< GridT, InterruptT >::Functor
oCMagnitude< InGridT, InterruptT >::Functor
oCNormalize< GridT, InterruptT >::Functor
oCGenBoundaryMask< SrcTreeT >
oCMeshToVoxelEdgeData::GenEdgeData
oCGenericMapA wrapper that holds a MapBase::ConstPtr and exposes a reduced set of functionality needed by the mathematical operators
oCGenPoints< TreeT, LeafManagerT >
oCGenPolygons< LeafManagerT, PrimBuilder >
oCGenSeamMask< TreeT, LeafManagerT >
oCGenTileMask< TreeT >
oCGenTopologyMask< SrcTreeT >
oCGetVal< IterT, StatsT >
oCGetValImpl< T, IsVector >
oCGetValImpl< T, false >
oCGetValImpl< T, true >
oCGradient< MapType, DiffScheme >Center difference gradient operators, defined with respect to the range-space of the map
oCGradient< InGridT, InterruptT >Computes the Gradient of a scalar grid
oCGradient< ScaleMap, CD_2ND >
oCGradient< ScaleTranslateMap, CD_2ND >
oCGradient< TranslationMap, DiffScheme >
oCGradient< UniformScaleMap, CD_2ND >
oCGradient< UniformScaleTranslateMap, CD_2ND >
oCGradientBiased< MapType, GradScheme >Biased gradient operators, defined with respect to the range-space of the map
oCGradientNormSqrd< MapType, GradScheme >
oCGradientNormSqrd< UniformScaleMap, GradScheme >
oCGradientNormSqrd< UniformScaleTranslateMap, GradScheme >
oCGridDescriptor
oCGridNamePredPredicate functor that returns true for grids that have a specified name
oCGridResampler
oCGridSampler< GridOrTreeType, SamplerType >Class that provides the interface for continuous sampling of values in a tree. Consider using the GridSampler below instead
oCGridSampler< tree::ValueAccessor< TreeT >, SamplerType >Specialization of GridSampler for construction from a ValueAccessor type
oCHalfReader< IsReal, T >
oCHalfReader< false, T >Partial specialization for non-floating-point types (no half to float promotion)
oCHalfReader< true, T >Partial specialization for floating-point types
oCHalfWriter< IsReal, T >
oCHalfWriter< false, T >Partial specialization for non-floating-point types (no float to half quantization)
oCHalfWriter< true, T >Partial specialization for floating-point types
oCHermiteQuantized Hermite data object that stores compressed intersection information (offsets and normlas) for the up-wind edges of a voxel. (Size 10 bytes)
oCHistogramThis class computes a histogram, with a fixed interval width, of a population of floating-point values
oCHistOp< IterT, ValueOp >
oCInactivePrune< ValueType >Helper class for use with Tree::pruneOp() to replace inactive branches with more memory-efficient inactive tiles with the provided value
oCInteriorMaskOp< TreeType >
oCInternalNode< _ChildNodeType, Log2Dim >
oCIntersectingVoxelCleaner< FloatTreeT >TBB body object that removes intersecting voxels that were set via voxelization of self-intersecting parts of a mesh
oCIntersectingVoxelSign< FloatTreeT >TBB body object that traversers all intersecting voxels (defined by the intersectingVoxelsGrid) and potentially flips their sign, by comparing the "closest point" directions of outside-marked and non-intersecting neighboring voxels
oCInvertedTree< HeadT, HeadLevel >
oCInvertedTree< HeadT, 1 >
oCis_diagonal_jacobian< T >
oCis_double< T >
oCis_double< double >
oCis_linear< T >Map traits
oCis_linear< AffineMap >
oCis_linear< CompoundMap< T1, T2 > >
oCis_linear< ScaleMap >
oCis_linear< ScaleTranslateMap >
oCis_linear< TranslationMap >
oCis_linear< UniformScaleMap >
oCis_linear< UniformScaleTranslateMap >
oCis_linear< UnitaryMap >
oCis_scale< T >
oCis_scale< ScaleMap >
oCis_scale_translate< T >
oCis_scale_translate< ScaleTranslateMap >
oCis_uniform_diagonal_jacobian< T >
oCis_uniform_scale< T >
oCis_uniform_scale< UniformScaleMap >
oCis_uniform_scale_translate< T >
oCis_uniform_scale_translate< TranslationMap >
oCis_uniform_scale_translate< UniformScaleTranslateMap >
oCis_vec3d< Vec3T >
oCis_vec3d< Vec3d >
oCISCurl< DiffScheme >Curl operator defined in index space using various first derivative schemes
oCISDivergence< DiffScheme >Divergence operator defined in index space using various first derivative schemes
oCISGradient< DiffScheme >Gradient operators defined in index space of various orders
oCISGradientBiased< GradScheme, Vec3Bias >Biased Gradient Operators, using upwinding defined by the Vec3Bias input
oCISGradientNormSqrd< GradScheme >
oCISLaplacian< DiffScheme >Laplacian defined in index space, using various center-difference stencils
oCISLaplacian< CD_FOURTH >
oCISLaplacian< CD_SECOND >
oCISLaplacian< CD_SIXTH >
oCISMeanCurvature< DiffScheme2, DiffScheme1 >Compute the mean curvature in index space
oCISOpMagnitude< OpType >Adapter for vector-valued index-space operators to return the vector magnitude
oCBIAS_SCHEME< bgs >::ISStencil< GridType >
oCBIAS_SCHEME< FIRST_BIAS >::ISStencil< GridType >
oCBIAS_SCHEME< SECOND_BIAS >::ISStencil< GridType >
oCBIAS_SCHEME< THIRD_BIAS >::ISStencil< GridType >
oCBIAS_SCHEME< WENO5_BIAS >::ISStencil< GridType >
oCBIAS_SCHEME< HJWENO5_BIAS >::ISStencil< GridType >
oCLeafManager< TreeT >::LeafRange::Iterator
oCIteratorBase< MaskIterT, NodeT >Base class for iterators over internal and leaf nodes
oCIteratorBase< MaskDenseIter, NodeT >
oCIteratorBase< MaskDenseIterator, NodeT >
oCIteratorRange< IterT >
oCIterListItem< PrevItemT, NodeVecT, VecSize, _Level >An IterListItem is an element of a compile-time linked list of iterators to nodes of different types
oCIterListItem< IterListItem, RestT, VecSize-1, 1 >
oCIterListItem< PrevChildItem, InvTreeT, ROOT_LEVEL+1, 0 >
oCIterListItem< PrevItem, InvTreeT, ROOT_LEVEL+1, LEAF_LEVEL >
oCIterListItem< PrevItemT, NodeVecT, 1, _Level >The final element of a compile-time linked list of iterators to nodes of different types
oCIterListItem< PrevItemT, NodeVecT, VecSize, 0U >The initial element of a compile-time linked list of iterators to nodes of different types
oCIterListItem< PrevValueItem, InvTreeT, ROOT_LEVEL+1, 0 >
oCIterTraits< IterT, AuxT >
oCIterTraits< NodeT, IterT >
oCIterTraits< NodeT, typename NodeT::ChildAllCIter >
oCIterTraits< NodeT, typename NodeT::ChildAllIter >
oCIterTraits< NodeT, typename NodeT::ChildOffCIter >
oCIterTraits< NodeT, typename NodeT::ChildOffIter >
oCIterTraits< NodeT, typename NodeT::ChildOnCIter >
oCIterTraits< NodeT, typename NodeT::ChildOnIter >
oCIterTraits< NodeT, typename NodeT::ValueAllCIter >
oCIterTraits< NodeT, typename NodeT::ValueAllIter >
oCIterTraits< NodeT, typename NodeT::ValueOffCIter >
oCIterTraits< NodeT, typename NodeT::ValueOffIter >
oCIterTraits< NodeT, typename NodeT::ValueOnCIter >
oCIterTraits< NodeT, typename NodeT::ValueOnIter >
oCIterTraits< tree::TreeValueIteratorBase< TreeT, ValueIterT > >
oCIterTraits< typename PrevIterT::NonConstNodeType, PrevIterT >
oCLaplacian< MapType, DiffScheme >Compute the Laplacian at a given location in a grid using finite differencing of various orders. The result is defined in the range of the map
oCLaplacian< GridT, InterruptT >Computes the Laplacian of a scalar grid
oCLaplacian< ScaleMap, DiffScheme >
oCLaplacian< ScaleTranslateMap, DiffScheme >
oCLaplacian< TranslationMap, DiffScheme >
oCLaplacian< UniformScaleMap, DiffScheme >
oCLaplacian< UniformScaleTranslateMap, DiffScheme >
oCLaplacian< UnitaryMap, DiffScheme >
oCLeafBS< IntLeafT >
oCLeafIteratorBase< TreeT, RootChildOnIterT >Base class for tree-traversal iterators over all leaf nodes (but not leaf voxels)
oCLeafManager< TreeT >This class manages a linear array of pointers to a given tree's leaf nodes, as well as optional auxiliary buffers (one or more per leaf) that can be swapped with the leaf nodes' voxel data buffers
oCLeafManagerImpl< ManagerT >
oCLeafManagerImpl< LeafManager< const TreeT > >
oCLeafNode< T, Log2Dim >Templated block class to hold specific data types and a fixed number of values determined by Log2Dim. The actual coordinate dimension of the block is 2^Log2Dim, i.e. Log2Dim=3 corresponds to a LeafNode that spans a 8^3 block
oCLeafNode< bool, Log2Dim >LeafNode specialization for values of type bool that stores both the active states and the values of (2^Log2Dim)^3 voxels as bit masks
oCLeafManager< TreeT >::LeafRange
oCLeafTopologyDiffOp< TreeType >
oCLeafTopologyDiffOp< TreeType1, TreeType2 >Functor for use with tools::foreach() to compute the boolean difference between the value masks of corresponding leaf nodes in two trees
oCLeafTopologyIntOp< TreeType1, TreeType2 >Functor for use with tools::foreach() to compute the boolean intersection between the value masks of corresponding leaf nodes in two trees
oCLegacyFrustumLegacyFrustum class used at DreamWorks for converting old vdb files
oCLevelSetAdvection< GridT, FieldT, InterruptT >Hyperbolic advection of narrow-band level sets in an external velocity field
oCLevelSetFracture< GridType, InterruptType >Level set fracturing
oCLevelSetHDDA< GridT, NodeLevel >Helper class that implements Hierarchical Digital Differential Analyzers and is specialized for ray intersections with level sets
oCLevelSetHDDA< TreeT,-1 >Specialization of Hierarchical Digital Differential Analyzer class that intersects a ray against the voxels of a level set
oCLevelSetPrune< ValueType >Helper class for use with Tree::pruneOp() to prune any branches whose values are all inactive and replace each with an inactive tile whose value is equal in magnitude to the background value and whose sign is equal to that of the first value encountered in the (inactive) child
oCLevelSetRayIntersector< GridT, SearchImplT, NodeLevel, RayT >This class provides the public API for intersecting a ray with a narrow-band level set
oCLevelSetRayTracer< GridT, IntersectorT >A (very) simple multithreaded ray tracer specifically for narrow-band level sets
oCLevelSetSphere< GridT, InterruptT >Generates a signed distance field (or narrow band level set) to a single sphere
oCLevelSetTracker< GridT, InterruptT >Performs multi-threaded interface tracking of narrow band level sets
oCLinearSearchImpl< GridT, Iterations, RealT >Implements linear iterative search for a zero-crossing of the level set along along the direction of the ray
oCMagnitude< InGridT, InterruptT >
oCMapAdapter< MapType, OpType, ResultType >Adapter to associate a map with a world-space operator, giving it the same call signature as an index-space operator
oCMapBaseAbstract base class for maps
oCMapPoints< Int16TreeT >Computes the point list indices for the index tree
oCMapRegistryThreadsafe singleton object for accessing the map type-name dictionary. Associates a map type-name with a factory function
oCMaskEdges< BoolTreeT >
oCMat< SIZE, T >
oCMat2< T >
oCMat< 3, T >
oCMat< 4, double >
oCMat< 4, Real >
oCMat< 4, T >
oCMathOp< IterT, OpT >
oCGridTransformer::MatrixTransform
oCMaxOp< ValueType >
oCMeanCurvature< MapType, DiffScheme2, DiffScheme1 >Compute the mean curvature
oCMeanCurvature< GridT, InterruptT >
oCMeanCurvature< TranslationMap, DiffScheme2, DiffScheme1 >
oCMeanCurvature< UniformScaleMap, DiffScheme2, DiffScheme1 >
oCMeanCurvature< UniformScaleTranslateMap, DiffScheme2, DiffScheme1 >
oCMergeBufferOp< TreeType, ValueType >
oCMergeVoxelRegions< TreeT, LeafManagerT >
oCMeshToVolume< FloatGridT, InterruptT >
oCMeshToVoxelEdgeDataExtracts and stores voxel edge intersection data from a mesh
oCMeshVoxelizer< FloatTreeT, InterruptT >TBB body object to voxelize a mesh of triangles and/or quads into a collection of VDB grids, namely a squared distance grid, a closest primitive grid and an intersecting voxels grid (masks the mesh intersecting voxels)
oCMetadataBase class for storing metadata information in a grid
oCMetaMapProvides functionality storing type agnostic metadata information. Grids and other structures can inherit from this to attain metadata functionality
oCMinMaxVoxel< TreeType >Threaded operator that finds the minimum and maximum values among the active leaf-level voxels of a grid
oCMinOp< TreeType, ValueType >
oCMinOp< ValueType >
oCMorphology< TreeType >
oCMovePoints
oCMultOp< ValueType >
oCFile::NameIterator
oCNodeBS
oCNodeChain< HeadType, HeadLevel >NodeChain<RootNodeType, RootNodeType::LEVEL>::Type is a boost::mpl::vector that lists the types of the nodes of the tree rooted at RootNodeType in reverse order, from LeafNode to RootNode
oCNodeChain< HeadT, 1 >Specialization to terminate NodeChain
oCIterTraits< NodeT, typename NodeT::ValueOnIter >::NodeConverter< OtherNodeT >
oCIterTraits< NodeT, typename NodeT::ValueOffIter >::NodeConverter< OtherNodeT >
oCIterTraits< NodeT, typename NodeT::ChildAllCIter >::NodeConverter< OtherNodeT >
oCIterTraits< NodeT, typename NodeT::ValueOnCIter >::NodeConverter< OtherNodeT >
oCIterTraits< NodeT, typename NodeT::ValueAllIter >::NodeConverter< OtherNodeT >
oCIterTraits< NodeT, typename NodeT::ValueAllCIter >::NodeConverter< OtherNodeT >
oCIterTraits< NodeT, typename NodeT::ValueOffCIter >::NodeConverter< OtherNodeT >
oCIterTraits< NodeT, typename NodeT::ChildOffIter >::NodeConverter< OtherNodeT >
oCIterTraits< NodeT, typename NodeT::ChildOffCIter >::NodeConverter< OtherNodeT >
oCIterTraits< NodeT, typename NodeT::ChildAllIter >::NodeConverter< OtherNodeT >
oCIterTraits< NodeT, typename NodeT::ChildOnIter >::NodeConverter< OtherNodeT >
oCIterTraits< NodeT, typename NodeT::ChildOnCIter >::NodeConverter< OtherNodeT >
oCNodeIteratorBase< _TreeT, RootChildOnIterT >Base class for tree-traversal iterators over all nodes
oCNodeMask< Log2Dim >Bit mask for the internal and leaf nodes of VDB. This is a 64-bit implementation
oCNodeMask< 1 >Template specialization of NodeMask for Log2Dim=1, i.e. 2^3 nodes
oCNodeMask< 2 >Template specialization of NodeMask for Log2Dim=2, i.e. 4^3 nodes
oCNodeUnionImpl< ValueIsClass, ValueT, ChildT >
oCNodeUnionImpl< boost::is_class< ValueT >::value, ValueT, ChildT >
oCNodeUnionImpl< boost::is_class< ValueType >::value, ValueType, ChildNodeType >
oCNodeUnionImpl< false, ValueT, ChildT >
oCNodeUnionImpl< true, ValueT, ChildT >
oCNonUniformPointScatter< PointAccessorType, RandomGenerator, InterruptType >Non-uniform scatters of point in the active voxels. The local point count is implicitly defined as a product of of a global density and the local voxel (or tile) value
oCNormalize< GridT, InterruptT >
oCNullInterrupterDummy NOOP interrupter class defining interface
oCOffsetOp< ValueType >
oCOpAccumulator< IterT, OpT >
oCOpMagnitude< OpType, MapT >Adapter for vector-valued world-space operators to return the vector magnitude
oCMagnitude< InGridT, InterruptT >::OpT
oCNormalize< GridT, InterruptT >::OpT
oCPartGen< SrcTreeT >
oCParticlesToLevelSet< SdfGridT, AttributeT, InterrupterT >
oCPartOp
oCPointAccessor
oCPointAdvect< GridT, PointListT, StaggeredVelocity, InterrupterType >
oCPointListCopy
oCPointListTransform
oCPointSampler
oCPointTransform
oCPolygonPoolCollection of quads and triangles
oCPrimCpy
oCpromote< S, T >
oCPropagateSign< FloatTreeT, InterruptT >TBB body object that performs a parallel flood fill
oCQuadraticSampler
oCQuantizedUnitVec
oCQuat< T >
oCRand01< FloatType, EngineType >Simple generator of random numbers over the range [0, 1)
oCRandInt< EngineType >Simple random integer generator
oCRay< RealT >
oCRay< double >
oCRealToHalf< T >RealToHalf and its specializations define a mapping from floating-point data types to analogous half float types
oCRealToHalf< double >
oCRealToHalf< float >
oCRealToHalf< Vec2d >
oCRealToHalf< Vec2s >
oCRealToHalf< Vec3d >
oCRealToHalf< Vec3s >
oCRemapIndices
oCRenormOp< GridType, ValueType >
oCReturnValue< T >
oCFilm::RGBAFloating-point RGBA components in the range [0, 1]
oCRootNode< ChildType >
oCRootNodeMask
oCSampler
oCScalarToVectorConverter< ScalarGridType >ScalarToVectorConverter<ScalarGridType>::Type is the type of a grid having the same tree configuration as ScalarGridType but value type Vec3<T> where T is ScalarGridType::ValueType
oCSeamWeights< TreeT >
oCShallowCopy
oCSharedOpApplier< IterT, OpT >
oCSharedOpTransformer< InIterT, OutTreeT, OpT >
oCShellVoxelCleaner< FloatTreeT >TBB body object that removes non-intersecting voxels that where set by rasterizing self-intersecting parts of the mesh
oCSignData< TreeT, LeafManagerT >
oCSignMask< FloatTreeT, InterruptT >TBB body object that that finds seed points for the parallel flood fill
oCSqrtAndScaleOp< ValueType >
oCStaggeredBoxSampler
oCStaggeredPointSampler
oCStaggeredQuadraticSampler
oCStatsThis class computes statistics (minimum value, maximum value, mean, variance and standard deviation) of a population of floating-point values
oCStatsOp< IterT, ValueOp >
oCSumOp< ValueType >
oCSwappedCombineOp< ValueType, CombineOp >
oCTagSeamEdges< TreeT >
oCTestLeafIO< typename >
oCTolerance< ValueType >
oCTolerance< T >Tolerance for floating-point comparison
oCTolerance< double >
oCTolerance< float >
oCTolerancePrune< ValueType, TerminationLevel >Helper class for use with Tree::pruneOp() to replace constant branches (to within the provided tolerance) with more memory-efficient tiles
oCTopologyCopy
oCTransformCalculate an axis-aligned bounding box in index space from a bounding sphere in world space
oCTree3< T, N1, N2 >Tree3<T, N1, N2>::Type is the type of a three-level tree (Root, Internal, Leaf) with value type T and internal and leaf node log dimensions N1 and N2, respectively
oCTree4< T, N1, N2, N3 >Tree4<T, N1, N2, N3>::Type is the type of a four-level tree (Root, Internal, Internal, Leaf) with value type T and internal and leaf node log dimensions N1, N2 and N3, respectively
oCTree4< EdgeData, 5, 4, 3 >
oCTree5< T, N1, N2, N3, N4 >Tree5<T, N1, N2, N3, N4>::Type is the type of a five-level tree (Root, Internal, Internal, Internal, Leaf) with value type T and internal and leaf node log dimensions N1, N2, N3 and N4, respectively
oCTreeAdapter< _TreeType >This adapter allows code that is templated on a Tree type to accept either a Tree type or a Grid type
oCTreeAdapter< Grid< _TreeType > >Partial specialization for Grid types
oCTreeAdapter< tree::ValueAccessor< _TreeType > >Partial specialization for ValueAccessor types
oCTreeBaseBase class for typed trees
oCTreeIterTraits< TreeT, IterT >TreeIterTraits provides, for all tree iterators, a begin(tree) function that returns an iterator over a tree of arbitrary type
oCTreeIterTraits< TreeT, typename TreeT::LeafCIter >
oCTreeIterTraits< TreeT, typename TreeT::LeafIter >
oCTreeIterTraits< TreeT, typename TreeT::NodeCIter >
oCTreeIterTraits< TreeT, typename TreeT::NodeIter >
oCTreeIterTraits< TreeT, typename TreeT::RootNodeType::ChildAllCIter >
oCTreeIterTraits< TreeT, typename TreeT::RootNodeType::ChildAllIter >
oCTreeIterTraits< TreeT, typename TreeT::RootNodeType::ChildOffCIter >
oCTreeIterTraits< TreeT, typename TreeT::RootNodeType::ChildOffIter >
oCTreeIterTraits< TreeT, typename TreeT::RootNodeType::ChildOnCIter >
oCTreeIterTraits< TreeT, typename TreeT::RootNodeType::ChildOnIter >
oCTreeIterTraits< TreeT, typename TreeT::ValueAllCIter >
oCTreeIterTraits< TreeT, typename TreeT::ValueAllIter >
oCTreeIterTraits< TreeT, typename TreeT::ValueOffCIter >
oCTreeIterTraits< TreeT, typename TreeT::ValueOffIter >
oCTreeIterTraits< TreeT, typename TreeT::ValueOnCIter >
oCTreeIterTraits< TreeT, typename TreeT::ValueOnIter >
oCTreeTraits< TreeT >Useful traits for Tree types
oCTreeTraits< const TreeT >
oCTreeValueIteratorBase< _TreeT, ValueIterT >Base class for tree-traversal iterators over tile and voxel values
oCTrimOp< ValueType >
oCTuple< SIZE, T >
oCTuple< 2, T >
oCTuple< 3, double >
oCTuple< 3, Real >
oCTuple< 3, T >
oCTuple< 4, T >
oCTupleAbs< SIZE, T, IsInteger >Helper class to compute the absolute value of a Tuple
oCTupleAbs< SIZE, T, true >
oCUniformPointScatter< PointAccessorType, RandomGenerator, InterruptType >The two point scatters UniformPointScatter and NonUniformPointScatter depend on the following two classes:
oCUniformPrimBuilder
oCUpdatePoints
oCValueAccessorBase< TreeType >This base class for ValueAccessors manages registration of an accessor with a tree so that the tree can automatically clear the accessor whenever one of its nodes is deleted
oCValueAccessorBase< _TreeType >
oCValueAccessorBase< BoolTreeT >
oCValueAccessorBase< const BoolTreeT >
oCValueAccessorBase< const Int16TreeT >
oCValueAccessorBase< const IntTreeT >
oCValueAccessorBase< const TreeT >
oCValueAccessorBase< FloatTreeT >
oCValueAccessorBase< Int16TreeT >
oCValueAccessorBase< IntTreeT >
oCValueAccessorBase< TreeT >
oCInternalNode< _ChildNodeType, Log2Dim >::ValueAll
oCLeafNode< T, Log2Dim >::ValueAll
oCGrid< typename >::ValueConverter< OtherValueType >ValueConverter<T>::Type is the type of a grid having the same hierarchy as this grid but a different value type, T
oCTree< _RootNodeType >::ValueConverter< OtherValueType >ValueConverter<T>::Type is the type of a tree having the same hierarchy as this tree but a different value type, T
oCLeafNode< bool, Log2Dim >::ValueConverter< ValueType >ValueConverter<T>::Type is the type of a LeafNode having the same dimensions as this node but a different value type, T
oCInternalNode< _ChildNodeType, Log2Dim >::ValueConverter< OtherValueType >ValueConverter<T>::Type is the type of an InternalNode having the same child hierarchy and dimensions as this node but a different value type, T
oCLeafNode< T, Log2Dim >::ValueConverter< OtherValueType >ValueConverter<T>::Type is the type of a LeafNode having the same child hierarchy and dimensions as this node but a different value type, T
oCRootNode< ChildType >::ValueConverter< OtherValueType >ValueConverter<T>::Type is the type of a RootNode having the same child hierarchy as this node but a different value type, T
oCTree< _RootNodeType >::ValueConverter< Int32 >
oCLeafNode< T, Log2Dim >::ValueOff
oCInternalNode< _ChildNodeType, Log2Dim >::ValueOff
oCLeafNode< T, Log2Dim >::ValueOn
oCInternalNode< _ChildNodeType, Log2Dim >::ValueOn
oCVectorToScalarConverter< VectorGridType >VectorToScalarConverter<VectorGridType>::Type is the type of a grid having the same tree configuration as VectorGridType but a scalar value type, T, where T is the type of the original vector components
oCVecTraits< T >
oCVecTraits< math::Vec2< T > >
oCVecTraits< math::Vec3< T > >
oCVecTraits< math::Vec4< T > >
oCVelocityIntegrator< GridT, StaggeredVelocity >Performs runge-kutta time integration of variable order in a static velocity field
oCVelocitySampler< GridT, StaggeredVelocity >
oCVersionId
oCVolumeHDDA< GridT, NodeLevel >
oCVolumeHDDA< TreeT,-1 >Specialization of Hierarchical Digital Differential Analyzer class that intersects against the voxels of a generic volume
oCVolumeRayIntersector< GridT, NodeLevel, RayT >This class provides the public API for intersecting a ray with a generic (e.g. density) volume
oCVolumeToMeshMesh any scalar grid that has a continuous isosurface
\CVoxelSignOp< ValueType >