25 #ifndef __TERRALIB_RP_INTERNAL_FUNCTIONS_H    26 #define __TERRALIB_RP_INTERNAL_FUNCTIONS_H    34 #include "../dataaccess/datasource/DataSource.h"    35 #include "../raster/Raster.h"    36 #include "../raster/RasterFactory.h"    37 #include "../raster/Grid.h"    38 #include "../raster/BandProperty.h"    39 #include "../raster/RasterFactory.h"    40 #include "../raster/Interpolator.h"    41 #include "../raster/Utils.h"    42 #include "../srs/Converter.h"    43 #include "../geometry/LinearRing.h"    44 #include "../geometry/GTParameters.h"    45 #include "../geometry/MultiPoint.h"    46 #include "../geometry/Surface.h"    56 #include <boost/numeric/ublas/matrix.hpp>    57 #include <boost/shared_ptr.hpp>    84       SpectralSensorParams(
const int &band, 
const double &lower, 
const double &upper, 
const double &min, 
const double &max) :
   111       const std::vector< te::rst::BandProperty* >& bandsProperties,
   112       const std::string& outDataSetName,
   113       const std::string& dataSourceType,
   128       const std::vector< te::rst::BandProperty* >& bandsProperties,
   129       const std::string& outDataSetName,
   145       const std::vector< te::rst::BandProperty* >& bandsProperties,
   146       const std::map< std::string, std::string>& rasterInfo,
   147       const std::string& rasterType,
   148       std::unique_ptr< te::rst::Raster >& outRasterPtr );    
   160       std::vector< te::rst::BandProperty* > bandsProperties,
   174       std::vector< te::rst::BandProperty* > bandsProperties,
   175       const std::string& fileName,
   189       std::vector< te::rst::BandProperty* > bandsProperties,
   190       const std::string& fileName,
   191       std::unique_ptr< te::rst::Raster >& outRasterPtr );    
   205       const std::string& fileName );      
   230       unsigned int inputVectorSize, 
double* outputVector );
   242       unsigned int inputVectorSize, 
const int outputVectorDataType,
   243       void* outputVector );
   253     template< 
typename MatrixElementT >
   255       const bool normalize, 
const std::string& fileName )
   257       std::map<std::string, std::string> rInfo;
   258       rInfo[
"URI"] = fileName;
   260       std::vector<te::rst::BandProperty*> bandsProperties;
   266       bandsProperties[0]->m_noDataValue = -1.0 * std::numeric_limits<double>::max();
   271       std::unique_ptr< te::rst::Raster > outputRasterPtr(
   275       unsigned int line = 0;
   276       unsigned int col = 0;
   279       MatrixElementT matrixValue = 0;
   281       MatrixElementT gain = 1.0;
   282       MatrixElementT offset = 0.0;
   285         MatrixElementT matrixValueMin = std::numeric_limits< MatrixElementT >::max();
   286         MatrixElementT matrixValueMax = -1.0 * matrixValueMin;
   287         for( line = 0 ; line < nLines ; ++line )
   289           for( col = 0 ; col < nCols ; ++col )
   291             matrixValue = matrix[ line ][ col ];
   292             if( matrixValue < matrixValueMin )
   293               matrixValueMin = matrixValue;
   294             if( matrixValue > matrixValueMax )
   295               matrixValueMax = matrixValue;
   299         if( matrixValueMax == matrixValueMin )
   306           gain = 255.0 / ( matrixValueMax - matrixValueMin );
   307           offset = -1.0 * ( matrixValueMin );
   311       const MatrixElementT min0 = 0;
   312       const MatrixElementT max255 = 255;
   314       for( line = 0 ; line < nLines ; ++line )
   316         for( col = 0 ; col < nCols ; ++col )
   318           matrixValue = matrix[ line ][ col ];
   322             matrixValue += offset;
   324             matrixValue = std::max( min0, matrixValue );
   325             matrixValue = std::min( max255, matrixValue );
   328           outputRasterPtr->setValue( col, line, static_cast<double>(matrixValue), 0 );
   422       const unsigned int redBandIdx, 
const unsigned int greenBandIdx,
   423       const unsigned int blueBandIdx, 
const double rgbRangeMin, 
   443       const te::rst::Raster& inputGreenRaster, 
const unsigned int greenBandIdx,
   444       const te::rst::Raster& inputBlueRaster, 
const unsigned int blueBandIdx,
   445       const double rgbRangeMin, 
const double rgbRangeMax, 
te::rst::Raster& outputIHSRaster);
   461       const unsigned int intensityBandIdx, 
const unsigned int hueBandIdx,
   462       const unsigned int saturationBandIdx, 
const double rgbRangeMin, 
   482       const te::rst::Raster& inputSRaster, 
const unsigned int saturationBandIdx,
   483       const double rgbRangeMin, 
const double rgbRangeMax, 
te::rst::Raster& outputRGBRaster);
   499       const unsigned int redBandIdx, 
const unsigned int greenBandIdx,
   500       const unsigned int blueBandIdx, 
const double rgbRangeMin,
   519       const te::rst::Raster& inputGreenRaster, 
const unsigned int greenBandIdx,
   520       const te::rst::Raster& inputBlueRaster, 
const unsigned int blueBandIdx,
   521       const double rgbRangeMin, 
const double rgbRangeMax, 
te::rst::Raster& outputHLSRaster);
   536       const unsigned int hueBandIdx, 
const unsigned int lightBandIdx,
   537       const unsigned int saturationBandIdx, 
const double rgbRangeMin,
   556       const te::rst::Raster& inputSRaster, 
const unsigned int saturationBandIdx,
   557       const double rgbRangeMin, 
const double rgbRangeMax, 
te::rst::Raster& outputRGBRaster);
   570       const unsigned int maxThreads, 
   585       const unsigned int maxThreads, 
   586       double const * 
const meanValuePtr, 
   587       double& stdDevValue );         
   604       const unsigned int maxThreads, 
   605       double const * 
const mean1ValuePtr, 
   606       double const * 
const mean2ValuePtr,  
   607       double& covarianceValue );      
   623       const std::vector< unsigned int >& inputRasterBands,
   624       boost::numeric::ublas::matrix< double >& pcaMatrix,
   626       const std::vector< unsigned int >& pcaRasterBands,
   627       const unsigned int maxThreads );  
   642       const boost::numeric::ublas::matrix< double >& pcaMatrix,
   644       const std::vector< unsigned int >& outputRasterBands,
   645       const unsigned int maxThreads );       
   661       const std::vector< unsigned int >& inputRasterBands,
   662       const boost::numeric::ublas::matrix< double >& remapMatrix,
   664       const std::vector< unsigned int >& outputRasterBands,
   665       const unsigned int maxThreads ); 
   679       const std::vector< unsigned int >& inputRasterBands,
   680       const std::vector< std::map<std::string, std::string> > & outputRastersInfos,
   681       const std::string& outputDataSourceType,
   682       std::vector< boost::shared_ptr< te::rst::Raster > > & outputRastersPtrs );   
   698       const std::vector< unsigned int >& inputRasterBands,
   700       const std::map<std::string, std::string>& outputRasterInfo,
   701       const std::string& outputDataSourceType,
   702       std::unique_ptr< te::rst::Raster >& outputRasterPtr );     
   730     TERPEXPORT boost::numeric::ublas::matrix< double > 
   747       const std::vector< unsigned int >& inputRasterBands,
   749       const unsigned int levelsNumber,
   750       const boost::numeric::ublas::matrix< double >& filter );     
   766       const unsigned int levelsNumber,
   768       const std::vector< unsigned int >& outputRasterBands ); 
   788       const std::vector< unsigned int >& inputRasterBands,
   790       const unsigned int firstRow,
   791       const unsigned int firstColumn, 
   792       const unsigned int height, 
   793       const unsigned int width,
   794       const unsigned int newheight, 
   795       const unsigned int newwidth, 
   796       const std::map<std::string, std::string>& rinfo,
   797       const std::string& dataSourceType,
   798       std::unique_ptr< te::rst::Raster >& resampledRasterPtr ); 
   806     template< 
typename ContainerT >
   808       const bool useTPSecondCoordPair )
   810       if( tiePoints.size() < 3 )
   818         typename ContainerT::const_iterator it =
   820         const typename ContainerT::const_iterator itE =
   825           if( useTPSecondCoordPair )
   833         std::unique_ptr< te::gm::Geometry > convexHullPolPtr( points.
convexHull() );
   835         if( dynamic_cast< te::gm::Surface* >( convexHullPolPtr.get() ) )
   852       const unsigned int paletteSize,
   853       const bool randomize,
   854       std::vector< te::rst::BandProperty::ColorEntry >& palette );
   873       const unsigned int inputRasterBand,
   874       const bool createPaletteRaster,
   875       const unsigned int slicesNumber,
   876       const bool eqHistogram,
   877       const std::map< std::string, std::string >& rasterInfo,
   878       const std::string& rasterType,
   879       const bool enableProgress,
   880       std::vector< te::rst::BandProperty::ColorEntry > 
const * 
const palettePtr,
   881       std::unique_ptr< te::rst::Raster >& outRasterPtr );         
   886 #endif  // __TERRALIB_RP_INTERNAL_FUNCTIONS_H TERPEXPORT bool GetMeanValue(const te::rst::Band &band, const unsigned int maxThreads, double &meanValue)
Get the mean of band pixel values. 
 
TERPEXPORT double GetDigitalNumberBandMax(std::string bandName)
Returns the maximum digital number of a given sensor/band. 
 
TERPEXPORT bool ConvertIHS2RGB(const te::rst::Raster &inputIRaster, const unsigned int intensityBandIdx, const te::rst::Raster &inputHRaster, const unsigned int hueBandIdx, const te::rst::Raster &inputSRaster, const unsigned int saturationBandIdx, const double rgbRangeMin, const double rgbRangeMax, te::rst::Raster &outputRGBRaster)
IHS to RGB conversion. 
 
Index into a lookup table. 
 
A raster band description. 
 
double GetTPConvexHullArea(const ContainerT &tiePoints, const bool useTPSecondCoordPair)
Returns the tie points converx hull area. 
 
TERPEXPORT void SaveSensorParams(std::map< std::string, SpectralSensorParams > &)
Saves in SpectralSensor.json file the spectral sensors parameters. 
 
void TERPEXPORT GetDataTypeRange(const int dataType, double &min, double &max)
Returns the real data type range (all values that can be represented by the given data type)...
 
bool TERPEXPORT CreateNewMemRaster(const te::rst::Grid &rasterGrid, std::vector< te::rst::BandProperty * > bandsProperties, RasterHandler &outRasterHandler)
Create a new raster into a new memory datasource. 
 
TERPEXPORT std::vector< std::string > GetBandNames()
Returns a vector os with band's names. 
 
TERPEXPORT bool ConvertRGB2IHS(const te::rst::Raster &inputRedRaster, const unsigned int redBandIdx, const te::rst::Raster &inputGreenRaster, const unsigned int greenBandIdx, const te::rst::Raster &inputBlueRaster, const unsigned int blueBandIdx, const double rgbRangeMin, const double rgbRangeMax, te::rst::Raster &outputIHSRaster)
RGB to IHS conversion. 
 
TERASTEREXPORT void GetDataTypeRanges(const int &dataType, double &min, double &max)
Return the values range of a given data type. 
 
TERPEXPORT bool ComposeBands(te::rp::FeederConstRaster &feeder, const std::vector< unsigned int > &inputRasterBands, const te::rst::Interpolator::Method &interpMethod, const std::map< std::string, std::string > &outputRasterInfo, const std::string &outputDataSourceType, std::unique_ptr< te::rst::Raster > &outputRasterPtr)
Compose a set of bands into one multi-band raster. 
 
TERPEXPORT std::pair< double, double > GetDigitalNumberBandInfo(std::string bandName)
Returns the maximun and minimum digital numbers of a given sensor/band. 
 
An abstract class for data providers like a DBMS, Web Services or a regular file. ...
 
TERPEXPORT bool DirectPrincipalComponents(const te::rst::Raster &inputRaster, const std::vector< unsigned int > &inputRasterBands, boost::numeric::ublas::matrix< double > &pcaMatrix, te::rst::Raster &pcaRaster, const std::vector< unsigned int > &pcaRasterBands, const unsigned int maxThreads)
Generate all principal components from the given input raster. 
 
TERPEXPORT bool DecomposeBands(const te::rst::Raster &inputRaster, const std::vector< unsigned int > &inputRasterBands, const std::vector< std::map< std::string, std::string > > &outputRastersInfos, const std::string &outputDataSourceType, std::vector< boost::shared_ptr< te::rst::Raster > > &outputRastersPtrs)
Decompose a multi-band raster into a set of one-band rasters. 
 
TERPEXPORT double GetDigitalNumberBandMin(std::string bandName)
Returns the minimum digital number of a given sensor/band. 
 
InterpolationMethod
Allowed interpolation methods. 
 
TERPEXPORT double GetSpectralBandMax(std::string bandName)
Returns the maximum reflectance value of a given sensor/band. 
 
TERPEXPORT bool RemapValues(const te::rst::Raster &inputRaster, const std::vector< unsigned int > &inputRasterBands, const boost::numeric::ublas::matrix< double > &remapMatrix, te::rst::Raster &outputRaster, const std::vector< unsigned int > &outputRasterBands, const unsigned int maxThreads)
Remap pixel values using a remap function matrix. 
 
TERPEXPORT bool ConvertRGB2HLS(const te::rst::Raster &inputRedRaster, const unsigned int redBandIdx, const te::rst::Raster &inputGreenRaster, const unsigned int greenBandIdx, const te::rst::Raster &inputBlueRaster, const unsigned int blueBandIdx, const double rgbRangeMin, const double rgbRangeMax, te::rst::Raster &outputHLSRaster)
RGB to HLS conversion. 
 
#define TERP_TRUE_OR_RETURN_FALSE(value, message)
Checks if value is true. For false values a warning message will be logged and a return of context wi...
 
bool CreateRasterFileFromMatrix(const te::rp::Matrix< MatrixElementT > &matrix, const bool normalize, const std::string &fileName)
Create a tiff file from a matrix. 
 
bool TERPEXPORT Copy2DiskRaster(const te::rst::Raster &inputRaster, const std::string &fileName)
Create a new raster into a GDAL datasource. 
 
A LinearRing is a LineString that is both closed and simple. 
 
MultiPoint is a GeometryCollection whose elements are restricted to points. 
 
TERPEXPORT std::map< std::string, SpectralSensorParams > getSensorParams()
Returns a map with spectral sensors parameters defined in SpectralSensor.json file. 
 
A point with x and y coordinate values. 
 
TERPEXPORT bool NormalizeRaster(te::rst::Raster &inputRaster, double nmin=0.0, double nmax=255.0)
Normalizes one raster in a given interval. 
 
An abstract class for raster data strucutures. 
 
unsigned int getColumnsNumber() const 
The number of current matrix columns. 
 
TERPEXPORT bool InverseWaveletAtrous(const te::rst::Raster &waveletRaster, const unsigned int levelsNumber, te::rst::Raster &outputRaster, const std::vector< unsigned int > &outputRasterBands)
Regenerate the original raster from its wavelets planes. 
 
WaveletAtrousFilterType
Wavelet Atrous Filter types. 
 
virtual Geometry * convexHull() const _NOEXCEPT_OP(false)
This method calculates the Convex Hull of a geometry. 
 
TERPEXPORT bool ConvertHLS2RGB(const te::rst::Raster &inputHRaster, const unsigned int hueBandIdx, const te::rst::Raster &inputLRaster, const unsigned int lightBandIdx, const te::rst::Raster &inputSRaster, const unsigned int saturationBandIdx, const double rgbRangeMin, const double rgbRangeMax, te::rst::Raster &outputRGBRaster)
HLS to RGB conversion. 
 
TERPEXPORT bool DirectWaveletAtrous(const te::rst::Raster &inputRaster, const std::vector< unsigned int > &inputRasterBands, te::rst::Raster &waveletRaster, const unsigned int levelsNumber, const boost::numeric::ublas::matrix< double > &filter)
Generate all wavelet planes from the given input raster. 
 
#define TERPEXPORT
You can use this macro in order to export/import classes and functions from this module. 
 
bool TERPEXPORT CreateNewRaster(const te::rst::Grid &rasterGrid, const std::vector< te::rst::BandProperty * > &bandsProperties, const std::map< std::string, std::string > &rasterInfo, const std::string &rasterType, std::unique_ptr< te::rst::Raster > &outRasterPtr)
Create a new raster into the givem data source. 
 
void TERPEXPORT Convert2DoublesVector(void *inputVector, const int inputVectorDataType, unsigned int inputVectorSize, double *outputVector)
Convert vector elements. 
 
A raster band description. 
 
TERPEXPORT bool GetDetailedExtent(const te::rst::Grid &grid, te::gm::LinearRing &detailedExtent)
Create a datailed extent from the given grid. 
 
SpectralSensorParams(const int &band, const double &lower, const double &upper, const double &min, const double &max)
 
TERPEXPORT boost::numeric::ublas::matrix< double > CreateWaveletAtrousFilter(const WaveletAtrousFilterType &filterType)
Create a Wavele Atrous Filter. 
 
TERPEXPORT bool GetCovarianceValue(const te::rst::Band &band1, const te::rst::Band &band2, const unsigned int maxThreads, double const *const mean1ValuePtr, double const *const mean2ValuePtr, double &covarianceValue)
Get the covariance of band pixel values. 
 
TERPEXPORT bool RasterResample(const te::rst::Raster &inputRaster, const std::vector< unsigned int > &inputRasterBands, const te::rst::Interpolator::Method interpMethod, const unsigned int firstRow, const unsigned int firstColumn, const unsigned int height, const unsigned int width, const unsigned int newheight, const unsigned int newwidth, const std::map< std::string, std::string > &rinfo, const std::string &dataSourceType, std::unique_ptr< te::rst::Raster > &resampledRasterPtr)
Resample a subset of the raster, given a box. 
 
Configuration flags for the Raster Processing module of TerraLib. 
 
TERPEXPORT double GetSpectralBandMin(std::string bandName)
Returns the minimum reflectance value of a given sensor/band. 
 
TERPEXPORT bool RasterSlicing(const te::rst::Raster &inputRaster, const unsigned int inputRasterBand, const bool createPaletteRaster, const unsigned int slicesNumber, const bool eqHistogram, const std::map< std::string, std::string > &rasterInfo, const std::string &rasterType, const bool enableProgress, std::vector< te::rst::BandProperty::ColorEntry > const *const palettePtr, std::unique_ptr< te::rst::Raster > &outRasterPtr)
Generate all wavelet planes from the given input raster. 
 
TERPEXPORT SpectralSensorParams GetSpectralBandInfo(std::string bandName)
Returns the maximun and minimum reflectance values of a given sensor/band. 
 
Feeder from a input rasters. 
 
void add(Geometry *g)
It adds the geometry into the collection. 
 
A generic template matrix. 
 
TERPEXPORT bool GetIndexedDetailedExtent(const te::rst::Grid &grid, te::gm::LinearRing &indexedDetailedExtent)
Create a indexed (lines,columns) datailed extent from the given grid. 
 
TERPEXPORT bool InversePrincipalComponents(const te::rst::Raster &pcaRaster, const boost::numeric::ublas::matrix< double > &pcaMatrix, te::rst::Raster &outputRaster, const std::vector< unsigned int > &outputRasterBands, const unsigned int maxThreads)
Regenerate the original raster from its principal components. 
 
TERPEXPORT void CreateFixedStepPalette(const unsigned int paletteSize, const bool randomize, std::vector< te::rst::BandProperty::ColorEntry > &palette)
Create a fixed step sequential color palette. 
 
static Raster * make()
It creates and returns an empty raster with default raster driver. 
 
A rectified grid is the spatial support for raster data. 
 
TERPEXPORT std::string GetSensorFilename()
Returns a json filename with spectral sensors parameters. 
 
unsigned int getLinesNumber() const 
The number of current matrix lines. 
 
TERPEXPORT bool GetStdDevValue(const te::rst::Band &band, const unsigned int maxThreads, double const *const meanValuePtr, double &stdDevValue)
Get the standard deviation of band pixel values. 
 
bool TERPEXPORT CreateNewGdalRaster(const te::rst::Grid &rasterGrid, std::vector< te::rst::BandProperty * > bandsProperties, const std::string &fileName, std::unique_ptr< te::rst::Raster > &outRasterPtr)
Create a new raster into a GDAL datasource. 
 
void TERPEXPORT ConvertDoublesVector(double *inputVector, unsigned int inputVectorSize, const int outputVectorDataType, void *outputVector)
Convert a doubles vector. 
 
Surface is an abstract class that represents a 2-dimensional geometric objects.