opals Namespace Reference

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  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  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 header information of a vector or raster file (ODM, GDAL). 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 }
 TODO: Enumerator for what? 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, 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 &)
 
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)
 

Detailed Description

Contains the public interface of OPALS.

Enumeration Type Documentation

◆ ApplyTrafo

enum ApplyTrafo
strong

TODO: Enumerator for what?

Enumerator
first 

apply transformation to the first grid before subtracting

second 

apply transformation to the second grid before subtracting

Count 

number of elements

◆ BeamInfo

enum BeamInfo
strong

TODO: Enumerator for what?

Enumerator
BeamVector 

Beam vector in the world coordinate system.

BeamVectorSCS 

Beam vector in the sensor coordinate system.

Range 

Measurment range.

ScanAngle 

Scan angle as defined by LAS standard.

PanAngle 

The pan angle is the rotation of scanner head around primary axis of scanner. In case of a 1-D scanner, this is the varying angle around the only axis of the scanner.

Count 

number of elements

◆ BoundaryType

enum BoundaryType
strong

BoundaryType enumerates different types of outlines of a point cloud.

Enumerator
convexHull 

convex hull (strictly convex boundary polygon)

minimumRectangle 

minimum enclosing, oriented rectangle

alphaShape 

alpha shape ( strictly simple boundary polygon with dished parts but without holes)

Count 

number of elements

◆ CalcMode

enum CalcMode
strong

TODO: Enumerator for what?

Enumerator
perimeter 

Calculate only the perimeter.

area 

Calculate only the area.

both 

Calculate perimeter and area.

Count 

number of elements

◆ DataSetType

enum DataSetType
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

◆ DBHModel

enum DBHModel
strong

Specifying DBH geometry fitting model.

Enumerator
auto_ 

automatic model selection

cylinder 

cylinder model

cone 

cone model

Count 

number of elements

◆ DivisionMode

enum DivisionMode
strong

TODO: Enumerator for what?

Enumerator
irregular 

free division division of cells

hierarchical 

quad-tree division of cells

Count 

number of elements

◆ EchoRatioMode

enum EchoRatioMode
strong

Enumerator defining different types of EchoRatio computation (used by opalsEchoRatio)

Enumerator
basic 

basic echo ratio (# neighb. 3D / # neighb. 2D * 100)

slopeAdaptive 

slope adaptive echo ratio (slope based extension of 3D radius) if slope available, basic e.r. otherwise

Count 

number of elements

◆ EdgeDetector

enum EdgeDetector
strong

Enumerator for edge detection algorithm used in Module EdgeDetect.

Enumerator
Canny 

Canny Edge Detector.

Count 

number of elements

◆ EdgeHandling

enum EdgeHandling
strong

Enumerator defining different strategies for handling the image border pixels.

Enumerator
trend 

Pixels beyond the image edge are linearly extrapolated based on the nearest and second nearest pixel value.

mirror 

Pixels beyond the image edge are mirrored, so the order of pixels is inverse.

propagate 

Pixels from the image border are propagated beyond the image edge.

nodata 

Pixels beyond the image edge considered as nodata values. See noDataHandling parameter.

Count 

number of elements

◆ FillMethod

enum FillMethod
strong

Enumerator defining different raster fill methods.

Enumerator
feature 

Use a statistic feature of the boundary gap points for filling.

plane 

Uses tilted plane fit to fill gaps.

adaptive 

Uses adaptive plane fit with inverse distance weighting.

triangulation 

Uses triangulation of boundary points.

kriging 

Fill gap with kriging interpolation.

Count 

number of elements

◆ FullwaveAlgorithm

enum FullwaveAlgorithm
strong

Enumerator defining different pulse extraction methods.

Enumerator
gaussian 

Gaussian decomposition, standard.

asdf 

ASDF only (no pulse width)

enhancedGaussian 

Gaussian decompostion, ASDF echo detection.

Count 

number of elements

◆ GapInfo

enum GapInfo
strong

Write additional gap information to files.

Enumerator
BoundaryMask 

Write file with boundary pixels of individual gaps.

BoundaryValues 

Write file with boundary pixels showing their actual value.

MBR 

Write minimum bounding rectangles of individual gaps.

VoidMask 

Write file with void pixels of individual gaps.

Count 

number of elements

◆ GeomModel

enum GeomModel
strong

TODO: Enumerator for what?

Enumerator
mean 

Mean.

robustMean 

Robust Mean.

plane 

Plane.

robustPlane 

Robust Plane.

quadric 

Quadric.

robustQuadric 

Robust Quadric.

Count 

number of elements

◆ GridInterpolator

enum GridInterpolator
strong

Enumerator defining different grid interpolation methods (used by opalsGrid)

Enumerator
snap 

simple 'snap-height-of-nearest-data-point' interpolation

nearestNeighbour 

nearest neighbour interpolation

naturalNeighbours 

natural neighbours interpolation

delaunayTriangulation 

Delaunay triangulation interpolation.

movingAverage 

moving average interpolation (=moving horizontal plane)

movingPlanes 

moving (tilted) plane interpolation

robMovingPlanes 

robust moving (tilted) plane interpolation

movingParaboloid 

moving circular, elliptic or hyperbolic paraboloid

thinPlateSpline 

thin plate spline interpolation

kriging 

kriging interpolation

Count 

number of elements

◆ GridResolution

enum GridResolution
strong

Enumerator for specifying the (output) grid resolution depending on the size of the processing kernel.

Enumerator
native 

output grid size equals native input grid size

halfKernel 

output grid size equals half kernel size

kernelSize 

output grid size equals entire kernel size

Count 

number of elements

◆ HeaderFeature

enum HeaderFeature
strong

TODO: Enumerator for what?

Enumerator
all 

all possible header feature

overviewZ 

Z-Matrix overview.

overviewPcount 

Pcount-Matrix overview.

Count 

number of elements

◆ Hemisphere

enum Hemisphere
strong

Hemispheres of the Earth or another planet.

Enumerator
north 

Northern hemisphere.

south 

Southern hemisphere.

Count 

number of elements

◆ HistoMode

enum HistoMode
strong

HistoMode enumerates different modes of histogram computations.

Enumerator
automatic 

derived mode from attribute type

real 

allow arbitrary bin width values

integer 

limits bin width and centers bins to natural numbers

Count 

number of elements

◆ IndexType

enum IndexType
strong

TODO: Enumerator for what?

Enumerator
tile 

flat tiling structure

quadtree 

quad- or octree structure (depending on index dimension)

kdtree 

kd-tree structure

rtree 

r-tree structure

Count 

number of elements

◆ KernelShape

enum KernelShape
strong

TODO: Enumerator for what?

Enumerator
square 

square kernel (Chebyshev metrics))

circle 

circular kernel (Euclidean metrics)

diamond 

diamond kernel (Manhattan metrics)

Count 

number of elements

◆ LogLevel

enum LogLevel
strong

Enumerator defining different importance levels of log records.

Enumerator
none 

Suppress all logging output.

error 

Some failure that cannot be handled. Program execution is aborted.

warning 

Some weird program state which can still be handled (e.g. 'poor matrix condition', 'poor data distribution')

info 

Some progress that may be interesting in everyday-use.

verbose 

Something that may help in understanding normal program behaviour.

debug 

Anything that may help 'debugging' by means of a release-build.

Count 

number of elements

◆ LSMProcMode

enum LSMProcMode
strong

TODO: Enumerator for what?

Enumerator
local 

LSM for a set of patches (xy position and patch size)

continuous 

LSM for patches sliding along the flight path (patch length and overlap)

global 

LSM for entire overlap area.

Count 

number of elements

◆ LSMTrafoType

enum LSMTrafoType
strong

Type of transformation used for LSM computation.

Enumerator
zShift 

compute z-shift only

shifts 

compute 3D-shifts only

rigid 

compute rigid 3D transformation (3 rotations + 3 shifts = 6 parameters)

mounting 

compute 3D-shifts and flight direction aligned rotations (roll-pitch-yaw)

helmert 

compute 3D Helmert transformation (3 rotations + 3 shifts + 1 scale = 7 parameters)

full 

compute full 3D affine transformation (12 parameters)

Count 

number of elements

◆ MergePolygonMode

enum MergePolygonMode
strong

TODO: Enumerator for what?

Enumerator
safe 

incremental merge of polygon parts (slow but robust)

fast 

build polygon object at once (fast but fails in case of topological incorrect polygon parts)

Count 

number of elements

◆ MorphOperation

enum MorphOperation
strong

TODO: Enumerator for what?

Enumerator
erode 

morphological erosion filter

dilate 

morphological dilation filter

open 

morphological opening filter

close 

morphological closing filter

Count 

number of elements

◆ NavigationFrame

enum NavigationFrame
strong

TODO: Enumerator for what?

Enumerator
ned 

north east down (ARINC)

enu 

east north up

Count 

number of elements

◆ NoDataHandling

enum NoDataHandling
strong

Enumerator for defining the behaviour in case of nodata pixels in the image kernel.

Enumerator
fill 

Fills nodata values in the input dataset, if a valid value can be calculated.

leave 

Leaves nodata value as it is.

avoid 

If a nodata value is covered by the filter kernel, nodata value is assigned to output dataset pixel.

Count 

number of elements

◆ NormalsAlgorithm

enum NormalsAlgorithm
strong

Enumerator defining different normals estimation methods.

Enumerator
simplePlane 

performs a simple plane fit

robustPlane 

performs a robust plane fit

fmcd 

robust plane fit based on the Fast Minimum Covariance Determinant

Count 

number of elements

◆ NormalsDirection

enum NormalsDirection
strong

TODO: Enumerator for what?

Enumerator
upwards 

make all NormalZ positive or zero

downwards 

make all NormalZ negative or zero

toOrigin 

towards the origin of the coordinate system

fromOrigin 

away from the origin of the coordinate system

toScanner 

towards the scanner position where the point was recorded from (Requires: BeamVectorX, BeamVectorY, BeamVectorZ)

fromScanner 

away from the scanner position where the point was recorded from (Requires: BeamVectorX, BeamVectorY, BeamVectorZ)

Count 

number of elements

◆ NormalsMetaInfo

enum NormalsMetaInfo
strong

TODO: Enumerator for what?

Enumerator
minimum 

Storage of normal vector, sigma0 and estimtation method.

medium 

Storage of 'minimum' infos, eigenvalues, nr. of given points and nr. of used points.

maximum 

Storage of 'medium' infos, eigenvektor matrix.

Count 

number of elements

◆ OpennessFeature

enum OpennessFeature
strong

Enumerator for what?

Enumerator
positive 

positive openness

negative 

negative openness

Count 

number of elements

◆ RasterDataType

enum RasterDataType
strong

The data type of each pixel of a raster.

Enumerator
uint8 

8 bit unsigned integer

uint16 

16 bit unsigned integer

int16 

16 bit signed integer

uint32 

32 bit unsigned integer

int32 

32 bit signed integer

float32 

32 bit floating point

float64 

64 bit floating point

cint16 

Complex 16 bit signed integer.

cint32 

Complex 32 bit signed integer.

cfloat32 

Complex 32 bit floating point.

cfloat64 

Complex 64 bit floating point.

Count 

number of elements

◆ RasterType

enum RasterType
strong

Enumerator defining different data selection modes.

Enumerator
point 

pixel (center) represents a point, mainly used for DTM grids

area 

pixel represents area, mainly used for rater images like hill shading, etc.

Count 

number of elements

◆ ResamplingMethod

enum ResamplingMethod
strong

Enumerator defining different resampling methods.

Enumerator
weightedAverage 

weighted average (low pass filter)

simpleAverage 

simple average (low pass filter)

nearestNeighbour 

nearest neighbour

bilinear 

bi-linear interpolation

bicubic 

bi-cubic interpolation

never 

indicator avoiding resampling

Count 

number of elements

◆ RobustInterpolator

enum RobustInterpolator
strong

robust surface interpolation methods

Enumerator
plane 

tilted plane

paraboloid 

elliptic, circular or hyperpolic paraboloids

adapting 

adapting surface (prefers higher degree if necessary)

Count 

number of elements

◆ ScannerOrientation

enum ScannerOrientation
strong

Approximate directions of the scanner axes w.r.t. the platform, restricted to right-handed systems: front/back/left/right/up/down.

Enumerator
frd 

front/right/down

fdl 

front/down/left

flu 

front/left/up

fur 

front/up/right

bdr 

back/down/right

bld 

back/left/down

bul 

back/up/left

bru 

back/right/up

lfd 

left/front/down

ldb 

left/down/back

lbu 

left/back/up

luf 

left/up/front

rdf 

right/down/front

rbd 

right/back/down

rub 

right/up/back

rfu 

right/front/up

ufl 

up/front/left

ulb 

up/left/back

ubr 

up/back/right

urf 

up/right/front

dlf 

down/left/front

dbl 

down/back/left

drb 

down/right/back

dfr 

down/front/right

Count 

number of elements

◆ SearchMode

enum SearchMode
strong

TODO: Enumerator for what?

Enumerator
d2 

Search based on 2D coordinates (x and y) only.

d3 

Search based on full 3D coordinates (x,y and z)

d2_5 

Search based on 3D coordinates but with different horizontal and vertical scales.

Count 

number of elements

◆ SegmentationMethod

enum SegmentationMethod
strong

Enumerator defining different segmentation methods.

Enumerator
condClustering 

Performs the default conditional region growing based on euclidean 2D, 2.5D or 3D neighbourhood search.

planeExtraction 

This method detects planar surface segments with the use of normal vectors.

Count 

number of elements

◆ SegmentSort

enum SegmentSort
strong

Enumerator for sorting segments.

Enumerator
native 

internal continous segment numbers

ascendingPSize 

sort ascending by points per segment

descendingPSize 

sort descending by point per segment

Count 

number of elements

◆ SelectionMode

enum SelectionMode
strong

Enumerator defining different grid interpolation methods (used by opalsGrid)

Enumerator
nearest 

pure nearest neighbour (nn) selection

quadrant 

quadrant-wise nn selection, ie. nn per quadrant, then 2nd nn per quadrant, ...

octant 

octant-wise nn selection, ie. nn per octant, then 2nd nn per octant, ...

Count 

number of elements

◆ ShadingMethod

enum ShadingMethod
strong

Enumerator defining different shading methods.

Enumerator
tanaka 

use algorithm according to Tanaka

lambert 

lambertian reflection (proportional to cosine of incident angle)

peucker 

lambertian reflection (approximation according to Peucker)

Count 

number of elements

◆ StripAdjustStage

enum StripAdjustStage
strong

Defines the workflow phases of module StripAdjust.

Enumerator
importData 

Import strip data.

preprocess 

Preprocess data.

adjust 

Do the actual adjustment.

postprocess 

Postprocess the adjusted data.

exportData 

Export the adjusted data.

exportStrips 

Export the adjusted strips.

Count 

number of elements

◆ TerrainFilterMethod

enum TerrainFilterMethod
strong

Enumerator for terrain filtering methods.

Enumerator
robustInterpolation 

terrain points filter via (hierarchical) robust surface interpolation

Count 

number of elements

◆ TopologyProcessingMethod

Enumerator defining different modes in opalsLineTopology.

Enumerator
merge 

Best candidate merging strategy (iterative)

longest 

Merge lines based on recursive longest line strategy (Dijkstra)

clean 

Build topologically correct line networks.

Count 

number of elements

◆ TrajectoryCorrectionModel

Correction models for flight trajectories.

Enumerator
bias 

Offsets of position and rotation. Polynomial degree: 0.

linear 

Offsets and scales of position and rotation. Polynomial degree: 1.

spline 

Cubic spline. Polynomial degree: 3.

Count 

number of elements

◆ UsageLevel

enum UsageLevel
strong

Frequency of use / needed level of user experience of an option.

Enumerator
basic 

Relevant for all kinds of use.

mid 

Relevant for advanced use only.

pro 

Relevant for expert use only.

Count 

number of elements

◆ ValueSource

enum ValueSource
strong

Origin of an option value.

Enumerator
unknown 

The value's origin is unknown.

internalDefault 

The value has been set internally by the module.

configFile 

The value has been parsed from a configuration file.

estimated 

The value has been estimated, probably based on other values.

paramMapping 

The value has been mapped from a parameter file.

interFace 

The value has been set interactively / via the public interface.

run 

The value has been set during module execution.

Count 

number of elements

◆ VectorizationMode

enum VectorizationMode
strong

TODO: Enumerator for what?

Enumerator
toPolyline 

converts a grid/raster to polyline topology connecting the cell centers

toPolygon 

converts a grid/raster to polygon topology enclosing the boundary of connected cells

Count 

number of elements

◆ ZStatsMode

enum ZStatsMode
strong

TODO: Enumerator for what?

Enumerator
horizontalPlane 

Use signed distances to a horizontal plane within the current point for statistics computation.

tiltedPlane 

Use signed distances to a titled plane within the current point based on its normal vector for statistics computation.

Count 

number of elements