Modifier and Type | Interface and Description |
---|---|
interface |
BSplineCoefficientsInterpolator<T extends RealType<T>>
Performs b-spline interpolation for order up to and including 5.
|
class |
BSplineCoefficientsInterpolatorEven<T extends RealType<T>>
Computes b-spline coefficients for splines of even order.
|
class |
BSplineCoefficientsInterpolatorFunction<T extends RealType<T>>
Performs b-spline interpolation using pre-computed coefficients.
|
class |
BSplineCoefficientsInterpolatorOdd<T extends RealType<T>>
Computes b-spline coefficients for splines of odd order.
|
class |
BSplineDecomposition<T extends RealType<T>,S extends RealType<S>>
Compute Bspline coefficients from an image.
|
class |
BSplineDecomposition<T extends RealType<T>,S extends RealType<S>>
Compute Bspline coefficients from an image.
|
class |
BSplineLazyCoefficientsInterpolatorFactory<T extends RealType<T>,S extends RealType<S> & NativeType<S>> |
class |
BSplineLazyCoefficientsInterpolatorFactory<T extends RealType<T>,S extends RealType<S> & NativeType<S>> |
static class |
BSplineLazyCoefficientsInterpolatorFactory.LazyCellImgFactory<T extends RealType<T>,S extends RealType<S> & NativeType<S>>
Returns an image of coefficients that is lazily evaluated and cached.
|
static class |
BSplineLazyCoefficientsInterpolatorFactory.LazyCellImgFactory<T extends RealType<T>,S extends RealType<S> & NativeType<S>>
Returns an image of coefficients that is lazily evaluated and cached.
|
Modifier and Type | Field and Description |
---|---|
protected S |
BSplineLazyCoefficientsInterpolatorFactory.coefficientType |
Modifier and Type | Method and Description |
---|---|
static <S extends RealType<S>> |
BSplineCoefficientsInterpolator.build(int order,
RandomAccessible<S> coefficients,
S type) |
protected static <T extends RealType<T>> |
BSplineDecomposition.initializeAntiCausalCoefficients(double z,
double c,
T previous,
RandomAccess<T> coefs) |
protected static <T extends RealType<T>> |
BSplineDecomposition.initializeCausalCoefficients(double z,
double tolerance,
int dimension,
RandomAccess<T> dataAccess)
Data must be 1d or permuted such that the first dimension
is the dimension to be iterated over.
|
<S extends RealType<S>,T extends RealType<T>> |
BSplineDecomposition.recursion1d(RandomAccess<T> srcAccess,
RandomAccess<S> destAccess,
double z,
double Ci,
S previous,
long N,
int dimension)
Compute a 1d forward-backward recursion to compute bspline coefficients.
|
<S extends RealType<S>,T extends RealType<T>> |
BSplineDecomposition.recursion1d(RandomAccess<T> srcAccess,
RandomAccess<S> destAccess,
double z,
double Ci,
S previous,
long N,
int dimension)
Compute a 1d forward-backward recursion to compute bspline coefficients.
|
static <S extends RealType<S>,T extends RealType<T>> |
BSplineDecomposition.recursion1dUnpadded(RandomAccess<T> srcAccess,
RandomAccess<S> destAccess,
S previous,
long N,
int dimension,
double tolerance,
int numberOfPoles,
double[] poles,
double[] Ci)
Compute a 1d forward-backward recursion to compute bspline coefficients.
|
static <S extends RealType<S>,T extends RealType<T>> |
BSplineDecomposition.recursion1dUnpadded(RandomAccess<T> srcAccess,
RandomAccess<S> destAccess,
S previous,
long N,
int dimension,
double tolerance,
int numberOfPoles,
double[] poles,
double[] Ci)
Compute a 1d forward-backward recursion to compute bspline coefficients.
|
Constructor and Description |
---|
BSplineLazyCoefficientsInterpolatorFactory(RandomAccessible<T> img,
int order,
boolean clipping,
S coefficientType,
int[] blockSize,
OutOfBoundsFactory<? extends RealType<?>,?> oobFactory) |
BSplineLazyCoefficientsInterpolatorFactory(RandomAccessible<T> img,
Interval interval,
int order,
boolean clipping,
S coefficientType,
int[] blockSize,
OutOfBoundsFactory<? extends RealType<?>,?> oobFactory)
Creates a new
BSplineLazyCoefficientsInterpolatorFactory . |
Modifier and Type | Method and Description |
---|---|
static <T extends RealType<T>> |
MserTree.buildMserTree(RandomAccessibleInterval<T> input,
double delta,
long minSize,
long maxSize,
double maxVar,
double minDiversity,
boolean darkToBright)
Build a MSER tree from an input image.
|
static <T extends RealType<T>> |
MserTree.buildMserTree(RandomAccessibleInterval<T> input,
T delta,
long minSize,
long maxSize,
double maxVar,
double minDiversity,
boolean darkToBright)
Build a MSER tree from an input image.
|
static <T extends RealType<T>> |
MserTree.buildMserTree(RandomAccessibleInterval<T> input,
T delta,
long minSize,
long maxSize,
double maxVar,
double minDiversity,
ImgFactory<LongType> imgFactory,
boolean darkToBright)
Build a MSER tree from an input image.
|
Modifier and Type | Method and Description |
---|---|
static <T extends RealType<T>> |
PixelListComponentTree.buildComponentTree(RandomAccessibleInterval<T> input,
T type,
boolean darkToBright)
Build a component tree from an input image.
|
static <T extends RealType<T>> |
PixelListComponentTree.buildComponentTree(RandomAccessibleInterval<T> input,
T type,
ImgFactory<LongType> imgFactory,
boolean darkToBright)
Build a component tree from an input image.
|
Modifier and Type | Method and Description |
---|---|
RealType<?> |
FastGaussConvolverRealType.preferredSourceType(RealType<?> targetType) |
Modifier and Type | Method and Description |
---|---|
static Convolution<RealType<?>> |
FastGauss.convolution(double sigma) |
static Convolution<RealType<?>> |
FastGauss.convolution(double[] sigma) |
static Convolution<RealType<?>> |
FastGauss.convolution1d(double sigma,
int direction) |
Modifier and Type | Method and Description |
---|---|
RealType<?> |
FastGaussConvolverRealType.preferredSourceType(RealType<?> targetType) |
Modifier and Type | Method and Description |
---|---|
static void |
FastGauss.convolve(double[] sigmas,
RandomAccessible<? extends RealType<?>> input,
RandomAccessibleInterval<? extends RealType<?>> output) |
static void |
FastGauss.convolve(double[] sigmas,
RandomAccessible<? extends RealType<?>> input,
RandomAccessibleInterval<? extends RealType<?>> output) |
static void |
FastGauss.convolve(double sigma,
RandomAccessible<? extends RealType<?>> input,
RandomAccessibleInterval<? extends RealType<?>> output) |
static void |
FastGauss.convolve(double sigma,
RandomAccessible<? extends RealType<?>> input,
RandomAccessibleInterval<? extends RealType<?>> output) |
Runnable |
FastGaussConvolverRealType.getConvolver(RandomAccess<? extends RealType<?>> in,
RandomAccess<? extends RealType<?>> out,
int d,
long lineLength) |
Runnable |
FastGaussConvolverRealType.getConvolver(RandomAccess<? extends RealType<?>> in,
RandomAccess<? extends RealType<?>> out,
int d,
long lineLength) |
Constructor and Description |
---|
MyConvolver(int d,
FastGaussCalculator.Parameters fc,
RandomAccess<? extends RealType<?>> in,
RandomAccess<? extends RealType<?>> out,
long lineLength) |
MyConvolver(int d,
FastGaussCalculator.Parameters fc,
RandomAccess<? extends RealType<?>> in,
RandomAccess<? extends RealType<?>> out,
long lineLength) |
Constructor and Description |
---|
DoubleConvolverRealType(Kernel1D kernel,
RandomAccess<? extends RealType<?>> in,
RandomAccess<? extends RealType<?>> out,
int d,
long lineLength) |
DoubleConvolverRealType(Kernel1D kernel,
RandomAccess<? extends RealType<?>> in,
RandomAccess<? extends RealType<?>> out,
int d,
long lineLength) |
FloatConvolverRealType(Kernel1D kernel,
RandomAccess<? extends RealType<?>> in,
RandomAccess<? extends RealType<?>> out,
int d,
long lineLength) |
FloatConvolverRealType(Kernel1D kernel,
RandomAccess<? extends RealType<?>> in,
RandomAccess<? extends RealType<?>> out,
int d,
long lineLength) |
Modifier and Type | Class and Description |
---|---|
class |
DogDetection<T extends RealType<T> & NativeType<T>> |
protected class |
DogDetection.TypedDogDetection<F extends RealType<F> & NativeType<F>> |
Modifier and Type | Field and Description |
---|---|
protected F |
DogDetection.TypedDogDetection.type |
Modifier and Type | Method and Description |
---|---|
static <T extends RealType<T>> |
SubpixelEdgelDetection.getEdgels(RandomAccessibleInterval<T> input,
ImgFactory<T> factory,
double minGradientMagnitude)
Compute the set of sub-pixel edgels for the input image.
|
Modifier and Type | Class and Description |
---|---|
class |
FourierConvolution<T extends RealType<T>,S extends RealType<S>>
Deprecated.
use
FFTConvolution instead |
class |
FourierConvolution<T extends RealType<T>,S extends RealType<S>>
Deprecated.
use
FFTConvolution instead |
class |
FourierTransform<T extends RealType<T>,S extends ComplexType<S>>
Deprecated.
use
FFT instead |
class |
InverseFourierConvolution<T extends RealType<T>,S extends RealType<S>>
Deprecated.
use
FFT instead |
class |
InverseFourierConvolution<T extends RealType<T>,S extends RealType<S>>
Deprecated.
use
FFT instead |
class |
InverseFourierTransform<T extends RealType<T>,S extends ComplexType<S>>
Deprecated.
use
FFT instead |
Modifier and Type | Method and Description |
---|---|
static <T extends RealType<T>,S extends ComplexType<S>> |
FFTFunctions.computeFFT(RandomAccessibleInterval<T> input,
ImgFactory<S> imgFactory,
S complexType,
OutOfBoundsFactory<T,RandomAccessibleInterval<T>> outOfBoundsFactory,
int[] imageOffset,
int[] imageSize,
int numThreads,
boolean scale)
Deprecated.
|
static <T extends RealType<T>,S extends ComplexType<S>> |
FFTFunctions.computeInverseFFT(RandomAccessibleInterval<S> complex,
ImgFactory<T> imgFactory,
T type,
int numThreads,
boolean scale,
boolean cropBack,
int[] originalSize,
int[] originalOffset,
float additionalNormalization)
Deprecated.
|
static <T extends RealType<T>,S extends RealType<S>> |
FourierConvolution.convolve(Img<T> img,
Img<S> kernel)
Deprecated.
|
static <T extends RealType<T>,S extends RealType<S>> |
FourierConvolution.convolve(Img<T> img,
Img<S> kernel)
Deprecated.
|
static <T extends RealType<T>,S extends RealType<S>> |
FourierConvolution.convolve(RandomAccessibleInterval<T> input,
RandomAccessibleInterval<S> kernel,
ImgFactory<T> imgFactory,
ImgFactory<S> kernelImgFactory,
ImgFactory<ComplexFloatType> fftImgFactory)
Deprecated.
|
static <T extends RealType<T>,S extends RealType<S>> |
FourierConvolution.convolve(RandomAccessibleInterval<T> input,
RandomAccessibleInterval<S> kernel,
ImgFactory<T> imgFactory,
ImgFactory<S> kernelImgFactory,
ImgFactory<ComplexFloatType> fftImgFactory)
Deprecated.
|
Modifier and Type | Class and Description |
---|---|
class |
FFTConvolution<R extends RealType<R>>
Computes the convolution of an image with an arbitrary kernel.
|
Modifier and Type | Method and Description |
---|---|
static <C extends ComplexType<C>,R extends RealType<R>> |
FFT.complexToReal(RandomAccessible<C> input,
Interval inputInterval,
ImgFactory<R> factory,
R type) |
static <C extends ComplexType<C>,R extends RealType<R>> |
FFT.complexToReal(RandomAccessible<C> input,
Interval inputInterval,
ImgFactory<R> factory,
R type,
ExecutorService service) |
static <C extends ComplexType<C>,R extends RealType<R>> |
FFT.complexToReal(RandomAccessible<C> input,
Interval inputInterval,
ImgFactory<R> factory,
R type,
int numThreads) |
static <C extends ComplexType<C>,R extends RealType<R>> |
FFT.complexToReal(RandomAccessible<C> input,
Interval inputInterval,
Interval outputDimensions,
ImgFactory<R> factory,
ExecutorService service) |
static <C extends ComplexType<C>,R extends RealType<R>> |
FFT.complexToReal(RandomAccessible<C> input,
Interval inputInterval,
Interval outputDimensions,
ImgFactory<R> factory,
R type) |
static <C extends ComplexType<C>,R extends RealType<R>> |
FFT.complexToReal(RandomAccessible<C> input,
Interval inputInterval,
Interval outputDimensions,
ImgFactory<R> factory,
R type,
ExecutorService service)
Deprecated.
|
static <C extends ComplexType<C>,R extends RealType<R>> |
FFT.complexToReal(RandomAccessible<C> input,
Interval inputInterval,
Interval outputDimensions,
ImgFactory<R> factory,
R type,
int numThreads) |
static <C extends ComplexType<C>,R extends RealType<R>> |
FFT.complexToReal(RandomAccessibleInterval<C> input,
ImgFactory<R> factory,
R type) |
static <C extends ComplexType<C>,R extends RealType<R>> |
FFT.complexToReal(RandomAccessibleInterval<C> input,
ImgFactory<R> factory,
R type,
ExecutorService service) |
static <C extends ComplexType<C>,R extends RealType<R>> |
FFT.complexToReal(RandomAccessibleInterval<C> input,
ImgFactory<R> factory,
R type,
int numThreads) |
static <C extends ComplexType<C>,R extends RealType<R>> |
FFT.complexToReal(RandomAccessibleInterval<C> input,
Interval outputDimensions,
ImgFactory<R> factory,
R type) |
static <C extends ComplexType<C>,R extends RealType<R>> |
FFT.complexToReal(RandomAccessibleInterval<C> input,
Interval outputDimensions,
ImgFactory<R> factory,
R type,
ExecutorService service) |
static <C extends ComplexType<C>,R extends RealType<R>> |
FFT.complexToReal(RandomAccessibleInterval<C> input,
Interval outputDimensions,
ImgFactory<R> factory,
R type,
int numThreads) |
static <C extends ComplexType<C>,R extends RealType<R>> |
FFT.complexToReal(RandomAccessibleInterval<C> input,
RandomAccessibleInterval<R> output) |
static <C extends ComplexType<C>,R extends RealType<R>> |
FFT.complexToReal(RandomAccessibleInterval<C> input,
RandomAccessibleInterval<R> output,
ExecutorService service) |
static <C extends ComplexType<C>,R extends RealType<R>> |
FFTMethods.complexToReal(RandomAccessibleInterval<C> input,
RandomAccessibleInterval<R> output,
int dim)
Computes a complex-to-real inverse FFT transform of an n-dimensional
dataset in a certain dimension (typically dim = 0).
|
static <C extends ComplexType<C>,R extends RealType<R>> |
FFT.complexToReal(RandomAccessibleInterval<C> input,
RandomAccessibleInterval<R> output,
int numThreads) |
static <C extends ComplexType<C>,R extends RealType<R>> |
FFTMethods.complexToReal(RandomAccessibleInterval<C> input,
RandomAccessibleInterval<R> output,
int dim,
boolean scale,
ExecutorService service)
Computes a complex-to-real inverse FFT transform of an n-dimensional
dataset in a certain dimension (typically dim = 0).
|
static <C extends ComplexType<C>,R extends RealType<R>> |
FFTMethods.complexToReal(RandomAccessibleInterval<C> input,
RandomAccessibleInterval<R> output,
int dim,
boolean scale,
int nThreads)
Computes a complex-to-real inverse FFT transform of an n-dimensional
dataset in a certain dimension (typically dim = 0).
|
static <C extends ComplexType<C>,R extends RealType<R>> |
FFTMethods.complexToReal(RandomAccessibleInterval<C> input,
RandomAccessibleInterval<R> output,
Interval interval,
int dim)
Computes a complex-to-real inverse FFT transform of an n-dimensional
dataset in a certain dimension (typically dim = 0).
|
static <C extends ComplexType<C>,R extends RealType<R>> |
FFTMethods.complexToReal(RandomAccessibleInterval<C> input,
RandomAccessibleInterval<R> output,
Interval interval,
int dim,
boolean scale)
Computes a complex-to-real inverse FFT transform of an n-dimensional
dataset in a certain dimension (typically dim = 0).
|
static <C extends ComplexType<C>,R extends RealType<R>> |
FFTMethods.complexToReal(RandomAccessibleInterval<C> input,
RandomAccessibleInterval<R> output,
Interval interval,
int dim,
boolean scale,
ExecutorService service)
Computes a complex-to-real inverse FFT transform of an n-dimensional
dataset in a certain dimension (typically dim = 0).
|
static <C extends ComplexType<C>,R extends RealType<R>> |
FFTMethods.complexToReal(RandomAccessibleInterval<C> input,
RandomAccessibleInterval<R> output,
Interval interval,
int dim,
boolean scale,
int nThreads)
Computes a complex-to-real inverse FFT transform of an n-dimensional
dataset in a certain dimension (typically dim = 0).
|
static <C extends ComplexType<C>,R extends RealType<R>> |
FFT.complexToRealUnpad(RandomAccessibleInterval<C> input,
RandomAccessibleInterval<R> output) |
static <C extends ComplexType<C>,R extends RealType<R>> |
FFT.complexToRealUnpad(RandomAccessibleInterval<C> input,
RandomAccessibleInterval<R> output,
ExecutorService service) |
static <C extends ComplexType<C>,R extends RealType<R>> |
FFT.complexToRealUnpad(RandomAccessibleInterval<C> input,
RandomAccessibleInterval<R> output,
int numThreads) |
static <R extends RealType<R>> |
FFTConvolution.computeConvolution(Img<ComplexFloatType> fftImg,
Img<ComplexFloatType> fftKernel,
RandomAccessibleInterval<R> output,
boolean keepImgFFT,
boolean div,
ExecutorService service) |
static <R extends RealType<R>> |
FFTConvolution.computeImgFFT(Interval imgConvolutionInterval,
RandomAccessible<R> img,
ImgFactory<ComplexFloatType> fftFactory,
ExecutorService service) |
static <R extends RealType<R>> |
FFTConvolution.computeKernelFFT(Interval kernelConvolutionInterval,
long[] min,
long[] max,
boolean complexConjugate,
RandomAccessible<R> kernel,
ImgFactory<ComplexFloatType> fftFactory,
ExecutorService service) |
static <R extends RealType<R>> |
FFTConvolution.convolve(RandomAccessible<R> img,
Interval imgInterval,
RandomAccessible<R> kernel,
Interval kernelInterval,
RandomAccessibleInterval<R> output,
ImgFactory<ComplexFloatType> factory,
boolean div,
ExecutorService service) |
static <R extends RealType<R>,C extends ComplexType<C>> |
FFT.realToComplex(RandomAccessible<R> input,
Interval inputInterval,
ImgFactory<C> factory,
C type) |
static <R extends RealType<R>,C extends ComplexType<C>> |
FFT.realToComplex(RandomAccessible<R> input,
Interval inputInterval,
ImgFactory<C> factory,
C type,
ExecutorService service)
Deprecated.
|
static <R extends RealType<R>,C extends ComplexType<C>> |
FFT.realToComplex(RandomAccessible<R> input,
Interval inputInterval,
ImgFactory<C> factory,
C type,
int numThreads) |
static <R extends RealType<R>,C extends ComplexType<C>> |
FFT.realToComplex(RandomAccessible<R> input,
Interval inputInterval,
ImgFactory<C> factory,
ExecutorService service) |
static <R extends RealType<R>> |
FFT.realToComplex(RandomAccessibleInterval<R> input,
ImgFactory<ComplexFloatType> factory) |
static <R extends RealType<R>> |
FFT.realToComplex(RandomAccessibleInterval<R> input,
ImgFactory<ComplexFloatType> factory,
ExecutorService service) |
static <R extends RealType<R>> |
FFT.realToComplex(RandomAccessibleInterval<R> input,
ImgFactory<ComplexFloatType> factory,
int numThreads) |
static <R extends RealType<R>> |
FFT.realToComplex(RandomAccessibleInterval<R> input,
OutOfBoundsFactory<R,RandomAccessibleInterval<R>> oobs,
ImgFactory<ComplexFloatType> factory) |
static <R extends RealType<R>> |
FFT.realToComplex(RandomAccessibleInterval<R> input,
OutOfBoundsFactory<R,RandomAccessibleInterval<R>> oobs,
ImgFactory<ComplexFloatType> factory,
ExecutorService service) |
static <R extends RealType<R>> |
FFT.realToComplex(RandomAccessibleInterval<R> input,
OutOfBoundsFactory<R,RandomAccessibleInterval<R>> oobs,
ImgFactory<ComplexFloatType> factory,
int numThreads) |
static <R extends RealType<R>,C extends ComplexType<C>> |
FFT.realToComplex(RandomAccessibleInterval<R> input,
RandomAccessibleInterval<C> output) |
static <R extends RealType<R>,C extends ComplexType<C>> |
FFT.realToComplex(RandomAccessibleInterval<R> input,
RandomAccessibleInterval<C> output,
ExecutorService service) |
static <R extends RealType<R>,C extends ComplexType<C>> |
FFTMethods.realToComplex(RandomAccessibleInterval<R> input,
RandomAccessibleInterval<C> output,
int dim)
Computes a real-to-complex forward FFT transform of an n-dimensional
dataset in a certain dimension (typically dim = 0).
|
static <R extends RealType<R>,C extends ComplexType<C>> |
FFT.realToComplex(RandomAccessibleInterval<R> input,
RandomAccessibleInterval<C> output,
int numThreads) |
static <R extends RealType<R>,C extends ComplexType<C>> |
FFTMethods.realToComplex(RandomAccessibleInterval<R> input,
RandomAccessibleInterval<C> output,
int dim,
boolean scale)
Computes a real-to-complex forward FFT transform of an n-dimensional
dataset in a certain dimension (typically dim = 0).
|
static <R extends RealType<R>,C extends ComplexType<C>> |
FFTMethods.realToComplex(RandomAccessibleInterval<R> input,
RandomAccessibleInterval<C> output,
int dim,
boolean scale,
ExecutorService service)
Computes a real-to-complex forward FFT transform of an n-dimensional
dataset in a certain dimension (typically dim = 0).
|
static <R extends RealType<R>,C extends ComplexType<C>> |
FFTMethods.realToComplex(RandomAccessibleInterval<R> input,
RandomAccessibleInterval<C> output,
int dim,
boolean scale,
int nThreads)
Computes a real-to-complex forward FFT transform of an n-dimensional
dataset in a certain dimension (typically dim = 0).
|
static <R extends RealType<R>,C extends ComplexType<C>> |
FFTMethods.realToComplex(RandomAccessibleInterval<R> input,
RandomAccessibleInterval<C> output,
Interval interval,
int dim)
Computes a real-to-complex forward FFT transform of an n-dimensional
dataset in a certain dimension (typically dim = 0).
|
static <R extends RealType<R>,C extends ComplexType<C>> |
FFTMethods.realToComplex(RandomAccessibleInterval<R> input,
RandomAccessibleInterval<C> output,
Interval interval,
int dim,
boolean scale)
Computes a real-to-complex forward FFT transform of an n-dimensional
dataset in a certain dimension (typically dim = 0).
|
static <R extends RealType<R>,C extends ComplexType<C>> |
FFTMethods.realToComplex(RandomAccessibleInterval<R> input,
RandomAccessibleInterval<C> output,
Interval interval,
int dim,
boolean scale,
ExecutorService service)
Computes a real-to-complex forward FFT transform of an n-dimensional
dataset in a certain dimension (typically dim = 0).
|
static <R extends RealType<R>,C extends ComplexType<C>> |
FFTMethods.realToComplex(RandomAccessibleInterval<R> input,
RandomAccessibleInterval<C> output,
Interval interval,
int dim,
boolean scale,
int nThreads)
Computes a real-to-complex forward FFT transform of an n-dimensional
dataset in a certain dimension (typically dim = 0).
|
Modifier and Type | Method and Description |
---|---|
protected static ImgFactory<ComplexFloatType> |
FFTConvolution.getFFTFactory(Img<? extends RealType<?>> img) |
Modifier and Type | Class and Description |
---|---|
class |
FloydSteinbergDithering<T extends RealType<T>>
TODO
|
Modifier and Type | Class and Description |
---|---|
class |
NormMinMax<A extends RealType<A>>
TODO
|
class |
SubtractNormReal<A extends RealType<A>,B extends RealType<B>,C extends RealType<C>>
TODO
|
class |
SubtractNormReal<A extends RealType<A>,B extends RealType<B>,C extends RealType<C>>
TODO
|
class |
SubtractNormReal<A extends RealType<A>,B extends RealType<B>,C extends RealType<C>>
TODO
|
class |
SubtractReal<A extends RealType<A>,B extends RealType<B>,C extends RealType<C>>
TODO
|
class |
SubtractReal<A extends RealType<A>,B extends RealType<B>,C extends RealType<C>>
TODO
|
class |
SubtractReal<A extends RealType<A>,B extends RealType<B>,C extends RealType<C>>
TODO
|
Modifier and Type | Method and Description |
---|---|
static <T extends RealType<T>> |
Gauss.inDouble(double[] sigma,
Img<T> img)
Deprecated.
Computes a Gaussian convolution with double precision on an entire
Img using the OutOfBoundsMirrorFactory with single
boundary |
static <T extends RealType<T>> |
Gauss.inDouble(double[] sigma,
Img<T> img,
OutOfBoundsFactory<DoubleType,RandomAccessibleInterval<DoubleType>> outofbounds)
Deprecated.
Computes a Gaussian convolution with double precision on an entire
Img |
static <T extends RealType<T>> |
Gauss.inDouble(double[] sigma,
RandomAccessible<T> img,
Interval interval,
RandomAccessible<T> output,
Localizable origin,
ImgFactory<DoubleType> imgFactory)
Deprecated.
Computes a Gaussian convolution with double precision on an infinite
RandomAccessible |
static <T extends RealType<T>> |
Gauss.inDouble(double sigma,
Img<T> img)
Deprecated.
Computes a Gaussian convolution with double precision on an entire
Img using the OutOfBoundsMirrorFactory with single
boundary |
static <T extends RealType<T>> |
Gauss.inDouble(double sigma,
Img<T> img,
OutOfBoundsFactory<DoubleType,RandomAccessibleInterval<DoubleType>> outofbounds)
Deprecated.
Computes a Gaussian convolution with double precision on an entire
Img |
static <T extends RealType<T>> |
Gauss.inDouble(double sigma,
RandomAccessible<T> img,
Interval interval,
RandomAccessible<T> output,
Localizable origin,
ImgFactory<DoubleType> imgFactory)
Deprecated.
Computes a Gaussian convolution with double precision on an infinite
RandomAccessible |
static <T extends RealType<T>> |
Gauss.inDoubleInPlace(double[] sigma,
Img<T> img)
Deprecated.
Computes a Gaussian convolution in-place (temporary imgs are necessary)
with double precision on an entire
Img using the
OutOfBoundsMirrorFactory with single boundary |
static <T extends RealType<T>> |
Gauss.inDoubleInPlace(double[] sigma,
Img<T> img,
OutOfBoundsFactory<DoubleType,RandomAccessibleInterval<DoubleType>> outofbounds)
Deprecated.
Computes a Gaussian convolution in-place (temporary imgs are necessary)
with double precision on an entire
Img |
static <T extends RealType<T>> |
Gauss.inDoubleInPlace(double sigma,
Img<T> img)
Deprecated.
Computes a Gaussian convolution in-place (temporary imgs are necessary)
with double precision on an entire
Img using the
OutOfBoundsMirrorFactory with single boundary |
static <T extends RealType<T>> |
Gauss.inDoubleInPlace(double sigma,
Img<T> img,
OutOfBoundsFactory<DoubleType,RandomAccessibleInterval<DoubleType>> outofbounds)
Deprecated.
Computes a Gaussian convolution in-place (temporary imgs are necessary)
with double precision on an entire
Img |
static <T extends RealType<T>> |
Gauss.inFloat(double[] sigma,
Img<T> img)
Deprecated.
Computes a Gaussian convolution with float precision on an entire
Img using the OutOfBoundsMirrorFactory with single
boundary |
static <T extends RealType<T>> |
Gauss.inFloat(double[] sigma,
Img<T> img,
OutOfBoundsFactory<FloatType,RandomAccessibleInterval<FloatType>> outofbounds)
Deprecated.
Computes a Gaussian convolution with float precision on an entire
Img |
static <T extends RealType<T>> |
Gauss.inFloat(double[] sigma,
RandomAccessible<T> img,
Interval interval,
RandomAccessible<T> output,
Localizable origin,
ImgFactory<FloatType> imgFactory)
Deprecated.
Computes a Gaussian convolution with float precision on an infinite
RandomAccessible |
static <T extends RealType<T>> |
Gauss.inFloat(double sigma,
Img<T> img)
Deprecated.
Computes a Gaussian convolution with float precision on an entire
Img using the OutOfBoundsMirrorFactory with single
boundary |
static <T extends RealType<T>> |
Gauss.inFloat(double sigma,
Img<T> img,
OutOfBoundsFactory<FloatType,RandomAccessibleInterval<FloatType>> outofbounds)
Deprecated.
Computes a Gaussian convolution with float precision on an entire
Img |
static <T extends RealType<T>> |
Gauss.inFloat(double sigma,
RandomAccessible<T> img,
Interval interval,
RandomAccessible<T> output,
Localizable origin,
ImgFactory<FloatType> imgFactory)
Deprecated.
Computes a Gaussian convolution with float precision on an infinite
RandomAccessible |
static <T extends RealType<T>> |
Gauss.inFloatInPlace(double[] sigma,
Img<T> img)
Deprecated.
Computes a Gaussian convolution in-place (temporary imgs are necessary)
with float precision on an entire
Img using the
OutOfBoundsMirrorFactory with single boundary |
static <T extends RealType<T>> |
Gauss.inFloatInPlace(double[] sigma,
Img<T> img,
OutOfBoundsFactory<FloatType,RandomAccessibleInterval<FloatType>> outofbounds)
Deprecated.
Computes a Gaussian convolution in-place (temporary imgs are necessary)
with float precision on an entire
Img |
static <T extends RealType<T>> |
Gauss.inFloatInPlace(double sigma,
Img<T> img)
Deprecated.
Computes a Gaussian convolution in-place (temporary imgs are necessary)
with float precision on an entire
Img using the
OutOfBoundsMirrorFactory with single boundary |
static <T extends RealType<T>> |
Gauss.inFloatInPlace(double sigma,
Img<T> img,
OutOfBoundsFactory<FloatType,RandomAccessibleInterval<FloatType>> outofbounds)
Deprecated.
Computes a Gaussian convolution in-place (temporary imgs are necessary)
with float precision on an entire
Img |
static <T extends RealType<T>> |
Gauss.toDouble(double[] sigma,
Img<T> img)
Deprecated.
Computes a Gaussian convolution with double precision on an entire
Img using the OutOfBoundsMirrorFactory with single
boundary |
static <T extends RealType<T>> |
Gauss.toDouble(double[] sigma,
Img<T> img,
OutOfBoundsFactory<DoubleType,RandomAccessibleInterval<DoubleType>> outofbounds)
Deprecated.
Computes a Gaussian convolution with double precision on an entire
Img |
static <T extends RealType<T>> |
Gauss.toDouble(double sigma,
Img<T> img)
Deprecated.
Computes a Gaussian convolution with double precision on an entire
Img using the OutOfBoundsMirrorFactory with single
boundary |
static <T extends RealType<T>> |
Gauss.toDouble(double sigma,
Img<T> img,
OutOfBoundsFactory<DoubleType,RandomAccessibleInterval<DoubleType>> outofbounds)
Deprecated.
Computes a Gaussian convolution with double precision on an entire
Img |
static <T extends RealType<T>> |
Gauss.toFloat(double[] sigma,
Img<T> img)
Deprecated.
Computes a Gaussian convolution with float precision on an entire
Img using the OutOfBoundsMirrorFactory with single
boundary |
static <T extends RealType<T>> |
Gauss.toFloat(double[] sigma,
Img<T> img,
OutOfBoundsFactory<FloatType,RandomAccessibleInterval<FloatType>> outofbounds)
Deprecated.
Computes a Gaussian convolution with float precision on an entire
Img |
static <T extends RealType<T>> |
Gauss.toFloat(double sigma,
Img<T> img)
Deprecated.
Computes a Gaussian convolution with float precision on an entire
Img using the OutOfBoundsMirrorFactory with single
boundary |
static <T extends RealType<T>> |
Gauss.toFloat(double sigma,
Img<T> img,
OutOfBoundsFactory<FloatType,RandomAccessibleInterval<FloatType>> outofbounds)
Deprecated.
Computes a Gaussian convolution with float precision on an entire
Img |
Modifier and Type | Class and Description |
---|---|
class |
DoubleConvolverRealType<S extends RealType<S>,T extends RealType<T>>
Deprecated.
|
class |
DoubleConvolverRealType<S extends RealType<S>,T extends RealType<T>>
Deprecated.
|
class |
DoubleConvolverRealTypeBuffered<S extends RealType<S>,T extends RealType<T>>
Deprecated.
|
class |
DoubleConvolverRealTypeBuffered<S extends RealType<S>,T extends RealType<T>>
Deprecated.
|
class |
FloatConvolverRealType<S extends RealType<S>,T extends RealType<T>>
Deprecated.
|
class |
FloatConvolverRealType<S extends RealType<S>,T extends RealType<T>>
Deprecated.
|
class |
FloatConvolverRealTypeBuffered<S extends RealType<S>,T extends RealType<T>>
Deprecated.
|
class |
FloatConvolverRealTypeBuffered<S extends RealType<S>,T extends RealType<T>>
Deprecated.
|
Modifier and Type | Method and Description |
---|---|
static <S extends RealType<S>,T extends RealType<T>> |
FloatConvolverRealTypeBuffered.factory()
Deprecated.
|
static <S extends RealType<S>,T extends RealType<T>> |
FloatConvolverRealTypeBuffered.factory()
Deprecated.
|
static <S extends RealType<S>,T extends RealType<T>> |
FloatConvolverRealType.factory()
Deprecated.
|
static <S extends RealType<S>,T extends RealType<T>> |
FloatConvolverRealType.factory()
Deprecated.
|
static <S extends RealType<S>,T extends RealType<T>> |
DoubleConvolverRealTypeBuffered.factory()
Deprecated.
|
static <S extends RealType<S>,T extends RealType<T>> |
DoubleConvolverRealTypeBuffered.factory()
Deprecated.
|
static <S extends RealType<S>,T extends RealType<T>> |
DoubleConvolverRealType.factory()
Deprecated.
|
static <S extends RealType<S>,T extends RealType<T>> |
DoubleConvolverRealType.factory()
Deprecated.
|
Modifier and Type | Class and Description |
---|---|
class |
HoughTransforms<T extends RealType<T> & Comparable<T>>
This class provides static methods used to detect imperfect shapes in
two-dimensional images through the use of the Hough Transform.
|
Modifier and Type | Class and Description |
---|---|
class |
ScaleAreaAveraging2d<T extends RealType<T>,R extends RealType<R>>
TODO
|
class |
ScaleAreaAveraging2d<T extends RealType<T>,R extends RealType<R>>
TODO
|
Modifier and Type | Class and Description |
---|---|
class |
BSplineCoefficientsInterpolatorFactory<T extends RealType<T>,S extends RealType<S>> |
class |
BSplineCoefficientsInterpolatorFactory<T extends RealType<T>,S extends RealType<S>> |
class |
BSplineInterpolator<T extends RealType<T>>
Performs cubic b-spline interpolation by pre-computing coefficients on the fly.
|
class |
BSplineInterpolatorFactory<T extends RealType<T>> |
Modifier and Type | Field and Description |
---|---|
protected T |
BSplineInterpolator.value |
Constructor and Description |
---|
BSplineCoefficientsInterpolatorFactory(RandomAccessible<T> img,
Interval interval,
int order,
boolean clipping,
ImgFactory<S> coefficientFactory,
OutOfBoundsFactory<? extends RealType<?>,?> oobFactory)
Creates a new
BSplineCoefficientsInterpolatorFactory using the BSpline
interpolation in a certain window |
BSplineCoefficientsInterpolatorFactory(RandomAccessibleInterval<S> coefficients,
int order,
boolean clipping,
OutOfBoundsFactory<? extends RealType<?>,?> oobFactory) |
Modifier and Type | Class and Description |
---|---|
class |
Watershed<T extends RealType<T>,L extends Comparable<L>>
Watershed algorithms.
|
Modifier and Type | Interface and Description |
---|---|
interface |
EigenValues<T extends RealType<T>,U extends ComplexType<U>>
Interface for handling different cases, e.g.
|
class |
EigenValues1D<T extends RealType<T>,U extends ComplexType<U>> |
class |
EigenValues2DSquare<T extends RealType<T>,U extends ComplexType<U>> |
class |
EigenValues2DSymmetric<T extends RealType<T>,U extends ComplexType<U>> |
class |
EigenValuesSquare<T extends RealType<T>,U extends ComplexType<U>> |
class |
EigenValuesSymmetric<T extends RealType<T>,U extends ComplexType<U>> |
Modifier and Type | Method and Description |
---|---|
static <T extends RealType<T>,U extends ComplexType<U>> |
TensorEigenValues.calculateEigenValues(RandomAccessibleInterval<T> tensor,
RandomAccessibleInterval<U> eigenvalues,
EigenValues<T,U> ev) |
static <T extends RealType<T>,U extends ComplexType<U>> |
TensorEigenValues.calculateEigenValues(RandomAccessibleInterval<T> tensor,
RandomAccessibleInterval<U> eigenvalues,
EigenValues<T,U> ev,
int nTasks,
ExecutorService es) |
static <T extends RealType<T>,U extends ComplexType<U>> |
TensorEigenValues.calculateEigenValuesSquare(RandomAccessibleInterval<T> tensor,
RandomAccessibleInterval<U> eigenvalues) |
static <T extends RealType<T>,U extends ComplexType<U>> |
TensorEigenValues.calculateEigenValuesSquare(RandomAccessibleInterval<T> tensor,
RandomAccessibleInterval<U> eigenvalues,
int nTasks,
ExecutorService es) |
static <T extends RealType<T>,U extends RealType<U>> |
TensorEigenValues.calculateEigenValuesSymmetric(RandomAccessibleInterval<T> tensor,
RandomAccessibleInterval<U> eigenvalues) |
static <T extends RealType<T>,U extends RealType<U>> |
TensorEigenValues.calculateEigenValuesSymmetric(RandomAccessibleInterval<T> tensor,
RandomAccessibleInterval<U> eigenvalues) |
static <T extends RealType<T>,U extends RealType<U>> |
TensorEigenValues.calculateEigenValuesSymmetric(RandomAccessibleInterval<T> tensor,
RandomAccessibleInterval<U> eigenvalues,
int nTasks,
ExecutorService es) |
static <T extends RealType<T>,U extends RealType<U>> |
TensorEigenValues.calculateEigenValuesSymmetric(RandomAccessibleInterval<T> tensor,
RandomAccessibleInterval<U> eigenvalues,
int nTasks,
ExecutorService es) |
static <T extends RealType<T>,U extends RealType<U>> |
TensorEigenValues.createAppropriateResultImg(RandomAccessibleInterval<T> tensor,
ImgFactory<U> factory)
Create appropriately sized image for tensor input.
|
static <T extends RealType<T>,U extends RealType<U>> |
TensorEigenValues.createAppropriateResultImg(RandomAccessibleInterval<T> tensor,
ImgFactory<U> factory)
Create appropriately sized image for tensor input.
|
static <T extends RealType<T>,U extends RealType<U>> |
TensorEigenValues.createAppropriateResultImg(RandomAccessibleInterval<T> tensor,
ImgFactory<U> factory,
U u)
Deprecated.
|
static <T extends RealType<T>,U extends RealType<U>> |
TensorEigenValues.createAppropriateResultImg(RandomAccessibleInterval<T> tensor,
ImgFactory<U> factory,
U u)
Deprecated.
|
static <T extends RealType<T>,U extends ComplexType<U>> |
EigenValues.invalid() |
static <T extends RealType<T>,U extends ComplexType<U>> |
EigenValues.oneDimensional() |
static <T extends RealType<T>,U extends ComplexType<U>> |
EigenValues.square(int nDim) |
static <T extends RealType<T>,U extends ComplexType<U>> |
EigenValues.square2D() |
static <T extends RealType<T>,U extends ComplexType<U>> |
EigenValues.symmetric(int nDim) |
static <T extends RealType<T>,U extends ComplexType<U>> |
EigenValues.symmetric2D() |
Modifier and Type | Class and Description |
---|---|
class |
RealCompositeMatrix<T extends RealType<T>> |
class |
RealCompositeSquareMatrix<T extends RealType<T>> |
class |
RealCompositeSymmetricMatrix<T extends RealType<T>> |
Modifier and Type | Class and Description |
---|---|
class |
SubpixelLocalization<P extends Localizable,T extends RealType<T>>
Refine a set of peaks to subpixel coordinates.
|
Modifier and Type | Method and Description |
---|---|
protected static <T extends RealType<T>> |
SubpixelLocalization.quadraticFitOffset(Localizable p,
RandomAccess<T> access,
Matrix g,
Matrix H,
RealPositionable offset)
Estimate subpixel
offset of extremum of quadratic function
fitted at p . |
static <T extends RealType<T>,P extends Localizable> |
SubpixelLocalization.refinePeaks(List<P> peaks,
RandomAccessible<T> img,
Interval validInterval,
boolean returnInvalidPeaks,
int maxNumMoves,
boolean allowMaximaTolerance,
float maximaTolerance,
boolean[] allowedToMoveInDim)
Refine a set of peaks to subpixel coordinates.
|
static <T extends RealType<T>,P extends Localizable> |
SubpixelLocalization.refinePeaks(List<P> peaks,
RandomAccessible<T> img,
Interval validInterval,
boolean returnInvalidPeaks,
int maxNumMoves,
boolean allowMaximaTolerance,
float maximaTolerance,
boolean[] allowedToMoveInDim,
int numThreads)
Refine a set of peaks to subpixel coordinates.
|
Modifier and Type | Class and Description |
---|---|
class |
PeakFitter<T extends RealType<T>> |
Modifier and Type | Method and Description |
---|---|
static <T extends RealType<T>> |
LocalizationUtils.addEllipticGaussianSpotToImage(RandomAccessibleInterval<T> img,
double[] params) |
static <T extends RealType<T>> |
LocalizationUtils.addGaussianNoiseToImage(RandomAccessibleInterval<T> img,
double sigma_noise) |
static <T extends RealType<T>> |
LocalizationUtils.addGaussianSpotToImage(RandomAccessibleInterval<T> img,
double[] params) |
static <T extends RealType<T>> |
LocalizationUtils.gatherObservationData(RandomAccessibleInterval<T> image,
Localizable point,
long[] span)
Collects the points to build the observation array, by iterating in a
hypercube around the given location.
|
Modifier and Type | Class and Description |
---|---|
class |
BlockReadSource<I extends RealType<I>>
Intended for reading cuboid blocks out of an integral image.
|
class |
ImgSource<I extends RealType<I>> |
class |
KDTreeSource<I extends RealType<I>> |
class |
OffsetSource<I extends RealType<I>> |
class |
PickImagePeaks<T extends RealType<T>>
This class implements a very simple peak-picker, with optional ellipsoidal
peak suppression.
|
class |
RandomAccessibleSource<I extends RealType<I>> |
Modifier and Type | Method and Description |
---|---|
static <T extends RealType<T>> |
ImgMath.block(RandomAccessible<T> src,
long radius) |
static <T extends RealType<T>> |
ImgMath.block(RandomAccessible<T> src,
long[] radius) |
static <T extends RealType<T>> |
ImgMath.block(RandomAccessible<T> src,
long[][] corners) |
static <I extends RealType<I>> |
ImgMath.compute(RandomAccessibleInterval<I> src) |
static <O extends RealType<O>> |
ImgMath.computeInto(IFunction operation,
RandomAccessibleInterval<O> target) |
static <O extends RealType<O>> |
ImgMath.computeInto(IFunction operation,
RandomAccessibleInterval<O> target,
Converter<RealType<?>,O> converter) |
static <O extends NativeType<O> & RealType<O>> |
ImgMath.computeIntoArrayImg(IFunction operation) |
static <O extends NativeType<O> & RealType<O>> |
ImgMath.computeIntoImg(IFunction operation) |
<O extends RealType<O>> |
Compute.cursor()
Returns a
Cursor with the same type as the first input image found. |
<C extends RealType<C>,O extends RealType<O>> |
Compute.cursor(C computeType,
O outputType) |
<C extends RealType<C>,O extends RealType<O>> |
Compute.cursor(C computeType,
O outputType) |
<C extends RealType<C>,O extends RealType<O>> |
Compute.cursor(Converter<RealType<?>,C> inConverter,
C computeType,
O outputType,
Converter<C,O> outConverter) |
<C extends RealType<C>,O extends RealType<O>> |
Compute.cursor(Converter<RealType<?>,C> inConverter,
C computeType,
O outputType,
Converter<C,O> outConverter) |
<O extends RealType<O>> |
Compute.cursor(O outputType) |
<O extends RealType<O>> |
Compute.cursorDouble()
Returns a
Cursor with the same type as the first input image found. |
<O extends RealType<O>> |
Compute.cursorDouble(O outputType) |
<O extends RealType<O>> |
Compute.cursorDouble(O outputType,
Converter<RealType<?>,O> converter) |
static <T extends RealType<T>> |
ImgMath.gen(KDTree<T> kdtree,
double radius) |
static <T extends RealType<T>> |
ImgMath.gen(KDTree<T> kdtree,
double radius,
Object outside) |
static <T extends RealType<T>> |
ImgMath.gen(KDTree<T> kdtree,
double radius,
Object outside,
Interval interval) |
static <T extends RealType<T>> |
ImgMath.gen(List<Point> positions,
List<T> values,
double radius) |
static <T extends RealType<T>> |
ImgMath.gen(List<Point> positions,
List<T> values,
double radius,
Object outside) |
static <T extends RealType<T>> |
ImgMath.gen(List<Point> positions,
List<T> values,
double radius,
Object outside,
Interval interval) |
static <T extends RealType<T>> |
ImgMath.gen(List<Point> positions,
T value,
double radius) |
static <T extends RealType<T>> |
ImgMath.gen(List<Point> positions,
T value,
double radius,
Object outside) |
static <T extends RealType<T>> |
ImgMath.gen(List<Point> positions,
T value,
double radius,
Object outside,
Interval interval) |
static <T extends RealType<T>> |
ImgMath.img(RandomAccessibleInterval<T> rai) |
static <T extends RealType<T>> |
ImgMath.intervalSource(RandomAccessibleInterval<T> rai)
Synonym of
img(RandomAccessibleInterval) , given that img is a widely used variable name. |
<O extends RealType<O>> |
Compute.into(RandomAccessibleInterval<O> target)
Execute the computation and store the result into the
target . |
<O extends RealType<O>,C extends RealType<C>> |
Compute.into(RandomAccessibleInterval<O> target,
C computingType) |
<O extends RealType<O>,C extends RealType<C>> |
Compute.into(RandomAccessibleInterval<O> target,
C computingType) |
<O extends RealType<O>,C extends RealType<C>> |
Compute.into(RandomAccessibleInterval<O> target,
Converter<RealType<?>,C> inConverter,
C computingType,
Converter<C,O> outConverter) |
<O extends RealType<O>,C extends RealType<C>> |
Compute.into(RandomAccessibleInterval<O> target,
Converter<RealType<?>,C> inConverter,
C computingType,
Converter<C,O> outConverter) |
<O extends RealType<O>,C extends RealType<C>> |
Compute.into(RandomAccessibleInterval<O> target,
Converter<RealType<?>,C> inConverter,
C computingType,
Converter<C,O> outConverter,
boolean printHierarchy)
Execute the mathematical operations and store the result into the given
RandomAccessibleInterval . |
<O extends RealType<O>,C extends RealType<C>> |
Compute.into(RandomAccessibleInterval<O> target,
Converter<RealType<?>,C> inConverter,
C computingType,
Converter<C,O> outConverter,
boolean printHierarchy)
Execute the mathematical operations and store the result into the given
RandomAccessibleInterval . |
<O extends RealType<O>> |
Compute.into(RandomAccessibleInterval<O> target,
Converter<RealType<?>,O> inConverter)
Execute the mathematical operations and store the result into the given
RandomAccessibleInterval . |
<O extends RealType<O> & NativeType<O>> |
Compute.intoArrayImg() |
<O extends RealType<O> & NativeType<O>,C extends RealType<C> & NativeType<C>> |
Compute.intoArrayImg(C computeType,
O outputType) |
<O extends RealType<O> & NativeType<O>,C extends RealType<C> & NativeType<C>> |
Compute.intoArrayImg(C computeType,
O outputType) |
<O extends RealType<O> & NativeType<O>,C extends RealType<C>> |
Compute.intoArrayImg(O outputType) |
<O extends RealType<O> & NativeType<O>,C extends RealType<C>> |
Compute.intoArrayImg(O outputType) |
<O extends RealType<O> & NativeType<O>> |
Compute.intoImg()
Execute the computation and store the result into a newly created
Img of the same Type
(and kind, by ImgFactory ) as one of the input images, using as the computation Type
the type of that picked input image. |
<O extends RealType<O> & NativeType<O>,C extends RealType<C>> |
Compute.intoImg(C computeType,
O outputType)
Execute the computation and store the result into a newly created
Img of the same kind,
by ImgFactory , as one of the input images, but of type outputType , while using
computeType for math operations, converting to the outputType to store the result. |
<O extends RealType<O> & NativeType<O>,C extends RealType<C>> |
Compute.intoImg(C computeType,
O outputType)
Execute the computation and store the result into a newly created
Img of the same kind,
by ImgFactory , as one of the input images, but of type outputType , while using
computeType for math operations, converting to the outputType to store the result. |
<O extends RealType<O> & NativeType<O>> |
Compute.intoImg(O outputType)
Execute the computation and store the result into a newly created
Img of the same kind,
by ImgFactory , as one of the input images, but of type outputType , which is also
used as the computation Type . |
static <T extends RealType<T>> |
ImgMath.offset(IFunction f,
long[] offset) |
static <T extends RealType<T>> |
ImgMath.offset(RandomAccessible<T> src,
long[] offset) |
<O extends RealType<O>,C extends RealType<C>> |
Compute.parallelInto(Converter<RealType<?>,C> inConverter,
C computeType,
O outputType,
Converter<C,O> outConverter,
RandomAccessibleInterval<O> target)
Compute the result multithreaded into an
ArrayImg of the given Type . |
<O extends RealType<O>,C extends RealType<C>> |
Compute.parallelInto(Converter<RealType<?>,C> inConverter,
C computeType,
O outputType,
Converter<C,O> outConverter,
RandomAccessibleInterval<O> target)
Compute the result multithreaded into an
ArrayImg of the given Type . |
<O extends RealType<O>> |
Compute.parallelInto(RandomAccessibleInterval<O> target)
Compute the result multithreaded into an
ArrayImg of the given Type . |
<O extends RealType<O> & NativeType<O>> |
Compute.parallelIntoArrayImg()
Compute the result multithreaded into an
ArrayImg of the same Type as the first image found,
with mathematical operations using that same Type . |
<O extends RealType<O> & NativeType<O>,C extends RealType<C>> |
Compute.parallelIntoArrayImg(C computeType,
O outputType)
Compute the result multithreaded into an
ArrayImg of the given Type . |
<O extends RealType<O> & NativeType<O>,C extends RealType<C>> |
Compute.parallelIntoArrayImg(C computeType,
O outputType)
Compute the result multithreaded into an
ArrayImg of the given Type . |
<O extends RealType<O> & NativeType<O>,C extends RealType<C>> |
Compute.parallelIntoArrayImg(Converter<RealType<?>,C> inConverter,
C computeType,
O outputType,
Converter<C,O> outConverter)
Compute the result multithreaded into an
ArrayImg of the given Type . |
<O extends RealType<O> & NativeType<O>,C extends RealType<C>> |
Compute.parallelIntoArrayImg(Converter<RealType<?>,C> inConverter,
C computeType,
O outputType,
Converter<C,O> outConverter)
Compute the result multithreaded into an
ArrayImg of the given Type . |
<O extends RealType<O> & NativeType<O>> |
Compute.parallelIntoArrayImg(O outputType)
Compute the result multithreaded into an
ArrayImg of the given Type . |
<O extends RealType<O>> |
Compute.randomAccess()
Returns a
RandomAccess with the same type as the first input image found. |
<C extends RealType<C>,O extends RealType<O>> |
Compute.randomAccess(C computeType,
O outputType,
Converter<C,O> outConverter) |
<C extends RealType<C>,O extends RealType<O>> |
Compute.randomAccess(C computeType,
O outputType,
Converter<C,O> outConverter) |
<C extends RealType<C>,O extends RealType<O>> |
Compute.randomAccess(Converter<RealType<?>,C> inConverter,
C computeType,
O outputType,
Converter<C,O> outConverter) |
<C extends RealType<C>,O extends RealType<O>> |
Compute.randomAccess(Converter<RealType<?>,C> inConverter,
C computeType,
O outputType,
Converter<C,O> outConverter) |
<O extends RealType<O>> |
Compute.randomAccess(O outputType) |
<O extends RealType<O>> |
Compute.randomAccessDouble()
Returns a
RandomAccess with the same type as the first input image found. |
<O extends RealType<O>> |
Compute.randomAccessDouble(O outputType) |
<O extends RealType<O>> |
Compute.randomAccessDouble(O outputType,
Converter<RealType<?>,O> converter) |
<O extends RealType<O>> |
XorLogical.reInit(O tmp,
Map<String,LetBinding<O>> bindings,
Converter<RealType<?>,O> converter,
Map<Variable<O>,OFunction<O>> imgSources) |
<O extends RealType<O>> |
Var.reInit(O tmp,
Map<String,LetBinding<O>> bindings,
Converter<RealType<?>,O> converter,
Map<Variable<O>,OFunction<O>> imgSources) |
<O extends RealType<O>> |
Sub.reInit(O tmp,
Map<String,LetBinding<O>> bindings,
Converter<RealType<?>,O> converter,
Map<Variable<O>,OFunction<O>> imgSources) |
<O extends RealType<O>> |
RandomAccessibleSource.reInit(O tmp,
Map<String,LetBinding<O>> bindings,
Converter<RealType<?>,O> converter,
Map<Variable<O>,OFunction<O>> imgSources) |
<O extends RealType<O>> |
Print.reInit(O tmp,
Map<String,LetBinding<O>> bindings,
Converter<RealType<?>,O> converter,
Map<Variable<O>,OFunction<O>> imgSources) |
<O extends RealType<O>> |
Pow.reInit(O tmp,
Map<String,LetBinding<O>> bindings,
Converter<RealType<?>,O> converter,
Map<Variable<O>,OFunction<O>> imgSources) |
<O extends RealType<O>> |
OrLogical.reInit(O tmp,
Map<String,LetBinding<O>> bindings,
Converter<RealType<?>,O> converter,
Map<Variable<O>,OFunction<O>> imgSources) |
<O extends RealType<O>> |
OffsetSource.reInit(O tmp,
Map<String,LetBinding<O>> bindings,
Converter<RealType<?>,O> converter,
Map<Variable<O>,OFunction<O>> imgSources) |
<O extends RealType<O>> |
NumberSource.reInit(O tmp,
Map<String,LetBinding<O>> bindings,
Converter<RealType<?>,O> converter,
Map<Variable<O>,OFunction<O>> imgSources) |
<O extends RealType<O>> |
NotLogical.reInit(O tmp,
Map<String,LetBinding<O>> bindings,
Converter<RealType<?>,O> converter,
Map<Variable<O>,OFunction<O>> imgSources) |
<O extends RealType<O>> |
NotEqual.reInit(O tmp,
Map<String,LetBinding<O>> bindings,
Converter<RealType<?>,O> converter,
Map<Variable<O>,OFunction<O>> imgSources) |
<O extends RealType<O>> |
Mul.reInit(O tmp,
Map<String,LetBinding<O>> bindings,
Converter<RealType<?>,O> converter,
Map<Variable<O>,OFunction<O>> imgSources) |
<O extends RealType<O>> |
Minus.reInit(O tmp,
Map<String,LetBinding<O>> bindings,
Converter<RealType<?>,O> converter,
Map<Variable<O>,OFunction<O>> imgSources) |
<O extends RealType<O>> |
Min.reInit(O tmp,
Map<String,LetBinding<O>> bindings,
Converter<RealType<?>,O> converter,
Map<Variable<O>,OFunction<O>> imgSources) |
<O extends RealType<O>> |
Max.reInit(O tmp,
Map<String,LetBinding<O>> bindings,
Converter<RealType<?>,O> converter,
Map<Variable<O>,OFunction<O>> imgSources) |
<O extends RealType<O>> |
Log.reInit(O tmp,
Map<String,LetBinding<O>> bindings,
Converter<RealType<?>,O> converter,
Map<Variable<O>,OFunction<O>> imgSources) |
<O extends RealType<O>> |
Let.reInit(O tmp,
Map<String,LetBinding<O>> bindings,
Converter<RealType<?>,O> converter,
Map<Variable<O>,OFunction<O>> imgSources) |
<O extends RealType<O>> |
LessThan.reInit(O tmp,
Map<String,LetBinding<O>> bindings,
Converter<RealType<?>,O> converter,
Map<Variable<O>,OFunction<O>> imgSources) |
<O extends RealType<O>> |
KDTreeSource.reInit(O tmp,
Map<String,LetBinding<O>> bindings,
Converter<RealType<?>,O> converter,
Map<Variable<O>,OFunction<O>> imgSources) |
<O extends RealType<O>> |
ImgSource.reInit(O tmp,
Map<String,LetBinding<O>> bindings,
Converter<RealType<?>,O> converter,
Map<Variable<O>,OFunction<O>> imgSources) |
<O extends RealType<O>> |
If.reInit(O tmp,
Map<String,LetBinding<O>> bindings,
Converter<RealType<?>,O> converter,
Map<Variable<O>,OFunction<O>> imgSources) |
<O extends RealType<O>> |
GreaterThan.reInit(O tmp,
Map<String,LetBinding<O>> bindings,
Converter<RealType<?>,O> converter,
Map<Variable<O>,OFunction<O>> imgSources) |
<O extends RealType<O>> |
Exp.reInit(O tmp,
Map<String,LetBinding<O>> bindings,
Converter<RealType<?>,O> converter,
Map<Variable<O>,OFunction<O>> imgSources) |
<O extends RealType<O>> |
Equal.reInit(O tmp,
Map<String,LetBinding<O>> bindings,
Converter<RealType<?>,O> converter,
Map<Variable<O>,OFunction<O>> imgSources) |
<O extends RealType<O>> |
Div.reInit(O tmp,
Map<String,LetBinding<O>> bindings,
Converter<RealType<?>,O> converter,
Map<Variable<O>,OFunction<O>> imgSources) |
<O extends RealType<O>> |
BlockReadSource.reInit(O tmp,
Map<String,LetBinding<O>> bindings,
Converter<RealType<?>,O> converter,
Map<Variable<O>,OFunction<O>> imgSources) |
<O extends RealType<O>> |
AndLogical.reInit(O tmp,
Map<String,LetBinding<O>> bindings,
Converter<RealType<?>,O> converter,
Map<Variable<O>,OFunction<O>> imgSources) |
<O extends RealType<O>> |
Add.reInit(O tmp,
Map<String,LetBinding<O>> bindings,
Converter<RealType<?>,O> converter,
Map<Variable<O>,OFunction<O>> imgSources) |
static <T extends RealType<T>> |
ImgMath.source(RandomAccessible<T> src) |
<O extends RealType<O>> |
Compute.view() |
<O extends RealType<O>,C extends RealType<C>> |
Compute.view(C computingType,
O outputType)
View the result of the computations as a
RandomAccessibleInterval , i.e. |
<O extends RealType<O>,C extends RealType<C>> |
Compute.view(C computingType,
O outputType)
View the result of the computations as a
RandomAccessibleInterval , i.e. |
<O extends RealType<O>> |
Compute.view(Interval interval) |
<O extends RealType<O>,C extends RealType<C>> |
Compute.view(Interval interval,
Converter<RealType<?>,C> inConverter,
C computingType,
O outputType,
Converter<C,O> outConverter) |
<O extends RealType<O>,C extends RealType<C>> |
Compute.view(Interval interval,
Converter<RealType<?>,C> inConverter,
C computingType,
O outputType,
Converter<C,O> outConverter) |
<O extends RealType<O>> |
Compute.view(Interval interval,
O outputType) |
<O extends RealType<O>> |
Compute.view(O outputType) |
static <O extends RealType<O>> |
ImgMath.view(ViewableFunction operation)
Almost all
IFunction are also ViewableFunction . |
Modifier and Type | Method and Description |
---|---|
static <O extends RealType<O>> |
ImgMath.computeInto(IFunction operation,
RandomAccessibleInterval<O> target,
Converter<RealType<?>,O> converter) |
<C extends RealType<C>,O extends RealType<O>> |
Compute.cursor(Converter<RealType<?>,C> inConverter,
C computeType,
O outputType,
Converter<C,O> outConverter) |
<O extends RealType<O>> |
Compute.cursorDouble(O outputType,
Converter<RealType<?>,O> converter) |
<O extends RealType<O>,C extends RealType<C>> |
Compute.into(RandomAccessibleInterval<O> target,
Converter<RealType<?>,C> inConverter,
C computingType,
Converter<C,O> outConverter) |
<O extends RealType<O>,C extends RealType<C>> |
Compute.into(RandomAccessibleInterval<O> target,
Converter<RealType<?>,C> inConverter,
C computingType,
Converter<C,O> outConverter,
boolean printHierarchy)
Execute the mathematical operations and store the result into the given
RandomAccessibleInterval . |
<O extends RealType<O>> |
Compute.into(RandomAccessibleInterval<O> target,
Converter<RealType<?>,O> inConverter)
Execute the mathematical operations and store the result into the given
RandomAccessibleInterval . |
<O extends RealType<O>,C extends RealType<C>> |
Compute.parallelInto(Converter<RealType<?>,C> inConverter,
C computeType,
O outputType,
Converter<C,O> outConverter,
RandomAccessibleInterval<O> target)
Compute the result multithreaded into an
ArrayImg of the given Type . |
<O extends RealType<O> & NativeType<O>,C extends RealType<C>> |
Compute.parallelIntoArrayImg(Converter<RealType<?>,C> inConverter,
C computeType,
O outputType,
Converter<C,O> outConverter)
Compute the result multithreaded into an
ArrayImg of the given Type . |
<C extends RealType<C>,O extends RealType<O>> |
Compute.randomAccess(Converter<RealType<?>,C> inConverter,
C computeType,
O outputType,
Converter<C,O> outConverter) |
<O extends RealType<O>> |
Compute.randomAccessDouble(O outputType,
Converter<RealType<?>,O> converter) |
<O extends RealType<O>> |
XorLogical.reInit(O tmp,
Map<String,LetBinding<O>> bindings,
Converter<RealType<?>,O> converter,
Map<Variable<O>,OFunction<O>> imgSources) |
<O extends RealType<O>> |
Var.reInit(O tmp,
Map<String,LetBinding<O>> bindings,
Converter<RealType<?>,O> converter,
Map<Variable<O>,OFunction<O>> imgSources) |
<O extends RealType<O>> |
Sub.reInit(O tmp,
Map<String,LetBinding<O>> bindings,
Converter<RealType<?>,O> converter,
Map<Variable<O>,OFunction<O>> imgSources) |
<O extends RealType<O>> |
RandomAccessibleSource.reInit(O tmp,
Map<String,LetBinding<O>> bindings,
Converter<RealType<?>,O> converter,
Map<Variable<O>,OFunction<O>> imgSources) |
<O extends RealType<O>> |
Print.reInit(O tmp,
Map<String,LetBinding<O>> bindings,
Converter<RealType<?>,O> converter,
Map<Variable<O>,OFunction<O>> imgSources) |
<O extends RealType<O>> |
Pow.reInit(O tmp,
Map<String,LetBinding<O>> bindings,
Converter<RealType<?>,O> converter,
Map<Variable<O>,OFunction<O>> imgSources) |
<O extends RealType<O>> |
OrLogical.reInit(O tmp,
Map<String,LetBinding<O>> bindings,
Converter<RealType<?>,O> converter,
Map<Variable<O>,OFunction<O>> imgSources) |
<O extends RealType<O>> |
OffsetSource.reInit(O tmp,
Map<String,LetBinding<O>> bindings,
Converter<RealType<?>,O> converter,
Map<Variable<O>,OFunction<O>> imgSources) |
<O extends RealType<O>> |
NumberSource.reInit(O tmp,
Map<String,LetBinding<O>> bindings,
Converter<RealType<?>,O> converter,
Map<Variable<O>,OFunction<O>> imgSources) |
<O extends RealType<O>> |
NotLogical.reInit(O tmp,
Map<String,LetBinding<O>> bindings,
Converter<RealType<?>,O> converter,
Map<Variable<O>,OFunction<O>> imgSources) |
<O extends RealType<O>> |
NotEqual.reInit(O tmp,
Map<String,LetBinding<O>> bindings,
Converter<RealType<?>,O> converter,
Map<Variable<O>,OFunction<O>> imgSources) |
<O extends RealType<O>> |
Mul.reInit(O tmp,
Map<String,LetBinding<O>> bindings,
Converter<RealType<?>,O> converter,
Map<Variable<O>,OFunction<O>> imgSources) |
<O extends RealType<O>> |
Minus.reInit(O tmp,
Map<String,LetBinding<O>> bindings,
Converter<RealType<?>,O> converter,
Map<Variable<O>,OFunction<O>> imgSources) |
<O extends RealType<O>> |
Min.reInit(O tmp,
Map<String,LetBinding<O>> bindings,
Converter<RealType<?>,O> converter,
Map<Variable<O>,OFunction<O>> imgSources) |
<O extends RealType<O>> |
Max.reInit(O tmp,
Map<String,LetBinding<O>> bindings,
Converter<RealType<?>,O> converter,
Map<Variable<O>,OFunction<O>> imgSources) |
<O extends RealType<O>> |
Log.reInit(O tmp,
Map<String,LetBinding<O>> bindings,
Converter<RealType<?>,O> converter,
Map<Variable<O>,OFunction<O>> imgSources) |
<O extends RealType<O>> |
Let.reInit(O tmp,
Map<String,LetBinding<O>> bindings,
Converter<RealType<?>,O> converter,
Map<Variable<O>,OFunction<O>> imgSources) |
<O extends RealType<O>> |
LessThan.reInit(O tmp,
Map<String,LetBinding<O>> bindings,
Converter<RealType<?>,O> converter,
Map<Variable<O>,OFunction<O>> imgSources) |
<O extends RealType<O>> |
KDTreeSource.reInit(O tmp,
Map<String,LetBinding<O>> bindings,
Converter<RealType<?>,O> converter,
Map<Variable<O>,OFunction<O>> imgSources) |
<O extends RealType<O>> |
ImgSource.reInit(O tmp,
Map<String,LetBinding<O>> bindings,
Converter<RealType<?>,O> converter,
Map<Variable<O>,OFunction<O>> imgSources) |
<O extends RealType<O>> |
If.reInit(O tmp,
Map<String,LetBinding<O>> bindings,
Converter<RealType<?>,O> converter,
Map<Variable<O>,OFunction<O>> imgSources) |
<O extends RealType<O>> |
GreaterThan.reInit(O tmp,
Map<String,LetBinding<O>> bindings,
Converter<RealType<?>,O> converter,
Map<Variable<O>,OFunction<O>> imgSources) |
<O extends RealType<O>> |
Exp.reInit(O tmp,
Map<String,LetBinding<O>> bindings,
Converter<RealType<?>,O> converter,
Map<Variable<O>,OFunction<O>> imgSources) |
<O extends RealType<O>> |
Equal.reInit(O tmp,
Map<String,LetBinding<O>> bindings,
Converter<RealType<?>,O> converter,
Map<Variable<O>,OFunction<O>> imgSources) |
<O extends RealType<O>> |
Div.reInit(O tmp,
Map<String,LetBinding<O>> bindings,
Converter<RealType<?>,O> converter,
Map<Variable<O>,OFunction<O>> imgSources) |
<O extends RealType<O>> |
BlockReadSource.reInit(O tmp,
Map<String,LetBinding<O>> bindings,
Converter<RealType<?>,O> converter,
Map<Variable<O>,OFunction<O>> imgSources) |
<O extends RealType<O>> |
AndLogical.reInit(O tmp,
Map<String,LetBinding<O>> bindings,
Converter<RealType<?>,O> converter,
Map<Variable<O>,OFunction<O>> imgSources) |
<O extends RealType<O>> |
Add.reInit(O tmp,
Map<String,LetBinding<O>> bindings,
Converter<RealType<?>,O> converter,
Map<Variable<O>,OFunction<O>> imgSources) |
<O extends RealType<O>,C extends RealType<C>> |
Compute.view(Interval interval,
Converter<RealType<?>,C> inConverter,
C computingType,
O outputType,
Converter<C,O> outConverter) |
Modifier and Type | Class and Description |
---|---|
class |
ABooleanFunction<O extends RealType<O>> |
interface |
OFunction<O extends RealType<O>> |
Modifier and Type | Field and Description |
---|---|
protected O |
ABooleanFunction.one |
protected RealType<?> |
AUnaryFunction.scrap |
protected O |
ABooleanFunction.zero |
Modifier and Type | Method and Description |
---|---|
static <O extends RealType<O>> |
Util.findAllIterableImgSource(OFunction<O> f) |
static <O extends RealType<O>> |
Util.findFirstIterableImgSource(OFunction<O> f) |
static <O extends RealType<O>> |
Util.genericRealTypeConverter() |
<O extends RealType<O>> |
PassThrough.reInit(O tmp,
Map<String,LetBinding<O>> bindings,
Converter<RealType<?>,O> converter,
Map<Variable<O>,OFunction<O>> imgSources) |
<O extends RealType<O>> |
IFunction.reInit(O tmp,
Map<String,LetBinding<O>> bindings,
Converter<RealType<?>,O> converter,
Map<Variable<O>,OFunction<O>> imgSources) |
<C extends RealType<C>,O extends RealType<O>> |
ViewableFunction.view() |
<C extends RealType<C>,O extends RealType<O>> |
ViewableFunction.view() |
<C extends RealType<C>,O extends RealType<O>> |
ViewableFunction.view(C computeType,
O outputType) |
<C extends RealType<C>,O extends RealType<O>> |
ViewableFunction.view(C computeType,
O outputType) |
<C extends RealType<C>,O extends RealType<O>> |
ViewableFunction.view(O outputType) |
<C extends RealType<C>,O extends RealType<O>> |
ViewableFunction.view(O outputType) |
<C extends RealType<C>,O extends RealType<O>> |
ViewableFunction.view(O outputType,
Converter<C,O> converter) |
<C extends RealType<C>,O extends RealType<O>> |
ViewableFunction.view(O outputType,
Converter<C,O> converter) |
<O extends RealType<O>> |
ViewableFunction.viewDouble() |
<O extends RealType<O>> |
ViewableFunction.viewDouble(O outputType) |
<O extends RealType<O>> |
ViewableFunction.viewDouble(O outputType,
Converter<RealType<?>,O> converter) |
Modifier and Type | Method and Description |
---|---|
static <O extends RealType<O>> |
Util.genericRealTypeConverter() |
Modifier and Type | Method and Description |
---|---|
<O extends RealType<O>> |
PassThrough.reInit(O tmp,
Map<String,LetBinding<O>> bindings,
Converter<RealType<?>,O> converter,
Map<Variable<O>,OFunction<O>> imgSources) |
<O extends RealType<O>> |
IFunction.reInit(O tmp,
Map<String,LetBinding<O>> bindings,
Converter<RealType<?>,O> converter,
Map<Variable<O>,OFunction<O>> imgSources) |
<O extends RealType<O>> |
ViewableFunction.viewDouble(O outputType,
Converter<RealType<?>,O> converter) |
Modifier and Type | Class and Description |
---|---|
class |
Addition<O extends RealType<O>> |
class |
BlockReadingDirect<O extends RealType<O>> |
class |
BlockReadingSource<I extends RealType<I>,O extends RealType<O>> |
class |
BlockReadingSource<I extends RealType<I>,O extends RealType<O>> |
class |
Comparison<O extends RealType<O>> |
class |
Division<O extends RealType<O>> |
class |
Equality<O extends RealType<O>> |
class |
Exponential<O extends RealType<O>>
Doesn't use
NumericType math because it lacks the log function. |
class |
FunctionCursor<C extends RealType<C>,O extends RealType<O>> |
class |
FunctionCursor<C extends RealType<C>,O extends RealType<O>> |
class |
FunctionCursorDouble<O extends RealType<O>> |
class |
FunctionCursorDoubleIncompatibleOrder<O extends RealType<O>> |
class |
FunctionCursorIncompatibleOrder<C extends RealType<C>,O extends RealType<O>> |
class |
FunctionCursorIncompatibleOrder<C extends RealType<C>,O extends RealType<O>> |
class |
FunctionRandomAccess<C extends RealType<C>,O extends RealType<O>> |
class |
FunctionRandomAccess<C extends RealType<C>,O extends RealType<O>> |
class |
FunctionRandomAccessDouble<O extends RealType<O>> |
class |
IfStatement<O extends RealType<O>> |
class |
IfStatementBoolean<O extends RealType<O>> |
class |
ImgSourceIterable<I extends RealType<I>,O extends RealType<O>> |
class |
ImgSourceIterable<I extends RealType<I>,O extends RealType<O>> |
class |
ImgSourceIterableDirect<O extends RealType<O>> |
class |
IsGreaterThan<O extends RealType<O>> |
class |
IsLessThan<O extends RealType<O>> |
class |
IterableRandomAccessibleFunction<C extends RealType<C>,O extends RealType<O>>
|
class |
IterableRandomAccessibleFunction<C extends RealType<C>,O extends RealType<O>>
|
class |
IterableRandomAccessibleFunctionDouble<O extends RealType<O>> |
class |
KDTreeRadiusSource<I extends RealType<I>,O extends RealType<O>> |
class |
KDTreeRadiusSource<I extends RealType<I>,O extends RealType<O>> |
class |
LetBinding<O extends RealType<O>> |
class |
Logarithm<O extends RealType<O>>
Doesn't use
NumericType math because it lacks the log function. |
class |
LogicalAnd<O extends RealType<O>> |
class |
LogicalAndBoolean<O extends RealType<O>> |
class |
LogicalNot<O extends RealType<O>> |
class |
LogicalNotBoolean<O extends RealType<O>> |
class |
LogicalOr<O extends RealType<O>> |
class |
LogicalOrBoolean<O extends RealType<O>> |
class |
LogicalXor<O extends RealType<O>> |
class |
LogicalXorBoolean<O extends RealType<O>> |
class |
Maximum<O extends RealType<O>> |
class |
Minimum<O extends RealType<O>> |
class |
Multiplication<O extends RealType<O>> |
class |
NotEquality<O extends RealType<O>> |
class |
NumericSource<O extends RealType<O>> |
class |
Power<O extends RealType<O>> |
class |
Printing<O extends RealType<O>> |
class |
RandomAccessibleOffsetSource<I extends RealType<I>,O extends RealType<O>> |
class |
RandomAccessibleOffsetSource<I extends RealType<I>,O extends RealType<O>> |
class |
RandomAccessibleOffsetSourceDirect<O extends RealType<O>> |
class |
Subtraction<O extends RealType<O>> |
class |
Variable<O extends RealType<O>> |
class |
ZeroMinus<O extends RealType<O>> |
Modifier and Type | Field and Description |
---|---|
protected C |
IterableRandomAccessibleFunction.computeType |
protected O |
IterableRandomAccessibleFunction.outputType |
protected O |
RandomAccessibleOffsetSource.scrap |
protected O |
BlockReadingSource.scrap |
protected C |
FunctionCursor.scrapC |
protected O |
FunctionCursor.scrapO |
protected O |
BlockReadingSource.tmp |
Modifier and Type | Field and Description |
---|---|
protected Converter<RealType<?>,C> |
IterableRandomAccessibleFunction.inConverter |
protected Converter<RealType<?>,C> |
FunctionCursor.inConverter |
Constructor and Description |
---|
BlockReadingSource(O scrap,
Converter<RealType<?>,O> converter,
RandomAccessible<I> src,
long[][] corners,
byte[] signs) |
FunctionCursor(IFunction operation,
Converter<RealType<?>,C> inConverter,
C computeType,
O outputType,
Converter<C,O> outConverter) |
FunctionCursorDouble(IFunction operation,
O outputType,
Converter<RealType<?>,O> converter) |
FunctionCursorDoubleIncompatibleOrder(IFunction operation,
O outputType,
Converter<RealType<?>,O> converter) |
FunctionCursorIncompatibleOrder(IFunction operation,
Converter<RealType<?>,C> inConverter,
C computeType,
O outputType,
Converter<C,O> outConverter) |
FunctionRandomAccess(IFunction operation,
Converter<RealType<?>,C> inConverter,
C computeType,
O outputType,
Converter<C,O> outConverter) |
FunctionRandomAccessDouble(IFunction operation,
O outputType,
Converter<RealType<?>,O> converter) |
IterableRandomAccessibleFunction(IFunction operation,
Converter<RealType<?>,C> inConverter,
C computeType,
O outputType,
Converter<C,O> outConverter) |
IterableRandomAccessibleFunctionDouble(IFunction operation,
O outputType,
Converter<RealType<?>,O> converter) |
KDTreeRadiusSource(O scrap,
Converter<RealType<?>,O> converter,
KDTree<I> kdtree,
double radius,
I outside,
Interval interval) |
LetBinding(O scrap,
String varName,
Map<String,LetBinding<O>> bindings,
IFunction varValue,
IFunction body,
Converter<RealType<?>,O> converter,
Map<Variable<O>,OFunction<O>> imgSources) |
RandomAccessibleOffsetSource(O scrap,
Converter<RealType<?>,O> converter,
RandomAccessible<I> src,
long[] offset) |
Modifier and Type | Method and Description |
---|---|
static <T extends RealType<T>> |
BlackTopHat.blackTopHat(Img<T> source,
List<? extends Shape> strels,
int numThreads)
|
static <T extends RealType<T>> |
BlackTopHat.blackTopHat(Img<T> source,
Shape strel,
int numThreads)
|
static <T extends RealType<T>> |
BlackTopHat.blackTopHat(RandomAccessible<T> source,
IterableInterval<T> target,
List<? extends Shape> strels,
int numThreads)
Performs the black top-hat (or bottom-hat) morphological operation on a
RealType source RandomAccessible , using a list of
Shape s as a structuring element, and writes the result on a
specified target which must be an IterableInterval . |
static <T extends RealType<T>> |
BlackTopHat.blackTopHat(RandomAccessible<T> source,
IterableInterval<T> target,
Shape strel,
int numThreads)
Performs the black top-hat (or bottom-hat) morphological operation on a
RealType source RandomAccessible , using a Shape
as a structuring element, and writes the result on a specified target
which must be an IterableInterval . |
static <T extends RealType<T>> |
BlackTopHat.blackTopHatInPlace(RandomAccessible<T> source,
Interval interval,
List<? extends Shape> strels,
int numThreads)
|
static <T extends RealType<T>> |
BlackTopHat.blackTopHatInPlace(RandomAccessible<T> source,
Interval interval,
Shape strel,
int numThreads)
|
static <T extends RealType<T>> |
Closing.close(Img<T> source,
List<? extends Shape> strels,
int numThreads)
|
static <T extends RealType<T>> |
Closing.close(Img<T> source,
Shape strel,
int numThreads)
|
static <T extends RealType<T>> |
Closing.close(RandomAccessible<T> source,
IterableInterval<T> target,
List<? extends Shape> strels,
int numThreads)
Performs the morphological closing operation on a
RealType source
RandomAccessible , using a list of Shape s as a structuring
element, and writes the result on a specified target which must be an
IterableInterval . |
static <T extends RealType<T>> |
Closing.close(RandomAccessible<T> source,
IterableInterval<T> target,
Shape strel,
int numThreads)
Performs the morphological closing operation on a
RealType source
RandomAccessible , using a Shape as a structuring element,
and writes the result on a specified target which must be an
IterableInterval . |
static <T extends RealType<T>> |
Closing.closeInPlace(RandomAccessibleInterval<T> source,
Interval interval,
List<? extends Shape> strels,
int numThreads)
Performs the closing morphological operation, on a source
RandomAccessibleInterval using a list of Shape s as a flat
structuring element. |
static <T extends RealType<T>> |
Closing.closeInPlace(RandomAccessibleInterval<T> source,
Interval interval,
Shape strel,
int numThreads)
Performs the closing morphological operation, on a
RealType
RandomAccessibleInterval using a Shape as a flat
structuring element. |
static <T extends RealType<T>> |
Dilation.dilate(Img<T> source,
List<? extends Shape> strels,
int numThreads)
|
static <T extends RealType<T>> |
Dilation.dilate(Img<T> source,
Shape strel,
int numThreads)
|
static <T extends RealType<T>> |
Dilation.dilate(RandomAccessible<T> source,
IterableInterval<T> target,
List<? extends Shape> strels,
int numThreads)
Performs the dilation morphological operation, on a
RealType
RandomAccessible as a source and writing results in an
IterableInterval . |
static <T extends RealType<T>> |
Dilation.dilate(RandomAccessible<T> source,
IterableInterval<T> target,
Shape strel,
int numThreads)
Performs the dilation morphological operation, on a
RealType
RandomAccessible as a source and writing results in an
IterableInterval . |
static <T extends RealType<T>> |
Dilation.dilateFull(Img<T> source,
List<? extends Shape> strels,
int numThreads)
|
static <T extends RealType<T>> |
Dilation.dilateFull(Img<T> source,
Shape strel,
int numThreads)
|
static <T extends RealType<T>> |
Dilation.dilateInPlace(RandomAccessibleInterval<T> source,
Interval interval,
List<? extends Shape> strels,
int numThreads)
Performs the dilation morphological operation, on a
RealType
RandomAccessibleInterval using a Shape as a flat
structuring element. |
static <T extends RealType<T>> |
Dilation.dilateInPlace(RandomAccessibleInterval<T> source,
Interval interval,
Shape strel,
int numThreads)
Performs the dilation morphological operation, on a
RealType
RandomAccessibleInterval using a Shape as a flat
structuring element. |
static <T extends RealType<T>> |
Erosion.erode(Img<T> source,
List<? extends Shape> strels,
int numThreads)
|
static <T extends RealType<T>> |
Erosion.erode(Img<T> source,
Shape strel,
int numThreads)
|
static <T extends RealType<T>> |
Erosion.erode(RandomAccessible<T> source,
IterableInterval<T> target,
List<? extends Shape> strels,
int numThreads)
Performs the erosion morphological operation, on a
RealType
RandomAccessible as a source and writing results in an
IterableInterval . |
static <T extends RealType<T>> |
Erosion.erode(RandomAccessible<T> source,
IterableInterval<T> target,
Shape strel,
int numThreads)
Performs the erosion morphological operation, on a
RealType
RandomAccessible as a source and writing results in an
IterableInterval . |
static <T extends RealType<T>> |
Erosion.erodeFull(Img<T> source,
List<? extends Shape> strels,
int numThreads)
|
static <T extends RealType<T>> |
Erosion.erodeFull(Img<T> source,
Shape strel,
int numThreads)
|
static <T extends RealType<T>> |
Erosion.erodeInPlace(RandomAccessible<T> source,
Interval interval,
List<? extends Shape> strels,
int numThreads)
Performs the erosion morphological operation, on a
RealType
RandomAccessibleInterval using a Shape as a flat
structuring element. |
static <T extends RealType<T>> |
Erosion.erodeInPlace(RandomAccessible<T> source,
Interval interval,
Shape strel,
int numThreads)
Performs the erosion morphological operation, on a
RealType
RandomAccessibleInterval using a Shape as a flat
structuring element. |
static <T extends RealType<T>> |
Opening.open(Img<T> source,
List<? extends Shape> strels,
int numThreads)
|
static <T extends RealType<T>> |
Opening.open(Img<T> source,
Shape strel,
int numThreads)
|
static <T extends RealType<T>> |
Opening.open(RandomAccessible<T> source,
IterableInterval<T> target,
List<? extends Shape> strels,
int numThreads)
Performs the morphological opening operation on a
RealType source
RandomAccessible , using a list of Shape s as a structuring
element, and writes the result on a specified target which must be an
IterableInterval . |
static <T extends RealType<T>> |
Opening.open(RandomAccessible<T> source,
IterableInterval<T> target,
Shape strel,
int numThreads)
Performs the morphological opening operation on a
RealType source
RandomAccessible , using a Shape as a structuring element,
and writes the result on a specified target which must be an
IterableInterval . |
static <T extends RealType<T>> |
Opening.openInPlace(RandomAccessibleInterval<T> source,
Interval interval,
List<? extends Shape> strels,
int numThreads)
Performs the opening morphological operation, on a source
RandomAccessibleInterval using a list of Shape s as a flat
structuring element. |
static <T extends RealType<T>> |
Opening.openInPlace(RandomAccessibleInterval<T> source,
Interval interval,
Shape strel,
int numThreads)
Performs the opening morphological operation, on a
RealType
RandomAccessibleInterval using a Shape as a flat
structuring element. |
static <T extends RealType<T>> |
TopHat.topHat(Img<T> source,
List<? extends Shape> strels,
int numThreads)
|
static <T extends RealType<T>> |
TopHat.topHat(Img<T> source,
Shape strel,
int numThreads)
|
static <T extends RealType<T>> |
TopHat.topHat(RandomAccessible<T> source,
IterableInterval<T> target,
List<? extends Shape> strels,
int numThreads)
Performs the top-hat (white top-hat) morphological operation on a
RealType source RandomAccessible , using a list of
Shape s as a structuring element, and writes the result on a
specified target which must be an IterableInterval . |
static <T extends RealType<T>> |
TopHat.topHat(RandomAccessible<T> source,
IterableInterval<T> target,
Shape strel,
int numThreads)
Performs the top-hat (white top-hat) morphological operation on a
RealType source RandomAccessible , using a Shape
as a structuring element, and writes the result on a specified target
which must be an IterableInterval . |
static <T extends RealType<T>> |
TopHat.topHatInPlace(RandomAccessible<T> source,
Interval interval,
List<? extends Shape> strels,
int numThreads)
|
static <T extends RealType<T>> |
TopHat.topHatInPlace(RandomAccessible<T> source,
Interval interval,
Shape strel,
int numThreads)
|
Modifier and Type | Method and Description |
---|---|
static <B extends BooleanType<B>,U extends RealType<U>> |
DistanceTransform.binaryTransform(RandomAccessible<B> source,
RandomAccessibleInterval<U> target,
Distance d)
Create binary distance transform on
source using arbitrary
Distance d. |
static <B extends BooleanType<B>,U extends RealType<U>> |
DistanceTransform.binaryTransform(RandomAccessible<B> source,
RandomAccessibleInterval<U> target,
Distance d,
ExecutorService es,
int nTasks)
Create binary distance transform on
source using arbitrary
Distance d. |
static <B extends BooleanType<B>,U extends RealType<U>> |
DistanceTransform.binaryTransform(RandomAccessible<B> source,
RandomAccessibleInterval<U> target,
DistanceTransform.DISTANCE_TYPE distanceType,
double... weights)
Create binary distance transform on
source using squared
Euclidian (L2) or L1 distance. |
static <B extends BooleanType<B>,U extends RealType<U>> |
DistanceTransform.binaryTransform(RandomAccessible<B> source,
RandomAccessibleInterval<U> target,
DistanceTransform.DISTANCE_TYPE distanceType,
ExecutorService es,
int nTasks,
double... weights)
Create binary distance transform on
source using squared
Euclidian (L2) or L1 distance. |
static <B extends BooleanType<B>,U extends RealType<U>,V extends RealType<V>> |
DistanceTransform.binaryTransform(RandomAccessible<B> source,
RandomAccessibleInterval<U> tmp,
RandomAccessibleInterval<V> target,
Distance d)
Create binary distance transform on
source using arbitrary
Distance d. |
static <B extends BooleanType<B>,U extends RealType<U>,V extends RealType<V>> |
DistanceTransform.binaryTransform(RandomAccessible<B> source,
RandomAccessibleInterval<U> tmp,
RandomAccessibleInterval<V> target,
Distance d)
Create binary distance transform on
source using arbitrary
Distance d. |
static <B extends BooleanType<B>,U extends RealType<U>,V extends RealType<V>> |
DistanceTransform.binaryTransform(RandomAccessible<B> source,
RandomAccessibleInterval<U> tmp,
RandomAccessibleInterval<V> target,
Distance d,
ExecutorService es,
int nTasks)
Create binary distance transform on
source using arbitrary
Distance d. |
static <B extends BooleanType<B>,U extends RealType<U>,V extends RealType<V>> |
DistanceTransform.binaryTransform(RandomAccessible<B> source,
RandomAccessibleInterval<U> tmp,
RandomAccessibleInterval<V> target,
Distance d,
ExecutorService es,
int nTasks)
Create binary distance transform on
source using arbitrary
Distance d. |
static <B extends BooleanType<B>,U extends RealType<U>,V extends RealType<V>> |
DistanceTransform.binaryTransform(RandomAccessible<B> source,
RandomAccessibleInterval<U> tmp,
RandomAccessibleInterval<V> target,
DistanceTransform.DISTANCE_TYPE distanceType,
double... weights)
Create binary distance transform on
source using squared
Euclidian (L2) or L1 distance. |
static <B extends BooleanType<B>,U extends RealType<U>,V extends RealType<V>> |
DistanceTransform.binaryTransform(RandomAccessible<B> source,
RandomAccessibleInterval<U> tmp,
RandomAccessibleInterval<V> target,
DistanceTransform.DISTANCE_TYPE distanceType,
double... weights)
Create binary distance transform on
source using squared
Euclidian (L2) or L1 distance. |
static <B extends BooleanType<B>,U extends RealType<U>,V extends RealType<V>> |
DistanceTransform.binaryTransform(RandomAccessible<B> source,
RandomAccessibleInterval<U> tmp,
RandomAccessibleInterval<V> target,
DistanceTransform.DISTANCE_TYPE distanceType,
ExecutorService es,
int nTasks,
double... weights)
Create binary distance transform on
source using squared
Euclidian (L2) or L1 distance. |
static <B extends BooleanType<B>,U extends RealType<U>,V extends RealType<V>> |
DistanceTransform.binaryTransform(RandomAccessible<B> source,
RandomAccessibleInterval<U> tmp,
RandomAccessibleInterval<V> target,
DistanceTransform.DISTANCE_TYPE distanceType,
ExecutorService es,
int nTasks,
double... weights)
Create binary distance transform on
source using squared
Euclidian (L2) or L1 distance. |
static <T extends RealType<T>,U extends RealType<U>> |
DistanceTransform.transform(RandomAccessible<T> source,
RandomAccessibleInterval<U> target,
Distance d)
|
static <T extends RealType<T>,U extends RealType<U>> |
DistanceTransform.transform(RandomAccessible<T> source,
RandomAccessibleInterval<U> target,
Distance d)
|
static <T extends RealType<T>,U extends RealType<U>> |
DistanceTransform.transform(RandomAccessible<T> source,
RandomAccessibleInterval<U> target,
Distance d,
ExecutorService es,
int nTasks)
|
static <T extends RealType<T>,U extends RealType<U>> |
DistanceTransform.transform(RandomAccessible<T> source,
RandomAccessibleInterval<U> target,
Distance d,
ExecutorService es,
int nTasks)
|
static <T extends RealType<T>,U extends RealType<U>> |
DistanceTransform.transform(RandomAccessible<T> source,
RandomAccessibleInterval<U> target,
DistanceTransform.DISTANCE_TYPE distanceType,
double... weights)
Create
distance
transforms of sampled functions on
source using squared
Euclidian (L2) or L1 distance. |
static <T extends RealType<T>,U extends RealType<U>> |
DistanceTransform.transform(RandomAccessible<T> source,
RandomAccessibleInterval<U> target,
DistanceTransform.DISTANCE_TYPE distanceType,
double... weights)
Create
distance
transforms of sampled functions on
source using squared
Euclidian (L2) or L1 distance. |
static <T extends RealType<T>,U extends RealType<U>> |
DistanceTransform.transform(RandomAccessible<T> source,
RandomAccessibleInterval<U> target,
DistanceTransform.DISTANCE_TYPE distanceType,
ExecutorService es,
int nTasks,
double... weights)
Create
distance
transforms of sampled functions on
source using squared
Euclidian (L2) or L1 distance. |
static <T extends RealType<T>,U extends RealType<U>> |
DistanceTransform.transform(RandomAccessible<T> source,
RandomAccessibleInterval<U> target,
DistanceTransform.DISTANCE_TYPE distanceType,
ExecutorService es,
int nTasks,
double... weights)
Create
distance
transforms of sampled functions on
source using squared
Euclidian (L2) or L1 distance. |
static <T extends RealType<T>,U extends RealType<U>,V extends RealType<V>> |
DistanceTransform.transform(RandomAccessible<T> source,
RandomAccessibleInterval<U> tmp,
RandomAccessibleInterval<V> target,
Distance d)
|
static <T extends RealType<T>,U extends RealType<U>,V extends RealType<V>> |
DistanceTransform.transform(RandomAccessible<T> source,
RandomAccessibleInterval<U> tmp,
RandomAccessibleInterval<V> target,
Distance d)
|
static <T extends RealType<T>,U extends RealType<U>,V extends RealType<V>> |
DistanceTransform.transform(RandomAccessible<T> source,
RandomAccessibleInterval<U> tmp,
RandomAccessibleInterval<V> target,
Distance d)
|
static <T extends RealType<T>,U extends RealType<U>,V extends RealType<V>> |
DistanceTransform.transform(RandomAccessible<T> source,
RandomAccessibleInterval<U> tmp,
RandomAccessibleInterval<V> target,
Distance d,
ExecutorService es,
int nTasks)
|
static <T extends RealType<T>,U extends RealType<U>,V extends RealType<V>> |
DistanceTransform.transform(RandomAccessible<T> source,
RandomAccessibleInterval<U> tmp,
RandomAccessibleInterval<V> target,
Distance d,
ExecutorService es,
int nTasks)
|
static <T extends RealType<T>,U extends RealType<U>,V extends RealType<V>> |
DistanceTransform.transform(RandomAccessible<T> source,
RandomAccessibleInterval<U> tmp,
RandomAccessibleInterval<V> target,
Distance d,
ExecutorService es,
int nTasks)
|
static <T extends RealType<T>,U extends RealType<U>,V extends RealType<V>> |
DistanceTransform.transform(RandomAccessible<T> source,
RandomAccessibleInterval<U> tmp,
RandomAccessibleInterval<V> target,
DistanceTransform.DISTANCE_TYPE distanceType,
double... weights)
Create
distance
transforms of sampled functions on
source using squared
Euclidian (L2) or L1 distance. |
static <T extends RealType<T>,U extends RealType<U>,V extends RealType<V>> |
DistanceTransform.transform(RandomAccessible<T> source,
RandomAccessibleInterval<U> tmp,
RandomAccessibleInterval<V> target,
DistanceTransform.DISTANCE_TYPE distanceType,
double... weights)
Create
distance
transforms of sampled functions on
source using squared
Euclidian (L2) or L1 distance. |
static <T extends RealType<T>,U extends RealType<U>,V extends RealType<V>> |
DistanceTransform.transform(RandomAccessible<T> source,
RandomAccessibleInterval<U> tmp,
RandomAccessibleInterval<V> target,
DistanceTransform.DISTANCE_TYPE distanceType,
double... weights)
Create
distance
transforms of sampled functions on
source using squared
Euclidian (L2) or L1 distance. |
static <T extends RealType<T>,U extends RealType<U>,V extends RealType<V>> |
DistanceTransform.transform(RandomAccessible<T> source,
RandomAccessibleInterval<U> tmp,
RandomAccessibleInterval<V> target,
DistanceTransform.DISTANCE_TYPE distanceType,
ExecutorService es,
int nTasks,
double... weights)
Create
distance
transforms of sampled functions on
source using squared
Euclidian (L2) or L1 distance. |
static <T extends RealType<T>,U extends RealType<U>,V extends RealType<V>> |
DistanceTransform.transform(RandomAccessible<T> source,
RandomAccessibleInterval<U> tmp,
RandomAccessibleInterval<V> target,
DistanceTransform.DISTANCE_TYPE distanceType,
ExecutorService es,
int nTasks,
double... weights)
Create
distance
transforms of sampled functions on
source using squared
Euclidian (L2) or L1 distance. |
static <T extends RealType<T>,U extends RealType<U>,V extends RealType<V>> |
DistanceTransform.transform(RandomAccessible<T> source,
RandomAccessibleInterval<U> tmp,
RandomAccessibleInterval<V> target,
DistanceTransform.DISTANCE_TYPE distanceType,
ExecutorService es,
int nTasks,
double... weights)
Create
distance
transforms of sampled functions on
source using squared
Euclidian (L2) or L1 distance. |
static <T extends RealType<T>> |
DistanceTransform.transform(RandomAccessibleInterval<T> source,
Distance d)
|
static <T extends RealType<T>> |
DistanceTransform.transform(RandomAccessibleInterval<T> source,
Distance d,
ExecutorService es,
int nTasks)
|
static <T extends RealType<T>> |
DistanceTransform.transform(RandomAccessibleInterval<T> source,
DistanceTransform.DISTANCE_TYPE distanceType,
double... weights)
Create
distance
transforms of sampled functions on
source using squared
Euclidian (L2) or L1 distance. |
static <T extends RealType<T>> |
DistanceTransform.transform(RandomAccessibleInterval<T> source,
DistanceTransform.DISTANCE_TYPE distanceType,
ExecutorService es,
int nTasks,
double... weights)
Create
distance
transforms of sampled functions on
source using squared
Euclidian (L2) or L1 distance. |
Modifier and Type | Class and Description |
---|---|
class |
CoherenceEnhancingDiffusionTensor2D<T extends RealType<T>> |
class |
ExplicitDiffusionScheme<T extends RealType<T>> |
class |
ExplicitDiffusionScheme2D<T extends RealType<T>>
An abstract class for the 2D solvers of the diffusion equation.
|
class |
ExplicitDiffusionScheme3D<T extends RealType<T>> |
class |
Gradient<T extends RealType<T>> |
class |
IsotropicDiffusionTensor<T extends RealType<T>> |
class |
MomentOfInertiaTensor2D<T extends RealType<T>>
A class to compute a diffusion tensor for anisotropic diffusion, based on
moment of inertia.
|
class |
MomentOfInertiaTensor3D<T extends RealType<T>>
A class to compute a diffusion tensor for anisotropic diffusion, based on
moment of inertia.
|
class |
NonNegativityDiffusionScheme2D<T extends RealType<T>> |
class |
NonNegativityDiffusionScheme3D<T extends RealType<T>> |
class |
PeronaMalikAnisotropicDiffusion<T extends RealType<T>>
Perona & Malik Anisotropic diffusion
|
class |
StandardDiffusionScheme2D<T extends RealType<T>> |
class |
StandardDiffusionScheme3D<T extends RealType<T>> |
Modifier and Type | Method and Description |
---|---|
protected static <T extends RealType<T>> |
PeronaMalikAnisotropicDiffusion.copy(RandomAccessibleInterval<T> input,
ImgFactory<FloatType> factory)
|
static <T extends RealType<T>> |
PeronaMalikAnisotropicDiffusion.inFloatInPlace(Img<T> input,
double deltat,
double kappa) |
static <T extends RealType<T>> |
PeronaMalikAnisotropicDiffusion.inFloatInPlace(Img<T> input,
double deltat,
PeronaMalikAnisotropicDiffusion.DiffusionFunction function) |
static <T extends RealType<T>> |
PeronaMalikAnisotropicDiffusion.inFloatInPlace(RandomAccessibleInterval<T> input,
ImgFactory<FloatType> factory,
double deltat,
double kappa) |
static <T extends RealType<T>> |
PeronaMalikAnisotropicDiffusion.inFloatInPlace(RandomAccessibleInterval<T> input,
ImgFactory<FloatType> factory,
double deltat,
PeronaMalikAnisotropicDiffusion.DiffusionFunction function) |
static <T extends RealType<T>> |
PeronaMalikAnisotropicDiffusion.toFloat(Img<T> input,
double deltat,
double kappa) |
static <T extends RealType<T>> |
PeronaMalikAnisotropicDiffusion.toFloat(Img<T> input,
double deltat,
PeronaMalikAnisotropicDiffusion.DiffusionFunction function) |
static <T extends RealType<T>> |
PeronaMalikAnisotropicDiffusion.toFloat(RandomAccessibleInterval<T> input,
ImgFactory<FloatType> factory,
double deltat,
double kappa) |
static <T extends RealType<T>> |
PeronaMalikAnisotropicDiffusion.toFloat(RandomAccessibleInterval<T> input,
ImgFactory<FloatType> factory,
double deltat,
PeronaMalikAnisotropicDiffusion.DiffusionFunction function) |
Modifier and Type | Method and Description |
---|---|
static <T extends RealType<T>> |
Circles.inc(RandomAccessible<T> rai,
Localizable center,
long radius)
Writes a circle in the target
RandomAccessible . |
static <T extends RealType<T>> |
Circles.inc(RandomAccessible<T> rai,
Localizable center,
long radius,
int dimX,
int dimY)
Writes a circle in the target
RandomAccessible . |
static <T extends RealType<T>> |
Ellipses.inc(RandomAccessible<T> rai,
Localizable center,
long radiusX,
long radiusY)
Writes an ellipse in the target
RandomAccessible . |
static <T extends RealType<T>> |
Ellipses.inc(RandomAccessible<T> rai,
Localizable center,
long radiusX,
long radiusY,
int dimX,
int dimY)
Writes an ellipse in the target
RandomAccessible . |
Modifier and Type | Class and Description |
---|---|
class |
RealBinMapper<T extends RealType<T>>
A HistogramBinMapper over RealType, using arbitrary-width histogram bins.
|
Modifier and Type | Class and Description |
---|---|
class |
RealARGBConverter<R extends RealType<?>> |
class |
RealDoubleConverter<R extends RealType<R>>
Converts any
RealType to a DoubleType . |
class |
RealFloatConverter<R extends RealType<R>> |
class |
RealLUTConverter<R extends RealType<R>>
RealLUTConverter contains a
ColorTable8 , through which samples are
filtered. |
class |
RealUnsignedByteConverter<R extends RealType<R>> |
class |
RealUnsignedShortConverter<R extends RealType<R>> |
Modifier and Type | Method and Description |
---|---|
static <A extends RealType<A>,B extends Type<B>> |
Converters.composeReal(List<RandomAccessibleInterval<A>> components,
Converter<RealComposite<A>,B> composer,
B targetType)
Compose a list of same
Interval and same RealType A
RandomAccessibleIntervals into a
RandomAccessibleInterval of some target Type B using a
Converter from Composite of A to B. |
static <A extends RealType<A>,B extends Type<B>> |
Converters.composeReal(List<RandomAccessibleInterval<A>> components,
Converter<RealComposite<A>,B> composer,
Supplier<B> targetTypeSupplier)
Compose a list of same
Interval and same RealType A
RandomAccessibleIntervals into a
RandomAccessibleInterval of some target Type B using a
Converter from Composite of A to B. |
static <T extends RealType<T>> |
RealTypeConverters.convert(RandomAccessibleInterval<? extends RealType<?>> image,
T pixelType)
Convert the pixel type of the given image to a given output pixel type.
|
static <S extends RealType<?>,T extends RealType<?>> |
RealTypeConverters.getConverter(S inputType,
T outputType)
Returns a converter that converts from input to output type.
|
static <S extends RealType<?>,T extends RealType<?>> |
RealTypeConverters.getConverter(S inputType,
T outputType)
Returns a converter that converts from input to output type.
|
Modifier and Type | Method and Description |
---|---|
static <T extends RealType<T>> |
RealTypeConverters.convert(RandomAccessibleInterval<? extends RealType<?>> image,
T pixelType)
Convert the pixel type of the given image to a given output pixel type.
|
static void |
RealTypeConverters.copyFromTo(RandomAccessible<? extends RealType<?>> source,
RandomAccessibleInterval<? extends RealType<?>> destination)
Copy the image content from a source image to a destination image.
|
static void |
RealTypeConverters.copyFromTo(RandomAccessible<? extends RealType<?>> source,
RandomAccessibleInterval<? extends RealType<?>> destination)
Copy the image content from a source image to a destination image.
|
Modifier and Type | Class and Description |
---|---|
class |
RealDoubleSamplerConverter<R extends RealType<R>>
TODO
|
class |
RealFloatSamplerConverter<R extends RealType<R>>
TODO
|
Modifier and Type | Class and Description |
---|---|
class |
Real1dBinMapper<T extends RealType<T>>
Maps real values into a 1-d set of bins.
|
Modifier and Type | Method and Description |
---|---|
static <K extends RealType<K>> |
Real1dBinMapper.histogramNd(double[] minVals,
double[] maxVals,
long[] numBins,
boolean[] tailBins)
This is a convenience method for creating a
HistogramNd from
inputs that describe a set of real 1-d based bin mappers. |
Modifier and Type | Method and Description |
---|---|
static <T extends RealType<T>> |
ImageJFunctions.showFloat(RandomAccessibleInterval<T> img) |
static <T extends RealType<T>> |
ImageJFunctions.showFloat(RandomAccessibleInterval<T> img,
ExecutorService service)
Show a
RandomAccessibleInterval of RealType pixels as
single channel 32-bit float using a default Converter . |
static <T extends RealType<T>> |
ImageJFunctions.showFloat(RandomAccessibleInterval<T> img,
String title) |
static <T extends RealType<T>> |
ImageJFunctions.showFloat(RandomAccessibleInterval<T> img,
String title,
ExecutorService service)
Show a
RandomAccessibleInterval of RealType pixels as
single channel 32-bit float using a default Converter . |
static <T extends RealType<T>> |
ImageJFunctions.showUnsignedByte(RandomAccessibleInterval<T> img) |
static <T extends RealType<T>> |
ImageJFunctions.showUnsignedByte(RandomAccessibleInterval<T> img,
ExecutorService service)
Show a
RandomAccessibleInterval of RealType pixels as
single channel 8-bit unsigned integer ImagePlus using a default
Converter . |
static <T extends RealType<T>> |
ImageJFunctions.showUnsignedByte(RandomAccessibleInterval<T> img,
String title) |
static <T extends RealType<T>> |
ImageJFunctions.showUnsignedByte(RandomAccessibleInterval<T> img,
String title,
ExecutorService service)
Show a
RandomAccessibleInterval of RealType pixels as
single channel 8-bit unsigned integer ImagePlus using a default
Converter (clamp values to range [0, 255]). |
static <T extends RealType<T>> |
ImageJFunctions.showUnsignedShort(RandomAccessibleInterval<T> img) |
static <T extends RealType<T>> |
ImageJFunctions.showUnsignedShort(RandomAccessibleInterval<T> img,
ExecutorService service)
Show a
RandomAccessibleInterval of RealType pixels as
single channel 16-bit unsigned integer ImagePlus using a default
Converter . |
static <T extends RealType<T>> |
ImageJFunctions.showUnsignedShort(RandomAccessibleInterval<T> img,
String title) |
static <T extends RealType<T>> |
ImageJFunctions.showUnsignedShort(RandomAccessibleInterval<T> img,
String title,
ExecutorService service)
Show a
RandomAccessibleInterval of RealType pixels as
single channel 16-bit unsigned integer ImagePlus using a default
Converter . |
static <T extends RealType<?>> |
ImageJVirtualStackUnsignedShort.wrap(RandomAccessibleInterval<T> source) |
static <T extends RealType<?>> |
ImageJVirtualStackUnsignedByte.wrap(RandomAccessibleInterval<T> source) |
static <T extends RealType<?>> |
ImageJVirtualStackFloat.wrap(RandomAccessibleInterval<T> source) |
static <T extends RealType<T>> |
ImageJFunctions.wrapBit(RandomAccessibleInterval<T> img,
String title) |
static <T extends RealType<T>> |
ImageJFunctions.wrapBit(RandomAccessibleInterval<T> img,
String title,
ExecutorService service)
Create a single channel 8-bit unsigned integer
ImagePlus from a
BitType RandomAccessibleInterval using a custom Converter
. |
static <T extends RealType<T>> |
ImageJFunctions.wrapFloat(RandomAccessibleInterval<T> img,
String title) |
static <T extends RealType<T>> |
ImageJFunctions.wrapFloat(RandomAccessibleInterval<T> img,
String title,
ExecutorService service)
Create a single channel 32-bit float
ImagePlus from a
RandomAccessibleInterval using a custom Converter . |
static <T extends RealType<T>> |
ImageJFunctions.wrapReal(ij.ImagePlus imp) |
static <T extends RealType<T> & NativeType<T>> |
ImageJFunctions.wrapRealNative(ij.ImagePlus imp) |
static <T extends RealType<T>> |
ImageJFunctions.wrapUnsignedByte(RandomAccessibleInterval<T> img,
String title) |
static <T extends RealType<T>> |
ImageJFunctions.wrapUnsignedByte(RandomAccessibleInterval<T> img,
String title,
ExecutorService service)
Create a single channel 8-bit unsigned integer
ImagePlus from a
RandomAccessibleInterval using a custom Converter . |
static <T extends RealType<T>> |
ImageJFunctions.wrapUnsignedShort(RandomAccessibleInterval<T> img,
String title) |
static <T extends RealType<T>> |
ImageJFunctions.wrapUnsignedShort(RandomAccessibleInterval<T> img,
String title,
ExecutorService service)
Create a single channel 16-bit unsigned integer
ImagePlus from a
RandomAccessibleInterval using a default Converter (clamp
values to range [0, 65535]). |
Modifier and Type | Method and Description |
---|---|
static boolean |
ImgPlusViews.canFuseColor(ImgPlus<? extends RealType<?>> image)
Indicates it
ImgPlusViews.fuseColor(ImgPlus) can by used. |
static ImgPlus<ARGBType> |
ImgPlusViews.fuseColor(ImgPlus<? extends RealType<?>> image)
Generates a color image from a gray scale image that has a color axes of
dimension 3.
|
static ij.ImagePlus |
ImgToVirtualStack.wrap(ImgPlus<? extends RealType<?>> imgPlus,
boolean mergeRGB) |
Modifier and Type | Class and Description |
---|---|
class |
FloatAccessProxy<T extends RealType<T>>
Proxy access over any
RealType container. |
Modifier and Type | Class and Description |
---|---|
class |
InverseDistanceWeightingInterpolator<T extends RealType<T>>
RealRandomAccess to a KNearestNeighborSearch whose sample
value is generated by weighting the k nearest neighbors of a query
real coordinate by their inverse distance to an arbitrary power p. |
class |
InverseDistanceWeightingInterpolatorFactory<T extends RealType<T>>
Factory for
InverseDistanceWeightingInterpolator instances that work
on a KNearestNeighborSearch . |
Modifier and Type | Class and Description |
---|---|
class |
ClampingNLinearInterpolatorRealType<T extends RealType<T>>
N-linear interpolator for
RealType values with overflow check. |
class |
ClampingNLinearInterpolatorVolatileRealType<R extends RealType<R>,T extends AbstractVolatileRealType<R,T>>
N-linear interpolator for
RealType values with overflow check. |
class |
LanczosInterpolator<T extends RealType<T>>
n-dimensional double-based Lanczos Interpolation
|
class |
LanczosInterpolatorFactory<T extends RealType<T>>
TODO
|
Modifier and Type | Field and Description |
---|---|
protected T |
LanczosInterpolator.interpolatedValue |
Modifier and Type | Class and Description |
---|---|
class |
OutOfBoundsRandomValue<T extends RealType<T>>
Return a random value in a certain range when outside of the Interval
|
class |
OutOfBoundsRandomValueFactory<T extends RealType<T>,F extends Interval & RandomAccessible<T>> |
Modifier and Type | Field and Description |
---|---|
protected T |
OutOfBoundsRandomValueFactory.value |
Modifier and Type | Class and Description |
---|---|
class |
DeformationFieldTransform<T extends RealType<T>>
A
RealTransform by continuous offset lookup. |
class |
InvertibleDeformationFieldTransform<T extends RealType<T>> |
class |
PositionFieldTransform<T extends RealType<T>>
A
RealTransform by continuous coordinate lookup. |
Modifier and Type | Method and Description |
---|---|
protected static <T extends RealType<T>> |
PositionFieldTransform.extendAndInterpolate(RandomAccessibleInterval<T>[] positions,
OutOfBoundsFactory<T,RandomAccessibleInterval<T>> outOfBoundsFactory,
InterpolatorFactory<T,RandomAccessible<T>> interpolatorFactory) |
Modifier and Type | Method and Description |
---|---|
static void |
ImgLib2Assert.assertImageEqualsRealType(RandomAccessibleInterval<? extends RealType<?>> expected,
RandomAccessibleInterval<? extends RealType<?>> actual,
double tolerance)
Throws an AssertionError, if the content or intervals of the two images
differ.
|
static void |
ImgLib2Assert.assertImageEqualsRealType(RandomAccessibleInterval<? extends RealType<?>> expected,
RandomAccessibleInterval<? extends RealType<?>> actual,
double tolerance)
Throws an AssertionError, if the content or intervals of the two images
differ.
|
Modifier and Type | Interface and Description |
---|---|
interface |
BooleanType<T extends BooleanType<T>>
TODO
|
Modifier and Type | Class and Description |
---|---|
class |
BitType
TODO
|
class |
BoolType
A
BooleanType wrapping a single primitive boolean variable. |
class |
NativeBoolType
NativeType backed by boolean . |
Modifier and Type | Interface and Description |
---|---|
interface |
RealType<T extends RealType<T>>
TODO
|
Modifier and Type | Interface and Description |
---|---|
interface |
IntegerType<T extends IntegerType<T>>
TODO
|
Modifier and Type | Class and Description |
---|---|
class |
AbstractIntegerBitType<T extends AbstractIntegerBitType<T>>
The performance of this type is traded off for the gain in memory storage.
|
class |
AbstractIntegerType<T extends AbstractIntegerType<T>>
TODO
|
class |
ByteLongAccessType |
class |
ByteType
TODO
|
class |
GenericByteLongAccessType<T extends GenericByteLongAccessType<T>>
TODO
|
class |
GenericByteType<T extends GenericByteType<T>>
TODO
|
class |
GenericIntLongAccessType<T extends GenericIntLongAccessType<T>> |
class |
GenericIntType<T extends GenericIntType<T>>
TODO
|
class |
GenericLongLongAccessType<T extends GenericLongLongAccessType<T>>
Abstract superclass for Long types.
|
class |
GenericLongType<T extends GenericLongType<T>>
Abstract superclass for Long types.
|
class |
GenericShortLongAccessType<T extends GenericShortLongAccessType<T>>
Abstract base class for
native IntegerType s that
encode their value into a 16bit short. |
class |
GenericShortType<T extends GenericShortType<T>>
Abstract base class for
native IntegerType s that
encode their value into a 16bit short. |
class |
IntLongAccessType |
class |
IntType
TODO
|
class |
LongLongAccessType |
class |
LongType
TODO
|
class |
ShortLongAccessType |
class |
ShortType
TODO
|
class |
Unsigned128BitType
A
Type with a bit depth of 128. |
class |
Unsigned12BitType
A 12-bit
Type whose data is stored in a LongAccess . |
class |
Unsigned2BitType
A
Type with a bit depth of 2. |
class |
Unsigned4BitType
A
Type with a bit depth of 4. |
class |
UnsignedByteLongAccessType |
class |
UnsignedByteType
TODO
|
class |
UnsignedIntLongAccessType |
class |
UnsignedIntType
TODO
|
class |
UnsignedLongLongAccessType
TODO
|
class |
UnsignedLongType
TODO
|
class |
UnsignedShortLongAccessType |
class |
UnsignedShortType
TODO
|
class |
UnsignedVariableBitLengthType
A
Type with arbitrary bit depth up to maximum 64 bits. |
Modifier and Type | Class and Description |
---|---|
class |
AbstractRealType<T extends AbstractRealType<T>>
TODO
|
class |
DoubleLongAccessType |
class |
DoubleType
TODO
|
class |
FloatLongAccessType |
class |
FloatType
TODO
|
Modifier and Type | Class and Description |
---|---|
class |
AbstractVolatileNativeRealType<R extends RealType<R> & NativeType<R>,T extends AbstractVolatileNativeRealType<R,T>>
|
class |
AbstractVolatileRealType<R extends RealType<R>,T extends AbstractVolatileRealType<R,T>>
Abstract base class for
VolatileRealType s that wrap RealType . |
class |
VolatileRealType<T extends RealType<T>>
Something volatile that has a value and is either VALID or INVALID.
|
Modifier and Type | Class and Description |
---|---|
class |
AbstractVolatileNativeRealType<R extends RealType<R> & NativeType<R>,T extends AbstractVolatileNativeRealType<R,T>>
|
class |
AbstractVolatileRealType<R extends RealType<R>,T extends AbstractVolatileRealType<R,T>>
Abstract base class for
VolatileRealType s that wrap RealType . |
class |
VolatileByteType
|
class |
VolatileDoubleType
A
Volatile variant of DoubleType . |
class |
VolatileFloatType
|
class |
VolatileIntType
|
class |
VolatileLongType
|
class |
VolatileRealType<T extends RealType<T>>
Something volatile that has a value and is either VALID or INVALID.
|
class |
VolatileShortType
|
class |
VolatileUnsignedByteType
A
Volatile variant of UnsignedByteType . |
class |
VolatileUnsignedIntType
A
Volatile variant of UnsignedIntType . |
class |
VolatileUnsignedLongType
A
Volatile variant of UnsignedLongType . |
class |
VolatileUnsignedShortType
A
Volatile variant of UnsignedShortType . |
Modifier and Type | Method and Description |
---|---|
static <T extends RealType<T>> |
ImgUtil.copy(double[] src,
int offset,
int[] stride,
Img<T> dest)
Copy a flat array of doubles into an Img.
|
static <T extends RealType<T>> |
ImgUtil.copy(float[] src,
int offset,
int[] stride,
Img<T> dest) |
static <T extends RealType<T>> |
ImgUtil.copy(Img<T> src,
double[] dest,
int offset,
int[] stride)
Copy the contents of an Img to a double array
|
static <T extends RealType<T>> |
ImgUtil.copy(Img<T> src,
float[] dest,
int offset,
int[] stride) |
Modifier and Type | Method and Description |
---|---|
static double[] |
Util.asDoubleArray(Img<? extends RealType<?>> image)
Returns the pixels of an image of RealType as array of doubles.
|
static double[] |
Util.asDoubleArray(Iterable<? extends RealType<?>> iterable)
Returns the content of
Iterable<RealType> as array of doubles. |
static double[] |
Util.asDoubleArray(RandomAccessibleInterval<? extends RealType<?>> rai)
Returns the pixels of an RandomAccessibleInterval of RealType as array of doubles.
|
static Collection<Double> |
FlatCollections.doubleCollection(IterableInterval<? extends RealType<?>> image)
Wraps a
RealType iterable image as a collection. |
static List<Double> |
FlatCollections.doubleList(RandomAccessibleInterval<? extends RealType<?>> image)
Wraps a
RealType random-accessible image as a list. |
static Collection<Float> |
FlatCollections.floatCollection(IterableInterval<? extends RealType<?>> image)
Wraps a
RealType iterable image as a collection. |
static List<Float> |
FlatCollections.floatList(RandomAccessibleInterval<? extends RealType<?>> image)
Wraps a
RealType random-accessible image as a list. |
Modifier and Type | Method and Description |
---|---|
static <T extends RealType<T>> |
Views.collapseReal(RandomAccessible<T> source,
int numChannels)
Collapse the nth dimension of an n
-dimensional
RandomAccessible <T extends RealType
<T>> into an (n-1)-dimensional RandomAccessible
<RealComposite <T>> |
static <T extends RealType<T>> |
Views.collapseReal(RandomAccessibleInterval<T> source)
Collapse the nth dimension of an n
-dimensional
RandomAccessibleInterval <T extends
RealType <T>> into an (n-1)-dimensional
RandomAccessibleInterval <RealComposite <T>> |
static <T extends RealType<T>> |
Views.expandRandom(RandomAccessibleInterval<T> source,
double min,
double max,
long... border)
Expand a RandomAccessibleInterval as specified by border.
|
static <T extends RealType<T>> |
Views.expandValue(RandomAccessibleInterval<T> source,
double value,
long... border)
Expand a RandomAccessibleInterval as specified by border.
|
static <T extends RealType<T>> |
Views.expandValue(RandomAccessibleInterval<T> source,
float value,
long... border)
Expand a RandomAccessibleInterval as specified by border.
|
static <T extends RealType<T>,F extends RandomAccessibleInterval<T>> |
Views.extendRandom(F source,
double min,
double max)
Extend a RandomAccessibleInterval with a random-value out-of-bounds
strategy.
|
static <T extends RealType<T>,F extends RandomAccessibleInterval<T>> |
Views.extendValue(F source,
double value)
Extend a RandomAccessibleInterval with a constant-value out-of-bounds
strategy.
|
static <T extends RealType<T>,F extends RandomAccessibleInterval<T>> |
Views.extendValue(F source,
float value)
Extend a RandomAccessibleInterval with a constant-value out-of-bounds
strategy.
|
Modifier and Type | Class and Description |
---|---|
class |
RealComposite<T extends RealType<T>>
A vector of
RealType scalars. |
static class |
RealComposite.Factory<T extends RealType<T>> |
Copyright © 2015–2022 ImgLib2. All rights reserved.