Modifier and Type | Class and Description |
---|---|
class |
LiICQ<T extends RealType<T>,U extends RealType<U>>
This algorithm calculates Li et al.'s ICQ (intensity correlation quotient).
|
Modifier and Type | Class and Description |
---|---|
class |
KendallTauBRank<T extends RealType<T>,U extends RealType<U>>
This algorithm calculates Kendall's Tau-b rank correlation coefficient
|
Modifier and Type | Class and Description |
---|---|
class |
MTKT<T extends RealType<T>,U extends RealType<U>>
This algorithm calculates Maximum Trunctated Kendall Tau (MTKT) from Wang et
al.
|
Modifier and Type | Class and Description |
---|---|
class |
DefaultPearsons<T extends RealType<T>,U extends RealType<U>>
A class that represents the mean calculation of the two source images in the
data container.
|
Modifier and Type | Class and Description |
---|---|
class |
CopyArrayImg<T extends NativeType<T>,A extends ArrayDataAccess<A>>
|
class |
CopyII<T>
Copies an
IterableInterval into another IterableInterval |
class |
CopyImg<T extends NativeType<T>>
|
class |
CopyImgLabeling<T extends IntegerType<T> & NativeType<T>,L>
Copying
ImgLabeling into another ImgLabeling |
class |
CopyLabelingMapping<L>
Copies a
LabelingMapping into another LabelingMapping |
class |
CopyRAI<T>
Copies a
RandomAccessibleInterval into another
RandomAccessibleInterval |
class |
CopyType<T extends Type<T>>
|
Modifier and Type | Class and Description |
---|---|
class |
CreateImgFromDimsAndType<T extends NativeType<T>>
|
class |
CreateImgFromII<T extends NativeType<T>>
|
class |
CreateImgFromImg<T extends Type<T>>
|
class |
CreateImgFromInterval
|
class |
CreateImgFromRAI<T extends NativeType<T>>
|
Modifier and Type | Method and Description |
---|---|
UnaryFunctionOp<Interval,Img<DoubleType>> |
CreateImgFromInterval.createWorker(Interval input) |
UnaryFunctionOp<IterableInterval<T>,Img<T>> |
CreateImgFromII.createWorker(IterableInterval<T> input) |
UnaryFunctionOp<RandomAccessibleInterval<T>,Img<T>> |
CreateImgFromRAI.createWorker(RandomAccessibleInterval<T> input) |
Modifier and Type | Class and Description |
---|---|
class |
CreateImgFactoryFromImg<T>
Gets an
ImgFactory for the given Img . |
Modifier and Type | Class and Description |
---|---|
class |
CreateImgLabelingFromInterval<L,T extends IntegerType<T>>
Creates an
ImgLabeling from an Interval . |
class |
DefaultCreateImgLabeling<L,T extends IntegerType<T>>
Default implementation of the "create.imgLabeling" op.
|
Modifier and Type | Class and Description |
---|---|
class |
DefaultCreateImgPlus<T>
Default implementation of the "create.imgPlus" op.
|
Modifier and Type | Class and Description |
---|---|
class |
CreateKernel2D<T extends ComplexType<T>>
This Op takes a 2-D array of explicit values and creates a simple image, e.g.
|
Modifier and Type | Class and Description |
---|---|
class |
CreateKernel2ndDerivBiGaussDoubleType
Creates 2nd derivative of an isotropic BiGauss kernel of type
DoubleType ,
uses DefaultCreateKernel2ndDerivBiGauss to do the job. |
class |
CreateKernelBiGaussDoubleType
Creates an isotropic BiGauss kernel of type
DoubleType ,
uses DefaultCreateKernelBiGauss to do the job. |
class |
DefaultCreateKernel2ndDerivBiGauss<T extends ComplexType<T>>
Creates 2nd derivative of an isotropic BiGauss kernel
with the pair of sigmas specification.
|
class |
DefaultCreateKernelBiGauss<T extends ComplexType<T>>
Creates an isotropic BiGauss kernel
with the pair of sigmas specification.
|
Modifier and Type | Class and Description |
---|---|
class |
DefaultCreateKernelGibsonLanni<T extends ComplexType<T> & NativeType<T>>
Creates a Gibson Lanni Kernel.
|
Modifier and Type | Class and Description |
---|---|
class |
CreateKernelGaborComplexDoubleType
Creates a Gabor kernel of type
ComplexDoubleType ,
uses DefaultCreateKernelGabor to do the job. |
class |
CreateKernelGaborDoubleType
Creates a Gabor kernel of type
DoubleType ,
uses DefaultCreateKernelGabor to do the job. |
class |
CreateKernelGaborIsotropic<T extends ComplexType<T>>
Creates an isotropic Gabor kernel, i.e.,
with one sigma for all axes, and a period vector.
|
class |
CreateKernelGaborIsotropicComplexDoubleType
Creates an isotropic Gabor kernel of type
ComplexDoubleType ,
uses DefaultCreateKernelGabor to do the job. |
class |
CreateKernelGaborIsotropicDoubleType
Creates an isotropic Gabor kernel of type
DoubleType ,
uses DefaultCreateKernelGabor to do the job. |
class |
DefaultCreateKernelGabor<T extends ComplexType<T>>
Creates a Gabor kernel
with specifications for individual sigma per axis, and a period vector.
|
Modifier and Type | Class and Description |
---|---|
class |
CreateKernelGaussDoubleType
Creates a Gaussian kernel of type
DoubleType . |
class |
CreateKernelGaussSymmetric<T extends ComplexType<T>>
Creates a symmetric Gaussian kernel.
|
class |
CreateKernelGaussSymmetricDoubleType
Creates a symmetric Gaussian kernel of type
DoubleType . |
class |
DefaultCreateKernelGauss<T extends ComplexType<T>>
Creates a Gaussian Kernel
|
Modifier and Type | Method and Description |
---|---|
UnaryFunctionOp<Double,RandomAccessibleInterval<DoubleType>> |
CreateKernelGaussSymmetricDoubleType.createWorker(Double t) |
UnaryFunctionOp<double[],RandomAccessibleInterval<DoubleType>> |
CreateKernelGaussDoubleType.createWorker(double[] t) |
Modifier and Type | Class and Description |
---|---|
class |
CreateKernelLogDoubleType
Creates a log kernel of type
DoubleType . |
class |
CreateKernelLogSymmetric<T extends ComplexType<T>>
Creates a Gaussian Kernel
|
class |
CreateKernelLogSymmetricDoubleType
Creates a symmetric log kernel of type
DoubleType . |
class |
DefaultCreateKernelLog<T extends ComplexType<T>>
Laplacian of Gaussian filter ported from
fiji.plugin.trackmate.detection.DetectionUtil.
|
Modifier and Type | Method and Description |
---|---|
UnaryFunctionOp<Double,RandomAccessibleInterval<DoubleType>> |
CreateKernelLogSymmetricDoubleType.createWorker(Double t) |
UnaryFunctionOp<double[],RandomAccessibleInterval<DoubleType>> |
CreateKernelLogDoubleType.createWorker(double[] t) |
Modifier and Type | Class and Description |
---|---|
class |
CreateNativeTypeFromClass<T extends NativeType<T>>
Creates the
NativeType given by the input Class . |
Modifier and Type | Method and Description |
---|---|
UnaryFunctionOp<Class<T>,T> |
CreateNativeTypeFromClass.createWorker(Class<T> in) |
Modifier and Type | Class and Description |
---|---|
class |
CreateObjectFromClass<T>
Instantiates an object given by the input
Class . |
Modifier and Type | Class and Description |
---|---|
class |
NonCirculantFirstGuess<I extends RealType<I>,O extends RealType<O>,K extends RealType<K>,C extends ComplexType<C>>
Calculate non-circulant first guess.
|
Modifier and Type | Class and Description |
---|---|
class |
DefaultEval
Evaluates an expression.
|
Modifier and Type | Interface and Description |
---|---|
interface |
HaralickFeature<T extends RealType<T>>
Simple marker interface for Haralick Features.
|
Modifier and Type | Class and Description |
---|---|
class |
AbstractHaralickFeature<T extends RealType<T>>
Abstract class for HaralickFeatures.
|
class |
DefaultASM<T extends RealType<T>>
Implementation of Angular Second Moment Haralick Feature
|
class |
DefaultClusterPromenence<T extends RealType<T>>
Implementation of Cluster Promenence Haralick Feature
|
class |
DefaultClusterShade<T extends RealType<T>>
Implementation of Cluster Shade Haralick Feature
|
class |
DefaultContrast<T extends RealType<T>>
Implementation of texture contrast haralick feature.
|
class |
DefaultCorrelation<T extends RealType<T>>
Implementation of texture correlation haralick feature based on
http://earlglynn.github.io/RNotes/package/EBImage/Haralick-Textural-Features.html .
|
class |
DefaultDifferenceEntropy<T extends RealType<T>>
Implementation of Difference Entropy Haralick Feature
|
class |
DefaultDifferenceVariance<T extends RealType<T>>
Implementation of Difference Variance Haralick Feature
|
class |
DefaultEntropy<T extends RealType<T>>
Implementation of Entropy Haralick Feature Definition: -( sum_{i=1}^q
sum_{j=1}^q c(i,j) log(c(i,j)) )
|
class |
DefaultICM1<T extends RealType<T>>
Implementation of Information Measure of Correlation 1 Haralick Feature
|
class |
DefaultICM2<T extends RealType<T>>
Implementation of Information Measure of Correlation 2 Haralick Feature
|
class |
DefaultIFDM<T extends RealType<T>>
Implementation of Inverse Difference Moment Haralick Feature based on
http://www.uio.no/studier/emner/matnat/ifi/INF4300/h08/undervisningsmateriale/glcm.pdf .
|
class |
DefaultMaxProbability<T extends RealType<T>>
Implementation of Maximum Probability Haralick Feature
|
class |
DefaultSumAverage<T extends RealType<T>>
Implementation of Sum Average Haralick Feature
|
class |
DefaultSumEntropy<T extends RealType<T>>
Implementation of Sum Entropy Haralick Feature
|
class |
DefaultSumVariance<T extends RealType<T>>
Implementation of Sum Variance Haralick Feature according to
http://murphylab.web.cmu.edu/publications/boland/boland_node26.html .
|
class |
DefaultTextureHomogeneity<T extends RealType<T>>
Implementation of Texture Homogeneity Haralick Feature
|
Modifier and Type | Class and Description |
---|---|
class |
CoocHXY
NB: Helper class.
|
class |
CoocMeanX
NB: Helper class.
|
class |
CoocMeanY
NB: Helper class.
|
class |
CoocPX
NB: Helper class.
|
class |
CoocPXMinusY
NB: Helper class.
|
class |
CoocPXPlusY
NB: Helper class.
|
class |
CoocPY
NB: Helper class.
|
class |
CoocStdX
NB: Helper class.
|
class |
CoocStdY
NB: Helper class.
|
Modifier and Type | Class and Description |
---|---|
class |
HistogramOfOrientedGradients2D<T extends RealType<T>>
Calculates a histogram of oriented gradients which is a feature descriptor.
|
Modifier and Type | Interface and Description |
---|---|
interface |
LBP2DFeature<I extends RealType<I>>
Marker interface for 2D local binary pattern feature.
|
Modifier and Type | Class and Description |
---|---|
class |
AbstractLBP2DFeature<I extends RealType<I>>
Abstract class for 2d local binary pattern feature
|
class |
DefaultLBP2D<I extends RealType<I>>
Default implementation of 2d local binary patterns
|
Modifier and Type | Interface and Description |
---|---|
interface |
TamuraFeature<I extends RealType<I>,O extends RealType<O>>
Marker interface for tamura features.
|
Modifier and Type | Class and Description |
---|---|
class |
AbstractTamuraFeature<I extends RealType<I>,O extends RealType<O>>
Abstract tamura feature.
|
class |
DefaultCoarsenessFeature<I extends RealType<I>,O extends RealType<O>>
Implementation of Tamura's Coarseness feature
|
class |
DefaultContrastFeature<I extends RealType<I>,O extends RealType<O>>
Default implementation of tamura feature contrast.
|
class |
DefaultDirectionalityFeature<I extends RealType<I>,O extends RealType<O>>
Implementation of Tamura's Directionality Feature
|
Modifier and Type | Interface and Description |
---|---|
interface |
ZernikeFeature<I extends RealType<I>,O extends RealType<O>>
Marker interface for zernike ops.
|
Modifier and Type | Class and Description |
---|---|
class |
AbstractZernikeFeature<I extends RealType<I>,O extends RealType<O>>
Abstract Zernike Op.
|
class |
DefaultMagnitudeFeature<T extends RealType<T>,O extends RealType<O>>
Get Magnitude of Zernike moment as feature
|
class |
DefaultPhaseFeature<T extends RealType<T>,O extends RealType<O>>
Get Phase of Zernike moment as feature
|
Modifier and Type | Class and Description |
---|---|
class |
ZernikeComputer<T extends RealType<T>>
Computes a specific zernike moment
|
Modifier and Type | Method and Description |
---|---|
UnaryFunctionOp<Dimensions,RandomAccessibleInterval<C>> |
AbstractFFTFilterC.getCreateOp() |
Modifier and Type | Class and Description |
---|---|
class |
AddNoiseRealTypeCFI<T extends RealType<T>>
Adds Gaussian noise to a real number.
|
Modifier and Type | Class and Description |
---|---|
class |
ConvolveNaiveF<I extends RealType<I>,O extends RealType<O> & NativeType<O>,K extends RealType<K>>
Function adapter for
ConvolveFFTC . |
class |
PadAndConvolveFFTF<I extends RealType<I>,O extends RealType<O> & NativeType<O>,K extends RealType<K>>
Function adapter for
PadAndConvolveFFT . |
Modifier and Type | Class and Description |
---|---|
class |
PartialDerivativeRAI<T extends RealType<T>>
Calculates the derivative (with sobel kernel) of an image in a given
dimension.
|
class |
PartialDerivativesRAI<T extends RealType<T>>
Convenience op for partial derivatives.
|
Modifier and Type | Class and Description |
---|---|
class |
DefaultDoG<T extends NumericType<T> & NativeType<T>>
Low-level difference of Gaussians (DoG) implementation which leans on other
ops to do the work.
|
class |
DoGSingleSigmas<T extends NumericType<T> & NativeType<T>>
Difference of Gaussians (DoG) implementation where all sigmas are the same in
each dimension.
|
class |
DoGVaryingSigmas<T extends NumericType<T> & NativeType<T>>
Difference of Gaussians (DoG) implementation where sigmas can vary by
dimension.
|
Modifier and Type | Class and Description |
---|---|
class |
CreateOutputFFTMethods<T>
Function that creates an output for FFTMethods FFT
|
class |
FFTMethodsOpF<T extends RealType<T>,C extends ComplexType<C>>
Function that uses FFTMethods to perform a forward FFT
|
Modifier and Type | Class and Description |
---|---|
class |
ComputeFFTMethodsSize
Op that calculates FFT sizes.
|
class |
DefaultComputeFFTSize
Op that calculates FFT fast sizes according to the following logic.
|
Modifier and Type | Class and Description |
---|---|
class |
DefaultGaussRAI<T extends NumericType<T> & NativeType<T>>
Gaussian filter, wrapping
Gauss3 of imglib2-algorithms. |
class |
GaussRAISingleSigma<T extends NumericType<T> & NativeType<T>>
Gaussian filter which can be called with single sigma, i.e.
|
Modifier and Type | Class and Description |
---|---|
class |
HessianRAI<T extends RealType<T>>
Hessian filter using the sobel filter with separated kernel.
|
Modifier and Type | Class and Description |
---|---|
class |
DefaultPadInputFFT<T extends ComplexType<T>,I extends RandomAccessibleInterval<T>,O extends RandomAccessibleInterval<T>>
Op used to pad the image using the default FFT padding scheme.
|
class |
DefaultPadShiftKernelFFT<T extends ComplexType<T>,I extends RandomAccessibleInterval<T>,O extends RandomAccessibleInterval<T>>
Op used to pad the kernel using the default FFT padding scheme and shift the center
of the kernel to the origin
|
class |
PaddingIntervalCentered<T extends ComplexType<T>,I extends RandomAccessibleInterval<T>,O extends Interval>
Op used to calculate and return a centered padding interval given an input
RAI and the desired padded dimensions
|
class |
PaddingIntervalOrigin<T extends ComplexType<T>,I extends RandomAccessibleInterval<T>,O extends Interval>
Op used to translate the center of an interval the origin.
|
class |
PadInput<T extends ComplexType<T>,I extends RandomAccessibleInterval<T>,O extends RandomAccessibleInterval<T>>
Op used to pad the image by extending the borders
|
class |
PadInputFFT<T extends ComplexType<T>,I extends RandomAccessibleInterval<T>,O extends RandomAccessibleInterval<T>>
Abstract Op used to pad the image by extending the borders optionally using
an "fftSize" op to make the final image size compatible with an FFT library.
|
class |
PadInputFFTMethods<T extends ComplexType<T>,I extends RandomAccessibleInterval<T>,O extends RandomAccessibleInterval<T>>
Op used to pad the image to a size that is compatible with FFTMethods
|
class |
PadShiftKernel<T extends ComplexType<T>,I extends RandomAccessibleInterval<T>,O extends RandomAccessibleInterval<T>>
Op used to pad a kernel and shift the center of the kernel to the origin
|
class |
PadShiftKernelFFTMethods<T extends ComplexType<T>,I extends RandomAccessibleInterval<T>,O extends RandomAccessibleInterval<T>>
Op used to pad a kernel to a size that is compatible with FFTMethods and
shift the center of the kernel to the origin
|
Modifier and Type | Method and Description |
---|---|
protected void |
PadShiftKernel.setFFTSizeOp(UnaryFunctionOp<Dimensions,long[][]> fftSizeOp) |
protected void |
PadInputFFT.setFFTSizeOp(UnaryFunctionOp<Dimensions,long[][]> fftSizeOp) |
Modifier and Type | Class and Description |
---|---|
class |
SobelRAI<T extends RealType<T>>
Sobel filter implementation using separated sobel kernel.
|
Modifier and Type | Class and Description |
---|---|
class |
DefaultTubeness<T extends RealType<T>>
The Tubeness filter: enhance filamentous structures of a specified thickness.
|
Modifier and Type | Interface and Description |
---|---|
interface |
GeometricOp<I,O>
Simple marker interface for Geoemtric ops.
|
Modifier and Type | Class and Description |
---|---|
class |
AbstractBoundarySizeConvexHull<I>
Generic implementation of
Ops.Geometric.BoundarySizeConvexHull . |
class |
AbstractBoxivity<I>
Generic implementation of
Ops.Geometric.Boxivity . |
class |
AbstractConvexity<I>
Generic implementation of
Ops.Geometric.Convexity . |
class |
AbstractSizeConvexHull<I>
Generic implementation of
Ops.Geometric.SizeConvexHull
. |
class |
AbstractSolidity<I>
Generic implementation of
Ops.Geometric.Solidity . |
class |
CentroidII
This
Op computes the centroid of a IterableRegion (Label). |
class |
CentroidLabelRegion
This
Op computes the centroid of a IterableRegion (Label). |
class |
CentroidMesh
Generic implementation of
geom.centroid . |
class |
CentroidPolygon
Generic implementation of
geom.centroid . |
class |
DefaultCenterOfGravity<T extends RealType<T>>
This
Op computes the center of gravity of a IterableRegion
(Label). |
class |
SizeII
Generic implementation of
Ops.Geometric.Size . |
Modifier and Type | Class and Description |
---|---|
class |
DefaultBoundarySizeConvexHullPolygon |
class |
DefaultBoundingBox
Generic implementation of
geom.boundingBox . |
class |
DefaultBoxivityPolygon |
class |
DefaultCircularity
Generic implementation of
geom.circularity . |
class |
DefaultContour<B extends BooleanType<B>>
Generic implementation of
geom.contour . |
class |
DefaultConvexHull2D
Generic implementation of
geom.convexHull . |
class |
DefaultConvexityPolygon |
class |
DefaultEccentricity
Generic implementation of
geom.eccentricity . |
class |
DefaultElongation
Generic implementation of
geom.mainElongation based on
http://www.math.uci.edu/icamp/summer/research_11/park/
shape_descriptors_survey.pdf. |
class |
DefaultFeretsAngle
Generic implementation of
geom.feretsAngle . |
class |
DefaultFeretsDiameter
Generic implementation of
geom.feretsDiameter . |
class |
DefaultFeretsDiameterForAngle
Ferets Diameter for a certain angle.
|
class |
DefaultMajorAxis
Generic implementation of
geom.majorAxis . |
class |
DefaultMaximumFeret
Maximum Feret of a polygon.
|
class |
DefaultMaximumFeretAngle |
class |
DefaultMaximumFeretDiameter |
class |
DefaultMinimumFeret
Minimum Feret of a polygon.
|
class |
DefaultMinimumFeretAngle |
class |
DefaultMinimumFeretDiameter |
class |
DefaultMinorAxis
Generic implementation of
geom.minorAxis . |
class |
DefaultMinorMajorAxis
Generic implementation of
geom.secondMultiVariate . |
class |
DefaultPerimeterLength
Generic implementation of
geom.boundarySize . |
class |
DefaultRoundness
Generic implementation of
geom.roundness . |
class |
DefaultSizeConvexHullPolygon |
class |
DefaultSizePolygon
Specific implementation of
Area for a Polygon2D. |
class |
DefaultSmallestEnclosingRectangle
Generic implementation of
geom.smallestBoundingBox . |
class |
DefaultSolidityPolygon |
class |
DefaultVerticesCountConvexHullPolygon |
class |
DefaultVerticesCountPolygon |
Modifier and Type | Class and Description |
---|---|
class |
DefaultBoxivityMesh |
class |
DefaultCompactness
Generic implementation of
Ops.Geometric.Compactness . |
class |
DefaultConvexHull3D
This quickhull implementation is based on the paper
"The Quickhull Algorithm for Convex Hulls" by Barber, Dobkin and Huhdanpaa
(http://dpd.cs.princeton.edu/Papers/BarberDobkinHuhdanpaa.pdf).
|
class |
DefaultConvexityMesh |
class |
DefaultInertiaTensor3D<B extends BooleanType<B>>
This
Op computes the 2nd multi variate of a IterableRegion
(Label). |
class |
DefaultInertiaTensor3DMesh
This
Op computes the 2nd multi variate of a IterableRegion
(Label). |
class |
DefaultMainElongation
Generic implementation of
Ops.Geometric.MainElongation
Adapted to 3D from http://www.math.uci.edu/icamp/summer/research_11/park/
shape_descriptors_survey.pdf |
class |
DefaultMarchingCubes<T extends BooleanType<T>>
This is a marching cubes implementation.
|
class |
DefaultMedianElongation
Generic implementation of
Ops.Geometric.MedianElongation . |
class |
DefaultSolidityMesh |
class |
DefaultSparenessMesh
Generic implementation of
Ops.Geometric.Spareness . |
class |
DefaultSphericity
Generic implementation of
Ops.Geometric.Sphericity . |
class |
DefaultSurfaceArea
Generic implementation of
Ops.Geometric.BoundarySize . |
class |
DefaultSurfaceAreaConvexHullMesh |
class |
DefaultVerticesCountConvexHullMesh |
class |
DefaultVerticesCountMesh
Generic implementation of
geom.boundaryPixelCount . |
class |
DefaultVolumeConvexHullMesh |
class |
DefaultVolumeMesh
Generic implementation of
Ops.Geometric.Size . |
class |
DefaultVoxelization3D
This is a voxelizer that produces a binary image with values filled in along
the surface of the mesh.
|
Modifier and Type | Class and Description |
---|---|
class |
DefaultSmallestOrientedBoundingBox
Generic implementation of
geom.smallestBoundingBox . |
Modifier and Type | Method and Description |
---|---|
<T extends RealType<T>> |
ImageNamespace.equation(IterableInterval<T> out,
UnaryFunctionOp<long[],Double> in)
Executes the "equation" operation on the given arguments.
|
Modifier and Type | Class and Description |
---|---|
class |
DefaultASCII<T extends RealType<T>>
Generates an ASCII version of an image.
|
Modifier and Type | Class and Description |
---|---|
class |
CooccurrenceMatrix2D<T extends RealType<T>>
Calculates coocccurrence matrix from an 2D-
IterableInterval . |
class |
CooccurrenceMatrix3D<T extends RealType<T>>
Calculates coocccurrence matrix from an 3D-
IterableInterval . |
Modifier and Type | Class and Description |
---|---|
class |
DefaultDistanceTransform<B extends BooleanType<B>,T extends RealType<T>>
Computes a distance transform, i.e.
|
class |
DefaultDistanceTransformCalibration<B extends BooleanType<B>,T extends RealType<T>>
Computes a distance transform, i.e.
|
class |
DistanceTransform2D<B extends BooleanType<B>,T extends RealType<T>>
Computes a distance transform, i.e.
|
class |
DistanceTransform2DCalibration<B extends BooleanType<B>,T extends RealType<T>>
Computes a distance transform, i.e.
|
class |
DistanceTransform3D<B extends BooleanType<B>,T extends RealType<T>>
Computes a distance transform, i.e.
|
class |
DistanceTransform3DCalibration<B extends BooleanType<B>,T extends RealType<T>>
Computes a distance transform, i.e.
|
Modifier and Type | Class and Description |
---|---|
class |
DefaultEquation<T extends RealType<T>>
Computes an image using an equation.
|
Modifier and Type | Method and Description |
---|---|
void |
DefaultCoordinatesEquation.compute(UnaryFunctionOp<long[],N> op,
IterableInterval<T> output) |
Modifier and Type | Class and Description |
---|---|
class |
HistogramCreate<T extends RealType<T>> |
Modifier and Type | Class and Description |
---|---|
class |
AbstractIntegralImg<I extends RealType<I>>
Abstract base class for n-dimensional integral images.
|
class |
DefaultIntegralImg<I extends RealType<I>>
n-dimensional integral image that stores sums using
RealType . |
class |
SquareIntegralImg<I extends RealType<I>>
n-dimensional squared integral image that stores sums using
RealType . |
class |
WrappedIntegralImg<I extends RealType<I>>
Wrapper op for the creation of integral images with
net.imglib2.algorithm.integral.IntegralImg . |
Modifier and Type | Class and Description |
---|---|
class |
NormalizeIIFunction<T extends RealType<T>>
Normalizes an
IterableInterval given its minimum and maximum to
another range defined by minimum and maximum. |
Modifier and Type | Class and Description |
---|---|
class |
Watershed<T extends RealType<T>,B extends BooleanType<B>>
The Watershed algorithm segments and labels a grayscale image analogous to a
heightmap.
|
class |
WatershedBinary<T extends BooleanType<T>,B extends BooleanType<B>>
The Watershed algorithm segments and labels a grayscale image analogous to a
heightmap.
|
class |
WatershedBinarySingleSigma<T extends BooleanType<T>,B extends BooleanType<B>>
The Watershed algorithm segments and labels a grayscale image analogous to a
heightmap.
|
class |
WatershedSeeded<T extends RealType<T>,B extends BooleanType<B>>
The Watershed algorithm segments and labels a grayscale image analogous to a
heightmap.
|
Modifier and Type | Interface and Description |
---|---|
interface |
ImageMomentOp<I,O>
marker interface for image moment ops.
|
Modifier and Type | Class and Description |
---|---|
class |
AbstractImageMomentOp<I extends RealType<I>,O extends RealType<O>>
Abstract
ImageMomentOp . |
Modifier and Type | Class and Description |
---|---|
class |
DefaultCentralMoment00<I extends RealType<I>,O extends RealType<O>>
Op to calculate the imageMoments.centralMoment00 . |
class |
DefaultCentralMoment01<I extends RealType<I>,O extends RealType<O>>
Op to calculate the imageMoments.centralMoment01 directly. |
class |
DefaultCentralMoment02<I extends RealType<I>,O extends RealType<O>>
Op to calculate the imageMoments.centralMoment02 . |
class |
DefaultCentralMoment03<I extends RealType<I>,O extends RealType<O>>
Op to calculate the imageMoments.centralMoment03 using |
class |
DefaultCentralMoment10<I extends RealType<I>,O extends RealType<O>>
Op to calculate the imageMoments.centralMoment10 directly. |
class |
DefaultCentralMoment11<I extends RealType<I>,O extends RealType<O>>
Op to calculate the imageMoments.centralMoment11 . |
class |
DefaultCentralMoment12<I extends RealType<I>,O extends RealType<O>>
Op to calculate the imageMoments.centralMoment12 . |
class |
DefaultCentralMoment20<I extends RealType<I>,O extends RealType<O>>
Op to calculate the imageMoments.centralMoment20 . |
class |
DefaultCentralMoment21<I extends RealType<I>,O extends RealType<O>>
Op to calculate the imageMoments.centralMoment21 . |
class |
DefaultCentralMoment30<I extends RealType<I>,O extends RealType<O>>
Op to calculate the imageMoments.centralMoment30 . |
class |
IterableCentralMoment00<I extends RealType<I>,O extends RealType<O>>
Op to calculate the imageMoments.centralMoment00 directly. |
class |
IterableCentralMoment11<I extends RealType<I>,O extends RealType<O>>
Op to calculate the imageMoments.centralMoment11 directly. |
Modifier and Type | Class and Description |
---|---|
class |
DefaultHuMoment1<I extends RealType<I>,O extends RealType<O>>
Op to calculate the imageMoments.huMoment1 . |
class |
DefaultHuMoment2<I extends RealType<I>,O extends RealType<O>>
Op to calculate the imageMoments.huMoment2 . |
class |
DefaultHuMoment3<I extends RealType<I>,O extends RealType<O>>
Op to calculate the imageMoments.huMoment3 . |
class |
DefaultHuMoment4<I extends RealType<I>,O extends RealType<O>>
Op to calculate the imageMoments.huMoment4 . |
class |
DefaultHuMoment5<I extends RealType<I>,O extends RealType<O>>
Op to calculate the imageMoments.huMoment5 . |
class |
DefaultHuMoment6<I extends RealType<I>,O extends RealType<O>>
Op to calculate the imageMoments.huMoment6 . |
class |
DefaultHuMoment7<I extends RealType<I>,O extends RealType<O>>
Op to calculate the imageMoments.huMoment7 . |
Modifier and Type | Class and Description |
---|---|
class |
DefaultMoment00<I extends RealType<I>,O extends RealType<O>>
Op to calculate the imageMoments.moment00 . |
class |
DefaultMoment01<I extends RealType<I>,O extends RealType<O>>
Op to calculate the imageMoments.moment01 . |
class |
DefaultMoment10<I extends RealType<I>,O extends RealType<O>>
Op to calculate the imageMoments.moment10 . |
class |
DefaultMoment11<I extends RealType<I>,O extends RealType<O>>
Op to calculate the imageMoments.moment11 . |
Modifier and Type | Class and Description |
---|---|
class |
DefaultNormalizedCentralMoment02<I extends RealType<I>,O extends RealType<O>>
Op to calculate the imageMoments.normalizedCentralMoment02 . |
class |
DefaultNormalizedCentralMoment03<I extends RealType<I>,O extends RealType<O>>
Op to calculate the imageMoments.normalizedCentralMoment03 . |
class |
DefaultNormalizedCentralMoment11<I extends RealType<I>,O extends RealType<O>>
Op to calculate the imageMoments.normalizedCentralMoment11 . |
class |
DefaultNormalizedCentralMoment12<I extends RealType<I>,O extends RealType<O>>
Op to calculate the imageMoments.normalizedCentralMoment12 . |
class |
DefaultNormalizedCentralMoment20<I extends RealType<I>,O extends RealType<O>>
Op to calculate the imageMoments.normalizedCentralMoment20 . |
class |
DefaultNormalizedCentralMoment21<I extends RealType<I>,O extends RealType<O>>
Op to calculate the imageMoments.normalizedCentralMoment21 . |
class |
DefaultNormalizedCentralMoment30<I extends RealType<I>,O extends RealType<O>>
Op to calculate the imageMoments.normalizedCentralMoment30 . |
Modifier and Type | Class and Description |
---|---|
class |
MergeLabeling<L,I extends IntegerType<I>,B extends BooleanType<B>>
Merges the labels of two
ImgLabeling within a defined mask (if
provided). |
Modifier and Type | Class and Description |
---|---|
class |
DefaultCCA<T extends IntegerType<T>,L,I extends IntegerType<I>>
Default Implementation wrapping
ConnectedComponents of
ImgLib2-algorithms. |
Modifier and Type | Class and Description |
---|---|
class |
Rotate3d
Rotates the vector by the quaternion.
|
class |
Rotate3f
Rotates the vector by the quaternion.
|
Modifier and Type | Class and Description |
---|---|
static class |
BooleanTypeLogic.And<T extends BooleanType<T>>
Performs logical and (&&) between two
BooleanType s. |
static class |
BooleanTypeLogic.Not<T extends BooleanType<T>>
Performs logical not (!) on a
BooleanType . |
static class |
BooleanTypeLogic.Or<T extends BooleanType<T>>
Performs logical or (||) between two
BooleanType s. |
static class |
BooleanTypeLogic.Xor<T extends BooleanType<T>>
Performs logical xor (^) between two
BooleanType s. |
class |
If<I extends BooleanType<I>,O extends Type<O>>
An Op that works the same way as the
?: operator. |
static class |
IIToIIOutputII.And<T extends BooleanType<T>> |
static class |
IIToIIOutputII.Or<T extends BooleanType<T>> |
static class |
IIToIIOutputII.Xor<T extends BooleanType<T>> |
static class |
IIToRAIOutputII.And<T extends NumericType<T>> |
static class |
IIToRAIOutputII.Or<T extends NumericType<T>> |
static class |
IIToRAIOutputII.Xor<T extends NumericType<T>> |
Modifier and Type | Class and Description |
---|---|
class |
LookupByName
Implementation of "op" that finds the op by name.
|
class |
LookupByType
Implementation of "op" that finds the op by type.
|
Modifier and Type | Interface and Description |
---|---|
interface |
MapView<EI,EO,PI,PO>
A
MapUnaryComputer UnaryFunctionOp which converts entries on
demand by wrapping in a thin "view" data structure. |
Modifier and Type | Class and Description |
---|---|
class |
AbstractMapView<EI,EO,PI,PO>
Abstract base class for
MapView implementations. |
class |
MapViewIIToII<EI,EO extends Type<EO>>
MapView which converts an IterableInterval between element
types. |
class |
MapViewRAIToRAI<EI,EO extends Type<EO>>
MapView which converts an RandomAccessibleInterval between
element types. |
class |
MapViewRandomAccessToRandomAccess<EI,EO extends Type<EO>>
MapView which converts a RandomAccessible between element
types. |
Modifier and Type | Class and Description |
---|---|
static class |
ConstantToIIOutputII.Add<T extends NumericType<T>> |
static class |
ConstantToIIOutputII.Divide<T extends NumericType<T>> |
static class |
ConstantToIIOutputII.Multiply<T extends NumericType<T>> |
static class |
ConstantToIIOutputII.Subtract<T extends NumericType<T>> |
static class |
IIToIIOutputII.Add<T extends NumericType<T>> |
static class |
IIToIIOutputII.Divide<T extends NumericType<T>> |
static class |
IIToIIOutputII.Multiply<T extends NumericType<T>> |
static class |
IIToIIOutputII.Subtract<T extends NumericType<T>> |
static class |
IIToRAIOutputII.Add<T extends NumericType<T>> |
static class |
IIToRAIOutputII.Divide<T extends NumericType<T>> |
static class |
IIToRAIOutputII.Multiply<T extends NumericType<T>> |
static class |
IIToRAIOutputII.Subtract<T extends NumericType<T>> |
static class |
NumericTypeBinaryMath.Add<T extends NumericType<T>>
Op that adds (+) two NumericType values.
|
static class |
NumericTypeBinaryMath.Divide<T extends NumericType<T>>
Op that divides (/) two NumericType values.
|
static class |
NumericTypeBinaryMath.Multiply<T extends NumericType<T>>
Op that multiplies (*) two NumericType values.
|
static class |
NumericTypeBinaryMath.Subtract<T extends NumericType<T>>
Op that subtracts (-) two NumericType values.
|
Modifier and Type | Class and Description |
---|---|
class |
ListBlackTopHat<T extends RealType<T>>
|
Modifier and Type | Class and Description |
---|---|
class |
ListClose<T extends RealType<T>>
|
Modifier and Type | Class and Description |
---|---|
class |
DefaultDilate<T extends RealType<T>>
Computes the dilation of a
RandomAccessibleInterval using a single
Shape . |
class |
ListDilate<T extends RealType<T>>
|
Modifier and Type | Class and Description |
---|---|
class |
DefaultErode<T extends RealType<T>>
Computes the erosion of a
RandomAccessibleInterval using a single
Shape . |
class |
ListErode<T extends RealType<T>>
|
Modifier and Type | Class and Description |
---|---|
class |
DefaultExtractHolesFunction<T extends BooleanType<T>> |
Modifier and Type | Class and Description |
---|---|
class |
DefaultFillHoles<T extends BooleanType<T>>
Fills the holes of a BooleanType image.
|
Modifier and Type | Class and Description |
---|---|
class |
DefaultFloodFill<T extends Type<T> & Comparable<T>> |
Modifier and Type | Class and Description |
---|---|
class |
ListOpen<T extends RealType<T>>
|
Modifier and Type | Class and Description |
---|---|
class |
Outline<B extends BooleanType<B>>
The Op creates an output interval where the objects are hollow versions from
the input.
|
Modifier and Type | Class and Description |
---|---|
class |
AbstractThin
Thinning Operation
|
class |
ThinGuoHall
Thinning Operation
|
class |
ThinHilditch
Thinning Operation
|
class |
ThinMorphological
Thinning Operation
|
class |
ThinZhangSuen
Thinning Operation
|
Modifier and Type | Class and Description |
---|---|
class |
ListTopHat<T extends RealType<T>>
|
Modifier and Type | Class and Description |
---|---|
class |
RunByName
Implementation of "run" that invokes the op by name.
|
class |
RunByOp
Implementation of "run" that invokes the specified
Op instance. |
class |
RunByType
Implementation of "run" that invokes the op by type.
|
Modifier and Type | Class and Description |
---|---|
class |
DefaultDetectJunctions
Finds the junctions between a
ArrayList of WritablePolyline ,
intended to be used optionally after running DefaultDetectRidges but
applicable to all groups of polylines. |
Modifier and Type | Class and Description |
---|---|
class |
DefaultDetectRidges<T extends RealType<T>>
Performs the Ridge Detection algorithm on a 2-Dimensional, gray-scale image.
|
Modifier and Type | Class and Description |
---|---|
class |
BFViaBC<I1 extends DI1,I2 extends DI2,O extends DO,DI1,DI2,DO>
Base class for
BinaryFunctionOp s that delegate to
BinaryComputerOp s. |
class |
BFViaBCAllSame<IO>
Base class for
BinaryFunctionOp s that delegate to
BinaryComputerOp s with all matching types (inputs same as output). |
class |
BFViaBCSameIO<I1,I2,O>
Base class for
BinaryFunctionOp s that delegate to
BinaryComputerOp s with the same input and output types. |
class |
BFViaBF<I1 extends DI1,I2 extends DI2,O,DI1,DI2,DO extends O>
Base class for
BinaryFunctionOp s that delegate to other
BinaryFunctionOp s. |
class |
BFViaBFAllSame<IO>
Base class for
BinaryFunctionOp s that delegate to other
BinaryFunctionOp s with all matching types (inputs same as output). |
class |
BFViaBFSameIO<I1,I2,O>
Base class for
BinaryFunctionOp s that delegate to other
BinaryFunctionOp s with the same input and output types. |
class |
BHCFViaBC<I1 extends DI1,I2 extends DI2,O extends DO,DI1,DI2,DO>
Base class for
BinaryHybridCF s that delegate to
BinaryComputerOp s. |
class |
BHCFViaBCAllSame<IO>
Base class for
BinaryHybridCF s that delegate to
BinaryComputerOp s with all matching types (inputs same as output). |
class |
BHCFViaBCSameIO<I1,I2,O>
Base class for
BinaryHybridCF s that delegate to
BinaryComputerOp s with the same input and output types. |
class |
BHCFViaBHCF<I1 extends DI1,I2 extends DI2,O,DI1,DI2>
Base class for
BinaryHybridCF s that delegate to
BinaryHybridCF s. |
class |
BHCFViaBHCFAllSame<IO>
Base class for
BinaryHybridCF s that delegate to
BinaryHybridCF s with all matching types (inputs same as output). |
class |
BHCFViaBHCFSameIO<I1,I2,O>
Base class for
BinaryHybridCF s that delegate to
BinaryHybridCF s with the same input and output types. |
class |
UFViaUC<I extends DI,O extends DO,DI,DO>
Base class for
UnaryFunctionOp s that delegate to
UnaryComputerOp s. |
class |
UFViaUCAllSame<IO>
Base class for
UnaryFunctionOp s that delegate to
UnaryComputerOp s with all matching types (input same as output). |
class |
UFViaUCSameIO<I,O>
Base class for
UnaryFunctionOp s that delegate to
UnaryComputerOp s with the same input and output types. |
class |
UFViaUF<I extends DI,O,DI,DO extends O>
Base class for
UnaryFunctionOp s that delegate to other
UnaryFunctionOp s. |
class |
UFViaUFAllSame<IO>
Base class for
UnaryFunctionOp s that delegate to other
UnaryFunctionOp s with all matching types (input same as output). |
class |
UFViaUFSameIO<I,O>
Base class for
UnaryFunctionOp s that delegate to other
UnaryFunctionOp s with the same input and output types. |
class |
UHCFViaUC<I extends DI,O extends DO,DI,DO>
Base class for
UnaryHybridCF s that delegate to
UnaryComputerOp s. |
class |
UHCFViaUCAllSame<IO>
Base class for
UnaryHybridCF s that delegate to
UnaryComputerOp s with all matching types (input same as output). |
class |
UHCFViaUCSameIO<I,O>
Base class for
UnaryHybridCF s that delegate to
UnaryComputerOp s with the same input and output types. |
class |
UHCFViaUHCF<I extends DI,O,DI>
Base class for
UnaryHybridCF s that delegate to other
UnaryHybridCF s. |
class |
UHCFViaUHCFAllSame<IO>
Base class for
UnaryHybridCF s that delegate to other
UnaryHybridCF s with all matching types (input same as output). |
class |
UHCFViaUHCFSameIO<I,O>
Base class for
UnaryHybridCF s that delegate to other
UnaryHybridCF s with the same input and output types. |
Modifier and Type | Method and Description |
---|---|
static <I,O extends RealType<O>> |
RTs.function(OpEnvironment ops,
Class<? extends Op> opType,
I in,
Object... otherArgs) |
static <T> UnaryFunctionOp<IterableInterval<T>,IterableInterval<T>> |
IIs.function(OpEnvironment ops,
Class<? extends Op> opType,
IterableInterval<T> in,
Object... otherArgs) |
static <T> UnaryFunctionOp<RandomAccessibleInterval<T>,RandomAccessibleInterval<T>> |
RAIs.function(OpEnvironment ops,
Class<? extends Op> opType,
RandomAccessibleInterval<T> in,
Object... otherArgs) |
Modifier and Type | Interface and Description |
---|---|
interface |
BinaryFunctionOp<I1,I2,O>
A binary function calculates a result from two given inputs,
returning it as a new object.
|
Modifier and Type | Class and Description |
---|---|
class |
AbstractBinaryFunctionOp<I1,I2,O>
Abstract superclass for
BinaryFunctionOp implementations. |
class |
AbstractUnaryFunctionOp<I,O>
Abstract superclass for
UnaryFunctionOp implementations. |
Modifier and Type | Method and Description |
---|---|
default UnaryFunctionOp<I,O> |
UnaryFunctionOp.getIndependentInstance() |
static <I,O> UnaryFunctionOp<I,O> |
Functions.unary(OpEnvironment ops,
Class<? extends Op> opType,
Class<O> outType,
Class<I> inType,
Object... otherArgs)
Gets the best
UnaryFunctionOp implementation for the given types
and arguments, populating its inputs. |
static <I,O> UnaryFunctionOp<I,O> |
Functions.unary(OpEnvironment ops,
Class<? extends Op> opType,
Class<O> outType,
I in,
Object... otherArgs)
Gets the best
UnaryFunctionOp implementation for the given types
and arguments, populating its inputs. |
Modifier and Type | Interface and Description |
---|---|
interface |
BinaryHybridCF<I1,I2,O>
A hybrid binary operation which can be used as a
BinaryComputerOp or
BinaryFunctionOp . |
interface |
BinaryHybridCFI<I,O extends I>
A hybrid binary operation which can be used as a
BinaryComputerOp ,
BinaryFunctionOp or BinaryInplaceOp . |
interface |
BinaryHybridCFI1<I1,I2,O extends I1>
A hybrid binary operation which can be used as a
BinaryComputerOp ,
BinaryFunctionOp or BinaryInplace1Op . |
interface |
UnaryHybridCF<I,O>
A hybrid unary operation which can be used as a
UnaryComputerOp or
UnaryFunctionOp . |
interface |
UnaryHybridCFI<I,O extends I>
|
Modifier and Type | Class and Description |
---|---|
class |
AbstractBinaryHybridCF<I1,I2,O>
Abstract superclass for
BinaryHybridCF implementations. |
class |
AbstractBinaryHybridCFI<I,O extends I>
Abstract superclass for
BinaryHybridCFI implementations. |
class |
AbstractBinaryHybridCFI1<I1,I2,O extends I1>
Abstract superclass for
BinaryHybridCFI1 implementations. |
class |
AbstractUnaryHybridCF<I,O>
Abstract superclass for
UnaryHybridCF implementations. |
class |
AbstractUnaryHybridCFI<I,O extends I>
Abstract superclass for
UnaryHybridCFI implementations. |
Modifier and Type | Interface and Description |
---|---|
interface |
StatsOp<I,O>
marker interface for statistic ops.
|
Modifier and Type | Class and Description |
---|---|
class |
AbstractStatsOp<I,O extends RealType<O>>
Abstract Statistics Op.
|
class |
DefaultGeometricMean<I extends RealType<I>,O extends RealType<O>>
|
class |
DefaultHarmonicMean<I extends RealType<I>,O extends RealType<O>>
|
class |
DefaultKurtosis<I extends RealType<I>,O extends RealType<O>>
|
class |
DefaultMean<I extends RealType<I>,O extends RealType<O>>
|
class |
DefaultMedian<I extends RealType<I>,O extends RealType<O>>
Op to calculate the stats.median . |
class |
DefaultMinMax<I extends RealType<I>>
Op to calculate the stats.minMax . |
class |
DefaultMoment1AboutMean<I extends RealType<I>,O extends RealType<O>>
|
class |
DefaultMoment2AboutMean<I extends RealType<I>,O extends RealType<O>>
|
class |
DefaultMoment3AboutMean<I extends RealType<I>,O extends RealType<O>>
|
class |
DefaultMoment4AboutMean<I extends RealType<I>,O extends RealType<O>>
|
class |
DefaultPercentile<I extends RealType<I>,O extends RealType<O>>
Op to calculate the n-th stats.percentile . |
class |
DefaultQuantile<I extends RealType<I>,O extends RealType<O>>
Op to calculate the n-th stats.percentile . |
class |
DefaultSize<I extends RealType<I>,O extends RealType<O>>
Op to calculate the stats.size . |
class |
DefaultSkewness<I extends RealType<I>,O extends RealType<O>>
|
class |
DefaultStandardDeviation<I extends RealType<I>,O extends RealType<O>>
|
class |
DefaultSum<I extends RealType<I>,O extends RealType<O>>
Op to calculate the stats.sum . |
class |
DefaultSumOfInverses<I extends RealType<I>,O extends RealType<O>>
Op to calculate the stats.sumOfInverses . |
class |
DefaultSumOfLogs<I extends RealType<I>,O extends RealType<O>>
Op to calculate the stats.sumOfLogs . |
class |
DefaultSumOfSquares<I extends RealType<I>,O extends RealType<O>>
Op to calculate the stats.sumOfSquares . |
class |
DefaultVariance<I extends RealType<I>,O extends RealType<O>>
|
class |
IISize<I extends RealType<I>,O extends RealType<O>>
Op to calculate the stats.size directly. |
class |
IntegralSum<I extends RealType<I>>
|
class |
IterableGeometricMean<I extends RealType<I>,O extends RealType<O>>
Op to calculate the stats.geometricMean directly. |
class |
IterableHarmonicMean<I extends RealType<I>,O extends RealType<O>>
Op to calculate the stats.harmonicMean directly. |
class |
IterableMax<T extends RealType<T>>
Op to calculate the stats.max . |
class |
IterableMean<I extends RealType<I>,O extends RealType<O>>
Op to calculate the stats.mean directly. |
class |
IterableMin<T extends RealType<T>>
Op to calculate the stats.min . |
class |
IterableStandardDeviation<I extends RealType<I>,O extends RealType<O>>
Op to calculate the stats.stdDev directly. |
class |
IterableVariance<I extends RealType<I>,O extends RealType<O>>
Op to calculate the stats.variance using the online algorithm
from Knuth and Welford. |
Modifier and Type | Class and Description |
---|---|
class |
Quadric
An op that fits a quadratic surface (quadric) into a set of points.
|
Modifier and Type | Interface and Description |
---|---|
interface |
ComputeThreshold<I,O>
An algorithm for computing a threshold value that divides an object into two
classes.
|
interface |
ComputeThresholdHistogram<T extends RealType<T>>
Interface for threshold computation algorithms relying on a histogram.
|
Modifier and Type | Field and Description |
---|---|
protected UnaryFunctionOp<Iterable<T>,Histogram1d<T>> |
LocalThresholdMethodHistogram.histCreator |
protected UnaryFunctionOp<IterableInterval<T>,Histogram1d<T>> |
AbstractApplyThresholdImg.histCreator |
protected UnaryFunctionOp<IterableInterval<T>,Img<BitType>> |
AbstractApplyThresholdImg.imgCreator |
Modifier and Type | Class and Description |
---|---|
class |
ApplyManualThreshold<T extends RealType<T>>
Applies a threshold to an
Img . |
Modifier and Type | Class and Description |
---|---|
class |
ComputeHuangThreshold<T extends RealType<T>>
Implements Huang's threshold method by Huang & Wang.
|
Modifier and Type | Class and Description |
---|---|
class |
ComputeIJ1Threshold<T extends RealType<T>>
Implements the default threshold method from ImageJ 1.x.
|
Modifier and Type | Class and Description |
---|---|
class |
ComputeIntermodesThreshold<T extends RealType<T>>
Implements an intermodes threshold method by Prewitt & Mendelsohn.
|
Modifier and Type | Class and Description |
---|---|
class |
ComputeIsoDataThreshold<T extends RealType<T>>
Implements an IsoData (intermeans) threshold method by Ridler &
Calvard.
|
Modifier and Type | Class and Description |
---|---|
class |
ComputeLiThreshold<T extends RealType<T>>
Implements Li's threshold method by Li & Lee, and Li &
Tam, and Sezgin & Sankur.
|
Modifier and Type | Class and Description |
---|---|
class |
ComputeMaxEntropyThreshold<T extends RealType<T>>
Implements Kapur-Sahoo-Wong (Maximum Entropy) thresholding method.
|
Modifier and Type | Class and Description |
---|---|
class |
ComputeMaxLikelihoodThreshold<T extends RealType<T>>
Implements a maximum likelihood threshold method by Dempster, Laird,
& Rubin and Glasbey.
|
Modifier and Type | Class and Description |
---|---|
class |
ComputeMeanThreshold<T extends RealType<T>>
Implements a mean threshold method by Glasbey.
|
Modifier and Type | Class and Description |
---|---|
class |
ComputeMinErrorThreshold<T extends RealType<T>>
Implements a minimum error threshold method by Kittler & Illingworth and
Glasbey.
|
Modifier and Type | Class and Description |
---|---|
class |
ComputeMinimumThreshold<T extends RealType<T>>
Implements a minimum threshold method by Prewitt & Mendelsohn.
|
Modifier and Type | Class and Description |
---|---|
class |
ComputeMomentsThreshold<T extends RealType<T>>
Implements a moments based threshold method by Tsai.
|
Modifier and Type | Class and Description |
---|---|
class |
ComputeOtsuThreshold<T extends RealType<T>>
Implements Otsu's threshold method.
|
Modifier and Type | Class and Description |
---|---|
class |
ComputePercentileThreshold<T extends RealType<T>>
Implements a percentile threshold method by Doyle.
|
Modifier and Type | Class and Description |
---|---|
class |
ComputeRenyiEntropyThreshold<T extends RealType<T>>
Implements a Renyi entropy based threshold method by Kapur, Sahoo,
& Wong.
|
Modifier and Type | Class and Description |
---|---|
class |
ComputeRosinThreshold<T extends RealType<T>>
Implements Rosin's threshold method.
|
Modifier and Type | Class and Description |
---|---|
class |
ComputeShanbhagThreshold<T extends RealType<T>>
Implements Shanbhag's threshold method.
|
Modifier and Type | Class and Description |
---|---|
class |
ComputeTriangleThreshold<T extends RealType<T>>
Implements a Triangle algorithm threshold method from Zack, Rogers,
& Latt.
|
Modifier and Type | Class and Description |
---|---|
class |
ComputeYenThreshold<T extends RealType<T>>
Implements Yen's threshold method (Yen, Chang, & Chang, and Sezgin
& Sankur).
|
Modifier and Type | Class and Description |
---|---|
class |
BoxCount<B extends BooleanType<B>>
An N-dimensional version of fixed-grid box counting algorithm that can be
used to estimate the fractal dimension of an interval
|
Modifier and Type | Class and Description |
---|---|
class |
EulerCharacteristic26N<B extends BooleanType<B>>
An Op which calculates the euler characteristic (χ) of the given 3D binary image.
Here Euler characteristic is defined as χ = β_0 - β_1 + β_2, where β_i are so called Betti numbers β_0 = number of separate particles β_1 = number of handles β_2 = number enclosed cavities |
class |
EulerCharacteristic26NFloating<B extends BooleanType<B>>
An Op which calculates the euler characteristic (χ) of the given binary image.
|
class |
EulerCorrection<B extends BooleanType<B>>
An Op which calculates the correction needed to approximate the contribution of the image to the
Euler characteristic χ of the whole image.
|
Modifier and Type | Class and Description |
---|---|
class |
AddDimensionViewMinMax<T>
Wraps the
Views.addDimension(RandomAccessibleInterval, long, long)
method. |
class |
DefaultAddDimensionView<T>
Wraps the
Views.addDimension(RandomAccessible) method. |
Modifier and Type | Class and Description |
---|---|
class |
DefaultCollapseNumeric2CompositeIntervalView<T extends NumericType<T>>
Wraps the
Views.collapseNumeric(RandomAccessibleInterval) method. |
class |
DefaultCollapseNumeric2CompositeView<T extends NumericType<T>>
Wraps the
Views.collapseNumeric(RandomAccessible, int) method. |
Modifier and Type | Class and Description |
---|---|
class |
DefaultCollapseReal2CompositeIntervalView<T extends RealType<T>>
Wraps the
Views.collapseReal(RandomAccessibleInterval) method. |
class |
DefaultCollapseReal2CompositeView<T extends RealType<T>>
Wraps the
Views.collapseReal(RandomAccessible, int) method. |
Modifier and Type | Class and Description |
---|---|
class |
DefaultCollapse2CompositeIntervalView<T>
Wraps the
Views.collapse(RandomAccessibleInterval) method. |
class |
DefaultCollapse2CompositeView<T>
Wraps the
Views.collapse(RandomAccessible) method. |
Modifier and Type | Class and Description |
---|---|
class |
ConcatenateViewWithAccessMode<T>
Wraps the
Views#concatenate(int, StackAccessMode, List) method. |
class |
DefaultConcatenateView<T>
Wraps the
Views.concatenate(int, List) method. |
Modifier and Type | Class and Description |
---|---|
class |
CropImgPlus<T extends Type<T>> |
class |
CropRAI<T> |
Modifier and Type | Class and Description |
---|---|
class |
DefaultDropSingletonDimensionsView<T>
Wraps the
Views.dropSingletonDimensions(RandomAccessibleInterval)
method. |
Modifier and Type | Class and Description |
---|---|
class |
DefaultExtendBorderView<T,F extends RandomAccessibleInterval<T>>
Wraps the
Views.extendBorder(RandomAccessibleInterval) method. |
Modifier and Type | Class and Description |
---|---|
class |
DefaultExtendMirrorDoubleView<T,F extends RandomAccessibleInterval<T>>
Wraps the
Views.extendMirrorDouble(RandomAccessibleInterval) method. |
Modifier and Type | Class and Description |
---|---|
class |
DefaultExtendMirrorSingleView<T,F extends RandomAccessibleInterval<T>>
Wraps the
Views.extendMirrorSingle(RandomAccessibleInterval) method. |
Modifier and Type | Class and Description |
---|---|
class |
DefaultExtendPeriodicView<T,F extends RandomAccessibleInterval<T>>
Wraps the
Views.extendPeriodic(RandomAccessibleInterval) method. |
Modifier and Type | Class and Description |
---|---|
class |
DefaultExtendRandomView<T extends RealType<T>,F extends RandomAccessibleInterval<T>>
Wraps the
Views.extendRandom(RandomAccessibleInterval, double, double) method. |
Modifier and Type | Class and Description |
---|---|
class |
DefaultExtendValueView<T extends Type<T>,F extends RandomAccessibleInterval<T>>
Wraps the
Views.extendValue(RandomAccessibleInterval, Type) method. |
Modifier and Type | Class and Description |
---|---|
class |
DefaultExtendView<T,F extends RandomAccessibleInterval<T>>
Wraps the
Views.extend(RandomAccessibleInterval, OutOfBoundsFactory)
method. |
Modifier and Type | Class and Description |
---|---|
class |
DefaultExtendZeroView<T extends NumericType<T>,F extends RandomAccessibleInterval<T>>
Wraps the
Views.extendZero(RandomAccessibleInterval) method. |
Modifier and Type | Class and Description |
---|---|
class |
DefaultFlatIterableView<T>
Wraps the
Views.flatIterable(RandomAccessibleInterval) method. |
Modifier and Type | Class and Description |
---|---|
class |
DefaultHyperSliceView<T>
Wraps the
Views.hyperSlice(RandomAccessible, int, long) method. |
class |
IntervalHyperSliceView<T>
Wraps the
Views.hyperSlice(RandomAccessibleInterval, int, long)
method. |
Modifier and Type | Class and Description |
---|---|
class |
DefaultInterpolateView<I extends EuclideanSpace,T>
Wraps the
Views.interpolate(EuclideanSpace, InterpolatorFactory)
method. |
Modifier and Type | Class and Description |
---|---|
class |
DefaultIntervalView<T>
Wraps the
Views.interval(RandomAccessible, Interval) method. |
class |
IntervalViewMinMax<T>
Wraps the
Views.interval(RandomAccessible, long[], long[]) method. |
Modifier and Type | Class and Description |
---|---|
class |
DefaultInvertAxisView<T>
Wraps the
Views.invertAxis(RandomAccessible, int) method. |
class |
IntervalInvertAxisView<T>
Wraps the
Views.invertAxis(RandomAccessible, int) method while
preserving interval bounds. |
Modifier and Type | Class and Description |
---|---|
class |
DefaultOffsetView<T>
Wraps the
Views.offset(RandomAccessible, long[]) method. |
class |
OffsetViewInterval<T>
Wraps the
Views.offsetInterval(RandomAccessible, Interval) method. |
class |
OffsetViewOriginSize<T>
Wraps the
Views.offsetInterval(RandomAccessible, long[], long[])
method. |
Modifier and Type | Class and Description |
---|---|
class |
DefaultPermuteCoordinatesInverseView<T>
Wraps the
Views.permuteCoordinatesInverse(RandomAccessibleInterval, int[])
method. |
class |
PermuteCoordinateInverseViewOfDimension<T>
Wraps the
Views.permuteCoordinateInverse(RandomAccessibleInterval, int[], int)
method. |
Modifier and Type | Class and Description |
---|---|
class |
DefaultPermuteCoordinatesView<T>
Wraps the
Views.permuteCoordinates(RandomAccessibleInterval, int[])
method. |
class |
PermuteCoordinatesViewOfDimension<T>
Wraps the
Views.permuteCoordinates(RandomAccessibleInterval, int[], int)
method. |
Modifier and Type | Class and Description |
---|---|
class |
DefaultPermuteView<T>
Wraps the
Views.permute(RandomAccessible, int, int) method. |
class |
IntervalPermuteView<T>
Wraps the
Views.permute(RandomAccessible, int, int) method while
preserving interval bounds. |
Modifier and Type | Class and Description |
---|---|
class |
DefaultRasterView<T>
Wraps the
Views.raster(RealRandomAccessible) method. |
Modifier and Type | Class and Description |
---|---|
class |
DefaultRotateView<T>
Wraps the
Views.rotate(RandomAccessible, int, int) method. |
class |
IntervalRotateView<T>
Wraps the
Views.rotate(RandomAccessibleInterval, int, int) method. |
Modifier and Type | Class and Description |
---|---|
class |
DefaultScaleView<T>
Scales a
RandomAccessibleInterval in each dimension with the provided
scale factors. |
Modifier and Type | Class and Description |
---|---|
class |
DefaultShearView<T>
Wraps the
Views.shear(RandomAccessible, int, int) method. |
class |
ShearViewInterval<T>
Wraps the
Views.shear(RandomAccessible, Interval, int, int) method. |
Modifier and Type | Class and Description |
---|---|
class |
DefaultStackView<T>
Wraps the
Views.stack(List) method. |
class |
StackViewWithAccessMode<T>
Wraps the
Views#stack(StackAccessMode, List) method. |
Modifier and Type | Class and Description |
---|---|
class |
DefaultSubsampleView<T>
Wraps the
Views.subsample(RandomAccessible, long) method. |
class |
IntervalSubsampleView<T>
Wraps the
Views.subsample(RandomAccessible, long) method while
preserving interval bounds. |
class |
SubsampleIntervalViewStepsForDims<T>
Wraps the
Views.subsample(RandomAccessible, long[]) method while
preserving interval bounds. |
class |
SubsampleViewStepsForDims<T>
Wraps the
Views.subsample(RandomAccessible, long[]) method. |
Modifier and Type | Class and Description |
---|---|
class |
DefaultTranslateView<T>
Wraps the
Views.translate(RandomAccessible, long[]) method. |
class |
IntervalTranslateView<T>
Wraps the
Views.translate(RandomAccessible, long[]) method while
preserving interval bounds. |
Modifier and Type | Class and Description |
---|---|
class |
DefaultUnshearView<T>
Wraps the
Views.unshear(RandomAccessible, int, int) method. |
class |
UnshearViewInterval<T>
Wraps the
Views.unshear(RandomAccessible, Interval, int, int) method. |
Modifier and Type | Class and Description |
---|---|
class |
DefaultZeroMinView<T>
Wraps the
Views.zeroMin(RandomAccessibleInterval) method. |
Copyright © 2014–2022 ImageJ. All rights reserved.