Modifier and Type | Method and Description |
---|---|
default <AI,AO extends AI,B> |
OpEnvironment.join(B out,
AO in,
UnaryInplaceOp<AI,AO> first,
UnaryComputerOp<AO,B> second)
Executes the "join" operation on the given arguments.
|
default <A,BI,BO extends BI> |
OpEnvironment.join(BO out,
A in,
UnaryComputerOp<A,BO> first,
UnaryInplaceOp<BI,BO> second)
Executes the "join" operation on the given arguments.
|
default <A,B,C> C |
OpEnvironment.join(C out,
A in,
UnaryComputerOp<A,B> first,
UnaryComputerOp<B,C> second,
UnaryOutputFactory<A,B> outputFactory)
Executes the "join" operation on the given arguments.
|
default <A,B,C> C |
OpEnvironment.join(C out,
A in,
UnaryComputerOp<A,B> first,
UnaryComputerOp<B,C> second,
UnaryOutputFactory<A,B> outputFactory)
Executes the "join" operation on the given arguments.
|
default <A> A |
OpEnvironment.loop(A out,
A in,
UnaryComputerOp<A,A> op,
UnaryOutputFactory<A,A> outputFactory,
int n)
Executes the "loop" operation on the given arguments.
|
default <EI,EO> Iterable<EO> |
OpEnvironment.map(Iterable<EO> out,
Iterable<EI> in,
UnaryComputerOp<EI,EO> op)
Executes the "map" operation on the given arguments.
|
default <EI,EO extends Type<EO>> |
OpEnvironment.map(IterableInterval<EI> input,
UnaryComputerOp<EI,EO> op,
EO type)
Executes the "map" operation on the given arguments.
|
default <EI,EO> IterableInterval<EO> |
OpEnvironment.map(IterableInterval<EO> out,
IterableInterval<EI> in,
UnaryComputerOp<EI,EO> op)
Executes the "map" operation on the given arguments.
|
default <EI,EO> IterableInterval<EO> |
OpEnvironment.map(IterableInterval<EO> out,
RandomAccessibleInterval<EI> in,
Shape shape,
UnaryComputerOp<Iterable<EI>,EO> op)
Executes the "map" operation on the given arguments.
|
default <EI,EO> IterableInterval<EO> |
OpEnvironment.map(IterableInterval<EO> out,
RandomAccessibleInterval<EI> in,
UnaryComputerOp<EI,EO> op)
Executes the "map" operation on the given arguments.
|
default <EI,EO extends Type<EO>> |
OpEnvironment.map(RandomAccessible<EI> input,
UnaryComputerOp<EI,EO> op,
EO type)
Executes the "map" operation on the given arguments.
|
default <EI,EO extends Type<EO>> |
OpEnvironment.map(RandomAccessibleInterval<EI> input,
UnaryComputerOp<EI,EO> op,
EO type)
Executes the "map" operation on the given arguments.
|
default <EI,EO> RandomAccessibleInterval<EO> |
OpEnvironment.map(RandomAccessibleInterval<EO> out,
IterableInterval<EI> in,
UnaryComputerOp<EI,EO> op)
Executes the "map" operation on the given arguments.
|
default <I,O> RandomAccessibleInterval<O> |
OpEnvironment.slice(RandomAccessibleInterval<O> out,
RandomAccessibleInterval<I> in,
UnaryComputerOp<RandomAccessibleInterval<I>,RandomAccessibleInterval<O>> op,
int... axisIndices)
Executes the "slicewise" operation on the given arguments.
|
default <I,O> RandomAccessibleInterval<O> |
OpEnvironment.slice(RandomAccessibleInterval<O> out,
RandomAccessibleInterval<I> in,
UnaryComputerOp<RandomAccessibleInterval<I>,RandomAccessibleInterval<O>> op,
int[] axisIndices,
boolean dropSingleDimensions)
Executes the "slicewise" operation on the given arguments.
|
Modifier and Type | Method and Description |
---|---|
default <A> A |
OpEnvironment.join(A out,
A in,
List<? extends UnaryComputerOp<A,A>> ops,
UnaryOutputFactory<A,A> outputFactory)
Executes the "join" operation on the given arguments.
|
Modifier and Type | Class and Description |
---|---|
class |
DefaultPValue<T extends RealType<T>,U extends RealType<U>>
This algorithm repeatedly executes a colocalization algorithm, computing a
p-value.
|
Modifier and Type | Interface and Description |
---|---|
interface |
ProjectMethod<T extends RealType<T>>
Interface marking functions that can be used within the
ProjectCommand . |
Modifier and Type | Class and Description |
---|---|
class |
ClipRealTypes<I extends RealType<I>,O extends RealType<O>>
Copies the value of one
RealType to another, and clips values which
are outside of the output types range. |
Modifier and Type | Class and Description |
---|---|
class |
CopyRealTypes<I extends RealType<I>,O extends RealType<O>>
Copies the value of one
RealType into another using double
precision. |
Modifier and Type | Class and Description |
---|---|
class |
ConvertIIs<I extends RealType<I>,O extends RealType<O>> |
Modifier and Type | Class and Description |
---|---|
class |
NormalizeScaleRealTypes<I extends RealType<I>,O extends RealType<O>>
Scales input values to their corresponding value in the output type range
based on the min/max values of an
IterableInterval not the range of
the input type. |
Modifier and Type | Class and Description |
---|---|
class |
ScaleRealTypes<I extends RealType<I>,O extends RealType<O>>
Scales input values to their corresponding value in the output type range.
|
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 |
PadAndRichardsonLucy<I extends RealType<I> & NativeType<I>,O extends RealType<O> & NativeType<O>,K extends RealType<K> & NativeType<K>,C extends ComplexType<C> & NativeType<C>>
Richardson Lucy function op that operates on (@link RandomAccessibleInterval)
(Lucy, L.
|
class |
PadAndRichardsonLucyTV<I extends RealType<I> & NativeType<I>,O extends RealType<O> & NativeType<O>,K extends RealType<K> & NativeType<K>,C extends ComplexType<C> & NativeType<C>>
Richardson Lucy with total variation function op that operates on (@link
RandomAccessibleInterval) (Richardson-Lucy algorithm with total variation
regularization for 3D confocal microscope deconvolution Microsc Res Rech 2006
Apr; 69(4)- 260-6)
|
class |
RichardsonLucyC<I extends RealType<I>,O extends RealType<O>,K extends RealType<K>,C extends ComplexType<C>>
Richardson Lucy algorithm for (@link RandomAccessibleInterval) (Lucy, L.
|
class |
RichardsonLucyCorrection<I extends RealType<I>,O extends RealType<O>,C extends ComplexType<C>>
Computes Richardson Lucy correction factor for (@link
RandomAccessibleInterval) (Lucy, L.
|
class |
RichardsonLucyTVUpdate<T extends RealType<T> & NativeType<T>,I extends RandomAccessibleInterval<T>>
Implements update step for Richardson-Lucy algorithm with total variation
regularization for 3D confocal microscope deconvolution Microsc Res Rech 2006
Apr; 69(4)- 260-6 The div_unit_grad function has been adapted from IOCBIOS,
Pearu Peterson https://code.google.com/p/iocbio/
|
class |
RichardsonLucyUpdate<T extends RealType<T>>
Implements update step for Richardson-Lucy algorithm on
RandomAccessibleInterval . |
Modifier and Type | Method and Description |
---|---|
protected UnaryComputerOp<RandomAccessibleInterval<O>,RandomAccessibleInterval<O>> |
PadAndRichardsonLucyTV.getComputeEstimateOp() |
protected UnaryComputerOp<RandomAccessibleInterval<O>,RandomAccessibleInterval<O>> |
PadAndRichardsonLucy.getComputeEstimateOp()
set up and return the compute estimate op.
|
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 |
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 |
AbstractCenterAwareNeighborhoodBasedFilter<I,O> |
class |
AbstractFFTFilterC<I extends RealType<I>,O extends RealType<O>,K extends RealType<K>,C extends ComplexType<C>>
Abstract class for FFT based filter computers
|
class |
AbstractIterativeFFTFilterC<I extends RealType<I>,O extends RealType<O>,K extends RealType<K>,C extends ComplexType<C>>
Abstract class for iterative FFT filters that perform on RAI.
|
class |
AbstractNeighborhoodBasedFilter<I,O> |
class |
AbstractPadAndFFTFilter<I extends RealType<I>,O extends RealType<O> & NativeType<O>,K extends RealType<K>,C extends ComplexType<C> & NativeType<C>>
Abstract class for binary filter that performs operations using an image and
kernel in the frequency domain using the imglib2 FFTMethods library.
|
class |
FFTMethodsLinearFFTFilterC<I extends RealType<I>,O extends RealType<O>,K extends RealType<K>,C extends ComplexType<C>>
Convolve op for (@link RandomAccessibleInterval)
|
Modifier and Type | Method and Description |
---|---|
protected abstract UnaryComputerOp<Iterable<I>,O> |
AbstractNeighborhoodBasedFilter.unaryComputer(O outType) |
Modifier and Type | Class and Description |
---|---|
class |
AddNoiseRealType<I extends RealType<I>,O extends RealType<O>>
Sets the real component of an output real number to the addition of the real
component of an input real number with an amount of Gaussian noise.
|
class |
AddNoiseRealTypeCFI<T extends RealType<T>>
Adds Gaussian noise to a real number.
|
Modifier and Type | Class and Description |
---|---|
class |
AddPoissonNoiseMap<T extends ComplexType<T>> |
class |
AddPoissonNoiseRealType<I extends RealType<I>,O extends RealType<O>>
Sets the real component of an output real number to a real number sampled
from a Poisson distribution with lambda of the input real number.
|
Modifier and Type | Class and Description |
---|---|
class |
DefaultBilateral<I extends RealType<I>,O extends RealType<O>>
Performs a bilateral filter on an image.
|
Modifier and Type | Class and Description |
---|---|
class |
ConvolveFFTC<I extends RealType<I>,O extends RealType<O>,K extends RealType<K>,C extends ComplexType<C>>
Convolve op for (@link RandomAccessibleInterval)
|
class |
ConvolveNaiveC<I extends RealType<I>,K extends RealType<K>,O extends RealType<O>>
Convolves an image naively.
|
class |
PadAndConvolveFFT<I extends RealType<I> & NativeType<I>,O extends RealType<O> & NativeType<O>,K extends RealType<K> & NativeType<K>,C extends ComplexType<C> & NativeType<C>>
Convolve op for (@link Img)
|
Modifier and Type | Class and Description |
---|---|
class |
CorrelateFFTC<I extends RealType<I>,O extends RealType<O>,K extends RealType<K>,C extends ComplexType<C>>
Correlate op for (@link RandomAccessibleInterval)
|
class |
PadAndCorrelateFFT<I extends RealType<I> & NativeType<I>,O extends RealType<O> & NativeType<O>,K extends RealType<K> & NativeType<K>,C extends ComplexType<C> & NativeType<C>>
Correlate op for (@link Img)
|
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.
|
Modifier and Type | Class and Description |
---|---|
class |
DefaultDerivativeGauss<T extends RealType<T>>
Performs the 2-D partial derivative Gaussian kernel convolutions on an image,
at a particular point.
|
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 |
FFTMethodsOpC<T extends RealType<T>,C extends ComplexType<C>>
Forward FFT computer that operates on an RAI and wraps FFTMethods.
|
Modifier and Type | Class and Description |
---|---|
class |
DefaultGaussRA<T extends NumericType<T> & NativeType<T>>
Gaussian filter, wrapping
Gauss3 of imglib2-algorithms. |
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 |
IFFTMethodsOpC<C extends ComplexType<C>,T extends RealType<T>>
Inverse FFT computer that operates on an RAI and wraps FFTMethods.
|
Modifier and Type | Interface and Description |
---|---|
interface |
MaxFilterOp<I,O>
A typed "max" filter.
|
Modifier and Type | Class and Description |
---|---|
class |
DefaultMaxFilter<T,V>
Default implementation of
MaxFilterOp . |
Modifier and Type | Method and Description |
---|---|
protected UnaryComputerOp<Iterable<T>,V> |
DefaultMaxFilter.unaryComputer(V out) |
Modifier and Type | Interface and Description |
---|---|
interface |
MeanFilterOp<I,O>
A typed "mean" filter.
|
Modifier and Type | Class and Description |
---|---|
class |
DefaultMeanFilter<T,V>
Default implementation of
MeanFilterOp . |
Modifier and Type | Method and Description |
---|---|
protected UnaryComputerOp<Iterable<T>,V> |
DefaultMeanFilter.unaryComputer(V type) |
Modifier and Type | Interface and Description |
---|---|
interface |
MedianFilterOp<I,O>
A typed "median" filter.
|
Modifier and Type | Class and Description |
---|---|
class |
DefaultMedianFilter<T,V>
Default implementation of
MedianFilterOp . |
Modifier and Type | Method and Description |
---|---|
protected UnaryComputerOp<Iterable<T>,V> |
DefaultMedianFilter.unaryComputer(V type) |
Modifier and Type | Interface and Description |
---|---|
interface |
MinFilterOp<T,V>
A typed "min" filter.
|
Modifier and Type | Class and Description |
---|---|
class |
DefaultMinFilter<T,V>
Default implementation of
MinFilterOp . |
Modifier and Type | Method and Description |
---|---|
protected UnaryComputerOp<Iterable<T>,V> |
DefaultMinFilter.unaryComputer(V outClass) |
Modifier and Type | Interface and Description |
---|---|
interface |
SigmaFilterOp<T,V>
A typed "sigma" filter.
|
Modifier and Type | Class and Description |
---|---|
class |
DefaultSigmaFilter<T extends RealType<T>,V extends RealType<V>>
Default implementation of
SigmaFilterOp . |
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 |
VarianceFilterOp<I,O>
A typed "variance" filter.
|
Modifier and Type | Class and Description |
---|---|
class |
DefaultVarianceFilter<T,V>
Default implementation of
VarianceFilterOp . |
Modifier and Type | Method and Description |
---|---|
protected UnaryComputerOp<Iterable<T>,V> |
DefaultVarianceFilter.unaryComputer(V type) |
Modifier and Type | Class and Description |
---|---|
class |
DefaultFrangi<T extends RealType<T>,U extends RealType<U>>
Input is a 2- or 3-dimensional grayscales image.
|
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 . |
Modifier and Type | Class and Description |
---|---|
class |
DefaultBoundarySizeConvexHullPolygon |
class |
DefaultBoxivityPolygon |
class |
DefaultCircularity
Generic implementation of
geom.circularity . |
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 |
DefaultMaximumFeretAngle |
class |
DefaultMaximumFeretDiameter |
class |
DefaultMinimumFeretAngle |
class |
DefaultMinimumFeretDiameter |
class |
DefaultMinorAxis
Generic implementation of
geom.minorAxis . |
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 |
DefaultSolidityPolygon |
class |
DefaultVerticesCountConvexHullPolygon |
class |
DefaultVerticesCountPolygon |
Modifier and Type | Class and Description |
---|---|
class |
DefaultBoxivityMesh |
class |
DefaultCompactness
Generic implementation of
Ops.Geometric.Compactness . |
class |
DefaultConvexityMesh |
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 |
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 |
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 | Interface and Description |
---|---|
interface |
CoordinatesEquationOp<T,N extends Number>
An operation which computes image values based on coordinates.
|
interface |
DoubleBinaryEquationOp<T>
An equation operation which computes image values from real coordinates using
a binary lambda.
|
interface |
EquationOp<T>
An "equation" operation which computes image
values from interval coordinates using an equation.
|
Modifier and Type | Class and Description |
---|---|
class |
DefaultCoordinatesEquation<T extends RealType<T>,N extends Number>
An equation operation which computes image values from coordinates using
another op.
|
class |
DefaultEquation<T extends RealType<T>>
Computes an image using an equation.
|
class |
DefaultXYEquation<T extends RealType<T>>
An equation operation which computes image values from x and y coordinates
using a binary lambda.
|
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 . |
Modifier and Type | Class and Description |
---|---|
class |
InvertII<T extends RealType<T>> |
class |
InvertIIInteger<T extends IntegerType<T>> |
Modifier and Type | Class and Description |
---|---|
class |
NormalizeIIComputer<T extends RealType<T>>
Normalizes an
IterableInterval given its minimum and maximum to
another range defined by minimum and maximum. |
Modifier and Type | Method and Description |
---|---|
UnaryComputerOp<IterableInterval<T>,IterableInterval<T>> |
NormalizeIIFunction.createWorker(IterableInterval<T> t) |
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 | Interface and Description |
---|---|
interface |
Join2Computers<A,B,C>
A join operation which joins two
UnaryComputerOp s. |
interface |
JoinComputerAndInplace<A,BI,BO extends BI>
Joins an
UnaryInplaceOp with a UnaryComputerOp . |
interface |
JoinInplaceAndComputer<AI,AO extends AI,B>
Joins an
UnaryInplaceOp with a UnaryComputerOp . |
interface |
JoinNComputers<A>
A join operation which joins a list of
UnaryComputerOp s. |
Modifier and Type | Class and Description |
---|---|
class |
DefaultJoin2Computers<A,B,C>
Joins two
UnaryComputerOp s. |
class |
DefaultJoinComputerAndInplace<A,B>
Joins a
UnaryComputerOp with an UnaryInplaceOp . |
class |
DefaultJoinInplaceAndComputer<A,B>
Joins an
UnaryInplaceOp with a UnaryComputerOp . |
class |
DefaultJoinNComputers<A>
Joins a list of
UnaryComputerOp s. |
Modifier and Type | Method and Description |
---|---|
UnaryComputerOp<A,B> |
DefaultJoinComputerAndInplace.getFirst() |
UnaryComputerOp<A,B> |
DefaultJoin2Computers.getFirst() |
UnaryComputerOp<A,B> |
DefaultJoinInplaceAndComputer.getSecond() |
UnaryComputerOp<B,C> |
DefaultJoin2Computers.getSecond() |
Modifier and Type | Method and Description |
---|---|
List<? extends UnaryComputerOp<A,A>> |
DefaultJoinNComputers.getOps() |
Modifier and Type | Method and Description |
---|---|
void |
DefaultJoinComputerAndInplace.setFirst(UnaryComputerOp<A,B> first) |
void |
DefaultJoin2Computers.setFirst(UnaryComputerOp<A,B> first) |
void |
DefaultJoinInplaceAndComputer.setSecond(UnaryComputerOp<A,B> second) |
void |
DefaultJoin2Computers.setSecond(UnaryComputerOp<B,C> second) |
Modifier and Type | Method and Description |
---|---|
void |
DefaultJoinNComputers.setOps(List<? extends UnaryComputerOp<A,A>> ops) |
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.ComparableGreaterThan<I extends Comparable<I>,O extends BooleanType<O>>
Performs greater-than (>) between two
Comparable s. |
static class |
BooleanTypeLogic.ComparableGreaterThanOrEqual<I extends Comparable<I>,O extends BooleanType<O>>
Performs greater-than-or-equal (>=) between two
Comparable s. |
static class |
BooleanTypeLogic.ComparableLessThan<I extends Comparable<I>,O extends BooleanType<O>>
Performs less-than (<) between two
Comparable s. |
static class |
BooleanTypeLogic.ComparableLessThanOrEqual<I extends Comparable<I>,O extends BooleanType<O>>
Performs less-than-or-equal (<=) between two
Comparable s. |
static class |
BooleanTypeLogic.Not<T extends BooleanType<T>>
Performs logical not (!) on a
BooleanType . |
static class |
BooleanTypeLogic.ObjectsEqual<O extends BooleanType<O>>
Performs equals (==) between two
Object s. |
static class |
BooleanTypeLogic.ObjectsNotEqual<O extends BooleanType<O>>
Performs not-equals (!=) between two
Object s. |
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 |
Default<I extends BooleanType<I>,O extends Type<O>>
An Op that sets the output to the
defaultVal iff the input is
evaluated as false. |
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 | Interface and Description |
---|---|
interface |
LoopComputer<I>
Loops over an injected
UnaryComputerOp . |
Modifier and Type | Class and Description |
---|---|
class |
DefaultLoopComputer<I>
Applies a
UnaryComputerOp multiple times to an image. |
Modifier and Type | Method and Description |
---|---|
UnaryComputerOp<I,I> |
DefaultLoopComputer.getOp() |
Modifier and Type | Method and Description |
---|---|
void |
DefaultLoopComputer.setOp(UnaryComputerOp<I,I> op) |
Modifier and Type | Interface and Description |
---|---|
interface |
MapUnaryComputer<EI,EO,OP extends UnaryComputerOp<EI,EO>>
Typed interface for "map"
UnaryComputerOp s. |
Modifier and Type | Method and Description |
---|---|
UnaryComputerOp<EI,EO> |
AbstractMapView.getOp() |
UnaryComputerOp<EI,EO> |
AbstractMapComputer.getOp() |
Modifier and Type | Method and Description |
---|---|
static <I,O> void |
Maps.map(IterableInterval<I> a,
IterableInterval<O> b,
UnaryComputerOp<I,O> op) |
static <I,O> void |
Maps.map(IterableInterval<I> a,
IterableInterval<O> b,
UnaryComputerOp<I,O> op,
long startIndex,
long stepSize,
long numSteps) |
static <I,O> void |
Maps.map(IterableInterval<I> a,
RandomAccessibleInterval<O> b,
UnaryComputerOp<I,O> op) |
static <I,O> void |
Maps.map(IterableInterval<I> a,
RandomAccessibleInterval<O> b,
UnaryComputerOp<I,O> op,
long startIndex,
long stepSize,
long numSteps) |
static <I,O> void |
Maps.map(RandomAccessibleInterval<I> a,
IterableInterval<O> b,
UnaryComputerOp<I,O> op) |
static <I,O> void |
Maps.map(RandomAccessibleInterval<I> a,
IterableInterval<O> b,
UnaryComputerOp<I,O> op,
long startIndex,
long stepSize,
long numSteps) |
void |
AbstractMapView.setOp(UnaryComputerOp<EI,EO> op) |
void |
AbstractMapComputer.setOp(UnaryComputerOp<EI,EO> op) |
Modifier and Type | Interface and Description |
---|---|
interface |
CenterAwareComputerOp<I,O>
A center aware computer calculates a result from a given input and
its surrounding neighborhood, storing it into the specified output reference.
|
interface |
CenterAwareIntegralComputerOp<I,O>
A center-aware computer calculates a result from a given input and
the surrounding rectangular neighborhood in (multiple) integral images.
|
interface |
MapNeighborhood<EI,EO,PI,PO,OP extends Op>
Typed interface for "map" ops that work with neighborhoods.
|
Modifier and Type | Class and Description |
---|---|
class |
AbstractCenterAwareComputerOp<I,O>
Abstract superclass for
CenterAwareComputerOp implementations. |
class |
AbstractMapNeighborhood<EI,EO,PI,PO,OP extends Op>
Abstract base class for
MapNeighborhood implementations. |
class |
DefaultMapNeighborhood<I,O>
|
class |
MapNeighborhoodWithCenter<I,O>
Evaluates a
CenterAwareComputerOp for each Neighborhood on
the input RandomAccessibleInterval and sets the value of the
corresponding pixel on the output IterableInterval . |
Modifier and Type | Class and Description |
---|---|
static class |
BinaryRealTypeMath.Add<I1 extends RealType<I1>,I2 extends RealType<I2>,O extends RealType<O>>
Sets the real component of an output real number to the addition of the
real components of two input real numbers.
|
static class |
BinaryRealTypeMath.And<I1 extends RealType<I1>,I2 extends RealType<I2>,O extends RealType<O>>
Sets the real component of an output real number to the logical AND of the
real component of two input real numbers.
|
static class |
BinaryRealTypeMath.Divide<I1 extends RealType<I1>,I2 extends RealType<I2>,O extends RealType<O>>
Sets the real component of an output real number to the division of the
real component of two input real numbers.
|
static class |
BinaryRealTypeMath.Multiply<I1 extends RealType<I1>,I2 extends RealType<I2>,O extends RealType<O>>
Sets the real component of an output real number to the multiplication of
the real component of two input real numbers.
|
static class |
BinaryRealTypeMath.Or<I1 extends RealType<I1>,I2 extends RealType<I2>,O extends RealType<O>>
Sets the real component of an output real number to the logical OR of the
real component of two input real numbers.
|
static class |
BinaryRealTypeMath.Subtract<I1 extends RealType<I1>,I2 extends RealType<I2>,O extends RealType<O>>
Sets the real component of an output real number to the subtraction between
the real component of two input real numbers.
|
static class |
BinaryRealTypeMath.Xor<I1 extends RealType<I1>,I2 extends RealType<I2>,O extends RealType<O>>
Sets the real component of an output real number to the logical XOR of the
real component of two input real numbers.
|
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 |
ConstantToIIOutputRAI.Add<T extends NumericType<T>> |
static class |
ConstantToIIOutputRAI.Divide<T extends NumericType<T>> |
static class |
ConstantToIIOutputRAI.Multiply<T extends NumericType<T>> |
static class |
ConstantToIIOutputRAI.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.
|
static class |
UnaryRealTypeMath.Abs<I extends RealType<I>,O extends RealType<O>>
Sets the real component of an output real number to the absolute value of
the real component of an input real number.
|
static class |
UnaryRealTypeMath.Arccos<I extends RealType<I>,O extends RealType<O>>
Sets the real component of an output real number to the inverse cosine of
the real component of an input real number.
|
static class |
UnaryRealTypeMath.Arccosh<I extends RealType<I>,O extends RealType<O>>
Sets the real component of an output real number to the inverse hyperbolic
cosine of the real component of an input real number.
|
static class |
UnaryRealTypeMath.Arccot<I extends RealType<I>,O extends RealType<O>>
Sets the real component of an output real number to the inverse cotangent
of the real component of an input real number.
|
static class |
UnaryRealTypeMath.Arccoth<I extends RealType<I>,O extends RealType<O>>
Sets the real component of an output real number to the inverse hyperbolic
cotangent of the real component of an input real number.
|
static class |
UnaryRealTypeMath.Arccsc<I extends RealType<I>,O extends RealType<O>>
Sets the real component of an output real number to the inverse cosecant of
the real component of an input real number.
|
static class |
UnaryRealTypeMath.Arccsch<I extends RealType<I>,O extends RealType<O>>
Sets the real component of an output real number to the inverse hyperbolic
cosecant of the real component of an input real number.
|
static class |
UnaryRealTypeMath.Arcsec<I extends RealType<I>,O extends RealType<O>>
Sets the real component of an output real number to the inverse secant of
the real component of an input real number.
|
static class |
UnaryRealTypeMath.Arcsech<I extends RealType<I>,O extends RealType<O>>
Sets the real component of an output real number to the inverse hyperbolic
secant of the real component of an input real number.
|
static class |
UnaryRealTypeMath.Arcsin<I extends RealType<I>,O extends RealType<O>>
Sets the real component of an output real number to the inverse sine of the
real component of an input real number.
|
static class |
UnaryRealTypeMath.Arcsinh<I extends RealType<I>,O extends RealType<O>>
Sets the real component of an output real number to the inverse hyperbolic
sine of the real component of an input real number.
|
static class |
UnaryRealTypeMath.Arctan<I extends RealType<I>,O extends RealType<O>>
Sets the real component of an output real number to the inverse tangent of
the real component of an input real number.
|
static class |
UnaryRealTypeMath.Arctanh<I extends RealType<I>,O extends RealType<O>>
Sets the real component of an output real number to the inverse hyperbolic
tangent of the real component of an input real number.
|
static class |
UnaryRealTypeMath.Ceil<I extends RealType<I>,O extends RealType<O>>
Sets the real component of an output real number to the ceiling of the real
component of an input real number.
|
static class |
UnaryRealTypeMath.Cos<I extends RealType<I>,O extends RealType<O>>
Sets the real component of an output real number to the cosine of the real
component of an input real number.
|
static class |
UnaryRealTypeMath.Cosh<I extends RealType<I>,O extends RealType<O>>
Sets the real component of an output real number to the hyperbolic cosine
of the real component of an input real number.
|
static class |
UnaryRealTypeMath.Cot<I extends RealType<I>,O extends RealType<O>>
Sets the real component of an output real number to the cotangent of the
real component of an input real number.
|
static class |
UnaryRealTypeMath.Coth<I extends RealType<I>,O extends RealType<O>>
Sets the real component of an output real number to the hyperbolic
cotangent of the real component of an input real number.
|
static class |
UnaryRealTypeMath.Csc<I extends RealType<I>,O extends RealType<O>>
Sets the real component of an output real number to the cosecant of the
real component of an input real number.
|
static class |
UnaryRealTypeMath.Csch<I extends RealType<I>,O extends RealType<O>>
Sets the real component of an output real number to the hyperbolic cosecant
of the real component of an input real number.
|
static class |
UnaryRealTypeMath.CubeRoot<I extends RealType<I>,O extends RealType<O>>
Sets the real component of an output real number to the cube root of the
real component of an input real number.
|
static class |
UnaryRealTypeMath.Exp<I extends RealType<I>,O extends RealType<O>>
Sets the real component of an output real number to the exponentiation of
the real component of an input real number.
|
static class |
UnaryRealTypeMath.ExpMinusOne<I extends RealType<I>,O extends RealType<O>>
Sets the real component of an output real number to e^x - 1.
|
static class |
UnaryRealTypeMath.Floor<I extends RealType<I>,O extends RealType<O>>
Sets the real component of an output real number to the floor of the real
component of an input real number.
|
static class |
UnaryRealTypeMath.GammaConstant<I extends RealType<I>,O extends RealType<O>>
Sets the real component of an output real number to the gamma value of the
real component of an input real number.
|
static class |
UnaryRealTypeMath.Invert<I extends RealType<I>,O extends RealType<O>>
Sets the real component of an output real number to the inversion of the
real component of an input real number about a range.
|
static class |
UnaryRealTypeMath.Log<I extends RealType<I>,O extends RealType<O>>
Sets the real component of an output real number to the natural log of the
real component of an input real number.
|
static class |
UnaryRealTypeMath.Log10<I extends RealType<I>,O extends RealType<O>>
Sets the real component of an output real number to the 10-based log of the
real component of an input real number.
|
static class |
UnaryRealTypeMath.Log2<I extends RealType<I>,O extends RealType<O>>
Sets the real component of an output real number to the base 2 log of the
real component of an input real number.
|
static class |
UnaryRealTypeMath.LogOnePlusX<I extends RealType<I>,O extends RealType<O>>
Sets the real component of an output real number to the natural logarithm
of the sum of the argument and 1.
|
static class |
UnaryRealTypeMath.MaxConstant<I extends RealType<I>,O extends RealType<O>>
Sets the real component of an output real number to the real component of
an input real number unless it exceeds a maximum value.
|
static class |
UnaryRealTypeMath.MinConstant<I extends RealType<I>,O extends RealType<O>>
Sets the real component of an output real number to the real component of
an input real number unless it is less then a minimum value.
|
static class |
UnaryRealTypeMath.NearestInt<I extends RealType<I>,O extends RealType<O>>
Sets the real component of an output real number to the nearest integral
value of the real component of an input real number.
|
static class |
UnaryRealTypeMath.Negate<I extends RealType<I>,O extends RealType<O>>
Sets the real component of an output real number to the negation of the
real component of an input real number.
|
static class |
UnaryRealTypeMath.PowerConstant<I extends RealType<I>,O extends RealType<O>>
Sets the real component of an output real number to the raising of the real
component of an input real number to a constant value.
|
static class |
UnaryRealTypeMath.RandomGaussian<I extends RealType<I>,O extends RealType<O>>
Sets the real component of an output real number to a random value using a
gaussian distribution.
|
static class |
UnaryRealTypeMath.RandomUniform<I extends RealType<I>,O extends RealType<O>>
Sets the real component of an output real number to a random value between
0 and (input real number).
|
static class |
UnaryRealTypeMath.Reciprocal<I extends RealType<I>,O extends RealType<O>>
Sets the real component of an output real number to the reciprocal of the
real component of an input real number.
|
static class |
UnaryRealTypeMath.Round<I extends RealType<I>,O extends RealType<O>>
Sets the real component of an output real number to the rounding of the
real component of an input real number.
|
static class |
UnaryRealTypeMath.Sec<I extends RealType<I>,O extends RealType<O>>
Sets the real component of an output real number to the secant of the real
component of an input real number.
|
static class |
UnaryRealTypeMath.Sech<I extends RealType<I>,O extends RealType<O>>
Sets the real component of an output real number to the hyperbolic secant
of the real component of an input real number.
|
static class |
UnaryRealTypeMath.Signum<I extends RealType<I>,O extends RealType<O>>
Sets the real component of an output real number to the signum of the real
component of an input real number.
|
static class |
UnaryRealTypeMath.Sin<I extends RealType<I>,O extends RealType<O>>
Sets the real component of an output real number to the sine of the real
component of an input real number.
|
static class |
UnaryRealTypeMath.Sinc<I extends RealType<I>,O extends RealType<O>>
Sets the real component of an output real number to the sinc value of the
real component of an input real number.
|
static class |
UnaryRealTypeMath.SincPi<I extends RealType<I>,O extends RealType<O>>
Sets the real component of an output real number to the sinc (pi version)
of the real component of an input real number.
|
static class |
UnaryRealTypeMath.Sinh<I extends RealType<I>,O extends RealType<O>>
Sets the real component of an output real number to the hyperbolic sine of
the real component of an input real number.
|
static class |
UnaryRealTypeMath.Sqr<I extends RealType<I>,O extends RealType<O>>
Sets the real component of an output real number to the square of the real
component of an input real number.
|
static class |
UnaryRealTypeMath.Sqrt<I extends RealType<I>,O extends RealType<O>>
Sets the real component of an output real number to the square root of the
real component of an input real number.
|
static class |
UnaryRealTypeMath.Step<I extends RealType<I>,O extends RealType<O>>
Sets an output real number to 0 if the input real number is less than 0.
|
static class |
UnaryRealTypeMath.Tan<I extends RealType<I>,O extends RealType<O>>
Sets the real component of an output real number to the tangent of the real
component of an input real number.
|
static class |
UnaryRealTypeMath.Tanh<I extends RealType<I>,O extends RealType<O>>
Sets the real component of an output real number to the hyperbolic tangent
of the real component of an input real number.
|
static class |
UnaryRealTypeMath.Ulp<I extends RealType<I>,O extends RealType<O>>
Sets the real component of an output real number to the size of the ulp of
an input real number.
|
Modifier and Type | Class and Description |
---|---|
class |
ComplexConjugateMultiplyMap<T extends ComplexType<T>> |
class |
ComplexConjugateMultiplyOp<T extends ComplexType<T>> |
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 |
DefaultExtractHolesComputer<T extends BooleanType<T>>
Extracts the holes from a binary image.
|
Modifier and Type | Method and Description |
---|---|
UnaryComputerOp<RandomAccessibleInterval<T>,RandomAccessibleInterval<T>> |
DefaultExtractHolesFunction.createWorker(RandomAccessibleInterval<T> 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 | Interface and Description |
---|---|
interface |
SliceOp<I,O>
A typed "slice" function.
|
Modifier and Type | Class and Description |
---|---|
class |
SliceRAI2RAI<I,O>
|
Modifier and Type | Class and Description |
---|---|
class |
BCViaBC<I1 extends DI1,I2 extends DI2,O extends DO,DI1,DI2,DO>
Base class for
BinaryComputerOp s that delegate to other
BinaryComputerOp s. |
class |
BCViaBCAllSame<IO>
Base class for
BinaryComputerOp s that delegate to other
BinaryComputerOp s with all matching types (inputs same as output). |
class |
BCViaBCSameIO<I1,I2,O>
Base class for
BinaryComputerOp s that delegate to other
BinaryComputerOp 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 |
UCViaUC<I extends DI,O extends DO,DI,DO>
Base class for
UnaryComputerOp s that delegate to other
UnaryComputerOp s. |
class |
UCViaUCAllSame<IO>
Base class for
UnaryComputerOp s that delegate to other
UnaryComputerOp s with all matching types (input same as output). |
class |
UCViaUCSameIO<I,O>
Base class for
UnaryComputerOp s that delegate to other
UnaryComputerOp 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.computer(OpEnvironment ops,
Class<? extends Op> opType,
I in,
Object... otherArgs) |
static <T> UnaryComputerOp<IterableInterval<T>,IterableInterval<T>> |
IIs.computer(OpEnvironment ops,
Class<? extends Op> opType,
IterableInterval<T> in,
Object... otherArgs) |
static <T,F> UnaryComputerOp<RandomAccessibleInterval<T>,RandomAccessibleInterval<F>> |
RAIs.computer(OpEnvironment ops,
Class<? extends Op> opType,
RandomAccessibleInterval<F> out,
RandomAccessibleInterval<T> in,
Object... otherArgs) |
static <T> UnaryComputerOp<RandomAccessibleInterval<T>,RandomAccessibleInterval<T>> |
RAIs.computer(OpEnvironment ops,
Class<? extends Op> opType,
RandomAccessibleInterval<T> in,
Object... otherArgs) |
Modifier and Type | Interface and Description |
---|---|
interface |
BinaryComputerOp<I1,I2,O>
A binary computer computes a result from two given inputs, storing
it into the specified output reference.
|
Modifier and Type | Class and Description |
---|---|
class |
AbstractBinaryComputerOp<I1,I2,O>
Abstract superclass for
BinaryComputerOp implementations. |
class |
AbstractUnaryComputerOp<I,O>
Abstract superclass for
UnaryComputerOp implementations. |
Modifier and Type | Method and Description |
---|---|
default UnaryComputerOp<I,O> |
UnaryComputerOp.getIndependentInstance() |
static <I,O> UnaryComputerOp<I,O> |
Computers.unary(OpEnvironment ops,
Class<? extends Op> opType,
Class<O> outType,
Class<I> inType,
Object... otherArgs)
Gets the best
UnaryComputerOp implementation for the given types
and arguments, populating its inputs. |
static <I,O> UnaryComputerOp<I,O> |
Computers.unary(OpEnvironment ops,
Class<? extends Op> opType,
Class<O> outType,
I in,
Object... otherArgs)
Gets the best
UnaryComputerOp implementation for the given types
and arguments, populating its inputs. |
static <I,O> UnaryComputerOp<I,O> |
Computers.unary(OpEnvironment ops,
Class<? extends Op> opType,
O out,
I in,
Object... otherArgs)
Gets the best
UnaryComputerOp implementation for the given types
and arguments, populating its inputs. |
Constructor and Description |
---|
ComputerConverter(UnaryComputerOp<A,B> op) |
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 |
BinaryHybridCI<I,O extends I>
A hybrid binary operation which can be used as a
BinaryComputerOp or
BinaryInplaceOp . |
interface |
BinaryHybridCI1<I1,I2,O extends I1>
A hybrid binary operation which can be used as a
BinaryComputerOp , 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>
|
interface |
UnaryHybridCI<I,O extends I>
A hybrid unary operation which can be used as a
UnaryComputerOp or
UnaryInplaceOp . |
Modifier and Type | Class and Description |
---|---|
class |
AbstractBinaryHybridC<I1,I2,O>
Abstract superclass for
BinaryHybridCF and BinaryHybridCI1
implementations. |
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 |
AbstractBinaryHybridCI<I,O extends I>
Abstract superclass for
BinaryHybridCI implementations. |
class |
AbstractBinaryHybridCI1<I1,I2,O extends I1>
Abstract superclass for
BinaryHybridCI1 implementations. |
class |
AbstractUnaryHybridC<I,O>
Abstract superclass for
UnaryHybridCF and UnaryHybridCI
implementations. |
class |
AbstractUnaryHybridCF<I,O>
Abstract superclass for
UnaryHybridCF implementations. |
class |
AbstractUnaryHybridCFI<I,O extends I>
Abstract superclass for
UnaryHybridCFI implementations. |
class |
AbstractUnaryHybridCI<I,O extends I>
Abstract superclass for
UnaryHybridCI 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 |
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 |
IntegralMean<I extends RealType<I>>
|
class |
IntegralSum<I extends RealType<I>>
|
class |
IntegralVariance<I extends RealType<I>>
Op to calculate the stats.variance from an integral image
using a specialized Cursor implementation. |
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 | Interface and Description |
---|---|
interface |
ApplyThreshold<I,O>
An algorithm for applying a threshold value to an object.
|
interface |
ApplyThresholdIterable<T,I extends Iterable<T>,O>
Interface for
ApplyThreshold implementations that operate over an
iteration. |
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 UnaryComputerOp<Histogram1d<T>,T> |
LocalThresholdMethodHistogram.thresholdComputer |
Modifier and Type | Method and Description |
---|---|
protected abstract UnaryComputerOp<Histogram1d<T>,T> |
LocalThresholdMethodHistogram.getThresholdComputer() |
Modifier and Type | Class and Description |
---|---|
class |
ApplyConstantThreshold<T extends RealType<T>>
Applies the given threshold value to every element along the given
Iterable input. |
class |
ApplyManualThreshold<T extends RealType<T>>
Applies a threshold to an
Img . |
class |
ApplyThresholdComparable<T>
Applies a threshold value (the second input) to the given comparable object,
producing a
BitType set to 1 iff the object compares above the
threshold. |
class |
ApplyThresholdComparator<T>
Applies a threshold value (the second input) to the given object using the
specified comparator, producing a
BitType set to 1 iff the object
compares above the threshold. |
class |
LocalThreshold<T extends RealType<T>>
Apply a local thresholding method to an image, optionally using a out of
bounds strategy.
|
class |
LocalThresholdIntegral<I extends RealType<I>>
Apply a local thresholding method to an image using integral images for speed
up, optionally using a out of bounds strategy.
|
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 |
LocalBernsenThreshold<T extends RealType<T>>
LocalThresholdMethod which is similar to
LocalMidGreyThreshold , but uses a
constant value rather than the value of the input pixel when the contrast in
the neighborhood of that pixel is too small. |
Modifier and Type | Class and Description |
---|---|
class |
LocalContrastThreshold<T extends RealType<T>>
LocalThresholdMethod which determines whether a pixel is closer to the
maximum or minimum pixel of a neighborhood.
|
Modifier and Type | Class and Description |
---|---|
class |
LocalMeanThreshold<T extends RealType<T>>
LocalThresholdMethod that uses the mean and operates directly of RAIs.
|
class |
LocalMeanThresholdIntegral<T extends RealType<T>>
Local threshold method that uses the
IntegralMean for the threshold
computation. |
Modifier and Type | Class and Description |
---|---|
class |
LocalMedianThreshold<T extends RealType<T>>
LocalThresholdMethod using median.
|
Modifier and Type | Class and Description |
---|---|
class |
LocalMidGreyThreshold<T extends RealType<T>>
LocalThresholdMethod which thresholds against the average of the maximum and
minimum pixels of a neighborhood.
|
Modifier and Type | Class and Description |
---|---|
class |
LocalNiblackThreshold<T extends RealType<T>>
LocalThresholdMethod using Niblack's thresholding method.
|
class |
LocalNiblackThresholdIntegral<T extends RealType<T>>
Niblack's local thresholding algorithm.
|
Modifier and Type | Class and Description |
---|---|
class |
LocalPhansalkarThreshold<T extends RealType<T>>
This is a modification of Sauvola's thresholding method to deal with low
contrast images.
|
class |
LocalPhansalkarThresholdIntegral<T extends RealType<T>>
Local thresholding algorithm as proposed by Phansalkar et al.
|
Modifier and Type | Class and Description |
---|---|
class |
LocalSauvolaThreshold<T extends RealType<T>>
This is a modification of Niblack's thresholding method.
|
class |
LocalSauvolaThresholdIntegral<T extends RealType<T>>
Local thresholding algorithm as proposed by Sauvola et al.
|
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 |
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 | Method and Description |
---|---|
<T,V> IterableInterval<V> |
TransformNamespace.project(IterableInterval<V> out,
RandomAccessibleInterval<T> in,
UnaryComputerOp<Iterable<T>,V> method,
int dim)
Executes the "project" operation on the given arguments.
|
Modifier and Type | Class and Description |
---|---|
class |
DefaultProjectParallel<T,V> |
class |
ProjectRAIToII<T,V> |
class |
ProjectRAIToIterableInterval<T,V> |
Copyright © 2014–2022 ImageJ. All rights reserved.