OpendTect-6_4
6.4
|
Classes | |
class | AGC< T > |
Computes an AGC over a ValueSeries. More... | |
class | AILayer |
Acoustic Impedance layer. More... | |
class | ElasticLayer |
A table of elastic prop layers. More... | |
class | ElasticModel |
A table of elastic prop layers with processing utilities. More... | |
class | Array1DInterpol |
Base class for one dimensional array interpolators. More... | |
class | LinearArray1DInterpol |
Does linear interpolation of one dimensional arrays. More... | |
class | PolyArray1DInterpol |
Uses a 3rd degree polynomial for interpolation of one dimensional arrays. More... | |
class | Array2DInterpol |
Base class for two dimensional array interpolators. More... | |
class | Array2DInterpol::ArrayAccess |
class | InverseDistanceArray2DInterpol |
Interpolates 2D arrays using inverse distance method. More... | |
class | TriangulationArray2DInterpol |
Uses triangulation method to interpolate two dimensional arrays. More... | |
class | ExtensionArray2DInterpol |
Array 2D interpolator that works by extending the data into udf areas. More... | |
class | Array2DMatrix< fT > |
Matrix class based on Array2D. Initialized to 0. More... | |
class | Array3DFloodfill< T > |
Given an input array and a threshold, we use flood fill to find all the locations with values less (or greater) than the threshold based on seeds. User has the option to set inside or outside value on the output. More... | |
class | ArrayNDWindow |
Tapers the N-dimentional ArrayND with a windowFunction. More... | |
class | Array2DCopier< T > |
Transfers the common samples from one 2D array to another. More... | |
class | Array3DCopier< T > |
Transfers the common samples from one 3D array to another. More... | |
class | PolyTrend |
Polynomial trend with order 0 (mean), 1 (linear) or 2 (parabolic) The trend is derived from a set of values with positions and can be applied thereafter on any other position. More... | |
class | ArrayMath::ArrayOperExecSetup |
class | ArrayUdfValReplacer< T > |
class | ArrayUdfValRestorer< T > |
class | Array3DUdfTrcRestorer< T > |
class | MuteArrayExtracter< T > |
class | ArrayNDDumper< T > |
Dumps contents of ArrayND objects. More... | |
class | ArrayNDGentleSmoother< T > |
Gently smooths ArrayND by averaging with neighbours. More... | |
class | Array1DStacker< fT, ArrT > |
Gently stacks ArrayND by summation along the secondary axis Currently implemented only 1D, and Array1D's need to return getData() non-null. With normalize_, will return the average instead of the sum. More... | |
class | AxisLayout< T > |
Helps making nice axes for graphs. More... | |
class | BendPointFinderBase |
Base class that does the majority of the work finding bendpoints. Adaptions to different data-types are done in subclasses. More... | |
class | BendPointFinder2DBase |
Used to find bendpoints in two dimensional datasets. More... | |
class | BendPointFinder2D |
Used to find bendpoints in set of XY Coordinates. More... | |
class | BendPointFinderTrcKey |
Used to find bendpoints in set of TrcKeys. More... | |
class | BendPointFinder2DGeom |
Used to find bendpoints in Line 2D Geometry. More... | |
class | BendPointFinder3D |
Used to find bendpoints in three dimensional datasets. More... | |
class | BendPoints2Coords |
Inter/Extra-polate bendpoints to get the coordinates. More... | |
class | BinIDSorting |
BinID sorting parameters. More... | |
class | BinIDSortingAnalyser |
Analyses whether input BinIDs are sorted. More... | |
class | BodyVolumeCalculator |
Volume estimation for implicit bodies. getVolume returns the volume in cubic meters. More... | |
class | ChangeTracker |
Updates a variable when changes occur. More... | |
class | ConnComponents |
Classify connected components of a binarized array 2D, components are sorted in size. User could get the best quadratic fit for the component if needed. More... | |
class | ConnComponents3D |
Classify connected components of a binarized array 3D, components are sorted in size. More... | |
class | ContinuousCurvatureArray2DInterpol |
class | Convolver3D< T > |
Convolves (or correlates) two 3D signals. More... | |
class | Curvature |
Class to calculate curvature from 9 regularly sampled points. More... | |
class | Curvature::Setup |
class | DataClipper |
A DataClipper gets a bunch of data and determines at what value to clip if a certain clip percentage is desired. More... | |
class | DataClipSampler |
Data clipping sampler. More... | |
class | DAGTriangleTree |
Reference: "Parallel Incremental Delaunay Triangulation", by Kohout J.2005. More... | |
class | DelaunayTriangulator |
The parallel triangulation works for only one processor now. More... | |
class | Triangle2DInterpolator |
For a given triangulated geometry(set of points), interpolating any point located in or nearby the goemetry. If the point is located outside of the boundary of the geometry, we compare azimuth to find related points and then apply inverse distance to calculate weights. More... | |
class | DAGTetrahedraTree |
Delaunay triangulation for 3D points. Should make sure all the points are defined. More... | |
class | ParallelDTetrahedralator |
Delaunay triangulation for 3D points. More... | |
class | DipPCA |
Base class to calculate Dip/Azimuth using the method of PCA. More... | |
class | Dip2D |
To calculate Dip/Azimuth for 2D datasets using the method of PCA. More... | |
class | Dip3D |
To calculate Dip/Azimuth for 3D datasets using the method of PCA. More... | |
class | DragController |
Auxiliary class to control dragger speed. The idea is that slowly moving the mouse forces the dragger to move only one inl/crl/z per (few) pixel(s), while moving it fast can have it cover many lines per pixel. More... | |
class | ExtremeFinder1D |
Finds extreme values in FloatMathFunctions. More... | |
class | BisectionExtremeFinder1D |
Bisection Extreme Finder. More... | |
class | ExtremeFinderND |
Finds the nearest local extreme position in ND's. Implementation of Powell's Quadratically Convergent Method. More... | |
class | FFTFilter |
Classical FFT filter, use set to set up data step, min and max frequency and type of the filter (minfreq not required for highpass, maxfreq not required for lowpass) More... | |
class | Fourier::CC::CC1D |
class | Fourier::CC |
Does Fourier Transforms of any size. More... | |
class | Fourier::FFTCC1D |
Computes 1D FFT for any size of data. This function is used internally by the ND computation. More... | |
class | FourierInterpolBase |
Base class for fourier interpolation. More... | |
class | FourierInterpol1D |
Fourier interpolation for 1D datasets. More... | |
class | FourierInterpol2D |
Fourier interpolation for 2D datasets. More... | |
class | FourierInterpol3D |
Fourier interpolation for 3D datasets. More... | |
class | Gaussian1DProbDenFunc |
One dimensional Gaussian PDF. More... | |
class | Gaussian2DProbDenFunc |
Two dimensional Gaussian PDF. More... | |
class | GaussianNDProbDenFunc |
Multi-dimensional pure Gaussian PDF. More... | |
class | GaussianNDProbDenFunc::Corr |
class | GaussianNDProbDenFunc::VarDef |
class | Gridder2D |
Generic interface for 2D gridding. More... | |
class | InverseDistanceGridder2D |
Uses inverse distance method for 2D gridding. More... | |
class | TriangulatedGridder2D |
Uses Delaunay triangulation to find a points neighbors and does inverse distance between the neighbors. More... | |
class | RadialBasisFunctionGridder2D |
Uses Radial Basic Function to predict the values. More... | |
class | HilbertTransform |
Class to compute Hilbert Transform. More... | |
class | HistEqualizer |
Class to do histogram equalization of datasets. More... | |
class | PlaneFrom3DSpaceHoughTransform |
Finds planes in Array3D<float>'s regions with high values. All positions in the array above a threshold (defined by cliprate) are used to find the planes. More... | |
class | LineFrom2DSpaceHoughTransform |
Finds lines in Array2D<float>'s regions with high values. More... | |
class | Interpolate::PolyReg1D< T > |
class | Interpolate::PolyReg1DWithUdf< T > |
PolyReg1D which smoothly handles undefined values. More... | |
class | Interpolate::Applier2D< T > |
specification for a 2D interpolator More... | |
class | Interpolate::LinearReg2D< T > |
Linear 2D interpolation. More... | |
class | Interpolate::LinearReg2DWithUdf< T > |
Linear 2D interpolation with standard undef handling. More... | |
class | Interpolate::PolyReg2D< T > |
Interpolate 2D regularly sampled, using a 2nd order surface. More... | |
class | Interpolate::PolyReg2DWithUdf< T > |
PolyReg2D which smoothly handles undefined values. More... | |
class | Interpolate::LinearReg3D< T > |
Linear 3D interpolation. More... | |
class | Interpolate::LinearReg3DWithUdf< T > |
Linear 3D interpolation with standard undef handling. More... | |
class | Interpolate::PolyReg3D< T > |
Interpolate 3D regularly sampled, using a 3rd order surface. More... | |
class | InterpolationLayerModel |
class | ZSliceInterpolationModel |
class | IsoContourTracer |
Tracing the z-level contour of a 2D scalar field. More... | |
class | LineParameters< T > |
Steepness and intercept. More... | |
class | PlaneParameters< T > |
Steepnesses and intercept. More... | |
class | LinStats2D |
linear stats in 2D. More... | |
class | LinStats3D |
linear stats in 3D. More... | |
class | LineRectangleClipper< T > |
Clips a line between two points by a rectangle. The line may be completely outside, completely inside or partially inside. If partially inside, new endpoints are calculated. More... | |
class | LinSolver< T > |
LinSolver - Solves linear systems of equations on the form A*x=B. A is a matrix of the size N*N, x is a column vector of the size N and B is a column vector of the size N. More... | |
class | LinSolverTask< T > |
class | MathFunctionND< RT, PT > |
Multidimensional Mathematical function. More... | |
class | MathFunction< RT, PT > |
Mathematical function. More... | |
class | MathFunctionSampler< RT, PT > |
Makes a MathFunction indexable through an operator[]. More... | |
class | MathXYFunction< RT, PT > |
A Math Function as in F(x,y). More... | |
class | MathXYZFunction< RT, PT > |
A Math Function as in F(x,y,z). More... | |
class | BendPointBasedMathFunction< xT, yT > |
MathFunction based on bend points. More... | |
class | AlongVectorFunction< RT, PT > |
A MathFunction that cuts through another mathfunction with higher number of dimensions. More... | |
class | SecondOrderPoly |
A class for 2nd order polynomials of the form: a x^2 + b x + c. More... | |
class | ThirdOrderPoly |
A class for 3rd order polynomials on the form: a x^3 + b x^2 + c x + d. More... | |
class | ValSeriesMathFunc |
class | Muter |
Sets start or end part of a float series to 0. More... | |
class | PCA |
Performs Pricipal Component Analysis on samples with N variables. More... | |
class | PeriodicValue< T, P > |
PeriodicValue handles periodic data through mathematical operations. More... | |
class | Phase |
Phase calculates the phase distribution of a N-dimensional signal. The phase is the inverse tangent of the ratio between imaginary and real parts of the signal. More... | |
class | ODPolygon< T > |
(Closed) sequence of connected 2-D coordinates. More... | |
class | PolyLineND< T > |
(Closed) sequence(s) of connected n-D coordinates. Undefined coordinates separate consecutive sequences. More... | |
class | PolynomialND< T > |
PolynomialND is a N-dimensional polynomial with arbitary orders in each dimension. It can be fitted any ArrayND. To access the polynomial's data use getValue. getValue3D is optimized for third order, tree-dimensional cases. More... | |
class | Pos::Filter |
Decides whether a given position should be included. More... | |
class | Pos::Filter3D |
Provides a filter related to 3D data. More... | |
class | Pos::Filter2D |
Provides a filter related to 2D seismic data. More... | |
class | Pos::FilterSet |
Set of Filters. Owns the Filters. More... | |
class | Pos::FilterSet3D |
3D FilterSet More... | |
class | Pos::FilterSet2D |
2D FilterSet More... | |
class | Pos::RandomFilter |
Passes a percentage of the positions. More... | |
class | Pos::RandomFilter3D |
Passes a percentage of the positions (3D). More... | |
class | Pos::RandomFilter2D |
Passes a percentage of the positions (2D). More... | |
class | Pos::SubsampFilter |
Passes each nth position. More... | |
class | Pos::SubsampFilter3D |
Passes each nth position (3D). More... | |
class | Pos::SubsampFilter2D |
Passes each nth position (2D). More... | |
class | FloatVertexAttribList |
Base class for vertex attribute list. More... | |
class | Coord2List |
Interface for a list of Coords with automatically maintained IDs. More... | |
class | Coord3List |
Interface for a list of Coord3 with automatically maintained IDs. More... | |
class | Coord2ListImpl |
A list of Coord where each coord has a unique id. More... | |
class | Coord3ListImpl |
A list of Coord3 where each coord has a unique id. More... | |
class | Pos::Provider |
Provides a series of positions; can also be used for subselection. More... | |
class | Pos::Provider3D |
Provides a subselection for 3D surveys. More... | |
class | Pos::Provider2D |
Provides a subselection for 2D surveys - requires the line name(s). More... | |
class | ProbDenFunc |
Base class for Probability Density Functions. More... | |
class | ProbDenFunc1D |
Probability Density Function for one dimensional datasets. More... | |
class | ProbDenFunc2D |
Probability Density Function for two dimensional datasets. More... | |
class | ProbDenFuncDraw |
Stores one draw of a probability density function. More... | |
class | QRSolver< T > |
QRSolver - QR decomposition of a matrix A For an m-by-n matrix A, with m>=n, the QR decomposition is A = Q*R, where Q is an m-by-n orthogonal matrix, and R is an n-by-n upper-triangular matrix. More... | |
class | RayTracer1D |
Ray tracer in 1D. More... | |
class | RayTracer1D::Setup |
class | VrmsRayTracer1D |
Ray tracer in 1D based on Vrms. More... | |
class | RColLineBuilder< T > |
Creates a line in RowCol space. More... | |
class | ReflectivitySpike |
A reflectivity spike. More... | |
class | ReflectivitySampler |
Takes a ReflectivityModel and samples it in the frequency domain Applies inverse FFT if a second output is provided The time sampling determines the frequency distribution outsampling_.start should be a multiple of outsampling_.step. More... | |
class | ImageResizer |
Resizes Image. More... | |
class | SampledExtremeFinderND< T > |
Finds all local maximas/minimas in an ArrayND. More... | |
class | ArrayNDProbDenFunc |
PDF based on ArrayND implementation. More... | |
class | Sampled1DProbDenFunc |
One dimensional PDF based on binned data. More... | |
class | Sampled2DProbDenFunc |
Two dimensional PDF based on binned data. More... | |
class | SampledNDProbDenFunc |
Multi-dimensional PDF based on binned data. More... | |
class | SampledFunction< RT, T > |
Make any sampled series comply with MathFunction. More... | |
class | SampledFunctionImpl< RT, T > |
Implementation for array-type of SampledFunction. More... | |
class | Scaler |
Scaling of floating point numbers. More... | |
class | LinScaler |
Linear scaling. More... | |
class | LogScaler |
Logarithmic scaling, base e or ten. More... | |
class | ExpScaler |
Exponential scaling, base e or ten. More... | |
class | AsymptScaler |
Asymptotic or 'Squeeze' scaling, with a linear (main) part. More... | |
class | SincTableManager |
A manager used for constructing the table necessary for Sinc interpolations. The manager creates one table per design and provides its as necessary A table contains shifted, stretched KaiserWindow functions in both directions. More... | |
class | SincTableManager::Table |
class | SincInterpolator |
A sinc interpolator for bandlimited uniformly-sampled functions y(x). Interpolators can be designed for any two of three parameters: maximum error (emax), maximum frequency (fmax) and maximum length (lmax). The parameter not specified is computed when an interpolator is designed. More... | |
class | SincInterpolator1D< RT, PT > |
class | SincInterpolator2D< RT, PT > |
class | SincInterpolator3D< RT, PT > |
class | Smoother1D< T > |
Smoothes a 1d signal with an operator. More... | |
class | Smoother2D< T > |
Smoothes a 2d signal with an operator. More... | |
class | Smoother3D< T > |
Smoothes a 3d signal with an operator. More... | |
class | SortedList< T > |
A SortedList is a list where all objects are stored in ascending order. The objects should be capable of doing <,> and ==. If allowmultiples is true, multiple objects with the same value are allowed in the list. More... | |
class | SortedTable< IDT, T > |
A SortedTable keeps track of ids and their corresponding values. Each id can only be present once. More... | |
class | SortedPointers< T > |
A SortedPointers keeps track of ids and their corresponding pointer. Each id can only be present once. More... | |
class | ParallelSorter< T > |
Sorting in parallel. Code is still experimental. More... | |
class | Spectrogram |
Spectrogram calculates the spectrogram of a N-dimensional signal. The spectrogram is the square of the absolute values of the FourierTransform, and is the 'traditional' way to view a signal's frequency distribution. More... | |
class | DataSqueezer< T > |
Fits values into a pre-defined range. More... | |
class | Stats::SectorPartData |
Part of a data sector. More... | |
class | Stats::DirectionalData::Setup |
class | Stats::DirectionalData |
A circle of data. More... | |
class | Stats::Grubbs |
Grubbs' test to detect outliers in a univariate data set assumed to come from a normally distributed population. More... | |
class | StaticsDesc |
Specifies Statics as a horizon and either a horizon attribute or a constant velocity. Velocity is always in m/s. More... | |
class | Stats::ParallelCalc< T > |
Stats computation running in parallel. More... | |
class | Stats::RandomGenerator |
Random Generator. More... | |
class | Stats::RandGen |
Uniform Random Generator. More... | |
class | Stats::NormalRandGen |
class | Stats::CalcSetup |
Setup for the Stats::RunCalc and Stats::ParallelCalc objects. More... | |
class | Stats::BaseCalc< T > |
Base class to calculate mean, min, max, etc.. can be used either as running values (Stats::RunCalc) or in parallel (Stats::ParallelCalc). More... | |
class | Stats::RunCalc< T > |
Calculates mean, min, max etc., as running values. More... | |
class | Stats::WindowedCalc< T > |
RunCalc manager which buffers a part of the data. More... | |
class | TopList< VT, AVT > |
Is a class that holds a "top N" list with the N highest (or lowest) values that is added. Each value has an associated value that can be used as an identifier of where the value comes from or something like that. More... | |
class | GenericTransformND |
Lets any 1D orthogonal transform (GenericTransformND::GenericTransform1D) be extended to ND. Most transform fftw can be implemented as a subclass of GenericTransformND. More... | |
class | GenericTransformND::Transform1D |
class | Quaternion |
Quaternion is an extension to complex numbers. More... | |
class | ParamLine2 |
A ParamLine2 is a line in space, with the following equations: More... | |
class | Line2 |
A Line2 is a line on XY-plane, and it is defined in slope-intercept form y = slope*x + y-intercept; for making operations easier. More... | |
class | Line3 |
A Line3 is a line in space, with the following equations: More... | |
class | Plane3 |
A Plane3 is a plane in space, with the equation: Ax + By + Cz + D = 0. More... | |
class | Plane3CoordSystem |
Defines a 2D coordinate system on a 3D plane and transforms between the 3D space and the coordinate system. More... | |
class | Sphere |
Represents a point in spherical coordinates. The angle phi lies in the horizontal plane, theta in the vertical plane. More... | |
class | UndefArrayHandler |
Class that handles undefvalues in arrays that are in a format described by a BinDataDesc. More... | |
class | Undo |
Class to handle undo/redo information. More... | |
class | UndoEvent |
Holds the information on how to undo/redo something. More... | |
class | BinIDUndoEvent |
BinID UndoEvent. More... | |
class | VSEvent |
class | ValueSeriesEvent< VT, PT > |
Event in value series. More... | |
class | ValueSeriesEvFinder< VT, PT > |
Event finder in gate. More... | |
class | ValSeriesTracker |
Base class for a tracker that tracks something (e.g. min, max, a certain value)++ from one ValueSeries<float> to another. More... | |
class | EventTracker |
Tracker that tracks Min/Max & Zero crossings between valueseries. More... | |
class | VelocityDesc |
class | TimeDepthModel |
Converts between time, depth and velocity given a model. The velocity model can be either RMO-velocities in time, or interval velocity in either depth or time. More... | |
class | TimeDepthConverter |
Converts between time and depth given a model. More... | |
class | MoveoutComputer |
Base class for computing a moveout curve. More... | |
class | RMOComputer |
Computes moveout in depth from RMO at a certain reference offset. More... | |
class | NormalMoveout |
Computes moveout with anisotropy, according to the equation by Alkhalifah and Tsvankin 1995. More... | |
class | Vrms2Vint |
Rms velocity to interval velocity conversion. More... | |
class | DixConversion |
Rms velocity to interval velocity conversion using the Dix formula. More... | |
class | WaveletTransform |
WaveletTransform is a ND wavelet transform. More... | |
class | DWT |
Discrete Wavelet Transform. More... | |
class | DWT::FilterWT1D |
class | CWT |
Continuous Wavelet Transform. More... | |
class | WindowFunction |
Base class for window functions. The inheriting classes will give a value between 0 and 1 in the interval -1 to 1. Outside that interval, the result is zero. More... | |
class | BoxWindow |
class | HammingWindow |
class | HanningWindow |
class | BlackmanWindow |
class | BartlettWindow |
class | FlatTopWindow |
class | CosTaperWindow |
Tapered Cosine Window Function. More... | |
class | KaiserWindow |
Kaiser Window Function. More... | |
class | ZAxisTransform |
Base class for z-axis transforms. More... | |
class | ZAxisTransformSampler |
Samples Z-axis transformed data. More... | |
class | ZAxisTransformer |
Transforms an Array3D with a ZAxisTransform. It is assumed that the first dimension in the array is inline, the second is crossline and that the third is z. More... | |
class | ZoeppritzCoeff |
Zoeppritz Coefficients. More... | |
Macros | |
#define | mChgTrackGetSet(chtr, obj, getfn, setfn, newval) |
Macro to use when there is no direct access to data members. More... | |
#define mChgTrackGetSet | ( | chtr, | |
obj, | |||
getfn, | |||
setfn, | |||
newval | |||
) |
Macro to use when there is no direct access to data members.
chtr = the change tracker obj = object instance getfn = get function setfn - set function newval = new value
Generated at for the OpendTect seismic interpretation project. Copyright (C): dGB Beheer B. V. 2019