[ VIGRA Homepage | Function Index | Class Index | Namespaces | File List | Main Page ]

Class Hierarchy VIGRA

This inheritance list is sorted roughly, but not completely, alphabetically:
[detail level 1234]
oCAbsPowerSum< N >Basic statistic. AbsPowerSum<N> = $ \sum_i |x_i|^N $
oCAccumulatorChain< T, Selected, dynamic >Create an accumulator chain containing the selected statistics and their dependencies
oCAccumulatorChain< CoupledArrays< N, T1, T2, T3, T4, T5 >::HandleType, Selected, dynamic >
oCAccumulatorChain< CoupledArrays< N, T1, T2, T3, T4, T5 >::HandleType, Selected, true >
oCAccumulatorChain< T, Selected, true >
oCAccumulatorChainArray< T, Selected, dynamic >Create an array of accumulator chains containing the selected per-region and global statistics and their dependencies
oCAccumulatorChainArray< CoupledArrays< N, T1, T2, T3, T4, T5 >::HandleType, Selected, dynamic >
oCAccumulatorChainArray< CoupledArrays< N, T1, T2, T3, T4, T5 >::HandleType, Selected, true >
oCAccumulatorChainArray< T, Selected, true >
oCAdjacencyListGraphUndirected adjacency list graph in the LEMON API
oCAdjacencyListGraph::ArcMap< T >Default arc map
oCArgMaxWeightBasic statistic. Data where weight assumes its maximal value
oCArgMinWeightBasic statistic. Data value where weight assumes its minimal value
oCArrayOfRegionStatistics< RegionStatistics, LabelType >Calculate statistics for all regions of a labeled image
oCArrayVectorView< T >
oCArrayVectorView< arc_descriptor >
oCArrayVectorView< ARITHTYPE >
oCArrayVectorView< ArrayVector< bool > >
oCArrayVectorView< ArrayVector< edge_descriptor > >
oCArrayVectorView< ArrayVector< MultiArrayIndex > >
oCArrayVectorView< AxisInfo >
oCArrayVectorView< BinType >
oCArrayVectorView< bool >
oCArrayVectorView< char >
oCArrayVectorView< ClassLabelType >
oCArrayVectorView< DecisionTree_t >
oCArrayVectorView< detail::DecisionTreeDeprec >
oCArrayVectorView< double >
oCArrayVectorView< hsize_t >
oCArrayVectorView< ImageType >
oCArrayVectorView< index_type >
oCArrayVectorView< IndexType >
oCArrayVectorView< int >
oCArrayVectorView< INT >
oCArrayVectorView< Int32 >
oCArrayVectorView< Label >
oCArrayVectorView< Label_t >
oCArrayVectorView< Matrix< Complex > >
oCArrayVectorView< MultiArrayIndex >
oCArrayVectorView< NeighborOffsetArray >
oCArrayVectorView< Node >
oCArrayVectorView< npy_intp >
oCArrayVectorView< POINT >
oCArrayVectorView< point_type >
oCArrayVectorView< RegionAccumulatorChain >
oCArrayVectorView< Segment >
oCArrayVectorView< shape_type >
oCArrayVectorView< SharedChunkHandle< N, T > * >
oCArrayVectorView< size_t >
oCArrayVectorView< std::pair< Int32, double > >
oCArrayVectorView< std::ptrdiff_t >
oCArrayVectorView< std::queue< ValueType > >
oCArrayVectorView< unsigned char >
oCArrayVectorView< vigra::ArrayVector< index_type > >
oCArrayVectorView< vigra::ArrayVector< typename out_edge_iterator::vigra::TinyVector > >
oCArrayVectorView< vigra::TinyVector >
oCAutoRangeHistogram< BinCount >Histogram where range mapping bounds are defined by minimum and maximum of data
oCBasicImage< PIXELTYPE, Alloc >Fundamental class template for images
oCBasicImage< double >
oCBasicImage< float >
oCBasicImage< InternalValue >
oCBasicImage< TinyVector< double, 2 > >
oCBasicImage< value_type >
oCBasicImage< VALUETYPE >
oCBasicImageIteratorBase< IMAGEITERATOR, PIXELTYPE, REFERENCE, POINTER, LINESTARTITERATOR >
oCBasicImageIteratorBase< BasicImageIterator< PIXELTYPE, ITERATOR >, PIXELTYPE, PIXELTYPE &, PIXELTYPE *, ITERATOR >
oCBasicImageIteratorBase< ConstBasicImageIterator< PIXELTYPE, ITERATOR >, PIXELTYPE, PIXELTYPE const &, PIXELTYPE const *, ITERATOR >
oCBasicImageView< PIXELTYPE >BasicImage using foreign memory
oCBestGiniOfColumn< LineSearchLossTag >
oCBestGiniOfColumn< vigra::GiniCriterion >
oCBilinearInterpolatingAccessor< ACCESSOR, VALUETYPE >Bilinear interpolation at non-integer positions
oCBlueAccessor< RGBVALUE >
oCBox< VALUETYPE, DIMENSION >Represent an n-dimensional box as a (begin, end) pair. Depending on the value type, end() is considered to be outside the box (as in the STL, for integer types), or inside (for floating point types). size() will always be end() - begin()
oCBrightnessContrastFunctor< PixelType >Adjust brightness and contrast of an image
oCBrightnessContrastFunctor< ComponentType >
oCBrightnessContrastFunctor< unsigned char >
oCBSplineBase< ORDER, T >
oCBSplineBase< ORDER, double >
oCBucketQueue< ValueType, Ascending >Priority queue implemented using bucket sort
oCCatmullRomSpline< T >
oCCentral< A >Modifier. Substract mean before computing statistic
oCCentral< PowerSum< 2 > >Spezialization: works in pass 1, operator+=() supported (merging supported)
oCCentral< PowerSum< 3 > >Specialization: works in pass 2, operator+=() supported (merging supported)
oCCentral< PowerSum< 4 > >Specialization: works in pass 2, operator+=() supported (merging supported)
oCCentralMoment< N >Alias. CentralMoment<N>
oCChangeablePriorityQueue< T, COMPARE >Heap-based changable priority queue with a maximum number of elemements
oCChangeablePriorityQueue< ValueType >
oCChangeablePriorityQueue< WeightType >
oCChunkedArrayTag
oCcl_charNAccessor_COMP
oCcl_TYPE3WriteAccessor_s1
oCcl_TYPE3WriteAccessor_s2
oCColumnIterator< IMAGE_ITERATOR >Iterator adapter to linearly access columns
oCConstValueIterator< PIXELTYPE >Iterator that always returns the constant specified in the constructor
oCConvexHullCompute the contour of a 2D region
oCConvolutionOptions< dim >Options class template for convolutions
oCCoord< A >Modifier. Compute statistic from pixel coordinates rather than from pixel values
oCCoordinateConstValueAccessor< Accessor, COORD >Forward accessor to the value() part of the values an iterator points to
oCCoordinateSystemBasic statistic. Identity matrix of appropriate size
oCCorrectStatus
oCCorrelationFunctor< MaskIterator, MaskAccessor >This function performes a (slow) cross-correlation
oCCoscotFunction< T >
oCCoupledHandle< T, NEXT >
oCCoupledIteratorType< N, T1, T2, T3, T4, T5 >
oCCoupledScanOrderIterator< N, HANDLES, DIMENSION >Iterate over multiple images simultaneously in scan order
oCCoupledScanOrderIterator< N >
oCCrackContourCirculator< IMAGEITERATOR >Circulator that walks around a given region
oCDataArg< INDEX >Specifies index of data in CoupledHandle
oCDiff2DTwo dimensional difference vector
oCDiffusivityFunctor< Value >Diffusivity functor for non-linear diffusion
oCDist2D
oCDivideByCount< A >Modifier. Divide statistic by Count: DivideByCount<TAG> = TAG / Count
oCDivideUnbiased< A >Modifier. Divide statistics by Count-1: DivideUnbiased<TAG> = TAG / (Count-1)
oCDraw< T1, T2, C1, C2 >
oCDT_StackEntry< Iter >
oCDualVector< T, N >
oCEarlyStoppStdStandard early stopping criterion
oCEdgel
oCAdjacencyListGraph::EdgeMap< T >Default edge map
oCEdgeWeightNodeFeatures< MERGE_GRAPH, EDGE_INDICATOR_MAP, EDGE_SIZE_MAP, NODE_FEATURE_MAP, NODE_SIZE_MAP, MIN_WEIGHT_MAP >Get minimum edge weight from an edge indicator and difference of node features
oCEnhancedFrostFunctor< VALUETYPE >This function tries to reduce the speckle noise of an image by applying the Enhanced Frost filter
oCEnhancedLeeFunctor< VALUETYPE >This function tries to reduce the speckle noise of an image by applying the Enhanced Lee filter
oCEntropyCriterion
oCFFTWComplex< Real >Wrapper class for the FFTW complex types 'fftw_complex'
oCFFTWConvolvePlan< N, Real >
oCFFTWImaginaryAccessor< Real >
oCFFTWMagnitudeAccessor< Real >
oCFFTWPhaseAccessor< Real >
oCFFTWPlan< N, Real >
oCFFTWRealAccessor< Real >
oCFFTWSquaredMagnitudeAccessor< Real >
oCFindAverage< VALUETYPE >Find the average pixel value in an image or ROI
oCFindAverageAndVariance< VALUETYPE >Find the average pixel value and its variance in an image or ROI
oCFindBoundingRectangleCalculate the bounding rectangle of an ROI in an image
oCFindMinMax< VALUETYPE >Find the minimum and maximum pixel value in an image or ROI
oCFindROISize< VALUETYPE >Calculate the size of an ROI in an image
oCFindSum< VALUETYPE >Find the sum of the pixel values in an image or ROI
oCFirstSeenBasic statistic. First data value seen of the object
oCFixedPoint< IntBits, FractionalBits >
oCFixedPoint16< IntBits, OverflowHandling >
oCFlatScatterMatrixBasic statistic. Flattened uppter-triangular part of scatter matrix
oCFunctorTraits< T >Export associated information for a functor
oCGammaFunctor< PixelType >Perform gamma correction of an image
oCGammaFunctor< ComponentType >
oCGammaFunctor< unsigned char >
oCGammaMAPFunctor< VALUETYPE >This function tries to reduce the speckle noise of an image by applying the Gamma Maximum A Posteriori (MAP) filter
oCGaussian< T >
oCGetClusterVariables
oCGiniCriterion
oCGlobal< A >Modifier. Compute statistic globally rather than per region
oCGlobalRangeHistogram< BinCount >Like AutoRangeHistogram, but use global min/max rather than region min/max
oCGrayToRGBAccessor< VALUETYPE >
oCGreenAccessor< RGBVALUE >
oCGridGraph< N, DirectedTag >Define a grid graph in arbitrary dimensions
oCGridGraph< N, undirected_tag >
oCHC_Entry
oCHClustering
oCHDF5DisableErrorOutputTemporarily disable HDF5's native error output
oCHDF5FileAccess to HDF5 files
oCHDF5HandleWrapper for unique hid_t objects
oCHDF5HandleSharedWrapper for shared hid_t objects
oCHDF5ImportInfoArgument object for the function readHDF5()
oCHierarchicalClustering< CLUSTER_OPERATOR >Do hierarchical clustering with a given cluster operator
oCHierarchicalIteratorType< N, T1, T2, T3, T4, T5 >
oCHistogramOptionsSet histogram options
oCImageArray< ImageType, Alloc >Fundamental class template for arrays of equal-sized images
oCImageExportInfoArgument object for the function exportImage()
oCImageImportInfoArgument object for the function importImage()
oCImageIteratorBase< IMAGEITERATOR, PIXELTYPE, REFERENCE, POINTER, StridedOrUnstrided >Base class for 2D random access iterators
oCImageIteratorBase< ConstImageIterator< PIXELTYPE >, PIXELTYPE, PIXELTYPE const &, PIXELTYPE const * >
oCImageIteratorBase< ConstStridedImageIterator< PIXELTYPE >, PIXELTYPE, PIXELTYPE const &, PIXELTYPE const *, StridedArrayTag >
oCImageIteratorBase< ImageIterator< PIXELTYPE >, PIXELTYPE, PIXELTYPE &, PIXELTYPE * >
oCImageIteratorBase< StridedImageIterator< PIXELTYPE >, PIXELTYPE, PIXELTYPE &, PIXELTYPE *, StridedArrayTag >
oCImagePyramid< ImageType, Alloc >Class template for logarithmically tapering image pyramids
oCGridGraph< N, DirectedTag >::InDegMapType of a property map that returns the number of incoming edges of a given node (API: LEMON, use via lemon::InDegMap<Graph>)
oCGridGraph< N, DirectedTag >::IndexMapType of a property map that returns the coordinate of a given node (API: LEMON)
oCIntegerHistogram< BinCount >Histogram where data values are equal to bin indices
oCIterablePartition< T >
oCIterablePartition< IdType >
oCIteratorAdaptor< Policy >Quickly create 1-dimensional iterator adapters
oCIteratorTraits< T >Export associated information for each image iterator
oCKernel1D< ARITHTYPE >Generic 1 dimensional convolution kernel
oCKernel2D< ARITHTYPE >Generic 2 dimensional convolution kernel
oCKuanFunctor< VALUETYPE >This function tries to reduce the speckle noise of an image by applying the Kuan filter
oCKurtosisBasic statistic. Kurtosis
oCLab2RGBFunctor< T >Convert perceptual uniform CIE L*a*b* into linear (raw) RGB
oCLab2RGBPrimeFunctor< T >Convert perceptual uniform CIE L*a*b* into non-linear (gamma corrected) R'G'B'
oCLab2XYZFunctor< T >Convert perceptual uniform CIE L*a*b* into standardized tri-stimulus XYZ
oCLab2XYZFunctor< component_type >
oCLabelArg< INDEX >Specifies index of labels in CoupledHandle
oCLastValueFunctor< VALUETYPE >Stores and returns the last value it has seen
oCLeastAngleRegressionOptionsPass options to leastAngleRegression()
oCLeeFunctor< VALUETYPE >This function tries to reduce the speckle noise of an image by applying the basic Lee filter
oCLineIterator< IMAGE_ITERATOR >Iterator adapter to iterate along an arbitrary line on the image
oCLocalMinmaxOptionsOptions object for localMinima() and localMaxima()
oCLuv2RGBFunctor< T >Convert perceptual uniform CIE L*u*v* into linear (raw) RGB
oCLuv2RGBPrimeFunctor< T >Convert perceptual uniform CIE L*u*v* into non-linear (gamma corrected) R'G'B'
oCLuv2XYZFunctor< T >Convert perceptual uniform CIE L*u*v* into standardized tri-stimulus XYZ
oCLuv2XYZFunctor< component_type >
oCMagnitudeFunctor< ValueType >
oCMaximumBasic statistic. Maximum value
oCMedian
oCMergeGraphAdaptor< GRAPH >Undirected graph adaptor for edge contraction and feature merging
oCMeshGridAccessor
oCMinimumBasic statistic. Minimum value
oCMoment< N >Alias. Moment<N>
oCMultiArrayNavigator< MULTI_ITERATOR, N >A navigator that provides access to the 1D subranges of an n-dimensional range given by a vigra::MultiIterator and an nD shape
oCMultiArrayShape< N >
oCMultiArrayShape< 2 >
oCMultiArrayShape< actual_dimension >
oCMultiArrayShape< dim >
oCMultiArrayShape< Dimensions >
oCMultiArrayView< N, T, StrideTag >Base class for, and view to, vigra::MultiArray
oCMultiArrayView< 1, int >
oCMultiArrayView< 1, T, StridedArrayTag >
oCMultiArrayView< 2, double >
oCMultiArrayView< 2, int >
oCMultiArrayView< 2, LabelInt >
oCMultiArrayView< 2, T, C1 >
oCMultiArrayView< 2, T, C2 >
oCMultiArrayView< 2, T1, C1 >
oCMultiArrayView< 2, T2, C2 >
oCMultiArrayView< 2, UInt8 >
oCMultiArrayView< 2, VALUETYPE, StridedOrUnstrided >
oCMultiArrayView< DIM, PixelTypeIn >
oCMultiArrayView< DIM, RealPromotePixelType >
oCMultiArrayView< DIM, RealPromoteScalarType >
oCMultiArrayView< IntrinsicGraphShape< Graph >::IntrinsicEdgeMapDimension, Value >
oCMultiArrayView< IntrinsicGraphShape< Graph >::IntrinsicNodeMapDimension, Value >
oCMultiArrayView< N, NumpyArrayTraits< N, T, Stride >::value_type, Stride >
oCMultiArrayView< N, Real, UnstridedArrayTag >
oCMultiArrayView< N, T, S >
oCMultiArrayView< N, T, UnstridedArrayTag >
oCMultiArrayView< N, UnqualifiedType< U >::type >
oCMultiArrayView< N, vigra::detail::ResolveMultiband< T >::type, vigra::detail::ResolveMultiband< T >::Stride >
oCMultiCoordinateNavigator< Dimensions, N >A navigator that provides access to the 1D subranges of an n-dimensional range given by an nD shape
oCMultiImageAccessor2< Iter1, Acc1, Iter2, Acc2 >Access two images simultaneously
oCMultiIterator< N, T, REFERENCE, POINTER >A multi-dimensional hierarchical iterator to be used with vigra::MultiArrayView if it is not strided
oCNeighborCodeEncapsulation of direction management for 4-neighborhood
oCNeighborCodeEncapsulation of direction management for the 8-neighborhood
oCNeighborCode3DEncapsulation of direction management of neighbors for a 3D 26-neighborhood
oCNeighborCode3DEncapsulation of direction management of neighbors for a 3D 6-neighborhood
oCNeighborhoodCirculator< IMAGEITERATOR, NEIGHBORCODE >Circulator that walks around a given location in a given image
oCNeighborhoodCirculator< IMAGEITERATOR, EightNeighborCode >
oCNeighborOffsetCirculator< NEIGHBORCODE >Circulator that walks around a given location
oCNodeBase
oCAdjacencyListGraph::NodeMap< T >Default node map
oCNoiseNormalizationOptionsPass options to one of the noise normalization functions
oCNonlinearLSQOptionsPass options to nonlinearLeastSquares()
oCNormalizedCorrelationFunctor< MaskIterator, MaskAccessor >This function performes a (slow) normalized cross-correlation
oCNormalizeStatus
oCNormalRandomFunctor< Engine >
oCNumpyAnyArray
oCGridGraph< N, DirectedTag >::OutDegMapType of a property map that returns the number of outgoing edges of a given node (API: LEMON, use via lemon::OutDegMap<Graph>)
oCPermuteCluster< Iter, DT >
oCPLSAOptionsOption object for the pLSA algorithm
oCPolynomialView< T >
oCPowerSum< N >Basic statistic. PowerSum<N> = $ \sum_i x_i^N $
oCPrincipal< A >Modifier. Project onto PCA eigenvectors
oCPrincipal< CoordinateSystem >Specialization (covariance eigenvectors): works in pass 1, operator+=() supported (merging)
oCPrincipal< PowerSum< 2 > >Specialization (covariance eigenvalues): works in pass 1, operator+=() supported (merging)
oCPriorityQueue< ValueType, PriorityType, Ascending >Heap-based priority queue compatible to BucketQueue
oCProblemSpec< LabelType >Problem specification class for the random forest
oCProcessor< Tag, LabelType, T1, C1, T2, C2 >
oCProcessor< ClassificationTag, LabelType, T1, C1, T2, C2 >
oCProcessor< RegressionTag, LabelType, T1, C1, T2, C2 >
oCQuaternion< ValueType >
oCRandomForest< LabelType, PreprocessorTag >
oCRandomForestClassCounter< DataSource, CountArray >
oCRandomForestOptionsOptions object for the random forest
oCRandomNumberGenerator< Engine >
oCRandomSplitOfColumn
oCRangeReturn both the minimum and maximum in std::pair
oCRational< IntType >
oCRect2DTwo dimensional rectangle
oCRedAccessor< RGBVALUE >
oCReduceFunctor< FUNCTOR, VALUETYPE >Apply a functor to reduce the dimensionality of an array
oCRegionCircularityCompute the circularity of a 2D region
oCRegionContourCompute the contour of a 2D region
oCRegionEccentricityCompute the eccentricity of a 2D region in terms of its prinipal radii
oCRegionPerimeterCompute the perimeter of a 2D region
oCRFErrorCallback
oCRGB2LabFunctor< T >Convert linear (raw) RGB into perceptual uniform CIE L*a*b*
oCRGB2LuvFunctor< T >Convert linear (raw) RGB into perceptual uniform CIE L*u*v*
oCRGB2RGBPrimeFunctor< From, To >Convert linear (raw) RGB into non-linear (gamma corrected) R'G'B'
oCRGB2sRGBFunctor< From, To >Convert linear (raw) RGB into standardized sRGB
oCRGB2XYZFunctor< T >Convert linear (raw) RGB into standardized tri-stimulus XYZ
oCRGBGradientMagnitudeFunctor< ValueType >
oCRGBPrime2LabFunctor< T >Convert non-linear (gamma corrected) R'G'B' into perceptual uniform CIE L*a*b*
oCRGBPrime2LuvFunctor< T >Convert non-linear (gamma corrected) R'G'B' into perceptual uniform CIE L*u*v*
oCRGBPrime2RGBFunctor< From, To >Convert non-linear (gamma corrected) R'G'B' into non-linear (raw) RGB
oCRGBPrime2XYZFunctor< T >Convert non-linear (gamma corrected) R'G'B' into standardized tri-stimulus XYZ
oCRGBPrime2YPrimeCbCrFunctor< T >Convert non-linear (gamma corrected) R'G'B' into Y'CbCr color difference components
oCRGBPrime2YPrimeIQFunctor< T >Convert non-linear (gamma corrected) R'G'B' into Y'IQ components
oCRGBPrime2YPrimePbPrFunctor< T >Convert non-linear (gamma corrected) R'G'B' into Y'PbPr color difference components
oCRGBPrime2YPrimeUVFunctor< T >Convert non-linear (gamma corrected) R'G'B' into Y'UV components
oCRGBToGrayAccessor< RGBVALUE >
oCRootDivideByCount< A >Modifier. RootDivideByCount<TAG> = sqrt( TAG/Count )
oCRootDivideUnbiased< A >Modifier. RootDivideUnbiased<TAG> = sqrt( TAG / (Count-1) )
oCRowIterator< IMAGE_ITERATOR >Iterator adapter to linearly access row
oCSampler< Random >Create random samples from a sequence of indices
oCSamplerOptionsOptions object for the Sampler class
oCScatterMatrixEigensystem
oCSeedOptionsOptions object for generateWatershedSeeds()
oCSeedRgDirectValueFunctor< Value >Statistics functor to be used for seeded region growing
oCSelect< T01, T02, T03, T04, T05, T06, T07, T08, T09, T10, T11, T12, T13, T14, T15, T16, T17, T18, T19, T20 >Wrapper for MakeTypeList that additionally performs tag standardization
oCShortestPathDijkstra< GRAPH, WEIGHT_TYPE >Shortest path computer
oCSIFImportInfoExtracts image properties from an Andor SIF file header
oCSkeletonOptionsOption object for skeletonizeImage()
oCSkewnessBasic statistic. Skewness
oCSlantedEdgeMTFOptionsPass options to one of the slantedEdgeMTF() functions
oCSlicOptionsOptions object for slicSuperpixels()
oCSortSamplesByDimensions< DataMatrix >
oCSplice< T >
oCSplineImageView< ORDER, VALUETYPE >Create a continuous view onto a discrete image using splines
oCSplineImageView0< VALUETYPE, INTERNAL_TRAVERSER >Create an image view for nearest-neighbor interpolation
oCSplineImageView0< VALUETYPE >
oCSplineImageView1< VALUETYPE, INTERNAL_TRAVERSER >Create an image view for bi-linear interpolation
oCSplineImageView1< VALUETYPE >
oCSplitBase< Tag >
oCsRGB2RGBFunctor< From, To >Convert standardized sRGB into non-linear (raw) RGB
oCStandardAccessor< VALUETYPE >Encapsulate access to the values an iterator points to
oCStandardAccessor< RGBVALUE >
oCStandardAccessor< SEQUENCE >
oCStandardAccessor< VECTOR >
oCStandardConstAccessor< VALUETYPE >Encapsulate read access to the values an iterator points to
oCStandardConstValueAccessor< VALUETYPE >Encapsulate access to the values an iterator points to
oCStandardQuantiles< Hist >Compute (0%, 10%, 25%, 50%, 75%, 90%, 100%) quantiles from given histogram
oCStandardValueAccessor< VALUETYPE >Encapsulate access to the values an iterator points to
oCStopBase
oCStridedArrayTag
oCStridedMultiIterator< N, T, REFERENCE, POINTER >A multi-dimensional hierarchical iterator to be used with vigra::MultiArrayView if it is not strided
oCThreshold< SrcValueType, DestValueType >Threshold an image
oCTinyVectorBase< V1, SIZE, D1, D2 >Base class for fixed size vectors
oCTinyVectorBase< double, SIZE, double[SIZE], TinyVector< double, SIZE > >
oCTinyVectorBase< float, SIZE, float[SIZE], TinyVector< float, SIZE > >
oCTinyVectorBase< INDEX_TYPE, SIZE, INDEX_TYPE[SIZE], TinyVector< INDEX_TYPE, SIZE > >
oCTinyVectorBase< int, SIZE, int[SIZE], TinyVector< int, SIZE > >
oCTinyVectorBase< T, SIZE, T *, TinyVectorView< T, SIZE > >
oCTinyVectorBase< T, SIZE, T[SIZE], TinyVector< T, SIZE > >
oCTinyVectorBase< ValueType, SIZE, ValueType[SIZE], TinyVector< ValueType, SIZE > >
oCTinyVectorBase< VALUETYPE, SIZE, VALUETYPE[SIZE], TinyVector< VALUETYPE, SIZE > >
oCGridGraph< N, DirectedTag >::traversal_categoryDefine several graph tags related to graph traversal (API: boost::graph, use via boost::graph_traits<Graph>::traversal_category)
oCUnbiasedKurtosisBasic statistic. Unbiased Kurtosis
oCUnbiasedSkewnessBasic statistic. Unbiased Skewness
oCUniformIntRandomFunctor< Engine >
oCUniformRandomFunctor< Engine >
oCUnstridedArrayTag
oCUserRangeHistogram< BinCount >Histogram where user provides bounds for linear range mapping from values to indices
oCVariableSelectionResult
oCVectorComponentAccessor< VECTORTYPE >Accessor for one component of a vector
oCVectorComponentValueAccessor< VECTORTYPE >Accessor for one component of a vector
oCVectorElementAccessor< ACCESSOR >Accessor for one component of a vector
oCVectorNormFunctor< ValueType >A functor for computing the vector norm
oCVectorNormSqFunctor< ValueType >A functor for computing the squared vector norm
oCVisitorBase
oCVisitorNode< Visitor, Next >
oCVolumeExportInfoArgument object for the function exportVolume()
oCVolumeImportInfoArgument object for the function importVolume()
oCWatershedOptionsOptions object for watershed algorithms
oCWeightArg< INDEX >Specifies index of data in CoupledHandle
oCWeighted< A >Compute weighted version of the statistic
oCWignerMatrix< Real >Computation of Wigner D matrix + rotation functions in SH,VH and R³
oCXYZ2LabFunctor< T >Convert standardized tri-stimulus XYZ into perceptual uniform CIE L*a*b*
oCXYZ2LabFunctor< component_type >
oCXYZ2LuvFunctor< T >Convert standardized tri-stimulus XYZ into perceptual uniform CIE L*u*v*
oCXYZ2LuvFunctor< component_type >
oCXYZ2RGBFunctor< T >Convert standardized tri-stimulus XYZ into linear (raw) RGB
oCXYZ2RGBPrimeFunctor< T >Convert standardized tri-stimulus XYZ into non-linear (gamma corrected) R'G'B'
oCYPrimeCbCr2RGBPrimeFunctor< T >Convert Y'CbCr color difference components into non-linear (gamma corrected) R'G'B'
oCYPrimeIQ2RGBPrimeFunctor< T >Convert Y'IQ color components into non-linear (gamma corrected) R'G'B'
oCYPrimePbPr2RGBPrimeFunctor< T >Convert Y'PbPr color difference components into non-linear (gamma corrected) R'G'B'
\CYPrimeUV2RGBPrimeFunctor< T >Convert Y'UV color components into non-linear (gamma corrected) R'G'B'

© Ullrich Köthe (ullrich.koethe@iwr.uni-heidelberg.de)
Heidelberg Collaboratory for Image Processing, University of Heidelberg, Germany

html generated using doxygen and Python
vigra 1.10.0 (Thu Jan 8 2015)