- CallbackHandler - Interface in imagingbook.lib.ij
-
- CallbackSender - Interface in imagingbook.lib.ij
-
- CannyEdgeDetector - Class in imagingbook.pub.color.edge
-
This class implements a Canny edge detector for grayscale and RGB images.
- CannyEdgeDetector(ImageProcessor) - Constructor for class imagingbook.pub.color.edge.CannyEdgeDetector
-
- CannyEdgeDetector(ImageProcessor, CannyEdgeDetector.Parameters) - Constructor for class imagingbook.pub.color.edge.CannyEdgeDetector
-
- CannyEdgeDetector.Parameters - Class in imagingbook.pub.color.edge
-
- Cartesian(HomogeneousVector) - Static method in class imagingbook.lib.math.HomogeneousVector
-
- Cdf(int[]) - Static method in class imagingbook.pub.histogram.Util
-
- centralMoment(ImageProcessor, int, int) - Static method in class imagingbook.pub.moments.BinaryMoments
-
- ChamferMatcher - Class in imagingbook.pub.matching
-
This class performs chamfer matching on binary images.
- ChamferMatcher(ByteProcessor) - Constructor for class imagingbook.pub.matching.ChamferMatcher
-
- ChamferMatcher(ByteProcessor, DistanceTransform.Norm) - Constructor for class imagingbook.pub.matching.ChamferMatcher
-
- checkClass(String) - Static method in class imagingbook.lib.util.FileUtils
-
Checks 'by name' if a particular class exists.
- checkOutOfGamut(double, double, double) - Static method in class imagingbook.pub.color.image.RgbGamutChecker
-
- chooseOpenImage(String, ImagePlus) - Static method in class imagingbook.lib.ij.GuiTools
-
- chooseOpenImage(String) - Static method in class imagingbook.lib.ij.GuiTools
-
- chooseOpenImage() - Static method in class imagingbook.lib.ij.GuiTools
-
- ChromaticAdaptation - Class in imagingbook.pub.color.image
-
- ChromaticAdaptation() - Constructor for class imagingbook.pub.color.image.ChromaticAdaptation
-
- ChromaticAdaptation(float[], float[]) - Constructor for class imagingbook.pub.color.image.ChromaticAdaptation
-
- ChromaticAdaptation(Illuminant, Illuminant) - Constructor for class imagingbook.pub.color.image.ChromaticAdaptation
-
- CieUtil - Class in imagingbook.pub.color.image
-
- CieUtil() - Constructor for class imagingbook.pub.color.image.CieUtil
-
- clearProperties() - Method in class imagingbook.pub.regions.RegionLabeling.BinaryRegion
-
Removes all properties attached to this region.
- Clipboard - Class in imagingbook.lib.util
-
Methods from
http://examples.javacodegeeks.com/desktop-java/awt/datatransfer/getting-and-setting-text-on-the-system-clipboard/
- Clipboard() - Constructor for class imagingbook.lib.util.Clipboard
-
- clone() - Method in class imagingbook.pub.fd.FourierDescriptor
-
- clone() - Method in class imagingbook.pub.geometry.mappings.Mapping
-
- clone() - Method in class imagingbook.pub.sift.KeyPoint
-
- close() - Method in class imagingbook.lib.ij.IjLogStream
-
- close(ByteProcessor) - Method in class imagingbook.pub.morphology.BinaryMorphologyFilter
-
- closestRadialIndex(double) - Method in class imagingbook.pub.hough.HoughTransformLinesPosRadius
-
- cmin - Variable in class imagingbook.pub.threshold.adaptive.BernsenThresholder.Parameters
-
- ColorEdgeDetector - Class in imagingbook.pub.color.edge
-
This is the common super-class for all color edge detectors.
- ColorEdgeDetector() - Constructor for class imagingbook.pub.color.edge.ColorEdgeDetector
-
- ColorHistogram - Class in imagingbook.pub.color.statistics
-
This class calculates a color histogram of a set of colors (i.e., a color image).
- ColorHistogram(int[]) - Constructor for class imagingbook.pub.color.statistics.ColorHistogram
-
- ColorHistogram(int[], boolean) - Constructor for class imagingbook.pub.color.statistics.ColorHistogram
-
Creates a color histogram instance from the supplied sequence
of color pixel values (assumed to be ARGB-encoded integers).
- colorMode - Variable in class imagingbook.pub.edgepreservingfilters.PeronaMalikFilter.Parameters
-
Specify the color mode
- colorNorm - Variable in class imagingbook.pub.edgepreservingfilters.BilateralFilter
-
- colorNormType - Variable in class imagingbook.pub.edgepreservingfilters.BilateralFilter.Parameters
-
Specify which distance norm to use
- ColorQuantizer - Class in imagingbook.pub.color.quantize
-
- ColorQuantizer() - Constructor for class imagingbook.pub.color.quantize.ColorQuantizer
-
- Colors - Class in imagingbook.pub.fd
-
- Colors() - Constructor for class imagingbook.pub.fd.Colors
-
- Colors - Class in imagingbook.pub.sift.util
-
- Colors() - Constructor for class imagingbook.pub.sift.util.Colors
-
- Colors.ColorSequencer - Class in imagingbook.pub.fd
-
- colorScale - Variable in class imagingbook.pub.edgepreservingfilters.BilateralFilter
-
- ColorSequencer() - Constructor for class imagingbook.pub.fd.Colors.ColorSequencer
-
- ColorSequencer(int) - Constructor for class imagingbook.pub.fd.Colors.ColorSequencer
-
- ColorStack - Class in imagingbook.pub.color.image
-
This class contains only static methods for handling color images represented as
multi-plane image stacks.
- ColorStack() - Constructor for class imagingbook.pub.color.image.ColorStack
-
- ColorStack.ColorStackType - Enum in imagingbook.pub.color.image
-
- ColorStatistics - Class in imagingbook.pub.color.statistics
-
- ColorStatistics() - Constructor for class imagingbook.pub.color.statistics.ColorStatistics
-
- compareTo(Corner) - Method in class imagingbook.pub.corners.Corner
-
- compareTo(HoughTransformLines.HoughLine) - Method in class imagingbook.pub.hough.HoughTransformLines.HoughLine
-
Required by the
Comparable
interface, used for sorting
lines by their point count.
- compareTo(HoughTransformLinesPosRadius.HoughLine) - Method in class imagingbook.pub.hough.HoughTransformLinesPosRadius.HoughLine
-
Required by the
Comparable
interface, used for sorting
lines by their point count.
- compareTo(Contour) - Method in class imagingbook.pub.regions.Contour
-
- compareTo(RegionLabeling.BinaryRegion) - Method in class imagingbook.pub.regions.RegionLabeling.BinaryRegion
-
- compareTo(KeyPoint) - Method in class imagingbook.pub.sift.KeyPoint
-
- compareTo(SiftDescriptor) - Method in class imagingbook.pub.sift.SiftDescriptor
-
- compareTo(SiftMatch) - Method in class imagingbook.pub.sift.SiftMatch
-
- compareTo(SiftMatch3) - Method in class imagingbook.pub.sift.SiftMatch3
-
- Complex - Class in imagingbook.lib.math
-
- Complex(double, double) - Constructor for class imagingbook.lib.math.Complex
-
- Complex(Point2D) - Constructor for class imagingbook.lib.math.Complex
-
- Complex(Complex) - Constructor for class imagingbook.lib.math.Complex
-
- Complex(double) - Constructor for class imagingbook.lib.math.Complex
-
- componentLabels - Variable in enum imagingbook.pub.color.image.ColorStack.ColorStackType
-
- concat(AffineMapping) - Method in class imagingbook.pub.geometry.mappings.linear.AffineMapping
-
- concat(LinearMapping) - Method in class imagingbook.pub.geometry.mappings.linear.LinearMapping
-
- concat(ProjectiveMapping) - Method in class imagingbook.pub.geometry.mappings.linear.ProjectiveMapping
-
- concatDestructive(LinearMapping) - Method in class imagingbook.pub.geometry.mappings.linear.LinearMapping
-
- concatenate(float[]...) - Static method in class imagingbook.lib.math.Matrix
-
- concatenate(double[]...) - Static method in class imagingbook.lib.math.Matrix
-
- conjugate() - Method in class imagingbook.lib.math.Complex
-
- Contour - Class in imagingbook.pub.regions
-
This class represents a closed contour as a sequence of
pixel coordinates.
- Contour(int) - Constructor for class imagingbook.pub.regions.Contour
-
Creates a new (empty) contour with the given region label.
- ContourOverlay - Class in imagingbook.pub.regions
-
Updated: 2014-11-12
- ContourOverlay(ContourTracer) - Constructor for class imagingbook.pub.regions.ContourOverlay
-
- ContourOverlay(ContourTracer, double, Color, Color) - Constructor for class imagingbook.pub.regions.ContourOverlay
-
- ContourTracer - Interface in imagingbook.pub.regions
-
This interface defines the functionality of region segmenters
that perform contour extraction.
- ConvexHull - Class in imagingbook.pub.regions.geometry
-
This class serves to calculate the convex hull of a binary region
or a closed contour, given as a sequence of point coordinates.
- ConvexHull(RegionLabeling.BinaryRegion) - Constructor for class imagingbook.pub.regions.geometry.ConvexHull
-
- ConvexHull(Contour) - Constructor for class imagingbook.pub.regions.geometry.ConvexHull
-
- convolve(ImagePlus, float[], int, int) - Static method in class imagingbook.pub.color.image.ColorStack
-
- convolveX(ImageProcessor, float[]) - Static method in class imagingbook.lib.image.Filter
-
- convolveXY(ImageProcessor, float[]) - Static method in class imagingbook.lib.image.Filter
-
- convolveY(ImageProcessor, float[]) - Static method in class imagingbook.lib.image.Filter
-
- copyStringToClipboard(String) - Static method in class imagingbook.lib.util.Clipboard
-
- copyToFile(InputStream, File) - Static method in class imagingbook.lib.util.FileUtils
-
Reads all data from the given input stream and copies them
to to a file.
- Corner - Class in imagingbook.pub.corners
-
2013/06/09 Changed to 'final float' coordinates (WB).
- Corner(float, float, float) - Constructor for class imagingbook.pub.corners.Corner
-
- CorrCoeffMatcher - Class in imagingbook.pub.matching
-
- CorrCoeffMatcher(FloatProcessor) - Constructor for class imagingbook.pub.matching.CorrCoeffMatcher
-
- count(int[]) - Method in class imagingbook.pub.threshold.Thresholder
-
- count(int[], int, int) - Method in class imagingbook.pub.threshold.Thresholder
-
- countColors(ColorProcessor) - Static method in class imagingbook.pub.color.statistics.ColorStatistics
-
- countQuantizedColors() - Method in class imagingbook.pub.color.quantize.MedianCutQuantizer
-
Deprecated.
- covarianceMatrix(double[][]) - Static method in class imagingbook.lib.math.Statistics
-
Calculates the covariance matrix for a sequence of sample vectors.
- create(byte[], byte[], byte[]) - Static method in class imagingbook.lib.ij.LookupTables
-
Create a new lookup-table from three RGB arrays of length 256.
- create(ImageProcessor) - Static method in class imagingbook.lib.image.ImageAccessor
-
Creates a new ImageAccessor
instance for the given image,
using the default out-of-bounds strategy and interpolation method.
- create(ImageProcessor, OutOfBoundsStrategy, InterpolationMethod) - Static method in class imagingbook.lib.image.ImageAccessor
-
Creates a new ImageAccessor
instance for the given image,
using the specified out-of-bounds strategy and interpolation method.
- create(ImageProcessor, OutOfBoundsStrategy, InterpolationMethod) - Static method in class imagingbook.lib.image.ImageAccessor.Rgb
-
- create(ImageProcessor, OutOfBoundsStrategy, InterpolationMethod) - Static method in class imagingbook.lib.image.ImageAccessor.Scalar
-
- create(int, int, OutOfBoundsStrategy) - Static method in class imagingbook.lib.image.PixelIndexer
-
- create(ImageAccessor.Scalar) - Static method in class imagingbook.lib.interpolation.PixelInterpolator
-
- create(InterpolationMethod) - Static method in class imagingbook.lib.interpolation.PixelInterpolator
-
- create() - Static method in class imagingbook.pub.noise.hashing.HashFun
-
- create(int) - Static method in class imagingbook.pub.noise.hashing.HashFun
-
Creates a new
HashFun
object initialized with seed.
- createDoubleMatrix(int, int) - Static method in class imagingbook.lib.math.Matrix
-
- createDoubleVector(int) - Static method in class imagingbook.lib.math.Matrix
-
- createFloatMatrix(int, int) - Static method in class imagingbook.lib.math.Matrix
-
- createFloatVector(int) - Static method in class imagingbook.lib.math.Matrix
-
- createFrom(ImagePlus) - Static method in class imagingbook.pub.color.image.ColorStack
-
This static method creates a 3-slice float-stack from a RGB image
- createImage(String, float[][]) - Static method in class imagingbook.lib.ij.IjUtils
-
Creates an ImageJ ImagePlus
image for the matrix M[r][c]
(2D array),
where r
is treated as the row (vertical) coordinate and
c
is treated as the column (horizontal) coordinate.
- createImage(String, double[][]) - Static method in class imagingbook.lib.ij.IjUtils
-
Creates an ImageJ ImagePlus
image for the matrix M[r][c]
(2D array),
where r
is treated as the row (vertical) coordinate and
c
is treated as the column (horizontal) coordinate.
- crossProduct(Complex) - Method in class imagingbook.lib.math.Complex
-
- CssColor - Enum in imagingbook.lib.color
-
- CssColorSequencer - Class in imagingbook.lib.color
-
- CssColorSequencer() - Constructor for class imagingbook.lib.color.CssColorSequencer
-
- CssColorSequencer(int) - Constructor for class imagingbook.lib.color.CssColorSequencer
-
- currentLabel - Variable in class imagingbook.pub.regions.RegionLabeling
-
- g - Variable in class imagingbook.pub.fd.FourierDescriptor
-
- G - Variable in class imagingbook.pub.fd.FourierDescriptor
-
- gammaFwd(double) - Static method in class imagingbook.lib.color.sRgbUtil
-
- gammaFwd(double) - Static method in class imagingbook.pub.color.image.sRgbUtil
-
- gammaInv(double) - Static method in class imagingbook.lib.color.sRgbUtil
-
- gammaInv(double) - Static method in class imagingbook.pub.color.image.sRgbUtil
-
- Gauss() - Constructor for class imagingbook.pub.threshold.adaptive.NiblackThresholder.Gauss
-
- Gauss(NiblackThresholder.Parameters) - Constructor for class imagingbook.pub.threshold.adaptive.NiblackThresholder.Gauss
-
- GaussianFilter - Class in imagingbook.lib.filters
-
- GaussianFilter(double) - Constructor for class imagingbook.lib.filters.GaussianFilter
-
- GaussianFilter(double, double) - Constructor for class imagingbook.lib.filters.GaussianFilter
-
- GaussianFilter - Class in imagingbook.pub.sift.filters
-
- GaussianFilter(double) - Constructor for class imagingbook.pub.sift.filters.GaussianFilter
-
- GaussianOctave - Class in imagingbook.pub.sift.scalespace
-
- GaussianScaleSpace - Class in imagingbook.pub.sift.scalespace
-
- GaussianScaleSpace(FloatProcessor, double, double, int, int, int, int) - Constructor for class imagingbook.pub.sift.scalespace.GaussianScaleSpace
-
- GenericFilter - Class in imagingbook.lib.filters
-
This abstract class represents a generic filter that, when applied to
an ImageProcessor
object performs all pixel-level
iterations automatically.
- GenericFilter() - Constructor for class imagingbook.lib.filters.GenericFilter
-
- get() - Static method in class imagingbook.lib.settings.PrintPrecision
-
- get3x3Neighborhood(int, int, float[][]) - Method in class imagingbook.pub.sift.scalespace.ScaleLevel
-
- getAbsoluteScale(int, float) - Method in class imagingbook.pub.sift.scalespace.HierarchicalScaleSpace
-
- getAbsoluteScale() - Method in class imagingbook.pub.sift.scalespace.ScaleLevel
-
- getAbsoluteScale(int) - Method in class imagingbook.pub.sift.scalespace.ScaleOctave
-
- getAbsoluteScale(int, int) - Method in class imagingbook.pub.sift.scalespace.ScaleOctave
-
- getAccumulator() - Method in class imagingbook.pub.hough.HoughTransformLinesPosRadius
-
- getAccumulatorImage() - Method in class imagingbook.pub.hough.HoughTransformLines
-
Creates and returns an image of the 2D accumulator array.
- getAccumulatorImage() - Method in class imagingbook.pub.hough.HoughTransformLinesPosRadius
-
Creates and returns an image of the 2D accumulator array.
- getAccumulatorImageExtended() - Method in class imagingbook.pub.hough.HoughTransformLines
-
Creates and returns an image of the extended 2D accumulator array,
produced by adding a vertically mirrored copy of the accumulator
to its right end.
- getAccumulatorMax() - Method in class imagingbook.pub.hough.HoughTransformLinesPosRadius
-
- getAccumulatorMaxImage() - Method in class imagingbook.pub.hough.HoughTransformLines
-
Creates and returns an image of the local maxima of the
2D accumulator array.
- getAccumulatorMaxImage() - Method in class imagingbook.pub.hough.HoughTransformLinesPosRadius
-
Creates and returns an image of the local maxima of the
2D accumulator array.
- getAmplitudes() - Method in class imagingbook.pub.noise.perlin.PerlinNoiseGen
-
- getAngle() - Method in class imagingbook.pub.hough.HoughTransformLines.HoughLine
-
- getAngle() - Method in class imagingbook.pub.hough.HoughTransformLinesPosRadius.HoughLine
-
- getBestMatch(double[]) - Method in class imagingbook.pub.lucaskanade.LucasKanadeMatcher1D
-
- getBlockSum1(int, int, int, int) - Method in class imagingbook.lib.image.IntegralImage
-
Calculates the sum of the pixel values in the rectangle
R, specified by the corner points a = (ua, va) and b = (b1, vb).
- getBlockSum2(int, int, int, int) - Method in class imagingbook.lib.image.IntegralImage
-
Calculates the sum of the squared pixel values in the rectangle
R, specified by the corner points a = (ua, va) and b = (b1, vb).
- getBlue() - Method in enum imagingbook.lib.color.CssColor
-
- getBotIndex() - Method in class imagingbook.lib.util.LinearContainer
-
- getBoundingBox() - Method in class imagingbook.pub.regions.RegionLabeling.BinaryRegion
-
Get the x/y axes-parallel bounding box as a rectangle
(including the extremal coordinates).
- getCenter() - Method in class imagingbook.pub.color.filters.FilterMask
-
- getCenter() - Method in class imagingbook.pub.regions.RegionLabeling.BinaryRegion
-
- getCenterPoint() - Method in class imagingbook.pub.regions.RegionLabeling.BinaryRegion
-
Returns the centroid of this region as a 2D point.
- getClassPath(Class<?>) - Static method in class imagingbook.lib.util.FileUtils
-
Find the path from which a given class was loaded.
- getCoefficient(int) - Method in class imagingbook.pub.fd.FourierDescriptor
-
- getCoefficientIndex(int) - Method in class imagingbook.pub.fd.FourierDescriptor
-
- getCoefficients() - Method in class imagingbook.pub.fd.FourierDescriptor
-
- getColor() - Method in enum imagingbook.lib.color.CssColor
-
- getColor(int) - Method in class imagingbook.pub.color.statistics.ColorHistogram
-
Returns the unique color with the given index.
- getColorMap() - Method in class imagingbook.pub.color.quantize.ColorQuantizer
-
Retrieves the color map produced by this color quantizer.
- getColorMap() - Method in class imagingbook.pub.color.quantize.KMeansClusteringQuantizer
-
- getColorMap() - Method in class imagingbook.pub.color.quantize.KMeansClusteringQuantizerApache
-
Lists the color clusters to System.out (intended for debugging only).
- getColorMap() - Method in class imagingbook.pub.color.quantize.MedianCutQuantizer
-
- getColorMap() - Method in class imagingbook.pub.color.quantize.OctreeQuantizer
-
- getColors(CssColor...) - Static method in enum imagingbook.lib.color.CssColor
-
- getColumn(double[][], int) - Static method in class imagingbook.lib.math.Matrix
-
- getCornerPoints() - Method in class imagingbook.pub.regions.geometry.AxisAlignedBoundingBox
-
- getCount() - Method in class imagingbook.pub.color.filters.FilterMask
-
- getCount() - Static method in class imagingbook.pub.color.image.RgbGamutChecker
-
- getCount(int) - Method in class imagingbook.pub.color.statistics.ColorHistogram
-
Returns the frequency of the unique color with the given index.
- getCount() - Method in class imagingbook.pub.hough.HoughTransformLines.HoughLine
-
- getCount() - Method in class imagingbook.pub.hough.HoughTransformLinesPosRadius.HoughLine
-
- getCovarianceMatrix() - Method in class imagingbook.lib.math.MahalanobisDistance
-
- getCurrentErrStream() - Static method in class imagingbook.lib.ij.IjLogStream
-
Returns the redirection stream for System.err
if it exists.
- getCurrentOutStream() - Static method in class imagingbook.lib.ij.IjLogStream
-
Returns the redirection stream for System.out
if it exists.
- getDescriptor1() - Method in class imagingbook.pub.sift.SiftMatch
-
- getDescriptor1() - Method in class imagingbook.pub.sift.SiftMatch3
-
- getDescriptor2() - Method in class imagingbook.pub.sift.SiftMatch
-
- getDescriptor2() - Method in class imagingbook.pub.sift.SiftMatch3
-
- getDescriptor3() - Method in class imagingbook.pub.sift.SiftMatch3
-
- getDistance(double, double) - Method in class imagingbook.pub.hough.HoughTransformLines.HoughLine
-
Returns the perpendicular distance between this line and the point (x, y).
- getDistance(Point2D) - Method in class imagingbook.pub.hough.HoughTransformLines.HoughLine
-
Returns the perpendicular distance between this line and the point p.
- getDistance(double, double) - Method in class imagingbook.pub.hough.HoughTransformLinesPosRadius.HoughLine
-
Returns the perpendicular distance between this line and the point (x, y).
- getDistance(Point2D) - Method in class imagingbook.pub.hough.HoughTransformLinesPosRadius.HoughLine
-
Returns the perpendicular distance between this line and the point p.
- getDistance() - Method in class imagingbook.pub.sift.SiftMatch
-
- getDistance() - Method in class imagingbook.pub.sift.SiftMatch3
-
- getDistanceL1(SiftDescriptor) - Method in class imagingbook.pub.sift.SiftDescriptor
-
- getDistanceL2(SiftDescriptor) - Method in class imagingbook.pub.sift.SiftDescriptor
-
- getDistanceLinf(SiftDescriptor) - Method in class imagingbook.pub.sift.SiftDescriptor
-
- getDistanceMap() - Method in class imagingbook.pub.matching.DistanceTransform
-
- getEdgeBinary() - Method in class imagingbook.pub.color.edge.CannyEdgeDetector
-
- getEdgeMagnitude() - Method in class imagingbook.pub.color.edge.CannyEdgeDetector
-
- getEdgeMagnitude() - Method in class imagingbook.pub.color.edge.ColorEdgeDetector
-
- getEdgeMagnitude() - Method in class imagingbook.pub.color.edge.DiZenzoCumaniEdgeDetector
-
- getEdgeMagnitude() - Method in class imagingbook.pub.color.edge.GrayscaleEdgeDetector
-
- getEdgeMagnitude() - Method in class imagingbook.pub.color.edge.MonochromaticEdgeDetector
-
- getEdgeOrientation() - Method in class imagingbook.pub.color.edge.CannyEdgeDetector
-
- getEdgeOrientation() - Method in class imagingbook.pub.color.edge.ColorEdgeDetector
-
- getEdgeOrientation() - Method in class imagingbook.pub.color.edge.DiZenzoCumaniEdgeDetector
-
- getEdgeOrientation() - Method in class imagingbook.pub.color.edge.GrayscaleEdgeDetector
-
- getEdgeOrientation() - Method in class imagingbook.pub.color.edge.MonochromaticEdgeDetector
-
- getEdgeTraces() - Method in class imagingbook.pub.color.edge.CannyEdgeDetector
-
- getEigenvalue() - Method in class imagingbook.lib.math.Eigensolver2x2.EigenPair
-
- getEigenvector() - Method in class imagingbook.lib.math.Eigensolver2x2.EigenPair
-
- getElement(int) - Method in class imagingbook.lib.util.LinearContainer
-
- getEllipsePoint(Complex, Complex, int, double) - Method in class imagingbook.pub.fd.FourierDescriptor
-
Get the reconstructed point for two DFT coefficients G1, G2 at a given
position t.
- getEnumNames(Class<? extends Enum<?>>) - Static method in class imagingbook.lib.util.Enums
-
This static method returns an array of all constant names (strings)
for a given enumeration class.
- getFeatures() - Method in class imagingbook.pub.sift.SiftDescriptor
-
- getFileExtension(String) - Static method in class imagingbook.lib.util.FileUtils
-
Extracts the extension part of a pathname as a string.
- getFormatStringFloat() - Static method in class imagingbook.lib.settings.PrintPrecision
-
- getFrequencies() - Method in class imagingbook.pub.noise.perlin.PerlinNoiseGen
-
- getFrequencySteps(double, double) - Method in class imagingbook.pub.noise.perlin.PerlinNoiseGen
-
The number of frequency steps, given fmin and fmax.
- getGradientPolar(int, int, double[]) - Method in class imagingbook.pub.sift.scalespace.ScaleLevel
-
- getGreen() - Method in enum imagingbook.lib.color.CssColor
-
- getHeight() - Method in class imagingbook.pub.sift.scalespace.ScaleOctave
-
- getImag() - Method in class imagingbook.pub.dft.Dft2d
-
- getImagePlus(String) - Method in class imagingbook.pub.color.filters.FilterMask
-
- getImageShortTitles(ImagePlus[]) - Static method in class imagingbook.lib.ij.IjUtils
-
Returns an array of strings containing the short titles
of the images supplied.
- getIndex(int, int) - Method in class imagingbook.lib.image.PixelIndexer.DefaultValueIndexer
-
- getIndex(int, int) - Method in class imagingbook.lib.image.PixelIndexer.ExceptionIndexer
-
- getIndex(int, int) - Method in class imagingbook.lib.image.PixelIndexer
-
- getIndex(int, int) - Method in class imagingbook.lib.image.PixelIndexer.MirrorImageIndexer
-
- getIndex(int, int) - Method in class imagingbook.lib.image.PixelIndexer.NearestBorderIndexer
-
- getInnerContours() - Method in interface imagingbook.pub.regions.ContourTracer
-
Retrieves all inner contours of the associated region labeling.
- getInnerContours(boolean) - Method in interface imagingbook.pub.regions.ContourTracer
-
Retrieves all inner contours of the associated region labeling.
- getInnerContours() - Method in class imagingbook.pub.regions.RegionContourLabeling
-
- getInnerContours(boolean) - Method in class imagingbook.pub.regions.RegionContourLabeling
-
- getInnerContours() - Method in class imagingbook.pub.regions.RegionLabeling.BinaryRegion
-
Get all inner contours of this region.
- getInterpolatedValue(ImageAccessor.Scalar, double, double) - Method in class imagingbook.lib.interpolation.BicubicInterpolator
-
- getInterpolatedValue(ImageAccessor.Scalar, double, double) - Method in class imagingbook.lib.interpolation.BilinearInterpolator
-
- getInterpolatedValue(ImageAccessor.Scalar, double, double) - Method in class imagingbook.lib.interpolation.LanczosInterpolator
-
- getInterpolatedValue(ImageAccessor.Scalar, double, double) - Method in class imagingbook.lib.interpolation.NearestNeighborInterpolator
-
- getInterpolatedValue(ImageAccessor.Scalar, double, double) - Method in class imagingbook.lib.interpolation.PixelInterpolator
-
All interpolator classes must implement this method.
- getInterpolatedValue(ImageAccessor.Scalar, double, double) - Method in class imagingbook.lib.interpolation.SplineInterpolator
-
- getInterpolationMethod() - Method in class imagingbook.lib.image.ImageAccessor
-
- getInverse() - Method in class imagingbook.pub.geometry.mappings.linear.LinearMapping
-
- getInverse() - Method in class imagingbook.pub.geometry.mappings.Mapping
-
- getInverseCovarianceMatrix() - Method in class imagingbook.lib.math.MahalanobisDistance
-
- getIteration() - Method in class imagingbook.pub.lucaskanade.LucasKanadeMatcher
-
- getJarManifest(Class<?>) - Static method in class imagingbook.lib.util.FileUtils
-
Finds the manifest (from META-INF/MANIFEST.MF) of the JAR file
from which clazz was loaded.
- getKeyPoints() - Method in class imagingbook.pub.sift.SiftDetector
-
- getLabel() - Method in class imagingbook.pub.regions.Contour
-
Get the region label associated with this contour.
- getLabel(int, int) - Method in class imagingbook.pub.regions.RegionContourLabeling
-
- getLabel() - Method in class imagingbook.pub.regions.RegionLabeling.BinaryRegion
-
Get the label associated with this region.
- getLabel(int, int) - Method in class imagingbook.pub.regions.RegionLabeling
-
Get the label number for the specified image coordinate.
- getLength() - Method in class imagingbook.pub.regions.Contour
-
Get the length of the contour.
- getLevel(int) - Method in class imagingbook.pub.sift.scalespace.ScaleOctave
-
- getLine(ByteProcessor, int) - Method in class imagingbook.pub.threshold.adaptive.AdaptiveThresholder
-
- getLine(FloatProcessor, int) - Method in class imagingbook.pub.threshold.adaptive.AdaptiveThresholder
-
- getLines(int, int) - Method in class imagingbook.pub.hough.HoughTransformLines
-
Finds and returns the parameters of the strongest lines with
a specified min.
- getLines(int, int) - Method in class imagingbook.pub.hough.HoughTransformLinesPosRadius
-
Finds and returns the parameters of the strongest lines with
a specified min.
- getMagnitude() - Method in class imagingbook.pub.sift.SiftDescriptor
-
- getMask() - Method in class imagingbook.pub.color.filters.FilterMask
-
- getMatch(ProjectiveMapping) - Method in class imagingbook.pub.lucaskanade.LucasKanadeMatcher
-
Performs the full optimization on the given image pair (I, R).
- getMatch(ByteProcessor) - Method in class imagingbook.pub.matching.ChamferMatcher
-
- getMatch(Point[], int, int) - Method in class imagingbook.pub.matching.ChamferMatcher
-
- getMatch(FloatProcessor) - Method in class imagingbook.pub.matching.CorrCoeffMatcher
-
- getMax(int[]) - Static method in class imagingbook.lib.math.Statistics
-
- getMax(float[]) - Static method in class imagingbook.lib.math.Statistics
-
- getMax(double[]) - Static method in class imagingbook.lib.math.Statistics
-
- getMaxCoefficientPairs() - Method in class imagingbook.pub.fd.FourierDescriptor
-
- getMaxDftMagnitude() - Method in class imagingbook.pub.fd.FourierDescriptor
-
- getMaxDftMagnitudeIndex() - Method in class imagingbook.pub.fd.FourierDescriptor
-
- getMaxNegHarmonic() - Method in class imagingbook.pub.fd.FourierDescriptor
-
- getMaxPosHarmonic() - Method in class imagingbook.pub.fd.FourierDescriptor
-
- getMean(int, int, int, int) - Method in class imagingbook.lib.image.IntegralImage
-
Calculates the mean of the image values in the specified rectangle.
- getMean(FloatProcessor) - Static method in class imagingbook.lib.image.Statistics
-
- getMeanVector() - Method in class imagingbook.lib.math.MahalanobisDistance
-
- getMin(int[]) - Static method in class imagingbook.lib.math.Statistics
-
- getMin(float[]) - Static method in class imagingbook.lib.math.Statistics
-
- getMin(double[]) - Static method in class imagingbook.lib.math.Statistics
-
- getnAng() - Method in class imagingbook.pub.hough.HoughTransformLinesPosRadius
-
- getNeighborhood(int, int, int, float[][][]) - Method in class imagingbook.pub.sift.scalespace.ScaleOctave
-
- getnRad() - Method in class imagingbook.pub.hough.HoughTransformLinesPosRadius
-
- getNumberOfColors() - Method in class imagingbook.pub.color.statistics.ColorHistogram
-
Returns the number of unique colors.
- getNumberOfColumns(double[][]) - Static method in class imagingbook.lib.math.Matrix
-
- getNumberOfColumns(float[][]) - Static method in class imagingbook.lib.math.Matrix
-
- getNumberOfRows(double[][]) - Static method in class imagingbook.lib.math.Matrix
-
- getNumberOfRows(float[][]) - Static method in class imagingbook.lib.math.Matrix
-
- getNumberOfSamples() - Method in class imagingbook.lib.math.MahalanobisDistance
-
- getOctave(int) - Method in class imagingbook.pub.sift.scalespace.HierarchicalScaleSpace
-
- getOctaveIndex() - Method in class imagingbook.pub.sift.scalespace.ScaleOctave
-
- getOpenImages(boolean) - Static method in class imagingbook.lib.ij.IjUtils
-
Returns a (possibly empty) array of ImagePlus objects that are
sorted by their titles if the 'sortByTitle' flag is set.
- getOpenImages(boolean, ImagePlus) - Static method in class imagingbook.lib.ij.IjUtils
-
Returns a (possibly empty) array of ImagePlus
objects that are
sorted by their titles if the sortByTitle flag is set.
- getOpNames() - Static method in class imagingbook.pub.morphology.old.BinMorpher
-
Deprecated.
- getOrientation() - Method in class imagingbook.pub.sift.SiftDescriptor
-
- getOuterContour() - Method in class imagingbook.pub.regions.RegionLabeling.BinaryRegion
-
Get the (single) outer contour of this region.
- getOuterContours() - Method in interface imagingbook.pub.regions.ContourTracer
-
Retrieves all outer contours of the associated region labeling.
- getOuterContours(boolean) - Method in interface imagingbook.pub.regions.ContourTracer
-
Retrieves all outer contours of the associated region labeling.
- getOuterContours() - Method in class imagingbook.pub.regions.RegionContourLabeling
-
- getOuterContours(boolean) - Method in class imagingbook.pub.regions.RegionContourLabeling
-
- getOutOfBoundsStrategy() - Method in class imagingbook.lib.image.ImageAccessor
-
- getP() - Method in class imagingbook.pub.sift.scalespace.HierarchicalScaleSpace
-
- getPaddedPixel(ByteProcessor, int, int) - Method in class imagingbook.pub.threshold.adaptive.AdaptiveThresholder
-
- getPdf() - Method in class imagingbook.pub.histogram.PiecewiseLinearCdf
-
- getPix(int, int) - Method in class imagingbook.lib.image.ImageAccessor
-
- getPix(double, double) - Method in class imagingbook.lib.image.ImageAccessor
-
- getPix(int, int) - Method in class imagingbook.lib.image.ImageAccessor.Rgb
-
- getPix(double, double) - Method in class imagingbook.lib.image.ImageAccessor.Rgb
-
- getPix(int, int) - Method in class imagingbook.lib.image.ImageAccessor.Scalar
-
- getPix(double, double) - Method in class imagingbook.lib.image.ImageAccessor.Scalar
-
- getPointArray() - Method in class imagingbook.pub.regions.Contour
-
Get the contour points as an array.
- getPointList() - Method in class imagingbook.pub.regions.Contour
-
Get the list of contour points.
- getPolygonPath() - Method in class imagingbook.pub.regions.Contour
-
Get the polygon for this contour (for subsequent drawing).
- getPolygonPath(double, double) - Method in class imagingbook.pub.regions.Contour
-
Get the polygon for this contour (for subsequent drawing).
- getPower() - Method in class imagingbook.pub.dft.Dft2d
-
- getProcessor() - Method in class imagingbook.lib.image.ImageAccessor.Byte
-
- getProcessor() - Method in class imagingbook.lib.image.ImageAccessor.Float
-
- getProcessor() - Method in class imagingbook.lib.image.ImageAccessor
-
- getProcessor() - Method in class imagingbook.lib.image.ImageAccessor.Rgb
-
- getProcessor() - Method in class imagingbook.lib.image.ImageAccessor.Short
-
- getProcessors(ImagePlus) - Static method in class imagingbook.pub.color.image.ColorStack
-
- getProperty(String) - Method in class imagingbook.pub.regions.RegionLabeling.BinaryRegion
-
Retrieves the specified region property.
- getQ() - Method in class imagingbook.pub.corners.Corner
-
- getQ() - Method in class imagingbook.pub.sift.scalespace.HierarchicalScaleSpace
-
- getQuantizedColors() - Method in class imagingbook.pub.color.quantize.MedianCutQuantizer
-
Deprecated.
- getRadius() - Method in class imagingbook.pub.hough.HoughTransformLines.HoughLine
-
- getRadius() - Method in class imagingbook.pub.hough.HoughTransformLinesPosRadius.HoughLine
-
- getReal() - Method in class imagingbook.pub.dft.Dft2d
-
- getRealX(int, double) - Method in class imagingbook.pub.sift.scalespace.HierarchicalScaleSpace
-
- getRealY(int, double) - Method in class imagingbook.pub.sift.scalespace.HierarchicalScaleSpace
-
- getReconstruction(int) - Method in class imagingbook.pub.fd.FourierDescriptor
-
Calculates a reconstruction from the full DFT spectrum with N samples.
- getReconstruction(int, int) - Method in class imagingbook.pub.fd.FourierDescriptor
-
Calculate a reconstruction from the partial DFT spectrum with N sample
points and using Mp coefficient pairs.
- getReconstructionPoint(double) - Method in class imagingbook.pub.fd.FourierDescriptor
-
Reconstructs a single spatial point from the complete FD
at the fractional path position t in [0,1].
- getReconstructionPoint(double, int) - Method in class imagingbook.pub.fd.FourierDescriptor
-
- getReconstructionScale() - Method in class imagingbook.pub.fd.FourierDescriptor
-
- getRed() - Method in enum imagingbook.lib.color.CssColor
-
- getReferenceMappingTo(Point2D[]) - Method in class imagingbook.pub.lucaskanade.LucasKanadeMatcher
-
Calculates the transformation that maps the reference image R
(centered
around the origin) to the given quad Q.
- getReferencePoint() - Method in class imagingbook.pub.hough.HoughTransformLines
-
- getReferencePoint() - Method in class imagingbook.pub.hough.HoughTransformLines.HoughLine
-
- getReferencePoint() - Method in class imagingbook.pub.hough.HoughTransformLinesPosRadius
-
- getReferencePoint() - Method in class imagingbook.pub.hough.HoughTransformLinesPosRadius.HoughLine
-
- getReferencePoints() - Method in class imagingbook.pub.lucaskanade.LucasKanadeMatcher
-
- getRegion(int, int) - Method in class imagingbook.pub.regions.RegionLabeling
-
- getRegionPoints() - Method in class imagingbook.pub.regions.RegionLabeling.BinaryRegion
-
- getRegionPoints(RegionLabeling.BinaryRegion) - Method in class imagingbook.pub.regions.RegionLabeling
-
- getRegions() - Method in class imagingbook.pub.regions.RegionLabeling
-
Get an unsorted list of all regions associated with this region labeling.
- getRegions(boolean) - Method in class imagingbook.pub.regions.RegionLabeling
-
Get a possibly sorted list of all regions associated with this region labeling.
- getRelativeScale(double, double) - Method in class imagingbook.pub.sift.scalespace.HierarchicalScaleSpace
-
- getResourcePath(Class<?>, String) - Static method in class imagingbook.lib.util.ResourceUtils
-
Find the path to a resource relative to the location of class c.
- getResourceUri(Class<?>, String) - Static method in class imagingbook.lib.util.ResourceUtils
-
Finds the URI for a resource relative to a specified class.
- getRGB() - Method in enum imagingbook.lib.color.CssColor
-
- getRGBString() - Method in enum imagingbook.lib.color.CssColor
-
- getRmsError() - Method in class imagingbook.pub.lucaskanade.LucasKanadeForwardMatcher
-
- getRmsError() - Method in class imagingbook.pub.lucaskanade.LucasKanadeInverseMatcher
-
- getRmsError() - Method in class imagingbook.pub.lucaskanade.LucasKanadeMatcher
-
Measures the RMS intensity difference between the reference image R and the
patch in the search image I defined by the current warp Tp.
- getRmsError() - Method in class imagingbook.pub.lucaskanade.LucasKanadeMatcher1D
-
- getRow(double[][], int) - Static method in class imagingbook.lib.math.Matrix
-
- getS1() - Method in class imagingbook.lib.image.IntegralImage
-
Returns the summed area table of pixel values (Sigma_1).
- getS2() - Method in class imagingbook.lib.image.IntegralImage
-
Returns the summed area table of squared pixel values (Sigma_2).
- getSampleDimension() - Method in class imagingbook.lib.math.MahalanobisDistance
-
- getSamples() - Method in class imagingbook.pub.fd.FourierDescriptor
-
- getScale(int) - Method in class imagingbook.lib.math.MahalanobisDistance
-
- getScale(int) - Method in class imagingbook.lib.math.VectorNorm
-
Returns a factor to scale magnitude and distance values
to the range of the vector components of dimensionality
n.
- getScale(int) - Method in class imagingbook.lib.math.VectorNorm.L1
-
- getScale(int) - Method in class imagingbook.lib.math.VectorNorm.L2
-
- getScale(int) - Method in class imagingbook.lib.math.VectorNorm.Linf
-
- getScale() - Method in class imagingbook.pub.sift.SiftDescriptor
-
- getScaleIndex(int, int) - Method in class imagingbook.pub.sift.scalespace.HierarchicalScaleSpace
-
- getScaleIndex(int, int) - Method in class imagingbook.pub.sift.scalespace.ScaleOctave
-
- getScaleIndexFloat(float, float) - Method in class imagingbook.pub.sift.scalespace.HierarchicalScaleSpace
-
- getScaleLevel(int, int) - Method in class imagingbook.pub.sift.scalespace.HierarchicalScaleSpace
-
- getSiftFeatures() - Method in class imagingbook.pub.sift.SiftDetector
-
THE REAL STUFF: Creating the SIFT Descriptors
- getSigma_0() - Method in class imagingbook.pub.sift.scalespace.HierarchicalScaleSpace
-
- getSigma_s() - Method in class imagingbook.pub.sift.scalespace.HierarchicalScaleSpace
-
- getSize(int, int, int, int) - Method in class imagingbook.lib.image.IntegralImage
-
- getSize() - Method in class imagingbook.pub.regions.RegionLabeling.BinaryRegion
-
Get the size of this region.
- getSourceWhite() - Method in class imagingbook.pub.color.image.ChromaticAdaptation
-
- getStartPointPhase(int) - Method in class imagingbook.pub.fd.FourierDescriptor
-
Calculates the 'canonical' start point.
- getStringFromClipboard() - Static method in class imagingbook.lib.util.Clipboard
-
- getTargetWhite() - Method in class imagingbook.pub.color.image.ChromaticAdaptation
-
- getThreshold(ByteProcessor) - Method in class imagingbook.pub.threshold.adaptive.AdaptiveThresholder
-
- getThreshold(ByteProcessor) - Method in class imagingbook.pub.threshold.adaptive.BernsenThresholder
-
- getThreshold(ByteProcessor) - Method in class imagingbook.pub.threshold.adaptive.InterpolatingThresholder
-
- getThreshold(ByteProcessor) - Method in class imagingbook.pub.threshold.adaptive.NiblackThresholder
-
- getThreshold(ByteProcessor) - Method in class imagingbook.pub.threshold.adaptive.SauvolaThresholder
-
- getThreshold(int[]) - Method in class imagingbook.pub.threshold.global.GlobalThresholder
-
- getThreshold(ByteProcessor) - Method in class imagingbook.pub.threshold.global.GlobalThresholder
-
- getThreshold(int[]) - Method in class imagingbook.pub.threshold.global.IsodataThresholder
-
- getThreshold(int[]) - Method in class imagingbook.pub.threshold.global.IsodataThresholderSlow
-
- getThreshold(int[]) - Method in class imagingbook.pub.threshold.global.MaxEntropyThresholder
-
- getThreshold(int[]) - Method in class imagingbook.pub.threshold.global.MeanThresholder
-
- getThreshold(int[]) - Method in class imagingbook.pub.threshold.global.MinErrorThresholder
-
- getThreshold(int[]) - Method in class imagingbook.pub.threshold.global.OtsuThresholder
-
- getThreshold(int[]) - Method in class imagingbook.pub.threshold.global.QuantileThresholder
-
- getTopIndex() - Method in class imagingbook.lib.util.LinearContainer
-
- getTotalError() - Method in class imagingbook.pub.color.quantize.KMeansClusteringQuantizer
-
Returns the total error of this clustering, calculated as the sum of
the squared distances of the color samples to the associated cluster
center.
- getTransformationMatrix() - Method in class imagingbook.pub.geometry.mappings.linear.LinearMapping
-
- getType(ImagePlus) - Static method in class imagingbook.pub.color.image.ColorStack
-
- getUnwarpedImage(ImageProcessor, LinearMapping, int, int) - Static method in class imagingbook.pub.lucaskanade.RoiUtils
-
Deprecated.
- getVal(int, int) - Method in class imagingbook.lib.image.ImageAccessor.Byte
-
- getVal(int, int) - Method in class imagingbook.lib.image.ImageAccessor.Float
-
- getVal(int, int) - Method in class imagingbook.lib.image.ImageAccessor.Scalar
-
- getVal(double, double) - Method in class imagingbook.lib.image.ImageAccessor.Scalar
-
- getVal(int, int) - Method in class imagingbook.lib.image.ImageAccessor.Short
-
- getVariance(int, int, int, int) - Method in class imagingbook.lib.image.IntegralImage
-
Calculates the variance of the image values in the specified rectangle.
- getVariance(FloatProcessor) - Static method in class imagingbook.lib.image.Statistics
-
- getVariance2(FloatProcessor) - Static method in class imagingbook.lib.image.Statistics
-
- getVersion() - Static method in class imagingbook.Info
-
Deprecated.
- getVersionInfo() - Static method in class imagingbook.Info
-
Reads version information from the MANIFEST.MF file of the JAR file from
which this class was loaded.
- getVertices() - Method in class imagingbook.pub.regions.geometry.ConvexHull
-
- getWarpedPointsCentered(Roi, LinearMapping) - Static method in class imagingbook.pub.lucaskanade.RoiUtils
-
Deprecated.
- getWarpJacobian(double[]) - Method in class imagingbook.pub.geometry.mappings.linear.AffineMapping
-
- getWarpJacobian(double[]) - Method in class imagingbook.pub.geometry.mappings.linear.ProjectiveMapping
-
- getWarpJacobian(double[]) - Method in class imagingbook.pub.geometry.mappings.linear.Translation
-
- getWarpJacobian(double[]) - Method in interface imagingbook.pub.geometry.mappings.WarpParameters
-
- getWarpParameterCount() - Method in class imagingbook.pub.geometry.mappings.linear.AffineMapping
-
- getWarpParameterCount() - Method in class imagingbook.pub.geometry.mappings.linear.ProjectiveMapping
-
- getWarpParameterCount() - Method in class imagingbook.pub.geometry.mappings.linear.Translation
-
- getWarpParameterCount() - Method in interface imagingbook.pub.geometry.mappings.WarpParameters
-
- getWarpParameters() - Method in class imagingbook.pub.geometry.mappings.linear.AffineMapping
-
- getWarpParameters() - Method in class imagingbook.pub.geometry.mappings.linear.ProjectiveMapping
-
- getWarpParameters() - Method in class imagingbook.pub.geometry.mappings.linear.Translation
-
- getWarpParameters() - Method in interface imagingbook.pub.geometry.mappings.WarpParameters
-
- getWhiteningTransformation() - Method in class imagingbook.lib.math.MahalanobisDistance
-
Returns the 'root' (U) of the inverse covariance matrix S^{-1},
such that S^{-1} = U^T .
- getWidth() - Method in class imagingbook.pub.sift.scalespace.ScaleOctave
-
- getX() - Method in class imagingbook.pub.corners.Corner
-
- getX() - Method in class imagingbook.pub.sift.SiftDescriptor
-
- getX1Sum() - Method in class imagingbook.pub.regions.RegionLabeling.BinaryRegion
-
Returns the sum of the x-values of the points
contained in this region.
- getX2Sum() - Method in class imagingbook.pub.regions.RegionLabeling.BinaryRegion
-
Returns the sum of the squared x-values of the points
contained in this region.
- getXc() - Method in class imagingbook.pub.regions.RegionLabeling.BinaryRegion
-
Get the x-value of the region's centroid.
- getXyzFloat() - Method in enum imagingbook.pub.color.image.Illuminant
-
- getY() - Method in class imagingbook.pub.corners.Corner
-
- getY() - Method in class imagingbook.pub.sift.SiftDescriptor
-
- getY1Sum() - Method in class imagingbook.pub.regions.RegionLabeling.BinaryRegion
-
Returns the sum of the y-values of the points
contained in this region.
- getY2Sum() - Method in class imagingbook.pub.regions.RegionLabeling.BinaryRegion
-
Returns the sum of the squared y-values of the points
contained in this region.
- getYc() - Method in class imagingbook.pub.regions.RegionLabeling.BinaryRegion
-
Get the y-value of the region's centroid.
- GlobalThresholder - Class in imagingbook.pub.threshold.global
-
- GlobalThresholder() - Constructor for class imagingbook.pub.threshold.global.GlobalThresholder
-
- gradientX(FloatProcessor) - Method in class imagingbook.pub.lucaskanade.LucasKanadeMatcher
-
- gradientY(FloatProcessor) - Method in class imagingbook.pub.lucaskanade.LucasKanadeMatcher
-
- grays() - Static method in class imagingbook.lib.ij.LookupTables
-
ImageJ's 'grays' LUT, as originally defined in class LutLoader
.
- GrayscaleEdgeDetector - Class in imagingbook.pub.color.edge
-
Simple grayscale edge detector for color images.
- GrayscaleEdgeDetector(ImageProcessor) - Constructor for class imagingbook.pub.color.edge.GrayscaleEdgeDetector
-
- GrayscaleEdgeDetector(ImageProcessor, GrayscaleEdgeDetector.Parameters) - Constructor for class imagingbook.pub.color.edge.GrayscaleEdgeDetector
-
- GrayscaleEdgeDetector.Parameters - Class in imagingbook.pub.color.edge
-
Currently unused, no parameters to set
- Green - Static variable in class imagingbook.pub.fd.Colors
-
- Green - Static variable in class imagingbook.pub.sift.util.Colors
-
- gSigma - Variable in class imagingbook.pub.color.edge.CannyEdgeDetector.Parameters
-
Gaussian sigma (scale)
- GuiTools - Class in imagingbook.lib.ij
-
- GuiTools() - Constructor for class imagingbook.lib.ij.GuiTools
-
- handleCallback(CallbackSender, int) - Method in interface imagingbook.lib.ij.CallbackHandler
-
- HarrisCornerDetector - Class in imagingbook.pub.corners
-
This class implements the Harris corner detector.
- HarrisCornerDetector(ImageProcessor) - Constructor for class imagingbook.pub.corners.HarrisCornerDetector
-
- HarrisCornerDetector(ImageProcessor, HarrisCornerDetector.Parameters) - Constructor for class imagingbook.pub.corners.HarrisCornerDetector
-
- HarrisCornerDetector.Parameters - Class in imagingbook.pub.corners
-
Default parameters; a (usually modified) instance of this class
may be passed to constructor of the main class.
- hasConverged() - Method in class imagingbook.pub.lucaskanade.LucasKanadeForwardMatcher
-
- hasConverged() - Method in class imagingbook.pub.lucaskanade.LucasKanadeInverseMatcher
-
- hasConverged() - Method in class imagingbook.pub.lucaskanade.LucasKanadeMatcher
-
Checks if the matcher has converged.
- hash(int) - Method in class imagingbook.pub.noise.hashing.Hash32
-
- hash(int, int) - Method in class imagingbook.pub.noise.hashing.Hash32
-
- hash(int, int, int) - Method in class imagingbook.pub.noise.hashing.Hash32
-
- hash(int[]) - Method in class imagingbook.pub.noise.hashing.Hash32
-
- hash(int) - Method in class imagingbook.pub.noise.hashing.HashFun
-
- hash(int, int) - Method in class imagingbook.pub.noise.hashing.HashFun
-
- hash(int, int, int) - Method in class imagingbook.pub.noise.hashing.HashFun
-
- hash(int[]) - Method in class imagingbook.pub.noise.hashing.HashFun
-
- hash(int) - Method in class imagingbook.pub.noise.hashing.HashPermute
-
- hash(int, int) - Method in class imagingbook.pub.noise.hashing.HashPermute
-
- hash(int, int, int) - Method in class imagingbook.pub.noise.hashing.HashPermute
-
- hash(int[]) - Method in class imagingbook.pub.noise.hashing.HashPermute
-
- Hash32 - Class in imagingbook.pub.noise.hashing
-
Gradient (Perlin) noise implementation.
- Hash32() - Constructor for class imagingbook.pub.noise.hashing.Hash32
-
- Hash32(int) - Constructor for class imagingbook.pub.noise.hashing.Hash32
-
- Hash32Shift - Class in imagingbook.pub.noise.hashing
-
Hash function described in Thomas Wang, "Integer Hash Function"
http://www.concentric.net/~Ttwang/tech/inthash.htm (Jan.
- Hash32Shift() - Constructor for class imagingbook.pub.noise.hashing.Hash32Shift
-
- Hash32Shift(int) - Constructor for class imagingbook.pub.noise.hashing.Hash32Shift
-
- Hash32ShiftMult - Class in imagingbook.pub.noise.hashing
-
Hash function described in Thomas Wang, "Integer Hash Function"
http://www.concentric.net/~Ttwang/tech/inthash.htm (Jan.
- Hash32ShiftMult() - Constructor for class imagingbook.pub.noise.hashing.Hash32ShiftMult
-
- Hash32ShiftMult(int) - Constructor for class imagingbook.pub.noise.hashing.Hash32ShiftMult
-
- Hash32Ward - Class in imagingbook.pub.noise.hashing
-
Hash function described in G.
- Hash32Ward() - Constructor for class imagingbook.pub.noise.hashing.Hash32Ward
-
- Hash32Ward(int) - Constructor for class imagingbook.pub.noise.hashing.Hash32Ward
-
- HashFun - Class in imagingbook.pub.noise.hashing
-
This class is the abstract superclass of various hash functions.
- HashFun() - Constructor for class imagingbook.pub.noise.hashing.HashFun
-
- HashFun(int) - Constructor for class imagingbook.pub.noise.hashing.HashFun
-
- HashPermute - Class in imagingbook.pub.noise.hashing
-
- HashPermute() - Constructor for class imagingbook.pub.noise.hashing.HashPermute
-
- HashPermute(int) - Constructor for class imagingbook.pub.noise.hashing.HashPermute
-
- hasNext() - Method in class imagingbook.lib.util.ArrayIterator
-
- height - Variable in class imagingbook.lib.image.ImageAccessor
-
- height - Variable in class imagingbook.lib.image.PixelIndexer
-
- height - Variable in class imagingbook.pub.regions.RegionLabeling
-
- HierarchicalScaleSpace - Class in imagingbook.pub.sift.scalespace
-
- HistogramMatcher - Class in imagingbook.pub.histogram
-
- HistogramMatcher() - Constructor for class imagingbook.pub.histogram.HistogramMatcher
-
- HistogramPlot - Class in imagingbook.pub.histogram
-
- HistogramPlot(int[], String) - Constructor for class imagingbook.pub.histogram.HistogramPlot
-
- HistogramPlot(double[], String) - Constructor for class imagingbook.pub.histogram.HistogramPlot
-
- HistogramPlot(PiecewiseLinearCdf, String) - Constructor for class imagingbook.pub.histogram.HistogramPlot
-
- hiThr - Variable in class imagingbook.pub.color.edge.CannyEdgeDetector.Parameters
-
High threshold (20% of max.
- HlsConverter - Class in imagingbook.pub.color.image
-
Methods for converting between RGB and HLS color spaces.
- HlsConverter() - Constructor for class imagingbook.pub.color.image.HlsConverter
-
- HLStoRGB(float[]) - Method in class imagingbook.pub.color.image.HlsConverter
-
- Homogen(RealVector) - Static method in class imagingbook.lib.math.HomogeneousVector
-
- HomogeneousVector - Class in imagingbook.lib.math
-
This class represents a homogeneous coordinate vector.
- HomogeneousVector(double[]) - Constructor for class imagingbook.lib.math.HomogeneousVector
-
Creates a new homogeneous vector from Cartesian
coordinates.
- HomogeneousVector(RealVector) - Constructor for class imagingbook.lib.math.HomogeneousVector
-
Creates a new homogeneous vector from Cartesian
coordinates.
- HoughLine(double, double, int) - Constructor for class imagingbook.pub.hough.HoughTransformLines.HoughLine
-
Public constructor (only available with an enclosing HoughTransformLines instance!)
- HoughLine(double, double, int) - Constructor for class imagingbook.pub.hough.HoughTransformLinesPosRadius.HoughLine
-
- HoughTransformLines - Class in imagingbook.pub.hough
-
This class implements the Hough Transform for straight lines.
- HoughTransformLines(ImageProcessor, HoughTransformLines.Parameters) - Constructor for class imagingbook.pub.hough.HoughTransformLines
-
Creates a new Hough transform from the image I.
- HoughTransformLines(Point2D[], int, int, HoughTransformLines.Parameters) - Constructor for class imagingbook.pub.hough.HoughTransformLines
-
Creates a new Hough transform from a sequence of 2D points.
- HoughTransformLines.HoughLine - Class in imagingbook.pub.hough
-
This class represents a straight line in Hessian normal form,
i.e., x * cos(angle) + y * sin(angle) = radius.
- HoughTransformLines.Parameters - Class in imagingbook.pub.hough
-
- HoughTransformLinesPosRadius - Class in imagingbook.pub.hough
-
This class implements the Hough Transform for straight lines.
- HoughTransformLinesPosRadius(ImageProcessor, HoughTransformLinesPosRadius.Parameters) - Constructor for class imagingbook.pub.hough.HoughTransformLinesPosRadius
-
Creates a new Hough transform from the image I.
- HoughTransformLinesPosRadius(Point2D[], int, int, HoughTransformLinesPosRadius.Parameters) - Constructor for class imagingbook.pub.hough.HoughTransformLinesPosRadius
-
Creates a new Hough transform from a list of 2D points.
- HoughTransformLinesPosRadius.HoughLine - Class in imagingbook.pub.hough
-
This class represents a straight line in Hessian normal form,
i.e., x * cos(angle) + y * sin(angle) = radius.
- HoughTransformLinesPosRadius.Parameters - Class in imagingbook.pub.hough
-
- HsvConverter - Class in imagingbook.pub.color.image
-
Methods for converting between RGB and HLS color spaces.
- HsvConverter() - Constructor for class imagingbook.pub.color.image.HsvConverter
-
- HSVtoRGB(float[]) - Method in class imagingbook.pub.color.image.HsvConverter
-
- ice() - Static method in class imagingbook.lib.ij.LookupTables
-
ImageJ's 'ice' LUT, as originally defined in class LutLoader
.
- iDCT(double[]) - Method in class imagingbook.pub.dct.Dct1d
-
Performs the 1D inverse discrete cosine transform.
- iDCT(double[]) - Method in class imagingbook.pub.dct.Dct1d_Slow
-
Destructively applies the inverse Discrete Cosine Transform to argument vector.
- iDCT(FloatProcessor) - Method in class imagingbook.pub.dct.Dct2d
-
- iDCT(float[][]) - Method in class imagingbook.pub.dct.Dct2d
-
- idMatrix(int) - Static method in class imagingbook.lib.math.Matrix
-
- IjLogStream - Class in imagingbook.lib.ij
-
This class provides the functionality to divert output sent to the System.out
and System.err streams to ImageJ's log console.
- IjUtils - Class in imagingbook.lib.ij
-
- IjUtils() - Constructor for class imagingbook.lib.ij.IjUtils
-
- Illuminant - Enum in imagingbook.pub.color.image
-
- im() - Method in class imagingbook.lib.math.Complex
-
- ImageAccessor - Class in imagingbook.lib.image
-
This class provides unified image access to all 4 types of images available in ImageJ.
- ImageAccessor.Byte - Class in imagingbook.lib.image
-
- ImageAccessor.Float - Class in imagingbook.lib.image
-
- ImageAccessor.Rgb - Class in imagingbook.lib.image
-
- ImageAccessor.Scalar - Class in imagingbook.lib.image
-
- ImageAccessor.Short - Class in imagingbook.lib.image
-
- ImageExtractor - Class in imagingbook.lib.image
-
Use to exctract warped images for testing the Lucas-Kanade matcher.
- ImageExtractor(ImageProcessor) - Constructor for class imagingbook.lib.image.ImageExtractor
-
- ImageMath - Class in imagingbook.lib.image
-
This class provides some static utility methods for ImageJ's ImageProcessors.
- ImageMath() - Constructor for class imagingbook.lib.image.ImageMath
-
- ImagePlusForAntialiasedFlattening - Class in imagingbook.lib.ij
-
Deprecated.
- ImagePlusForAntialiasedFlattening(String, ImageProcessor) - Constructor for class imagingbook.lib.ij.ImagePlusForAntialiasedFlattening
-
Deprecated.
- imagingbook - package imagingbook
-
- imagingbook.lib - package imagingbook.lib
-
Classes for elementary operations used by demo plugins and
library classes in the imagingbook.pub package.
- imagingbook.lib.color - package imagingbook.lib.color
-
- imagingbook.lib.filters - package imagingbook.lib.filters
-
- imagingbook.lib.ij - package imagingbook.lib.ij
-
- imagingbook.lib.image - package imagingbook.lib.image
-
- imagingbook.lib.interpolation - package imagingbook.lib.interpolation
-
- imagingbook.lib.math - package imagingbook.lib.math
-
- imagingbook.lib.settings - package imagingbook.lib.settings
-
- imagingbook.lib.util - package imagingbook.lib.util
-
- imagingbook.pub - package imagingbook.pub
-
Classes implementing specific image processing
tasks.
- imagingbook.pub.color.edge - package imagingbook.pub.color.edge
-
- imagingbook.pub.color.filters - package imagingbook.pub.color.filters
-
- imagingbook.pub.color.image - package imagingbook.pub.color.image
-
- imagingbook.pub.color.quantize - package imagingbook.pub.color.quantize
-
- imagingbook.pub.color.statistics - package imagingbook.pub.color.statistics
-
- imagingbook.pub.corners - package imagingbook.pub.corners
-
- imagingbook.pub.dct - package imagingbook.pub.dct
-
- imagingbook.pub.dft - package imagingbook.pub.dft
-
- imagingbook.pub.edgepreservingfilters - package imagingbook.pub.edgepreservingfilters
-
- imagingbook.pub.fd - package imagingbook.pub.fd
-
- imagingbook.pub.geometry.mappings - package imagingbook.pub.geometry.mappings
-
- imagingbook.pub.geometry.mappings.linear - package imagingbook.pub.geometry.mappings.linear
-
- imagingbook.pub.geometry.mappings.nonlinear - package imagingbook.pub.geometry.mappings.nonlinear
-
- imagingbook.pub.histogram - package imagingbook.pub.histogram
-
- imagingbook.pub.hough - package imagingbook.pub.hough
-
- imagingbook.pub.lucaskanade - package imagingbook.pub.lucaskanade
-
- imagingbook.pub.matching - package imagingbook.pub.matching
-
- imagingbook.pub.moments - package imagingbook.pub.moments
-
- imagingbook.pub.morphology - package imagingbook.pub.morphology
-
- imagingbook.pub.morphology.old - package imagingbook.pub.morphology.old
-
- imagingbook.pub.noise.hashing - package imagingbook.pub.noise.hashing
-
- imagingbook.pub.noise.perlin - package imagingbook.pub.noise.perlin
-
- imagingbook.pub.regions - package imagingbook.pub.regions
-
- imagingbook.pub.regions.geometry - package imagingbook.pub.regions.geometry
-
- imagingbook.pub.sift - package imagingbook.pub.sift
-
- imagingbook.pub.sift.filters - package imagingbook.pub.sift.filters
-
- imagingbook.pub.sift.scalespace - package imagingbook.pub.sift.scalespace
-
- imagingbook.pub.sift.util - package imagingbook.pub.sift.util
-
- imagingbook.pub.threshold - package imagingbook.pub.threshold
-
- imagingbook.pub.threshold.adaptive - package imagingbook.pub.threshold.adaptive
-
- imagingbook.pub.threshold.global - package imagingbook.pub.threshold.global
-
- imagingbook.test - package imagingbook.test
-
- Imean - Variable in class imagingbook.pub.threshold.adaptive.NiblackThresholder
-
- increment() - Static method in class imagingbook.pub.color.image.RgbGamutChecker
-
- indexer - Variable in class imagingbook.lib.image.ImageAccessor
-
- Info - Class in imagingbook
-
- Info() - Constructor for class imagingbook.Info
-
- initialize() - Method in class imagingbook.pub.regions.RegionContourLabeling
-
- initialize() - Method in class imagingbook.pub.regions.RegionLabeling
-
- IntegralImage - Class in imagingbook.lib.image
-
This class represents an 'integral image' or 'summed area table' [Crow, 1984],
as described in the book (see 2nd English ed.
- IntegralImage(int[][]) - Constructor for class imagingbook.lib.image.IntegralImage
-
Creates a new integral image from pixel values in a 2D int-array.
- IntegralImage(ByteProcessor) - Constructor for class imagingbook.lib.image.IntegralImage
-
Creates a new integral image from pixel values in a ByteProcessor
.
- interpolate(Point2D, Point2D, double) - Method in class imagingbook.pub.fd.PolygonSampler
-
- InterpolatingThresholder - Class in imagingbook.pub.threshold.adaptive
-
This thresholder splits the image into non-overlapping square
sub-images, computes the optimal threshold within each sub-image
(using an Otsu thresholder) and interpolates linearly between
these local thresholds.
- InterpolatingThresholder() - Constructor for class imagingbook.pub.threshold.adaptive.InterpolatingThresholder
-
- InterpolatingThresholder(InterpolatingThresholder.Parameters) - Constructor for class imagingbook.pub.threshold.adaptive.InterpolatingThresholder
-
- InterpolatingThresholder.Parameters - Class in imagingbook.pub.threshold.adaptive
-
- interpolationMethod - Variable in class imagingbook.lib.image.ImageAccessor
-
- InterpolationMethod - Enum in imagingbook.lib.interpolation
-
- interpolator - Variable in class imagingbook.lib.image.ImageAccessor.Scalar
-
- intToRgb(int) - Method in class imagingbook.pub.color.quantize.ColorQuantizer
-
- inverse(double[][]) - Static method in class imagingbook.lib.math.Matrix
-
- inverse(float[][]) - Static method in class imagingbook.lib.math.Matrix
-
- inverse2x2(float[][]) - Static method in class imagingbook.lib.math.Matrix
-
Deprecated.
- inverse2x2(double[][]) - Static method in class imagingbook.lib.math.Matrix
-
Deprecated.
- invert() - Method in class imagingbook.pub.geometry.mappings.linear.AffineMapping
-
- invert() - Method in class imagingbook.pub.geometry.mappings.linear.LinearMapping
-
- invert() - Method in class imagingbook.pub.geometry.mappings.linear.ProjectiveMapping
-
- invert() - Method in class imagingbook.pub.geometry.mappings.linear.Translation
-
- invert() - Method in class imagingbook.pub.geometry.mappings.Mapping
-
- invertDestructive() - Method in class imagingbook.pub.geometry.mappings.linear.LinearMapping
-
- ip - Variable in class imagingbook.lib.image.ImageAccessor.Scalar
-
- ip - Variable in class imagingbook.pub.regions.RegionLabeling
-
- isColorStack(ImagePlus) - Static method in class imagingbook.pub.color.image.ColorStack
-
- Isigma - Variable in class imagingbook.pub.threshold.adaptive.NiblackThresholder
-
- isInside(int, int, int) - Method in class imagingbook.pub.sift.scalespace.ScaleOctave
-
- isInsideJar(Class<?>) - Static method in class imagingbook.lib.util.ResourceUtils
-
Determines if the specified class was loaded from
a JAR file or a .class file in the file system.
- isInValid() - Method in class imagingbook.pub.color.edge.CannyEdgeDetector.Parameters
-
Checks the parameter set.
- isInverse() - Method in class imagingbook.pub.geometry.mappings.Mapping
-
- isInverseFlag - Variable in class imagingbook.pub.geometry.mappings.Mapping
-
- IsodataThresholder - Class in imagingbook.pub.threshold.global
-
This thresholder implements the algorithm proposed by Ridler and Calvard (1978),
T.W.
- IsodataThresholder() - Constructor for class imagingbook.pub.threshold.global.IsodataThresholder
-
- IsodataThresholderSlow - Class in imagingbook.pub.threshold.global
-
This thresholder implements the algorithm proposed by Ridler and Calvard (1978),
T.W.
- IsodataThresholderSlow() - Constructor for class imagingbook.pub.threshold.global.IsodataThresholderSlow
-
- isType(ImagePlus, ColorStack.ColorStackType) - Static method in class imagingbook.pub.color.image.ColorStack
-
- isZero(float) - Static method in class imagingbook.lib.math.Arithmetic
-
Test for zero (float version).
- isZero(double) - Static method in class imagingbook.lib.math.Arithmetic
-
Test for zero (double version).
- iterateOnce(ProjectiveMapping) - Method in class imagingbook.pub.lucaskanade.LucasKanadeForwardMatcher
-
- iterateOnce(ProjectiveMapping) - Method in class imagingbook.pub.lucaskanade.LucasKanadeInverseMatcher
-
- iterateOnce(ProjectiveMapping) - Method in class imagingbook.pub.lucaskanade.LucasKanadeMatcher
-
Performs a single matching iteration on the given image pair (I, R).
- iterations - Variable in class imagingbook.pub.edgepreservingfilters.PeronaMalikFilter.Parameters
-
Number of iterations to perform
- iterations - Variable in class imagingbook.pub.edgepreservingfilters.TschumperleDericheFilter.Parameters
-
Number of smoothing iterations
- iterator() - Method in class imagingbook.lib.util.LinearContainer
-
- iterator() - Method in class imagingbook.pub.regions.Contour
-
- iterator() - Method in class imagingbook.pub.regions.RegionLabeling.BinaryRegion
-
- L1() - Constructor for class imagingbook.lib.math.VectorNorm.L1
-
- L2() - Constructor for class imagingbook.lib.math.VectorNorm.L2
-
- LabColorSpace - Class in imagingbook.pub.color.image
-
This class implements the CIELab color space.
- LabColorSpace() - Constructor for class imagingbook.pub.color.image.LabColorSpace
-
- labelArray - Variable in class imagingbook.pub.regions.RegionLabeling
-
- labToSrgb(ImagePlus) - Static method in class imagingbook.pub.color.image.ColorStack
-
- LanczosInterpolator - Class in imagingbook.lib.interpolation
-
- LanczosInterpolator(ImageAccessor.Scalar) - Constructor for class imagingbook.lib.interpolation.LanczosInterpolator
-
- LanczosInterpolator(int) - Constructor for class imagingbook.lib.interpolation.LanczosInterpolator
-
- LinearContainer<T> - Class in imagingbook.lib.util
-
This class implements a 1D map for arbitrary objects
with flexible bottom and top index,
similar to an array in Pascal.
- LinearContainer(int) - Constructor for class imagingbook.lib.util.LinearContainer
-
Creates a LinearContainer with the index range
[0, n - 1], like an ordinary array.
- LinearContainer(int, int) - Constructor for class imagingbook.lib.util.LinearContainer
-
Creates a LinearContainer with the index range
[botIndex, topIndex].
- LinearFilter - Class in imagingbook.lib.filters
-
Generic linear convolution filter implemented
by extending the GenericFilter class.
- LinearFilter(float[][]) - Constructor for class imagingbook.lib.filters.LinearFilter
-
- LinearMapping - Class in imagingbook.pub.geometry.mappings.linear
-
- LinearMapping() - Constructor for class imagingbook.pub.geometry.mappings.linear.LinearMapping
-
- LinearMapping(double, double, double, double, double, double, double, double, double, boolean) - Constructor for class imagingbook.pub.geometry.mappings.linear.LinearMapping
-
- LinearMapping(LinearMapping) - Constructor for class imagingbook.pub.geometry.mappings.linear.LinearMapping
-
- Linf() - Constructor for class imagingbook.lib.math.VectorNorm.Linf
-
- listArray(String, double[]) - Static method in class imagingbook.lib.util.MathematicaIO
-
Generates a string holding the named definition
of a 1D double array for Mathematica in the form
name = {A[0], A[1], ...,A[m-1]};
- listArray(String, float[]) - Static method in class imagingbook.lib.util.MathematicaIO
-
Generates a string holding the named definition
of a 1D float array for Mathematica in the form
name = {A[0], A[1], ...,A[m-1]};
- listArray(String, int[]) - Static method in class imagingbook.lib.util.MathematicaIO
-
Generates a string holding the named definition
of a 1D int array for Mathematica in the form
name = {A[0], A[1], ...,A[m-1]};
- listArray(String, double[][]) - Static method in class imagingbook.lib.util.MathematicaIO
-
Generates a string holding the named definition
of a 2D double array for Mathematica in the form
name = {{A[0][0],...,A[0][m-1]},
{A[1][0],...,A[1][m-1]}, ...,
{A[n-1][0], A[n-1][1], ...,A[n-1][m-1]}};
- listArray(String, float[][]) - Static method in class imagingbook.lib.util.MathematicaIO
-
Generates a string holding the named definition
of a 2D float array for Mathematica in the form
name = {{A[0][0],...,A[0][m-1]},
{A[1][0],...,A[1][m-1]}, ...,
{A[n-1][0], A[n-1][1], ...,A[n-1][m-1]}};
- listClusters() - Method in class imagingbook.pub.color.quantize.KMeansClusteringQuantizer
-
Lists the color clusters to System.out (intended for debugging only).
- listColorMap() - Method in class imagingbook.pub.color.quantize.ColorQuantizer
-
- listCurrentLut(ImageProcessor) - Static method in class imagingbook.lib.ij.LookupTables
-
Lists the contents of the lookup-table currently associated
with the specified image.
- listNodes() - Method in class imagingbook.pub.color.quantize.OctreeQuantizer
-
Lists the octree nodes to System.out (intended for debugging only).
- listResources(URI) - Static method in class imagingbook.lib.util.ResourceUtils
-
- listResources(Path) - Static method in class imagingbook.lib.util.ResourceUtils
-
Method to obtain the paths to all files in a directory specified
by a path.
- listResources(Class<?>, String) - Static method in class imagingbook.lib.util.ResourceUtils
-
Use this method to obtain the paths to all files in a directory located
relative to the specified class.
- listUniqueColors() - Method in class imagingbook.pub.color.statistics.ColorHistogram
-
Lists the unique colors to System.out (intended for
debugging only).
- log2(int) - Method in class imagingbook.pub.color.quantize.ColorQuantizer
-
- LookupTables - Class in imagingbook.lib.ij
-
This class holds utility methods for lookup-tables and implementations
of various standard ImageJ lookup tables (originally defined in class
LutLoader
.
- LookupTables() - Constructor for class imagingbook.lib.ij.LookupTables
-
- loThr - Variable in class imagingbook.pub.color.edge.CannyEdgeDetector.Parameters
-
Low threshold (5% of max.
- LucasKanadeForwardMatcher - Class in imagingbook.pub.lucaskanade
-
Lucas-Kanade (forward-additive) matcher, as described in Simon Baker and Iain Matthews,
"Lucas-Kanade 20 Years On: A Unifying Framework: Part 1", CMU-RI-TR-02-16 (2002)
Also called the "forward-additive" algorithm.
- LucasKanadeForwardMatcher(FloatProcessor, FloatProcessor, LucasKanadeMatcher.Parameters) - Constructor for class imagingbook.pub.lucaskanade.LucasKanadeForwardMatcher
-
- LucasKanadeForwardMatcher(FloatProcessor, FloatProcessor) - Constructor for class imagingbook.pub.lucaskanade.LucasKanadeForwardMatcher
-
- LucasKanadeInverseMatcher - Class in imagingbook.pub.lucaskanade
-
Inverse Compositional Matcher, as described in Simon Baker and Iain Matthews,
"Lucas-Kanade 20 Years On: A Unifying Framework: Part 1", CMU-RI-TR-02-16 (2002)
- LucasKanadeInverseMatcher(FloatProcessor, FloatProcessor, LucasKanadeMatcher.Parameters) - Constructor for class imagingbook.pub.lucaskanade.LucasKanadeInverseMatcher
-
- LucasKanadeInverseMatcher(FloatProcessor, FloatProcessor) - Constructor for class imagingbook.pub.lucaskanade.LucasKanadeInverseMatcher
-
- LucasKanadeMatcher - Class in imagingbook.pub.lucaskanade
-
This is the common super-class for different variants of the Lucas-Kanade
matcher.
- LucasKanadeMatcher(FloatProcessor, FloatProcessor, LucasKanadeMatcher.Parameters) - Constructor for class imagingbook.pub.lucaskanade.LucasKanadeMatcher
-
Creates a new Lucas-Kanade-type matcher.
- LucasKanadeMatcher.Parameters - Class in imagingbook.pub.lucaskanade
-
Default parameters for the containing class and its sub-classes;
a (usually modified) instance of this class is passed to the constructor
of a non-abstract sub-class.
- LucasKanadeMatcher1D - Class in imagingbook.pub.lucaskanade
-
- LucasKanadeMatcher1D(double[], double[]) - Constructor for class imagingbook.pub.lucaskanade.LucasKanadeMatcher1D
-
- LuvColorSpace - Class in imagingbook.pub.color.image
-
- LuvColorSpace() - Constructor for class imagingbook.pub.color.image.LuvColorSpace
-
- luvToSrgb(ImagePlus) - Static method in class imagingbook.pub.color.image.ColorStack
-
- Magenta - Static variable in class imagingbook.pub.fd.Colors
-
- Magenta - Static variable in class imagingbook.pub.sift.util.Colors
-
- magL1(ImagePlus) - Static method in class imagingbook.pub.color.image.ColorStack
-
- magL2(ImagePlus) - Static method in class imagingbook.pub.color.image.ColorStack
-
- magnitude(double[]) - Method in class imagingbook.lib.math.MahalanobisDistance
-
- magnitude(int[]) - Method in class imagingbook.lib.math.MahalanobisDistance
-
- magnitude(double[]) - Method in class imagingbook.lib.math.VectorNorm.L1
-
- magnitude(int[]) - Method in class imagingbook.lib.math.VectorNorm.L1
-
- magnitude(double[]) - Method in class imagingbook.lib.math.VectorNorm.L2
-
- magnitude(int[]) - Method in class imagingbook.lib.math.VectorNorm.L2
-
- magnitude(double[]) - Method in class imagingbook.lib.math.VectorNorm.Linf
-
- magnitude(int[]) - Method in class imagingbook.lib.math.VectorNorm.Linf
-
- magnitude(double[]) - Method in class imagingbook.lib.math.VectorNorm
-
- magnitude(int[]) - Method in class imagingbook.lib.math.VectorNorm
-
- magnitude - Variable in class imagingbook.pub.sift.KeyPoint
-
- MahalanobisDistance - Class in imagingbook.lib.math
-
This class implements the Mahalanobis distance using the Apache commons math library.
- MahalanobisDistance(double[][], double) - Constructor for class imagingbook.lib.math.MahalanobisDistance
-
Create a new instance from an array of m-dimensional samples, e.g.
- MahalanobisDistance(double[][]) - Constructor for class imagingbook.lib.math.MahalanobisDistance
-
Create a new instance from an array of m-dimensional samples, e.g.
- main(String[]) - Static method in class imagingbook.lib.math.Complex
-
- main(String[]) - Static method in class imagingbook.lib.math.MahalanobisDistance
-
Test example from Burger/Burge UTICS-C Appendix:
N = 4 samples, K = 3 dimensions
- main(String[]) - Static method in class imagingbook.lib.math.Matrix
-
- main(String[]) - Static method in class imagingbook.lib.math.Test
-
- main(String[]) - Static method in class imagingbook.lib.util.FileUtils
-
- main(String[]) - Static method in class imagingbook.pub.color.image.LabColorSpace
-
- main(String[]) - Static method in class imagingbook.pub.color.image.LuvColorSpace
-
- main(String[]) - Static method in class imagingbook.pub.color.image.sRgbUtil
-
- main(String[]) - Static method in class imagingbook.pub.dct.Dct1d
-
- main(String[]) - Static method in class imagingbook.pub.dct.Dct1d_Slow
-
- main(String[]) - Static method in class imagingbook.pub.dct.DctMatrixTest
-
Test method.
- main(String[]) - Static method in class imagingbook.pub.geometry.mappings.linear.ProjectiveMapping
-
- main(String[]) - Static method in class imagingbook.pub.lucaskanade.LucasKanadeMatcher1D
-
- main(String[]) - Static method in class imagingbook.pub.noise.hashing.HashPermute
-
- makeComplex(Point2D[]) - Static method in class imagingbook.pub.fd.FourierDescriptor
-
- makeComplexVector(int) - Static method in class imagingbook.lib.math.Complex
-
- makeComplexVector(double[]) - Static method in class imagingbook.lib.math.Complex
-
- makeComplexVector(double[], double[]) - Static method in class imagingbook.lib.math.Complex
-
- makeDomainKernel2D(double, int) - Method in class imagingbook.pub.edgepreservingfilters.BilateralFilter
-
- makeEllipse(Complex, Complex, int, double, double) - Method in class imagingbook.pub.fd.FourierDescriptor
-
- makeFourierPairsReconstruction() - Method in class imagingbook.pub.fd.FourierDescriptor
-
Reconstructs the shape using all FD pairs.
- makeFourierPairsReconstruction(int) - Method in class imagingbook.pub.fd.FourierDescriptor
-
Reconstructs the shape obtained from FD-pairs 0,...,Mp as a polygon (path).
- makeGaussianHistogram(double, double) - Static method in class imagingbook.pub.histogram.Util
-
- makeGaussKernel1d(double) - Static method in class imagingbook.lib.filters.GaussianFilter
-
- makeGaussKernel1d(double) - Static method in class imagingbook.pub.sift.filters.GaussianFilter
-
- makeGaussKernel2d(double) - Static method in class imagingbook.lib.filters.GaussianFilter
-
- makeGaussKernel2d(double, double) - Static method in class imagingbook.lib.filters.GaussianFilter
-
- makeInnerContours() - Method in class imagingbook.pub.regions.RegionLabeling.BinaryRegion
-
- makeInvariant() - Method in class imagingbook.pub.fd.FourierDescriptor
-
- makeInvariant(int) - Method in class imagingbook.pub.fd.FourierDescriptor
-
- makeInverseMapping(Point2D, Point2D, Point2D, Point2D, Point2D, Point2D, Point2D, Point2D) - Static method in class imagingbook.pub.geometry.mappings.nonlinear.BilinearMapping
-
- makeInverseMapping(double, double, double, double) - Static method in class imagingbook.pub.geometry.mappings.nonlinear.RippleMapping
-
- makeInverseMapping(double, double, double) - Static method in class imagingbook.pub.geometry.mappings.nonlinear.SphereMapping
-
- makeInverseMapping(double, double, double, double) - Static method in class imagingbook.pub.geometry.mappings.nonlinear.TwirlMapping
-
- makeLabelImage(boolean) - Method in class imagingbook.pub.regions.RegionLabeling
-
Utility method that creates an image of the internal
label array.
- makeMapping(Point2D[], Point2D[]) - Static method in class imagingbook.pub.geometry.mappings.linear.ProjectiveMapping
-
- makeMeanAndVariance(ByteProcessor, NiblackThresholder.Parameters) - Method in class imagingbook.pub.threshold.adaptive.NiblackThresholder.Box
-
- makeMeanAndVariance(ByteProcessor, NiblackThresholder.Parameters) - Method in class imagingbook.pub.threshold.adaptive.NiblackThresholder.Disk
-
- makeMeanAndVariance(ByteProcessor, NiblackThresholder.Parameters) - Method in class imagingbook.pub.threshold.adaptive.NiblackThresholder.Gauss
-
- makeMeanAndVariance(ByteProcessor, NiblackThresholder.Parameters) - Method in class imagingbook.pub.threshold.adaptive.NiblackThresholder
-
- makePolygon(Point2D[], double, Color) - Static method in class imagingbook.pub.lucaskanade.RoiUtils
-
Deprecated.
- makePowerImage() - Method in class imagingbook.pub.dft.Dft2d
-
- makeRandomColor() - Method in class imagingbook.pub.regions.RegionLabeling
-
- makeRandomSeed() - Method in class imagingbook.pub.noise.hashing.HashFun
-
- makeRangeKernel(double, int) - Method in class imagingbook.pub.edgepreservingfilters.BilateralFilter
-
- makeRichKeypoints(List<KeyPoint>) - Method in class imagingbook.pub.sift.SiftDetector
-
Only used for debugging: produces key points with orientation
histograms attached for display purposes.
- makeRotationInvariant() - Method in class imagingbook.pub.fd.FourierDescriptor
-
- makeScaleInvariant() - Method in class imagingbook.pub.fd.FourierDescriptor
-
Normalizes this descriptor destructively to the L2 norm of G,
keeps G_0 untouched.
- makeStartPointInvariant() - Method in class imagingbook.pub.fd.FourierDescriptor
-
- makeTranslationInvariant() - Method in class imagingbook.pub.fd.FourierDescriptor
-
Sets the zero (DC) coefficient to zero.
- Mapping - Class in imagingbook.pub.geometry.mappings
-
2013-02-02: changed to use the returned new point of applyTo(Point2D),
not relying on side effect.
- Mapping() - Constructor for class imagingbook.pub.geometry.mappings.Mapping
-
- markModifiedPixels - Variable in class imagingbook.pub.color.filters.VectorMedianFilter.Parameters
-
For testing only
- markModifiedPixels - Variable in class imagingbook.pub.color.filters.VectorMedianFilterSharpen.Parameters
-
For testing only
- markOutOfGamutColors - Static variable in class imagingbook.pub.color.image.RgbGamutChecker
-
- matchDescriptors(List<SiftDescriptor>) - Method in class imagingbook.pub.sift.SiftMatcher
-
- matchHistograms(int[], int[]) - Method in class imagingbook.pub.histogram.HistogramMatcher
-
- matchHistograms(int[], PiecewiseLinearCdf) - Method in class imagingbook.pub.histogram.HistogramMatcher
-
- MathematicaIO - Class in imagingbook.lib.util
-
This class provides some static methods for formatting
Java arrays (representing vectors, matrices or measurements)
for copy-pasting to Mathematica.
- MathematicaIO() - Constructor for class imagingbook.lib.util.MathematicaIO
-
- Matrix - Class in imagingbook.lib.math
-
This class contains a collection of static methods for calculations
with vectors and matrices using native Java arrays without any enclosing
objects structures.
- Matrix() - Constructor for class imagingbook.lib.math.Matrix
-
- max(float[]) - Static method in class imagingbook.lib.math.Matrix
-
- max(double[]) - Static method in class imagingbook.lib.math.Matrix
-
- max(ImagePlus) - Static method in class imagingbook.pub.color.image.ColorStack
-
- max(double[]) - Method in class imagingbook.pub.threshold.Thresholder
-
- MAX_RGB - Static variable in class imagingbook.pub.color.quantize.ColorQuantizer
-
- maxColors - Variable in class imagingbook.pub.color.quantize.KMeansClusteringQuantizer.Parameters
-
Maximum number of quantized colors.
- maxColors - Variable in class imagingbook.pub.color.quantize.KMeansClusteringQuantizerApache.Parameters
-
Maximum number of quantized colors.
- maxColors - Variable in class imagingbook.pub.color.quantize.MedianCutQuantizer.Parameters
-
Maximum number of quantized colors.
- maxColors - Variable in class imagingbook.pub.color.quantize.OctreeQuantizer.Parameters
-
Maximum number of quantized colors.
- MaxEntropyThresholder - Class in imagingbook.pub.threshold.global
-
Maximum entropy thresholder modeled after Kapur et al.
- MaxEntropyThresholder() - Constructor for class imagingbook.pub.threshold.global.MaxEntropyThresholder
-
- maxIterations - Variable in class imagingbook.pub.color.quantize.KMeansClusteringQuantizer.Parameters
-
Maximum number of clustering iterations
- maxIterations - Variable in class imagingbook.pub.color.quantize.KMeansClusteringQuantizerApache.Parameters
-
Maximum number of clustering iterations
- maxIterations - Variable in class imagingbook.pub.lucaskanade.LucasKanadeMatcher.Parameters
-
Maximum number of iterations
- maxLabel - Variable in class imagingbook.pub.regions.RegionLabeling
-
- Mcat - Variable in class imagingbook.pub.color.image.BradfordAdaptation
-
- mean(int[]) - Method in class imagingbook.pub.threshold.Thresholder
-
- mean(int[], int, int) - Method in class imagingbook.pub.threshold.Thresholder
-
- MeanThresholder - Class in imagingbook.pub.threshold.global
-
- MeanThresholder() - Constructor for class imagingbook.pub.threshold.global.MeanThresholder
-
- median(int[]) - Method in class imagingbook.pub.threshold.Thresholder
-
- MedianCutQuantizer - Class in imagingbook.pub.color.quantize
-
This is an implementation of Heckbert's median-cut color quantization algorithm
(Heckbert P., "Color Image Quantization for Frame Buffer Display", ACM Transactions
on Computer Graphics (SIGGRAPH), pp.
- MedianCutQuantizer(ColorProcessor, int) - Constructor for class imagingbook.pub.color.quantize.MedianCutQuantizer
-
Deprecated.
- MedianCutQuantizer(int[], int) - Constructor for class imagingbook.pub.color.quantize.MedianCutQuantizer
-
Deprecated.
- MedianCutQuantizer(int[], MedianCutQuantizer.Parameters) - Constructor for class imagingbook.pub.color.quantize.MedianCutQuantizer
-
- MedianCutQuantizer.Parameters - Class in imagingbook.pub.color.quantize
-
- MedianThresholder - Class in imagingbook.pub.threshold.global
-
This is only a special case of a QuantileThresholder with b = 0.5.
- MedianThresholder() - Constructor for class imagingbook.pub.threshold.global.MedianThresholder
-
- Mfwd - Static variable in class imagingbook.pub.color.image.BradfordAdaptation
-
- min(float[]) - Static method in class imagingbook.lib.math.Matrix
-
- min(double[]) - Static method in class imagingbook.lib.math.Matrix
-
- MinErrorThresholder - Class in imagingbook.pub.threshold.global
-
Minimum Error thresholder after Kittler and Illingworth (1986).
- MinErrorThresholder() - Constructor for class imagingbook.pub.threshold.global.MinErrorThresholder
-
- Minv - Static variable in class imagingbook.pub.color.image.BradfordAdaptation
-
- mod(int, int) - Static method in class imagingbook.lib.math.Arithmetic
-
Integer version of modulus operator (as described in the book).
- mod(double, double) - Static method in class imagingbook.lib.math.Arithmetic
-
Non-integer version of modulus operator, with results identical to Mathematica.
- modifiedColor - Static variable in class imagingbook.pub.color.filters.VectorMedianFilter
-
- modifiedColor - Variable in class imagingbook.pub.color.filters.VectorMedianFilterSharpen.Parameters
-
For testing only
- modifiedCount - Variable in class imagingbook.pub.color.filters.VectorMedianFilter
-
- modifiedCount - Variable in class imagingbook.pub.color.filters.VectorMedianFilterSharpen
-
For testing only
- moment(ImageProcessor, int, int) - Static method in class imagingbook.pub.moments.BinaryMoments
-
- MonochromaticEdgeDetector - Class in imagingbook.pub.color.edge
-
Monochromatic color edge detector, as described in UTICS Vol.
- MonochromaticEdgeDetector(ColorProcessor) - Constructor for class imagingbook.pub.color.edge.MonochromaticEdgeDetector
-
- MonochromaticEdgeDetector(ColorProcessor, MonochromaticEdgeDetector.Parameters) - Constructor for class imagingbook.pub.color.edge.MonochromaticEdgeDetector
-
- MonochromaticEdgeDetector.Parameters - Class in imagingbook.pub.color.edge
-
- mult(T, T) - Static method in class imagingbook.lib.image.ImageMath
-
- mult(double) - Method in class imagingbook.lib.math.Complex
-
- mult(Complex) - Method in class imagingbook.lib.math.Complex
-
- multiply(double, double[]) - Static method in class imagingbook.lib.math.Matrix
-
- multiply(double, double[][]) - Static method in class imagingbook.lib.math.Matrix
-
- multiply(float, float[]) - Static method in class imagingbook.lib.math.Matrix
-
- multiply(float, float[][]) - Static method in class imagingbook.lib.math.Matrix
-
- multiply(double[], double[][]) - Static method in class imagingbook.lib.math.Matrix
-
- multiply(double[][], double[]) - Static method in class imagingbook.lib.math.Matrix
-
- multiply(float[][], float[]) - Static method in class imagingbook.lib.math.Matrix
-
- multiply(double[][], double[][]) - Static method in class imagingbook.lib.math.Matrix
-
- multiply(float[][], float[][]) - Static method in class imagingbook.lib.math.Matrix
-
- multiply(float[][], float[][], float[][]) - Static method in class imagingbook.lib.math.Matrix
-
- multiply(ImagePlus, double) - Static method in class imagingbook.pub.color.image.ColorStack
-
- multiplyD(double, double[]) - Static method in class imagingbook.lib.math.Matrix
-
- multiplyD(double, double[][]) - Static method in class imagingbook.lib.math.Matrix
-
- multiplyD(float, float[]) - Static method in class imagingbook.lib.math.Matrix
-
- multiplyD(float, float[][]) - Static method in class imagingbook.lib.math.Matrix
-
- multiplyD(double[], double[][], double[]) - Static method in class imagingbook.lib.math.Matrix
-
- multiplyD(double[][], double[], double[]) - Static method in class imagingbook.lib.math.Matrix
-
- multiplyD(float[][], float[], float[]) - Static method in class imagingbook.lib.math.Matrix
-
Matrix-vector product: A .
- multiplyD(double[][], double[][], double[][]) - Static method in class imagingbook.lib.math.Matrix
-
- n_Angl - Variable in class imagingbook.pub.sift.SiftDetector.Parameters
-
Number of angular descriptor bins
- n_Orient - Variable in class imagingbook.pub.sift.SiftDetector.Parameters
-
Number of orientation bins in the feature descriptor (angular resolution)
- n_Refine - Variable in class imagingbook.pub.sift.SiftDetector.Parameters
-
Max.
- n_Smooth - Variable in class imagingbook.pub.sift.SiftDetector.Parameters
-
Number of smoothing steps applied to the orientation histogram
- n_Spat - Variable in class imagingbook.pub.sift.SiftDetector.Parameters
-
Number of spatial descriptor bins along each x/y axis
- NagaoMatsuyamaFilter - Class in imagingbook.pub.edgepreservingfilters
-
This class implements a 5x5 Nagao-Matsuyama filter, as described in
NagaoMatsuyama (1979).
- NagaoMatsuyamaFilter() - Constructor for class imagingbook.pub.edgepreservingfilters.NagaoMatsuyamaFilter
-
- NagaoMatsuyamaFilter(NagaoMatsuyamaFilter.Parameters) - Constructor for class imagingbook.pub.edgepreservingfilters.NagaoMatsuyamaFilter
-
- NagaoMatsuyamaFilter.Parameters - Class in imagingbook.pub.edgepreservingfilters
-
- nAng - Variable in class imagingbook.pub.hough.HoughTransformLines.Parameters
-
Number of angular steps over [0, pi]
- nAng - Variable in class imagingbook.pub.hough.HoughTransformLinesPosRadius.Parameters
-
Number of angular steps over [0, pi]
- nCentralMoment(ImageProcessor, int, int) - Static method in class imagingbook.pub.moments.BinaryMoments
-
- NearestNeighborInterpolator - Class in imagingbook.lib.interpolation
-
- NearestNeighborInterpolator() - Constructor for class imagingbook.lib.interpolation.NearestNeighborInterpolator
-
- next() - Method in class imagingbook.lib.util.ArrayIterator
-
- nextColor() - Method in class imagingbook.lib.color.CssColorSequencer
-
- nextColor() - Method in class imagingbook.lib.color.RandomColorGenerator
-
- nextColor() - Method in class imagingbook.pub.fd.Colors.ColorSequencer
-
- nhType - Variable in class imagingbook.pub.sift.SiftDetector.Parameters
-
Type of neigborhood used for peak detection in 3D scale space
- NiblackThresholder - Class in imagingbook.pub.threshold.adaptive
-
This version of Niblack's thresholder uses a circular support region, implemented
with IJ's rank-filter methods.
- NiblackThresholder.Box - Class in imagingbook.pub.threshold.adaptive
-
- NiblackThresholder.Disk - Class in imagingbook.pub.threshold.adaptive
-
- NiblackThresholder.Gauss - Class in imagingbook.pub.threshold.adaptive
-
- NiblackThresholder.Parameters - Class in imagingbook.pub.threshold.adaptive
-
- NOISE(double) - Method in class imagingbook.pub.noise.perlin.PerlinNoiseGen1d
-
1D combined (multi-frequency) Perlin noise function.
- noise(double) - Method in class imagingbook.pub.noise.perlin.PerlinNoiseGen1d
-
1D elementary (single-frequency) Perlin noise function.
- NOISE(double, double) - Method in class imagingbook.pub.noise.perlin.PerlinNoiseGen2d
-
2D combined (multi-frequency) Perlin noise function.
- noise(double, double) - Method in class imagingbook.pub.noise.perlin.PerlinNoiseGen2d
-
2D elementary (single-frequency) Perlin noise function.
- NOISE(double[]) - Method in class imagingbook.pub.noise.perlin.PerlinNoiseGenNd
-
N-dim combined (multi-frequency) Perlin noise function.
- noise(double[]) - Method in class imagingbook.pub.noise.perlin.PerlinNoiseGenNd
-
2D elementary (single-frequency) Perlin noise function.
- norm - Variable in class imagingbook.pub.color.edge.MonochromaticEdgeDetector.Parameters
-
Specify which color distance to use
- norm - Variable in class imagingbook.pub.sift.SiftMatcher.Parameters
-
Specify type of distance norm
- normalCentralMoment(ImageProcessor, int, int) - Static method in class imagingbook.pub.moments.BinaryMoments
-
Deprecated.
- normalize(int[]) - Method in class imagingbook.pub.threshold.Thresholder
-
- normalize(double[]) - Method in class imagingbook.pub.threshold.Thresholder
-
- normalizeHistogram(double[]) - Static method in class imagingbook.pub.histogram.Util
-
- normalizeHistogram(int[]) - Static method in class imagingbook.pub.histogram.Util
-
- normGradMag - Variable in class imagingbook.pub.color.edge.CannyEdgeDetector.Parameters
-
Set true to normalize gradient magnitude
- normL1(double[]) - Static method in class imagingbook.lib.math.Matrix
-
- normL1(float[]) - Static method in class imagingbook.lib.math.Matrix
-
- normL2(double[]) - Static method in class imagingbook.lib.math.Matrix
-
- normL2(float[]) - Static method in class imagingbook.lib.math.Matrix
-
- normL2squared(double[]) - Static method in class imagingbook.lib.math.Matrix
-
- normL2squared(float[]) - Static method in class imagingbook.lib.math.Matrix
-
- nRad - Variable in class imagingbook.pub.hough.HoughTransformLines.Parameters
-
Number of radial steps in each pos/neg direction (accum.
- nRad - Variable in class imagingbook.pub.hough.HoughTransformLinesPosRadius.Parameters
-
Number of radial steps (pos.
- radius - Variable in class imagingbook.pub.color.filters.ScalarMedianFilter.Parameters
-
Filter radius
- radius - Variable in class imagingbook.pub.color.filters.VectorMedianFilter.Parameters
-
Filter radius
- radius - Variable in class imagingbook.pub.color.filters.VectorMedianFilterSharpen.Parameters
-
Filter radius
- radius - Variable in class imagingbook.pub.edgepreservingfilters.KuwaharaFilter.Parameters
-
Radius of the filter (should be even)
- radius - Variable in class imagingbook.pub.threshold.adaptive.BernsenThresholder.Parameters
-
- radius - Variable in class imagingbook.pub.threshold.adaptive.NiblackThresholder.Parameters
-
- radius - Variable in class imagingbook.pub.threshold.adaptive.SauvolaThresholder.Parameters
-
- radiusFromIndex(int) - Method in class imagingbook.pub.hough.HoughTransformLines
-
Calculates the actual radius for radius index ri.
- radiusFromIndex(int) - Method in class imagingbook.pub.hough.HoughTransformLinesPosRadius
-
Calculates the actual radius for radius index ri.
- RandomColorGenerator - Class in imagingbook.lib.color
-
- RandomColorGenerator() - Constructor for class imagingbook.lib.color.RandomColorGenerator
-
- RandomColorGenerator(int) - Constructor for class imagingbook.lib.color.RandomColorGenerator
-
- re() - Method in class imagingbook.lib.math.Complex
-
- readKeypointFile(String) - Method in class imagingbook.pub.sift.util.SiftKeyfileReaderLowe
-
- readKeypointFile(String) - Method in class imagingbook.pub.sift.util.SiftKeyfileReaderVLFEAT
-
- realEigenValues2x2() - Method in class imagingbook.lib.math.Eigensolver2x2
-
- reconstructionScale - Variable in class imagingbook.pub.fd.FourierDescriptor
-
- RecursiveLabeling - Class in imagingbook.pub.regions
-
Binary region labeler based on a recursive flood filling
algorithm.
- RecursiveLabeling(ByteProcessor) - Constructor for class imagingbook.pub.regions.RecursiveLabeling
-
Creates a new region labeling.
- Red - Static variable in class imagingbook.pub.fd.Colors
-
- Red - Static variable in class imagingbook.pub.sift.util.Colors
-
- redgreen() - Static method in class imagingbook.lib.ij.LookupTables
-
ImageJ's 'redgreen' LUT, as originally defined in class LutLoader
.
- redirectSystem() - Static method in class imagingbook.lib.ij.IjLogStream
-
Redirects all output sent to System.out
and System.err
to ImageJ's log console using empty prefix strings.
- redirectSystem(String, String) - Static method in class imagingbook.lib.ij.IjLogStream
-
Redirects all output sent to System.out
and System.err
to ImageJ's log console using the default prefixes.
- redirectSystemErr(String) - Static method in class imagingbook.lib.ij.IjLogStream
-
Redirects all output sent to System.err
to ImageJ's log console.
- redirectSystemOut(String) - Static method in class imagingbook.lib.ij.IjLogStream
-
Redirects all output sent to System.out
to ImageJ's log console.
- RegionContourLabeling - Class in imagingbook.pub.regions
-
Binary region labeler based on a combined region labeling
and contour tracing algorithm:
F.
- RegionContourLabeling(ByteProcessor) - Constructor for class imagingbook.pub.regions.RegionContourLabeling
-
Creates a new region labeling.
- RegionLabeling - Class in imagingbook.pub.regions
-
This class does the complete region labeling for a given image.
- RegionLabeling(ByteProcessor) - Constructor for class imagingbook.pub.regions.RegionLabeling
-
- RegionLabeling.BinaryRegion - Class in imagingbook.pub.regions
-
This inner class of
RegionLabeling
represents a connected
component or binary region.
- regions - Variable in class imagingbook.pub.regions.RegionLabeling
-
- remove() - Method in class imagingbook.lib.util.ArrayIterator
-
- reset() - Static method in class imagingbook.lib.settings.PrintPrecision
-
- reset() - Static method in class imagingbook.pub.color.image.RgbGamutChecker
-
- resetLabel() - Method in class imagingbook.pub.regions.RegionLabeling
-
- ResourceUtils - Class in imagingbook.lib.util
-
This class defines static methods for accessing resources.
- ResourceUtils() - Constructor for class imagingbook.lib.util.ResourceUtils
-
- revertSystem() - Static method in class imagingbook.lib.ij.IjLogStream
-
Use this method to revert both System.out
and System.err
to their original output streams.
- revertSystemErr() - Static method in class imagingbook.lib.ij.IjLogStream
-
Use this method to revertSystem.err
to the original output stream.
- revertSystemOut() - Static method in class imagingbook.lib.ij.IjLogStream
-
Use this method to revertSystem.out
to the original output stream.
- Rgb(ColorProcessor, OutOfBoundsStrategy, InterpolationMethod) - Constructor for class imagingbook.lib.image.ImageAccessor.Rgb
-
- rgb - Variable in class imagingbook.pub.edgepreservingfilters.BilateralFilter
-
- rgb332() - Static method in class imagingbook.lib.ij.LookupTables
-
ImageJ's 'rgb332' LUT, as originally defined in class LutLoader
.
- RgbGamutChecker - Class in imagingbook.pub.color.image
-
- RgbGamutChecker() - Constructor for class imagingbook.pub.color.image.RgbGamutChecker
-
- RGBtoHLS(int[]) - Method in class imagingbook.pub.color.image.HlsConverter
-
- RGBtoHSV(int[]) - Method in class imagingbook.pub.color.image.HsvConverter
-
- rgbToInt(int, int, int) - Method in class imagingbook.pub.color.quantize.ColorQuantizer
-
- rgbToSrgb(float[]) - Static method in class imagingbook.lib.color.sRgbUtil
-
- rgbToSrgb(ImagePlus) - Static method in class imagingbook.pub.color.image.ColorStack
-
- rgbToSrgb(float[]) - Static method in class imagingbook.pub.color.image.sRgbUtil
-
- rho_Max - Variable in class imagingbook.pub.sift.SiftDetector.Parameters
-
Max.
- rho_max - Variable in class imagingbook.pub.sift.SiftMatcher.Parameters
-
Max.
- RippleMapping - Class in imagingbook.pub.geometry.mappings.nonlinear
-
- RippleMapping(double, double, double, double, boolean) - Constructor for class imagingbook.pub.geometry.mappings.nonlinear.RippleMapping
-
- RoiUtils - Class in imagingbook.pub.lucaskanade
-
Deprecated.
- RoiUtils() - Constructor for class imagingbook.pub.lucaskanade.RoiUtils
-
Deprecated.
- rotate(double) - Method in class imagingbook.lib.math.Complex
-
- rotate(double) - Method in class imagingbook.pub.fd.FourierDescriptor
-
For testing: apply shape rotation to this FourierDescriptor (phi in radians)
- Rotation - Class in imagingbook.pub.geometry.mappings.linear
-
- Rotation(double) - Constructor for class imagingbook.pub.geometry.mappings.linear.Rotation
-
- s_Desc - Variable in class imagingbook.pub.sift.SiftDetector.Parameters
-
Spatial size factor of descriptor (relative to feature scale)
- s_Fscale - Variable in class imagingbook.pub.sift.SiftDetector.Parameters
-
Scale factor for converting normalized features to byte values in [0,255]
- samplePolygonUniformly(Point2D[], int) - Method in class imagingbook.pub.fd.PolygonSampler
-
Samples the closed polygon path specified by V at M
equi-distant positions.
- samplePolygonUniformly(Point2D[], int, double) - Method in class imagingbook.pub.fd.PolygonSampler
-
This is for testing: allows to choose an arbitrary start point by
setting 'startFrac' in [0,1].
- samplMethod - Variable in class imagingbook.pub.color.quantize.KMeansClusteringQuantizer.Parameters
-
The method used for selecting the initial color samples.
- SauvolaThresholder - Class in imagingbook.pub.threshold.adaptive
-
Adaptive thresholder as proposed in J.
- SauvolaThresholder() - Constructor for class imagingbook.pub.threshold.adaptive.SauvolaThresholder
-
- SauvolaThresholder(SauvolaThresholder.Parameters) - Constructor for class imagingbook.pub.threshold.adaptive.SauvolaThresholder
-
- SauvolaThresholder.Parameters - Class in imagingbook.pub.threshold.adaptive
-
- ScalarMedianFilter - Class in imagingbook.pub.color.filters
-
Ordinary (scalar) median filter for color images implemented
by extending the
GenericFilter
class.
- ScalarMedianFilter() - Constructor for class imagingbook.pub.color.filters.ScalarMedianFilter
-
- ScalarMedianFilter(ScalarMedianFilter.Parameters) - Constructor for class imagingbook.pub.color.filters.ScalarMedianFilter
-
- ScalarMedianFilter.Parameters - Class in imagingbook.pub.color.filters
-
- scale - Variable in class imagingbook.pub.sift.KeyPoint
-
- scale - Variable in class imagingbook.pub.sift.util.SiftKeypoint
-
- ScaleLevel - Class in imagingbook.pub.sift.scalespace
-
Represents a single scale level.
- ScaleLevel(int, int, float[], double) - Constructor for class imagingbook.pub.sift.scalespace.ScaleLevel
-
- ScaleLevel(FloatProcessor, double) - Constructor for class imagingbook.pub.sift.scalespace.ScaleLevel
-
- ScaleLevel(ScaleLevel) - Constructor for class imagingbook.pub.sift.scalespace.ScaleLevel
-
- ScaleOctave - Class in imagingbook.pub.sift.scalespace
-
Represents a stack of scale levels within an octave.
- Scaling - Class in imagingbook.pub.geometry.mappings.linear
-
- selectOpenImage(String) - Static method in class imagingbook.lib.ij.IjUtils
-
Opens a dialog to let the user select one of the currently open images.
- SequentialLabeling - Class in imagingbook.pub.regions
-
Binary region labeler based on a sequential labeling
algorithm.
- SequentialLabeling(ByteProcessor) - Constructor for class imagingbook.pub.regions.SequentialLabeling
-
Creates a new region labeling.
- set(int) - Static method in class imagingbook.lib.settings.PrintPrecision
-
- setAbsoluteScale(double) - Method in class imagingbook.pub.sift.scalespace.ScaleLevel
-
- setAntialiasRendering(boolean) - Method in class imagingbook.lib.ij.ImagePlusForAntialiasedFlattening
-
Deprecated.
- setCaller(CallbackHandler) - Method in interface imagingbook.lib.ij.CallbackSender
-
- setCoefficient(int, Complex) - Method in class imagingbook.pub.fd.FourierDescriptor
-
- setCoefficient(int, double, double) - Method in class imagingbook.pub.fd.FourierDescriptor
-
- setElement(int, T) - Method in class imagingbook.lib.util.LinearContainer
-
- setInterpolationMethod(int) - Method in class imagingbook.lib.image.ImageExtractor
-
- setLabel(int, int, int) - Method in class imagingbook.pub.regions.RegionContourLabeling
-
- setLabel(int, int, int) - Method in class imagingbook.pub.regions.RegionLabeling
-
- setMaxIterations(int) - Method in class imagingbook.pub.lucaskanade.LucasKanadeMatcher1D
-
- setOuterContour(Contour) - Method in class imagingbook.pub.regions.RegionLabeling.BinaryRegion
-
- setOutOfBoundsStrategy(OutOfBoundsStrategy) - Method in class imagingbook.lib.filters.GenericFilter
-
- setPix(int, int, float[]) - Method in class imagingbook.lib.image.ImageAccessor.Rgb
-
- setPix(int, int, float[]) - Method in class imagingbook.lib.image.ImageAccessor.Scalar
-
- setPix(int, int, float[]) - Method in class imagingbook.lib.image.ImageAccessor
-
- setProperty(String, double) - Method in class imagingbook.pub.regions.RegionLabeling.BinaryRegion
-
Sets the specified property of this region to the given value.
- setRgbConversionWeights(ImageProcessor) - Static method in class imagingbook.lib.ij.IjUtils
-
Sets the weighing factors for the color components used
in RGB-to-grayscale conversion for the specified image ip
.
- setRgbConversionWeights(ImageProcessor, double, double, double) - Static method in class imagingbook.lib.ij.IjUtils
-
Sets the weighing factors for the color components used
in RGB-to-grayscale conversion for the specified image ip
.
- setTolerance(double) - Method in class imagingbook.pub.lucaskanade.LucasKanadeMatcher1D
-
- setType(ImagePlus, ColorStack.ColorStackType) - Static method in class imagingbook.pub.color.image.ColorStack
-
- setup() - Method in class imagingbook.pub.color.edge.DiZenzoCumaniEdgeDetector
-
- setup() - Method in class imagingbook.pub.color.edge.GrayscaleEdgeDetector
-
- setup() - Method in class imagingbook.pub.color.edge.MonochromaticEdgeDetector
-
- setVal(int, int, float) - Method in class imagingbook.lib.image.ImageAccessor.Byte
-
- setVal(int, int, float) - Method in class imagingbook.lib.image.ImageAccessor.Float
-
- setVal(int, int, float) - Method in class imagingbook.lib.image.ImageAccessor.Scalar
-
- setVal(int, int, float) - Method in class imagingbook.lib.image.ImageAccessor.Short
-
- setWarpParameters(double[]) - Method in class imagingbook.pub.geometry.mappings.linear.AffineMapping
-
- setWarpParameters(double[]) - Method in class imagingbook.pub.geometry.mappings.linear.ProjectiveMapping
-
- setWarpParameters(double[]) - Method in class imagingbook.pub.geometry.mappings.linear.Translation
-
- setWarpParameters(double[]) - Method in interface imagingbook.pub.geometry.mappings.WarpParameters
-
- sharpen - Variable in class imagingbook.pub.color.filters.VectorMedianFilterSharpen.Parameters
-
Sharpening factor (0 = none, 1 = max.)
- Shear - Class in imagingbook.pub.geometry.mappings.linear
-
- Short(ShortProcessor, OutOfBoundsStrategy, InterpolationMethod) - Constructor for class imagingbook.lib.image.ImageAccessor.Short
-
- show(String) - Method in class imagingbook.pub.color.filters.FilterMask
-
- show() - Method in class imagingbook.pub.histogram.HistogramPlot
-
- show(int[][], String) - Method in class imagingbook.pub.morphology.BinaryMorphologyFilter
-
- show() - Method in class imagingbook.pub.sift.scalespace.HierarchicalScaleSpace
-
- show(String) - Method in class imagingbook.pub.sift.scalespace.HierarchicalScaleSpace
-
- show(String, int) - Method in class imagingbook.pub.sift.scalespace.ScaleOctave
-
- showAsStack(String) - Method in class imagingbook.pub.sift.scalespace.ScaleOctave
-
- showAsStack(String, int) - Method in class imagingbook.pub.sift.scalespace.ScaleOctave
-
- showCheckImage - Variable in class imagingbook.pub.hough.HoughTransformLines.Parameters
-
- showCheckImage - Variable in class imagingbook.pub.hough.HoughTransformLinesPosRadius.Parameters
-
- showFilter() - Method in class imagingbook.pub.morphology.old.BinMorpher
-
Deprecated.
- showFilter(int[][], String) - Method in class imagingbook.pub.morphology.old.BinMorpher
-
Deprecated.
- showHessians - Variable in class imagingbook.pub.lucaskanade.LucasKanadeMatcher.Parameters
-
Set true to display the Hessian matrices
- showMask - Variable in class imagingbook.pub.color.filters.VectorMedianFilter.Parameters
-
For testing only
- showMask - Variable in class imagingbook.pub.color.filters.VectorMedianFilterSharpen.Parameters
-
For testing only
- showProgress - Variable in class imagingbook.pub.hough.HoughTransformLines.Parameters
-
- showProgress - Variable in class imagingbook.pub.hough.HoughTransformLinesPosRadius.Parameters
-
- showSteepestDescentImages - Variable in class imagingbook.pub.lucaskanade.LucasKanadeMatcher.Parameters
-
Set true to display the steepest-descent images
- showSteepestDescentImages(double[][][]) - Method in class imagingbook.pub.lucaskanade.LucasKanadeMatcher
-
- showStructuringElement() - Method in class imagingbook.pub.morphology.BinaryMorphologyFilter
-
- SiftDescriptor - Class in imagingbook.pub.sift
-
SIFT descriptor.
- SiftDescriptor(double, double, double, double, double, int[]) - Constructor for class imagingbook.pub.sift.SiftDescriptor
-
- SiftDetector - Class in imagingbook.pub.sift
-
- SiftDetector(FloatProcessor) - Constructor for class imagingbook.pub.sift.SiftDetector
-
- SiftDetector(FloatProcessor, SiftDetector.Parameters) - Constructor for class imagingbook.pub.sift.SiftDetector
-
- SiftDetector.NeighborhoodType - Enum in imagingbook.pub.sift
-
Types of 3D neighborhoods used in min/max detection
- SiftDetector.Parameters - Class in imagingbook.pub.sift
-
- SiftKeyDisplay - Class in imagingbook.pub.sift.util
-
- SiftKeyDisplay(List<SiftKeypoint>) - Constructor for class imagingbook.pub.sift.util.SiftKeyDisplay
-
- SiftKeyfileReaderLowe - Class in imagingbook.pub.sift.util
-
- SiftKeyfileReaderLowe() - Constructor for class imagingbook.pub.sift.util.SiftKeyfileReaderLowe
-
- SiftKeyfileReaderVLFEAT - Class in imagingbook.pub.sift.util
-
- SiftKeyfileReaderVLFEAT() - Constructor for class imagingbook.pub.sift.util.SiftKeyfileReaderVLFEAT
-
- SiftKeypoint - Class in imagingbook.pub.sift.util
-
- SiftMatch - Class in imagingbook.pub.sift
-
- SiftMatch(SiftDescriptor, SiftDescriptor, double) - Constructor for class imagingbook.pub.sift.SiftMatch
-
- SiftMatch3 - Class in imagingbook.pub.sift
-
- SiftMatch3(SiftDescriptor, SiftDescriptor, SiftDescriptor, double) - Constructor for class imagingbook.pub.sift.SiftMatch3
-
- SiftMatcher - Class in imagingbook.pub.sift
-
- SiftMatcher(List<SiftDescriptor>) - Constructor for class imagingbook.pub.sift.SiftMatcher
-
- SiftMatcher(List<SiftDescriptor>, SiftMatcher.Parameters) - Constructor for class imagingbook.pub.sift.SiftMatcher
-
- SiftMatcher.Parameters - Class in imagingbook.pub.sift
-
- sigma2(int[]) - Method in class imagingbook.pub.threshold.Thresholder
-
- sigma2(int[], int, int) - Method in class imagingbook.pub.threshold.Thresholder
-
- sigma_0 - Variable in class imagingbook.pub.sift.SiftDetector.Parameters
-
Base scale of level 0 (base smoothing)
- sigma_s - Variable in class imagingbook.pub.sift.SiftDetector.Parameters
-
Sampling scale (nominal smoothing level of the input image)
- sigmaD - Variable in class imagingbook.pub.edgepreservingfilters.BilateralFilter.Parameters
-
Sigma (width) of domain filter
- sigmaG - Variable in class imagingbook.pub.edgepreservingfilters.TschumperleDericheFilter.Parameters
-
Gradient smoothing (sigma of Gaussian)
- sigmaMax - Variable in class imagingbook.pub.threshold.adaptive.SauvolaThresholder.Parameters
-
- sigmaR - Variable in class imagingbook.pub.edgepreservingfilters.BilateralFilter.Parameters
-
Sigma (width) of range filter
- sigmaR2 - Variable in class imagingbook.pub.edgepreservingfilters.BilateralFilter
-
- sigmaS - Variable in class imagingbook.pub.edgepreservingfilters.TschumperleDericheFilter.Parameters
-
Structure tensor smoothing (sigma of Gaussian)
- similarityGauss(float, float) - Method in class imagingbook.pub.edgepreservingfilters.BilateralFilter
-
- similarityGauss(float[], float[]) - Method in class imagingbook.pub.edgepreservingfilters.BilateralFilter
-
- size() - Method in class imagingbook.pub.fd.FourierDescriptor
-
- smoothRegions - Variable in class imagingbook.pub.edgepreservingfilters.PeronaMalikFilter.Parameters
-
Specify the type of conductivity function c()
- solve(double[][], double[]) - Static method in class imagingbook.lib.math.Matrix
-
- sort - Variable in class imagingbook.pub.sift.SiftMatcher.Parameters
-
Set true to sort matches
- sortKeyPoints - Variable in class imagingbook.pub.sift.SiftDetector.Parameters
-
Set true to sort detected keypoints by response magnitude
- spectrum() - Static method in class imagingbook.lib.ij.LookupTables
-
ImageJ's 'spectrum' LUT, as originally defined in class LutLoader
.
- SphereMapping - Class in imagingbook.pub.geometry.mappings.nonlinear
-
- SplineInterpolator - Class in imagingbook.lib.interpolation
-
- SplineInterpolator(ImageAccessor.Scalar) - Constructor for class imagingbook.lib.interpolation.SplineInterpolator
-
- SplineInterpolator(double, double) - Constructor for class imagingbook.lib.interpolation.SplineInterpolator
-
- sqr(T) - Static method in class imagingbook.lib.image.ImageMath
-
- sqr(int) - Static method in class imagingbook.lib.math.Arithmetic
-
- sqr(float) - Static method in class imagingbook.lib.math.Arithmetic
-
- sqr(double) - Static method in class imagingbook.lib.math.Arithmetic
-
- sqr(int) - Method in class imagingbook.pub.color.quantize.ColorQuantizer
-
- sqrt(T) - Static method in class imagingbook.lib.image.ImageMath
-
- sRgb65ColorSpace - Class in imagingbook.pub.color.image
-
- sRgb65ColorSpace() - Constructor for class imagingbook.pub.color.image.sRgb65ColorSpace
-
- srgbToLab(ImagePlus) - Static method in class imagingbook.pub.color.image.ColorStack
-
- srgbToLuv(ImagePlus) - Static method in class imagingbook.pub.color.image.ColorStack
-
- sRgbToRgb(float[]) - Static method in class imagingbook.lib.color.sRgbUtil
-
- srgbToRgb(ImagePlus) - Static method in class imagingbook.pub.color.image.ColorStack
-
- sRgbToRgb(float[]) - Static method in class imagingbook.pub.color.image.sRgbUtil
-
- sRgbUtil - Class in imagingbook.lib.color
-
- sRgbUtil() - Constructor for class imagingbook.lib.color.sRgbUtil
-
- sRgbUtil - Class in imagingbook.pub.color.image
-
This is a utility class with static methods for gamma correction
used by LabColorSpace and LuvColorSpace color spaces.
- sRgbUtil() - Constructor for class imagingbook.pub.color.image.sRgbUtil
-
- Statistics - Class in imagingbook.lib.image
-
- Statistics() - Constructor for class imagingbook.lib.image.Statistics
-
- Statistics - Class in imagingbook.lib.math
-
- Statistics() - Constructor for class imagingbook.lib.math.Statistics
-
- stripFileExtension(String) - Static method in class imagingbook.lib.util.FileUtils
-
Removes the extension part of a pathname.
- subtract(double[], double[]) - Static method in class imagingbook.lib.math.Matrix
-
- subtract(double[], int[]) - Static method in class imagingbook.lib.math.Matrix
-
- subtract(FloatProcessor) - Method in class imagingbook.pub.sift.scalespace.ScaleLevel
-
- sum(double[]) - Static method in class imagingbook.lib.math.Matrix
-
- sum(double[][]) - Static method in class imagingbook.lib.math.Matrix
-
- sum(float[]) - Static method in class imagingbook.lib.math.Matrix
-
- sum(float[][]) - Static method in class imagingbook.lib.math.Matrix
-
- sum(int[]) - Method in class imagingbook.pub.threshold.Thresholder
-
- swapQuadrants(ImageProcessor) - Method in class imagingbook.pub.dft.Dft2d
-
- v - Variable in class imagingbook.pub.sift.KeyPoint
-
- valueOf(String) - Static method in enum imagingbook.lib.color.CssColor
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum imagingbook.lib.image.OutOfBoundsStrategy
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum imagingbook.lib.interpolation.InterpolationMethod
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum imagingbook.lib.math.VectorNorm.NormType
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum imagingbook.pub.color.image.ColorStack.ColorStackType
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum imagingbook.pub.color.image.Illuminant
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum imagingbook.pub.color.quantize.KMeansClusteringQuantizer.SamplingMethod
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum imagingbook.pub.color.quantize.KMeansClusteringQuantizerApache.SamplingMethod
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum imagingbook.pub.edgepreservingfilters.PeronaMalikFilter.ColorMode
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum imagingbook.pub.matching.DistanceTransform.Norm
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum imagingbook.pub.morphology.BinaryMorphologyFilter.OpType
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum imagingbook.pub.morphology.old.BinMorpher.Operation
-
Deprecated.
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum imagingbook.pub.sift.FeatureDistanceNorm
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum imagingbook.pub.sift.SiftDetector.NeighborhoodType
-
Returns the enum constant of this type with the specified name.
- valueOf(String) - Static method in enum imagingbook.pub.threshold.BackgroundMode
-
Returns the enum constant of this type with the specified name.
- values() - Static method in enum imagingbook.lib.color.CssColor
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum imagingbook.lib.image.OutOfBoundsStrategy
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum imagingbook.lib.interpolation.InterpolationMethod
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum imagingbook.lib.math.VectorNorm.NormType
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum imagingbook.pub.color.image.ColorStack.ColorStackType
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum imagingbook.pub.color.image.Illuminant
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum imagingbook.pub.color.quantize.KMeansClusteringQuantizer.SamplingMethod
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum imagingbook.pub.color.quantize.KMeansClusteringQuantizerApache.SamplingMethod
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum imagingbook.pub.edgepreservingfilters.PeronaMalikFilter.ColorMode
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum imagingbook.pub.matching.DistanceTransform.Norm
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum imagingbook.pub.morphology.BinaryMorphologyFilter.OpType
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum imagingbook.pub.morphology.old.BinMorpher.Operation
-
Deprecated.
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum imagingbook.pub.sift.FeatureDistanceNorm
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum imagingbook.pub.sift.SiftDetector.NeighborhoodType
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- values() - Static method in enum imagingbook.pub.threshold.BackgroundMode
-
Returns an array containing the constants of this enum type, in
the order they are declared.
- varThreshold - Variable in class imagingbook.pub.edgepreservingfilters.NagaoMatsuyamaFilter.Parameters
-
Variance threshold
- VectorMedianFilter - Class in imagingbook.pub.color.filters
-
Basic vector median filter for color images implemented
by extending the
GenericFilter
class.
- VectorMedianFilter() - Constructor for class imagingbook.pub.color.filters.VectorMedianFilter
-
- VectorMedianFilter(VectorMedianFilter.Parameters) - Constructor for class imagingbook.pub.color.filters.VectorMedianFilter
-
- VectorMedianFilter.Parameters - Class in imagingbook.pub.color.filters
-
- VectorMedianFilterSharpen - Class in imagingbook.pub.color.filters
-
Sharpening vector median filter for color images implemented
by extending the
GenericFilter
class.
- VectorMedianFilterSharpen() - Constructor for class imagingbook.pub.color.filters.VectorMedianFilterSharpen
-
Uses default parameters.
- VectorMedianFilterSharpen(VectorMedianFilterSharpen.Parameters) - Constructor for class imagingbook.pub.color.filters.VectorMedianFilterSharpen
-
- VectorMedianFilterSharpen.Parameters - Class in imagingbook.pub.color.filters
-
- VectorNorm - Class in imagingbook.lib.math
-
- VectorNorm() - Constructor for class imagingbook.lib.math.VectorNorm
-
- VectorNorm.L1 - Class in imagingbook.lib.math
-
- VectorNorm.L2 - Class in imagingbook.lib.math
-
- VectorNorm.Linf - Class in imagingbook.lib.math
-
- VectorNorm.NormType - Enum in imagingbook.lib.math
-
- VERBOSE - Variable in class imagingbook.pub.noise.perlin.PerlinNoiseGen
-