▼Nstira | Several useful enum definitions |
►Ncommon | |
CclusterEntry | |
CClusteringLearning | Class for 2D point cloud analysis Uses OpenCV's functionalities |
CCurve | Class that contains a curve. For us, a curve is a list of 8-neighborhood connected pixels in an stl vector |
CCurveSet | Class to manage a set of curves |
CdataRow | Help struct to create data interpolation |
CDrawFigures | A class to draw some simple parametric figure contours |
CExecutionTimer | Small timer class to get execution timings of applications Ref: http://osr600doc.sco.com/en/SDK_c++/_Measuring_Program_Execution_Tim.html For windows, this becomes http://www.dreamincode.net/forums/showtopic24685.htm with some code #include <windows.h> // code long int before = GetTickCount(); |
CFileAccess | Class to facilitate file access in directories |
CFitCurve | Class to fit a parametric function to a set of data points For the moment, only linear, quadratic, exponential and polynomial fit are available The polynomial fit uses OpenCV's matrix operations |
CFixedBuffer | A class to represent a buffer of fixed size |
CIntensityPoint | |
CLineSegment | A class to represent a 2D line segment by a point couple |
CMathUtils | A class with some handy mathematical functions |
CMonotonicCubicSplineInterpolator | |
CNeighborPointPair | |
CPcaResult | Struct to hold results of a PCA analysis of the passed points |
CPoint | A class to represent a 2D point |
CpointCluster | Struct to hold results of a single point cluster |
CPolygon | Class that contains a polygon. For us, a polygon is a list of vertices in an stl vector, where the first point equals the last point |
CQuantileNormalDistribution | Class to check if a histogram follows a normal distribution |
CRectangularROI | A class to represent a rectangular ROI. The edges of this ROI are parallel with the x and y axes. Here, we consider a closed ROI, i.e., the edge points also belong to the ROI |
CStatistics | Class to compute some simple statistics Note void ProcessArray ( const int * , size_t numInts ) ; can be called directly with an stl vector as follows ProcessArray ( &foo[0], foo.size() ); |
CStringUtils | A class with some handy functions to manipulate STL strings |
CTextFileUtils | A class with some handy functions to manipulate ASCII text files |
►Ncontrastenhance | |
CAdaptiveEnhanceLuong | Adaptive contrast enhancement accoring to method of Hiep Luong The implementation is based on the text of his PhD thesis "Advanced Image and Video Resolution Enhancement Techniques", 2008, Ghent University, TELIN-IPI, page 57 and following |
CAdaptiveHistogramEqualizer | Class for adaptive histogram equalization like in https://en.wikipedia.org/wiki/Adaptive_histogram_equalization |
CHazeRemover | Haze removal from single image Ref: 1) Single Image Haze Removal using Dark Channel Prior Kaiming He, Jian Sun, and Xiaoou Tang IEEE Conference on Computer Vision and Pattern Recognition (CVPR), June 2009 http://personal.ie.cuhk.edu.hk/~hkm007/ 2) TODO: add matting to refine processing at depth transitions A Closed Form Solution to Natural Image Matting. A. Levin D. Lischinski and Y. Weiss. IEEE Trans. Pattern Analysis and Machine Intelligence, Feb 2008 Current website: http://www.wisdom.weizmann.ac.il/~levina/ Older, with pdf http://people.csail.mit.edu/alevin/papers/Matting-Levin-Lischinski-Weiss-CVPR06.pdf and matlab code http://people.csail.mit.edu/alevin/matting.tar.gz UNDER CONSTRUCTION!! |
CHistogramTools | Class with tools for image intensity remapping using histograms, like histogram matching and histogram equalization |
CRetinex | Retinex contrast enhancement/color restoration |
►Ndeconvolve | |
CDeconvolveMaster | Parent class for computing deconvolutions |
CGNCDeconvolve | Child class for computing GNC-based image deconvolution GNC stands for Graduated Non Convexity, related stuff to markov random fields |
CIterativeDeconvolve | Parent class for computing iterative deconvolution schemes |
CRichardsonLucyDeconvolve | Child class for computing Richardson-Lucy deconvolution |
CSimulateDegradation | Class to simulate image degradation, by blurring and applying noise |
CTikhonovMillerDeconvolve | Child class for computing Tikhonov-Miller deconvolution Based on implementation of my thesis student Tim Stevens |
CVanCittertLandweberDeconvolve | Child class for computing Van Cittert or Landweber deconvolution |
CWienerDeconvolve | Child class for computing wiener deconvolution |
►Ndegradationestimation | |
CBlurEstimator | A class to estimate blur by searching a range of blur values and selecting the one with the best gradient kurtosis References: - "Blur Identification based on Kurtosis Minimization". D. Li, R. Mersereau and S. Simsk in IEEE ICIP2005 |
CBlurEstimatorHu | A class to estimate blur using method of Hu and de Haan References: - "Low Cost Robust Blur estimator". H. Hu and G. De Haan in IEEE ICIP 2006, Oct. 8-11, 2006, Atlanta (GA), pp. 617-620 |
CCompareSmoothSharpDijk | Class to compare effects of sharpening and filtering using joint histograms of gradients Reference: "A new measure for the effect of sharpening and smoothing filters on images", J. Dijk, D. de Ridder, P.W. Verbeek, J. Walraven, I.T. Young, and L.J. van Vliet in: B.K. Ersboll, P. Johansen (eds.), SCIA'99, Proc. 11th Scandinavian Conference on Image Analysis (Kangerlussuaq, Greenland, June 7-11), Pattern Recognition Society of Denmark, Lyngby, 1999, 213-220. WORK IN PROGRESS |
►Ndiffusion | |
CAnisotropicDiffusion | A class to compute anisotropic diffusion for more info, see http://www.cs.sfu.ca/~stella/papers/blairthesis/main/node22.html |
►Nfilter | |
CAdaptiveBilateralFilter | Computes adaptive bilateral filter as described in reference Bibtex reference: article{ zhang08adaptive, author = {Zhang, B. and Allebach, J. P.}, title = {Adaptive Bilateral Filter for Sharpness Enhancement and Noise Removal}, journal = {IEEE Trans. Image Processing}, volume = {17}, number = {5}, pages = {664–678} year = {2008} } |
CAnisotropicGaussian | |
CblockMatch | Structure to compare image blocks We use the coordinates of the center of the candidate block and its Euclidean intensity distance with a given reference block. This distance is the summed squared intensity difference of two blocks |
CColorLookupTable | Colour lookup table to assign colours to the 4096 labels occuring in LBP's with a 12 point neighborhood |
CDifferenceOfGaussians | Creates a Difference of Gaussians filtered image http://en.wikipedia.org/wiki/Difference_of_Gaussians |
CGaussConvolve | Convolves image with Gaussian PSF |
CKuwaharaFilter | Computes Kuwahara filtered image |
CLaplacianOfGaussianFilter | Creates a Laplacian of Gaussian filtered image |
CLocalBinaryPattern | Computes the Local Binary Pattern operation for each pixel in the image |
CLogGabor | Generates Log Gabor filtered image Fourier domain transfer function is implemented in fouriertools/TransferFunctionGenerator Reference: Peter Kovesi: http://www.csse.uwa.edu.au/~pk/Research/MatlabFns/PhaseCongruency/Docs/convexpl.html |
CMedianFilter | Class for classical and hybrid median filter |
CNonLocalMeansFilter | Non-local means filter |
CNonSeparableFilter | Filters an image using a non-separable filter kernel |
CSeparableFilter | Filters an image using a separable filter kernel |
CUnsharpMask | Enhances image sharpness by unsharp masking |
►Nfouriertools | |
CFFT | A class to hold spectral bands of an image |
CFFTBand | Data structure for FFT manipulations |
CFFTCalculator | Parent class to compute the Fourier transforms based on several libraries Survey of FFT implementations: http://www.jjj.de/fft/fftpage.html Child classes specifically offer interface to |
CFFTWCalculator | A class to compute the Fourier transforms based on the FFTW library |
CKISSFFTCalculator | A class to compute the Fourier transforms based on the KISS FFT library by Mark Borgerding Mark Borgerding wrote all the kiss_fft files Source: http://sourceforge.net/projects/kissfft/ |
CTransferFunctionGenerator | Generate transfer functions to be applied in the fourier domain |
►Nhistogram | |
CCurveSegment | |
CFloatHistogram | Class for floating point valued histograms E.g. needed to represent an normalized histogram when performing histogram equalization WARNING: currently only works for default case when bin size is 1 |
CHistogramMaster | Simple histogram class |
CIntHistogram | Simple histogram class WARNING: currently only works for default case when bin size is 1 |
CJointHistogram | Conditional or joint histogram class WARNING: currently only works for default case when bin size is 1 |
CRunLengthHistogram | Histogram to keep track which values are found over which run lengths Reference: http://www.nlpr.ia.ac.cn/2008papers/gjhy/gh87.pdf http://www.roborealm.com/help/ShapeHistogram.php |
CSpatiogram | |
►Nimageanalysis | |
CCannyEdgeDetector | Canny edge detector inspired on http://en.wikipedia.org/wiki/Canny_edge_detector ftp://figment.csee.usf.edu/pub/Edge_Comparison/source_code http://www.pages.drexel.edu/~nk752/cannyTut2.html http://www.cvmt.dk/education/teaching/f09/VGIS8/AIP/canny_09gr820.pdf |
CCompareCurvesInImage | Compares two gray value images in which mono-colored curves are drawn |
CContourTracing | Contour tracing class Traces contours that go mainly horizontally |
CDistanceTransform | Class to compute distance transform based on method below Distance Transforms of Sampled Functions P. Felzenszwalb, D. Huttenlocher Theory of Computing, Vol. 8, No. 19, September 2012 http://cs.brown.edu/~pff/dt/ |
CFindMaximalIncludedRectangles | Finds maximal rectangles contained in an object Maximal means that the rectangle can not be in its whole part of a larger rectangle Algorithm is from http://www.montefiore.ulg.ac.be/~pierard/rectangles/ |
CFloodFill | Class that implements a simple flood fill Based on recursive implementation described in http://en.wikipedia.org/wiki/Flood_fill |
CFunctionsOpenCV | |
CHOG | Class to compute Image descriptor based on Histogram of Orientated Gradients (HOG) for gray-level images References: - https://software.intel.com/en-us/node/529070 |
CHoughTransform | Canny edge detector |
Cmycomparison | Help class: needed by priority_queue for ordering the elements |
CPixelElement | Little helper class to compare PixelElement's to order them in the priority queue |
CSLIC | |
CStegerLineDetector | Steger line detector article{ steger98line, author = {Steger, C.}, title = {An unbiased detector of curvilinear structures}, journal = {IEEE Trans. Pattern Analysis and Machine Intelligence}, volume = {20}, number = {2}, pages = {113–125}, month = {February}, year = {1998} } |
CStereoMatchDepth | |
CThinning | Morphological thinning: applies the following set of structure elements; |
CWatershedMeyer | Template class for watershed transformations variant of Meyer algorithm, as used in Matlab http://www.mathworks.com/access/helpdesk/help/toolbox/images/watershed.html Meyer, Fernand, "Topographic distance and watershed lines," Signal Processing , Vol. 38, July 1994, pp. 113-125 Alternative watershed algorithms with source code can be found on http://www.esiee.fr/~info/tw/ |
CWatershedToboggan | Watershed segmentation immersion according to Lin et al (Algorithm 1), as described in article{ lin06toboggan, author = {Yung-Chieh Lin, Yu-Pao Tsai, Yi-Ping Hung, and Zen-Chung Shih.}, title = {Comparison Between Immersion-Based and Toboggan-Based Watershed Image Segmentation}, journal = {IEEE Trans. Image Processing}, volume = {15}, number = {3}, pages = {632–640}, year = {2006} } http://ippr.csie.ntu.edu.tw |
►Nimagedata | |
CArrayGrid | A class to contain a regular grid of integer or float numbers, structs and even more complex objects |
CArrayGridTools | A class with operations to perform on a regular grid |
Ccmyk_t | Representation of a single CMYK color |
CColorConstants | Usefull constants related to color and color spaces * References: reference white points: http://www.digitalcolour.org/toolbox.htm Illuminants: Danny Pascale. "A Review of RGB color spaces". (Babel Color). http://www.babelcolor.com/download/A review of RGB color spaces.pdf |
CColorValue | Struct that represents the color value triplet and an identifier |
Ccompare_neighbor_entry_t | |
CCWTPyramid | Special child data class to contain complex-valued lowpass levels for a subsampled complex wavelet transform In essence a container for objects of the class PyramidLevel that contain the actual bands |
CDistinctColorGenerator | Generate distinct colors for visualization Based on http://stackoverflow.com/questions/309149/generate-distinctly-different-rgb-colors-in-graphs Generates (I, 0, 0), (0, I, 0), (0, 0, I), (I, I, 0), (I, 0, I), (0, I, I) with I 255, 128, 64+0x128=64, 64+1x128=192, 32+0x64=32, 32+1x64=96, 32+2x64=160, 32+3x64=224, .. |
CGridConverter | Class to convert a grid of one data type to another |
CGridExtender | Extends input grid in a user-selected way |
CGridStatistics | |
CImage | A class to hold image data. It consists of three things: the actual image data, the corresponding metadata and some operations that can be executed on an image as a whole. The image data arev stored as a vector of ArrayGrids that represent the spectral bands (like red, green, blue, ...) of an image |
CImageStatistics | |
Clab_t | Elementary color profile representations In this file, we have a few data structures and a class to represent some elementary color profiles that translate between a machine dependant CMYK space and a device independant Lab space |
CLocalOrientation | A class to contain the local orientation for a certain grid position |
Clut_entry_t | Single entry in a lookup table that translates between a CMYK color and a Lab color |
COrientationGrid | A data class to hold a grid of local orientations: for each pixel, a local orientation and magnitude are kept from this representation, it should be fairly easy to implement the Hough transform for different parametric models like straight lines and circles: loop over all possible values of the parameter sets for the lines to check a) based on parameters, generate parametric representation of candidate line (circle, curve) b) for all pixels along this line, check if the orientation map (direction/strength) supports the presence of this candidate if yes, add 1 to accumulator for the given parameters |
CProfileCorrect | Experimental class to interpolate CLUTS in ICC color profiles from measured or estimated values |
CProfileData | Class to manage data in a color profile Basically consists of a color LookUp Table (CLUT) between a device space (A) and an independant space (B) This independant space is usually L*a*b*. In a profile, we usually have two tables: in A2B, the values in the A space are on a regular grid and the corresponding B values usually aren't; in the B2A, the values in the B space are on a regular grid and the corresponding A values usually aren't |
CPyramid | A data class to contain all subbands of a pyramid decomposition These bands are grouped per resolution level. All bands in one resolution level are grouped in a member class PyramidLevel. So, a pyramid contains a vector of pointers to "PyramidLevel" objects for the recursive scales and an extra pointer to a "PyramidLevel" object for the residual scale (like used in the steerable pyramid, is NULL if no residual scale is used) |
CPyramidLevel | A class to contain a single level of a pyramid decomposition |
CTransformColorSpace | Transformations between color spaces |
►Nimagetools | |
CAffineTransform | Class to apply affine transform to an image x' = a11 * x + a12 * y + dx y' = a21 * x + a22 * y + dy |
CBicubicInterpolator | Child class for bicubic interpolation Source: http://www.paulinternet.nl/?page=bicubic |
CBilinearInterpolator | Child class for bilinear interpolation Source: http://en.wikipedia.org/wiki/Bilinear_interpolation |
CChromaticAdaptation | A class for color adaptation Chromatic adaptation is the estimation of the representation of an object under a different light source than the one in which it was recorded |
CColorBalancer | Ref: http://scien.stanford.edu/class/psych221/projects/00/trek/ |
CDrawImageTools | Class with operations on image objects; This class draws within an existing image without creating a new image object |
CFisheyeCorrector | Simple class to correct Fisheye distortion Reference: http://www.tannerhelland.com/4743/simple-algorithm-correcting-lens-distortion/ |
CFractalGenerator | Class to generate fractals It can generate the Mandelbrot set and associated Julia sets |
CGeometricTransform | Geometric parametric transformation of an image |
CGretagMacbethColorChecker | A class for generating the Gretag - Macbeth Color Checker chart References: http://www.rags-int-inc.com/PhotoTechStuff/MacbethTarget/ http://www.brucelindbloom.com/index.html?ColorCheckerRGB.html |
CGridGenerator | Generates different predefined grids |
CImageIO | A class to hold spectral bands of an image |
CImageTools | Class with operations on image objects; Each of these operations creates a new image object that the caller becomes responsable for |
CInterpolator | A class for interpolation |
CmyMinMax | |
CNearestNeighborInterpolator | Child class for Nearest Neighbor interpolation |
CNumberGridTools | Child class of ArrayGrid in specific case that the template represents numerical values In this case, certain extra operations are possible, like finding min and max, add, multiply, subtract Methods in this class are divided in the following "sections": 0. CONSTRUCT / DESTRUCT |
CPerlinNoise | Class to generate clouds of Perlin noise code slightly adapted from code of Isaac McGarvey: http://infohost.nmt.edu/~imcgarve/perlin_noise/ |
CPyramidTools | Class with operations on Pyramid objects |
CRigidTransform | Class to apply rigid transform to an image x' = cos(t) * x - sin(t) * y + dx y' = sin(t) * x + cos(t) * y + dy |
CTextureGenerator | Class to generate different kinds of textures code slightly adapted from http://lodev.org/cgtutor/randomnoise.html |
CTranslation | Class to translate an image |
►Npyramidapplications | |
CPyramidContrastEnhancer | A class to demonstrate simple contrast enhancement The original reference used curvelets, we replaced these by a steerable pyramid Original reference: |
CPyramidDenoiser | A class to demonstrate simple denoising of the bands of a steerable pyramid Reference: "Bivariate Shrinkage Functions for Wavelet-based Image Denoising", Sendur, L. and Selesnick, I., IEEE Transactions on Signal Processing, 50(11):2744-2756, November 2002 |
CPyramidKeyPointDetector | A class to demonstrate simple contrast enhancement using a steerable pyramid reference: |
►Nregistration | |
CRegistrationWrapper | C++ Wrapper for Intramodal registration software from Philippe Thévenaz http://bigwww.epfl.ch/thevenaz/registration/ |
►Nsteerable | |
CBasicFilterKernels | A container class to store taps for steerable filters G2 and H2 by Freeman and Adelson |
CComputeOrientation | A class to compute local orientation in an image |
CComputeSteerableFilteredImages | A class to compute the basic steerable filtered images according to Freeman and Adelson |
CPyramidBurtAdelson | Class implementing the Laplacian pyramid accoring to Burt and Adelson |
CPyramidComplex | Child class to compute FFT based complex-valued steerable pyramid decomposition/reconstruction Formulae used from appendix; main paper is about texture modeling |
CPyramidMaster | Parent class to compute FFT based real- and complex-valued steerable pyramids (decomposition/reconstruction) |
CPyramidReal | Child class to compute FFT based real-valued steerable pyramid decomposition/reconstruction Bibtex reference for formulae used here: Formulae used from appendix; main paper is about texture denoising article{ portilla03image, author = {Portilla, J. and Strela, V. and Wainwright, M. and Simoncelli, E.}, title = {Image denoising using scale mixtures of Gaussians in the wavelet domain}, journal = {IEEE Trans. Image Processing}, volume = {12}, number = {11}, pages = {1338–1351} year = {2003}, url = {http://citeseer.ist.psu.edu/article/portilla03image.html} } |
►Nwavelet | |
CCriticallySubsampledTransform | Parent class to compute redundant, non-subsampled wavelet decomposition / reconstruction |
CNoiseEstimator | A class to estimate sigma for white noise with the Mean Absolute Deviation method of Donoho References: - "Ideal spatial adaptation by wavelet shrinkage", D. Donoho and I. Johnstone, Biometrika, 1994, vol. 81, pp. 425–455 (relevant section is on 17th page of the paper, just above section 4.3) |
CNonSubsampledTransform | Computes orthogonal redundant (i.e., non-subsampled) wavelet decomposition / reconstruction This class implements the a-trous algorithm of Mallat |
CSubsampledTransform | |
CWavelet | Parent class to compute wavelet decomposition / reconstruction For the moment just a fast Haar wavelet is available. Fast in the sense that the downsampling and upsampling are directly integrated in the computations and that no unnecessary coefficients are computed that are removed by the subsampling |
CWaveletFilterSet | Struct containing filter taps needed for analysis and reconstruction |
CWaveletTapGenerator | Wavelet tap set factory Generates a set of decomposition/reconstruction filter taps for the type of wavelet specified |
CFlashROF | |
CcartesianCoord | |
CExample | |
CfitRec | |
ChistList | |
Ckiss_fft_cpx | |
Ckiss_fft_state | |
Ckiss_fftnd_state | |
CqParam | |
▼CRandom | |
CdSquared | |
CRegistrationDemon | |
CrOper | |
CrParam | |
CsphericalCoord | |
CSVD | |