Contains the public interface of OPALS. More...
Namespaces | |
ErrorCode | |
error codes that identify an Exception | |
Exceptions | |
The namespace containing all exception types that may be thrown from within namespace opals. | |
GridFeature | |
Enumerator defining different grid feature types (used, eg., by opalsGrid) | |
opts | |
Contains the public interface of OPALS option types. | |
Classes | |
class | AbsValueOrQuantile |
AbsValueOrQuantile provides a container to either store an absolute value or a realtive quantile, percentage value. More... | |
class | AngleType |
AngleType provides defining angular values in different units (deg, rad, grad and percentage) More... | |
class | Array |
A template class holding a C - array of constant size. More... | |
class | AttributeBandDescription |
AttributeBandDescription provides generic information about a single attribute (used by DataSetStats). More... | |
class | AttributeDescription |
AttributeDescription provides generic information about a single attribute (used by DataSetStats). More... | |
class | BoolReference |
Mimics std::vector<bool>::reference. More... | |
class | Calculator |
A typed version of DM::ICalculator. See Calculator. More... | |
struct | CalculatorHandle |
class | CalculatorWithPythonSupport |
A Calculator that alternatively supports Python formulas. See Calculator. More... | |
class | CalibrationEntry |
A CalibrationEntry object stores statistics and results of one calibration constant estimation. More... | |
class | CalibrationRegion |
CalibrationRegion stores calibration results of a single region based on a single ODM file. More... | |
class | CalibrationStats |
class | ColumnNameAlias |
Class for defining column name aliases. More... | |
class | ConvolutionKernel |
Class describing different kernels for convolution filtering. More... | |
class | CustomOptionType |
Base class for all custom parameter types. More... | |
class | DataSetStats |
DataSetStats provides generic information about a data file (use in opalsInfo). More... | |
class | DistributionDescription |
Description of a variety of different statistical distribution. More... | |
class | Filter |
A typed version of DM::IFilter. See Filters. More... | |
struct | FilterHandle |
class | FilterWithPlaceHolders |
A Filter with additional support for place holders. See Filters. More... | |
class | GridLimit |
Class describing xy-limits for grid datasets. More... | |
class | HistoStats |
HistoStats provides a histogram and additional statistical measures. More... | |
class | IAddInfo |
Inserts or updates ODM attributes by combining existing attributes and/or grid models. More... | |
class | IAlgebra |
Provides a generic raster algebra calculator featuring mathematical, statistical and conditional operators. More... | |
class | IBounds |
Derives and stores the 2D boundary polygon of a region covered by the point data of an ODM or the valid pixels of a raster. More... | |
class | ICell |
Calculates statistical features of user defined attributes and stores them as raster models or rasterized point clouds. More... | |
class | IContouring |
Derives the contour of foreground objects of a raster model and exports the results as a polygon shape file. More... | |
class | IControlObject |
Interface for retrieving status and progress information from a module run. More... | |
class | IConvolution |
Performs convolutional filtering operations on a raster image. More... | |
class | IDBH |
Estimate the Diameter at Breast Height (DBH) based on 3D point cloud data (ODM). More... | |
class | IDiff |
Calculates a difference grid model based on either two grids or a one grid and a horizontal reference plane. More... | |
class | IDirectGeoref |
Transforms points from scanner coordinates into geo-referenced coordinates by applying the sensor model (flight trajectory, mounting parameters). More... | |
class | IDSM |
Calculates a land cover dependent DSM raster model based on the approach of Hollaus et. al. (2010). More... | |
class | IDTM |
Calculates a high quality Digital Terrain Model in hybrid grid structure (i.e. regular grid + structure lines). More... | |
class | IEchoRatio |
Derives and stores the echo ratio (ER) attribute for points of an OPALS data manager. More... | |
class | IEdgeDetect |
Provides different raster based edge detection algorithms (e.g. Canny). More... | |
class | IExport |
Exports vector data stored in an OPALS data manager (ODM) in various data formats. More... | |
class | IFillGaps |
Detects gaps (i.e. void pixels) in raster models and provides several interpolation methods to close them. More... | |
class | IFullwave |
Performs decomposition of the full waveform signal and provides 3D coordinates (scanner system) and additional attributes for each return. More... | |
class | IGeorefApprox |
Improves the geo-referencing of an ALS flight block based on pairwise affine strip transformations (cf. Module LSM). More... | |
class | IGrid |
Derives a 2.5D digital elevation models (DEM) in regular grid structure using simple interpolation techniques. More... | |
class | IGridFeature |
Derives feature models (slope, curvature, roughness, etc.) from grid models based on the local grid neighbourhood defined by a kernel. More... | |
class | IHisto |
Derives histograms and descriptive statistics (min, max, mean, r.m.s, etc.) for ODM or grid/raster data sets and stores the results graphically (SVG) and numerically (XML). More... | |
class | IICP |
Performs orientation (co-registration) of multiple point cloud datasets using the Iterative Closest Point algorithm. More... | |
class | IImport |
Loads vector and raster data into an ODM for subsequent use in modules dealing with point cloud and line related data. More... | |
class | IInfo |
Extracts and reports information of an ODM, vector or raster file. More... | |
class | IIsolines |
Derives contour lines (isolines) from grid models and stores them as a vector dataset. More... | |
class | ILineModeler |
Models 3D structure lines based on a point cloud (ODM) and 2D line approximations. More... | |
class | ILineTopology |
Provides different line merging and topology correction tools for cleaning line networks derived via automatic edge detection. More... | |
class | ILSM |
Estimates an affine 3D transformation to align overlapping ALS strip DEMs using Least Squares Matching. More... | |
class | IModuleBase |
Abstract base class of all opals modules. More... | |
class | IMorph |
Applies morphological operations (opening, closing, erosion, dilation) on raster datasets. More... | |
class | IndexDescription |
IndexDescription provides generic information about a spatial index (used by DataSetStats). More... | |
class | INormals |
Estimates local surface normal vectors for each point of a specific point cloud (ODM). More... | |
class | IOpenness |
Provides a raster map of local viewsheds (i.e. openness) based on a DTM grid model. More... | |
class | IOverlap |
Analyses a set of strip boundaries and determines all overlapping strip pairs. More... | |
class | IPointStats |
Derives and stores statistical parameters describing the local distribution of a point attribute for each point of an ODM. More... | |
class | IQuery |
Interpolates height or attribute values for arbitrary 2D geometries based on either point clouds (not yet implemented) or grids. More... | |
class | IRadioCal |
Performs radiometric calibration of ALS data and calculates physical quantities (backscatter cross section/coefficient, reflectance) for each return. More... | |
class | IRasterize |
Performs vector-to-raster conversion for all types of simple feature geometries (points, lines, polygons). More... | |
class | IRobFilter |
Classification points into terrain and off-terrain using robust interpolation. More... | |
class | ISection |
Extracts sections of user defined width/length along a specified reference axis from a point cloud (ODM). More... | |
class | ISegment |
Segment interface. More... | |
class | ISegmentation |
Provides methods for point cloud segmentation based on local homogeneity using either a generic region growing approach or an adapted region growing for plane extraction. More... | |
class | ISegmentManager |
Segment manager interface. More... | |
class | IShade |
Derives shaded relief raster maps (geo-coded hill shading) of DEM grids. More... | |
class | ISimplify |
Analyses a regular or hybrid grid model and generates an approximating TIN surface based on a coarse-to-fine approach. More... | |
class | ISnellius |
Performs range and refraction corrections of raw laser bathymetry measurements according to Snell's law. More... | |
class | IStatFilter |
Performs statistical filtering of raster datasets with a sliding kernel of arbitrary shape and size. More... | |
class | IStripAdjust |
Improves the geo-referencing of ALS data and aerial images in a rigorous way combining strip adjustment and aerial triangulation. More... | |
class | ITerrainFilter |
Classifies a 3D point cloud (ODM) into terrain and off-terrain points. More... | |
class | ITerrainMask |
Identifies open terrain parts of a DSM input raster using the volume based approach by Piltz et al. (2016). More... | |
class | ITIN |
Creates a TIN surface from ODM vector data based on a 2D constrained Delaunay triangulation. More... | |
class | ITranslate |
Performs format conversion for vector data files with additional read support of GDAL rasters. More... | |
class | IVectorize |
Performs raster-to-vector conversion and exports polyline geometries. More... | |
class | IView |
Provides an interactive 3d viewer for points (including arbitrary attributes) and lines. More... | |
class | IZColor |
Derives color coded visualizations of grid models and stores them as geo-coded raster images. More... | |
class | IZonalFit |
Fits geometry models to a set of data points for multiple regions-of-interest. More... | |
class | List |
A template class representing an STL-conforming (doubly linked) std::list<T> More... | |
class | Matrix |
A template class for storing a two-dimensional array of constant size. More... | |
struct | ModuleDeleter |
A functor that may be used for memory management of modules allocated on the heap usage: e.g. std::shared_ptr<IGrid> grid( opals::IGrid::New(), opals::ModuleDeleter() );. More... | |
class | MountingPars |
class | MultiGridLimit |
Class describing xy-limits for grid datasets supporting multiple input datasets. More... | |
class | NoDataType |
Class for storing a type independent a nodata value (nodata value can be deactivated as well) More... | |
class | ObjectBase |
base class for objects which are controlled using the SharedPtr class. the virutal Delete function is used to delete the object in same heap where it was created More... | |
class | OdmOrRasterFile |
File path of an ODM or raster dataset. See OPALS Datamanager and Supported grid/raster formats. More... | |
class | OverlapDef |
Class implementing the potential specification of overlap areas as relative and/or absolute measures. More... | |
struct | Parameter |
Parameter stores a single parameter for file I/O in parameter files. More... | |
class | ParamList |
Contains several parameters in their string representation. More... | |
class | Path |
A file/directory path. More... | |
class | RasterBand |
File path of a raster dataset with optional specification of a zero-based band index or band name (default: 0. More... | |
class | RasterFile |
File path of a raster dataset. See Supported grid/raster formats. More... | |
class | ScalePal |
Class describing different scaling methods for palette entries. More... | |
class | SharedPtr |
smart pointer class for opals objects More... | |
class | StatFeature |
class | StemEntry |
A stem entry object represents the results of a single model fit. More... | |
class | StemModel |
class | String |
A dynamic character string whose interface conforms to STL's std::string. More... | |
class | TrafPars3dAffine |
class | Vector |
Mimics std::vector<T> More... | |
class | VectorOrRasterFile |
File path of a vector or raster dataset. See Supported vector formats, OPALS Datamanager, and Supported grid/raster formats. More... | |
class | ZColorLegend |
Class describing the legend parameter More... | |
class | ZColorScalePal |
Class describing different scaling methods for palette entries. More... | |
Enumerations | |
enum | ApplyTrafo { first, second, Count } |
TODO: Enumerator for what? More... | |
enum | BeamInfo { BeamVector, BeamVectorSCS, Range, ScanAngle, PanAngle, Count } |
TODO: Enumerator for what? More... | |
enum | BoundaryType { convexHull, minimumRectangle, alphaShape, Count } |
BoundaryType enumerates different types of outlines of a point cloud. More... | |
enum | CalcMode { perimeter, area, both, Count } |
TODO: Enumerator for what? More... | |
enum | DataSetType { odm, vector, grid, tin, Count } |
Possible data set types as used in DataSetStats (see opalsInfo) More... | |
enum | DBHModel { auto_, cylinder, cone, Count } |
Specifying DBH geometry fitting model. More... | |
enum | DivisionMode { irregular, hierarchical, Count } |
TODO: Enumerator for what? More... | |
enum | EchoRatioMode { basic, slopeAdaptive, Count } |
Enumerator defining different types of EchoRatio computation (used by opalsEchoRatio) More... | |
enum | EdgeDetector { Canny, Count } |
Enumerator for edge detection algorithm used in Module EdgeDetect. More... | |
enum | EdgeHandling { trend, mirror, propagate, nodata, Count } |
Enumerator defining different strategies for handling the image border pixels. More... | |
enum | FillMethod { feature, plane, adaptive, triangulation, kriging, Count } |
Enumerator defining different raster fill methods. More... | |
enum | FullwaveAlgorithm { gaussian, asdf, enhancedGaussian, Count } |
Enumerator defining different pulse extraction methods. More... | |
enum | GapInfo { BoundaryMask, BoundaryValues, MBR, VoidMask, Count } |
Write additional gap information to files. More... | |
enum | GeomModel { mean, robustMean, plane, robustPlane, quadric, robustQuadric, Count } |
TODO: Enumerator for what? More... | |
enum | GridInterpolator { snap, nearestNeighbour, naturalNeighbours, delaunayTriangulation, movingAverage, movingPlanes, robMovingPlanes, movingParaboloid, thinPlateSpline, kriging, Count } |
Enumerator defining different grid interpolation methods (used by opalsGrid) More... | |
enum | GridResolution { native, halfKernel, kernelSize, Count } |
Enumerator for specifying the (output) grid resolution depending on the size of the processing kernel. More... | |
enum | HeaderFeature { all, overviewZ, overviewPcount, Count } |
TODO: Enumerator for what? More... | |
enum | Hemisphere { north, south, Count } |
Hemispheres of the Earth or another planet. More... | |
enum | HistoMode { automatic, real, integer, Count } |
HistoMode enumerates different modes of histogram computations. More... | |
enum | IndexType { tile, quadtree, kdtree, rtree, Count } |
TODO: Enumerator for what? More... | |
enum | KernelShape { square, circle, diamond, Count } |
TODO: Enumerator for what? More... | |
enum | LogLevel { none, error, warning, info, verbose, debug, Count } |
Enumerator defining different importance levels of log records. More... | |
enum | LSMProcMode { local, continuous, global, Count } |
TODO: Enumerator for what? More... | |
enum | LSMTrafoType { zShift, shifts, rigid, mounting, helmert, full, Count } |
Type of transformation used for LSM computation. More... | |
enum | MergePolygonMode { safe, fast, Count } |
TODO: Enumerator for what? More... | |
enum | MorphOperation { erode, dilate, open, close, Count } |
TODO: Enumerator for what? More... | |
enum | NavigationFrame { ned, enu, Count } |
TODO: Enumerator for what? More... | |
enum | NoDataHandling { fill, leave, avoid, Count } |
Enumerator for defining the behaviour in case of nodata pixels in the image kernel. More... | |
enum | NormalsAlgorithm { simplePlane, robustPlane, fmcd, Count } |
Enumerator defining different normals estimation methods. More... | |
enum | NormalsDirection { upwards, downwards, toOrigin, fromOrigin, toScanner, fromScanner, Count } |
TODO: Enumerator for what? More... | |
enum | NormalsMetaInfo { minimum, medium, maximum, Count } |
TODO: Enumerator for what? More... | |
enum | OpennessFeature { positive, negative, Count } |
Enumerator for what? More... | |
enum | RasterDataType { uint8 = 1, uint16, int16, uint32, int32, float32, float64, cint16, cint32, cfloat32, cfloat64, Count } |
The data type of each pixel of a raster. More... | |
enum | RasterType { point, area, Count } |
Enumerator defining different data selection modes. More... | |
enum | ResamplingMethod { weightedAverage, simpleAverage, nearestNeighbour, bilinear, bicubic, never, Count } |
Enumerator defining different resampling methods. More... | |
enum | RobustInterpolator { plane, paraboloid, adapting, Count } |
robust surface interpolation methods More... | |
enum | ScannerOrientation { frd, fdl, flu, fur, bdr, bld, bul, bru, lfd, ldb, lbu, luf, rdf, rbd, rub, rfu, ufl, ulb, ubr, urf, dlf, dbl, drb, dfr, Count } |
Approximate directions of the scanner axes w.r.t. the platform, restricted to right-handed systems: front/back/left/right/up/down. More... | |
enum | SearchMode { d2, d3, d2_5, Count } |
Dimensionality selector. More... | |
enum | SegmentationMethod { condClustering, planeExtraction, Count } |
Enumerator defining different segmentation methods. More... | |
enum | SegmentSort { native, ascendingPSize, descendingPSize, Count } |
Enumerator for sorting segments. More... | |
enum | SelectionMode { nearest, quadrant, octant, Count } |
Enumerator defining different grid interpolation methods (used by opalsGrid) More... | |
enum | ShadingMethod { tanaka, lambert, peucker, Count } |
Enumerator defining different shading methods. More... | |
enum | StripAdjustStage { importData, preprocess, adjust, postprocess, exportData, exportStrips, Count } |
Defines the workflow phases of module StripAdjust. More... | |
enum | TerrainFilterMethod { robustInterpolation, Count } |
Enumerator for terrain filtering methods. More... | |
enum | TopologyProcessingMethod { merge, longest, clean, Count } |
Enumerator defining different modes in opalsLineTopology. More... | |
enum | TrajectoryCorrectionModel { bias, linear, spline, Count } |
Correction models for flight trajectories. More... | |
enum | UsageLevel { basic, mid, pro, Count } |
Frequency of use / needed level of user experience of an option. More... | |
enum | ValueSource { unknown, internalDefault, configFile, estimated, paramMapping, interFace, pickle, run, Count } |
Origin of an option value. More... | |
enum | VectorizationMode { toPolyline, toPolygon, Count } |
TODO: Enumerator for what? More... | |
enum | ZStatsMode { horizontalPlane, tiltedPlane, Count } |
TODO: Enumerator for what? More... | |
Functions | |
template<class T , std::size_t N> | |
bool | operator== (const Array< T, N > &l, const Array< T, N > &r) |
template<class T , std::size_t N> | |
bool | operator< (const Array< T, N > &l, const Array< T, N > &r) |
template<class T , std::size_t N> | |
bool | operator!= (const Array< T, N > &l, const Array< T, N > &r) |
template<class T , std::size_t N> | |
bool | operator> (const Array< T, N > &l, const Array< T, N > &r) |
template<class T , std::size_t N> | |
bool | operator<= (const Array< T, N > &l, const Array< T, N > &r) |
template<class T , std::size_t N> | |
bool | operator>= (const Array< T, N > &l, const Array< T, N > &r) |
template<class T , std::size_t N> | |
void | swap (Array< T, N > &l, Array< T, N > &r) |
void | embeddingSoftware (const char *text) |
Sets the name of the embedding software package. | |
void | object_base_deleter (ObjectBase *) |
deleter function for opals::BaseObject objects that can be used e.g. in std::shared_ptr class | |
void | swap (Path &, Path &) |
Path | operator/ (const Path &lhs, const Path &rhs) |
Path | operator/ (const Path &lhs, const char *rhs) |
Path | operator/ (const char *lhs, const Path &rhs) |
Path | operator/ (const Path &lhs, const String &rhs) |
Path | operator/ (const String &lhs, const Path &rhs) |
bool | operator< (const Path &, const Path &) |
bool | operator<= (const Path &, const Path &) |
bool | operator> (const Path &, const Path &) |
bool | operator>= (const Path &, const Path &) |
bool | operator== (const Path &, const Path &) |
bool | operator== (const Path &, const String &) |
bool | operator== (const String &, const Path &) |
bool | operator== (const Path &, const char *) |
bool | operator== (const char *, const Path &) |
bool | operator!= (const Path &, const Path &) |
bool | operator!= (const Path &, const String &) |
bool | operator!= (const String &, const Path &) |
bool | operator!= (const Path &, const char *) |
bool | operator!= (const char *, const Path &) |
std::size_t | hash_value (const Path &p) |
void | shared_ptr_create (SharedPtrImpl *&, void *obj, void(*deleter)(void *)) |
void | shared_ptr_create (SharedPtrImpl *&, ObjectBase *obj) |
void | shared_ptr_inc (SharedPtrImpl *&) |
void | shared_ptr_dec (SharedPtrImpl *&) |
unsigned int | shared_ptr_get_count (SharedPtrImpl *const &) |
void * | shared_ptr_get (SharedPtrImpl *const &) |
void * | shared_ptr_release (SharedPtrImpl *&) |
String | operator+ (const String &s1, const String &s2) |
String | operator+ (const char *s1, const String &s2) |
String | operator+ (const String &s1, const char *s2) |
String | operator+ (char c, const String &s2) |
String | operator+ (const String &s1, char c) |
bool | operator== (const String &s1, const String &s2) |
bool | operator== (const char *s1, const String &s2) |
bool | operator== (const String &s1, const char *s2) |
bool | operator!= (const String &s1, const String &s2) |
bool | operator!= (const char *s1, const String &s2) |
bool | operator!= (const String &s1, const char *s2) |
bool | operator< (const String &s1, const String &s2) |
bool | operator< (const char *s1, const String &s2) |
bool | operator< (const String &s1, const char *s2) |
void | swap (String &s1, String &s2) |
Contains the public interface of OPALS.
|
strong |
|
strong |
TODO: Enumerator for what?
|
strong |
BoundaryType enumerates different types of outlines of a point cloud.
|
strong |
|
strong |
Possible data set types as used in DataSetStats (see opalsInfo)
Enumerator | |
---|---|
odm | OPALS Datamanager file. |
vector | General vector data file (las, shp, ..) |
grid | Grid data file. |
tin | Triangulation data file. |
Count | number of elements |
|
strong |
|
strong |
|
strong |
Enumerator defining different types of EchoRatio computation (used by opalsEchoRatio)
|
strong |
Enumerator for edge detection algorithm used in Module EdgeDetect.
Enumerator | |
---|---|
Canny | Canny Edge Detector. |
Count | number of elements |
|
strong |
Enumerator defining different strategies for handling the image border pixels.
|
strong |
Enumerator defining different raster fill methods.
|
strong |
|
strong |
Write additional gap information to files.
|
strong |
|
strong |
Enumerator defining different grid interpolation methods (used by opalsGrid)
|
strong |
|
strong |
|
strong |
|
strong |
|
strong |
|
strong |
|
strong |
Enumerator defining different importance levels of log records.
|
strong |
|
strong |
Type of transformation used for LSM computation.
|
strong |
|
strong |
|
strong |
|
strong |
Enumerator for defining the behaviour in case of nodata pixels in the image kernel.
|
strong |
|
strong |
TODO: Enumerator for what?
|
strong |
|
strong |
|
strong |
The data type of each pixel of a raster.
|
strong |
|
strong |
Enumerator defining different resampling methods.
|
strong |
|
strong |
Approximate directions of the scanner axes w.r.t. the platform, restricted to right-handed systems: front/back/left/right/up/down.
|
strong |
|
strong |
|
strong |
|
strong |
Enumerator defining different grid interpolation methods (used by opalsGrid)
|
strong |
|
strong |
|
strong |
|
strong |
Enumerator defining different modes in opalsLineTopology.
|
strong |
|
strong |
|
strong |
Origin of an option value.
|
strong |
|
strong |
TODO: Enumerator for what?