OpendTect
7.0
|
Algebra, Calculus and Geometry related tools. More...
Classes | |
class | AGC< T > |
Computes an AGC over a ValueSeries. More... | |
class | AICalc1D |
Acoustic Impedance Calculator. More... | |
class | AILayer |
Acoustic Impedance layer implementation. More... | |
class | AlongVectorFunction< RT, PT > |
A MathFunction that cuts through another mathfunction with higher number of dimensions. More... | |
class | AngleReflectivityModel |
An angle-based TimeDepth model set that includes reflectivities, for a given azimuth and angle distributions. More... | |
class | Interpolate::Applier2D< T > |
specification for a 2D interpolator More... | |
class | Array1DInterpol |
Base class for one dimensional array interpolators. 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 | Array2DConverter |
Base class for two dimensional array converter. More... | |
class | Array2DCopier< T > |
Transfers the common samples from one 2D array to another. More... | |
class | Array2DFromXYConverter |
Class for two dimensional array converter from an XY grid to an inline/crossline grid. More... | |
class | Array2DInterpol |
Base class for two dimensional array interpolators. More... | |
class | Array2DMatrix< fT > |
Matrix class based on Array2D. Initialized to 0. More... | |
class | Array3DCopier< T > |
Transfers the common samples from one 3D array to another. 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 | Array3DUdfTrcRestorer< T > |
class | Array2DInterpol::ArrayAccess |
class | ArrayNDDumper< T > |
Dumps contents of ArrayND objects. More... | |
class | ArrayNDGentleSmoother< T > |
Gently smooths ArrayND by averaging with neighbours. More... | |
class | ArrayNDProbDenFunc |
PDF based on ArrayND implementation. More... | |
class | ArrayNDWindow |
Tapers the N-dimentional ArrayND with a windowFunction. More... | |
class | ArrayMath::ArrayOperExecSetup |
class | ArrayUdfValReplacer< T > |
class | ArrayUdfValRestorer< T > |
class | ArrayZValues< AT > |
ValueSeries<double> implementation where the Z values are retrieved from a stored array. The pointer is never managed, and must remain in memory while this object is being used. More... | |
class | AsymptScaler |
Asymptotic or 'Squeeze' scaling, with a linear (main) part. More... | |
class | AxisLayout< T > |
Helps making nice axes for graphs. More... | |
class | BartlettWindow |
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 | BendPointBasedMathFunction< xT, yT > |
MathFunction based on bend points. More... | |
class | BendPointFinder2D |
Used to find bendpoints in set of XY Coordinates. More... | |
class | BendPointFinder2DBase |
Used to find bendpoints in two dimensional datasets. More... | |
class | BendPointFinder2DGeom |
Used to find bendpoints in Line 2D Geometry. More... | |
class | BendPointFinder3D |
Used to find bendpoints in three dimensional datasets. 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 | BendPointFinderTrcKey |
Used to find bendpoints in set of TrcKeys. 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 | BinIDUndoEvent |
BinID UndoEvent. More... | |
class | BisectionExtremeFinder1D |
Bisection Extreme Finder. More... | |
class | BlackmanWindow |
class | BodyVolumeCalculator |
Volume estimation for implicit bodies. getVolume returns the volume in cubic meters. More... | |
class | BoxWindow |
class | Stats::CalcSetup |
Setup for the Stats::RunCalc and Stats::ParallelCalc objects. More... | |
class | Fourier::CC |
Does Fourier Transforms of any size. More... | |
class | Fourier::CC::CC1D |
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 | Coord2List |
Interface for a list of Coords with automatically maintained IDs. More... | |
class | Coord2ListImpl |
A list of Coord where each coord has a unique id. More... | |
class | Coord3List |
Interface for a list of Coord3 with automatically maintained IDs. More... | |
class | Coord3ListImpl |
A list of Coord3 where each coord has a unique id. More... | |
class | GaussianNDProbDenFunc::Corr |
class | CosTaperWindow |
Tapered Cosine Window Function. More... | |
class | Curvature |
Class to calculate curvature from 9 regularly sampled points. More... | |
class | CWT |
Continuous Wavelet Transform. More... | |
class | DAGTetrahedraTree |
Delaunay triangulation for 3D points. Should make sure all the points are defined. More... | |
class | DAGTriangleTree |
Reference: "Parallel Incremental Delaunay Triangulation", by Kohout J.2005. More... | |
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 | DataDistribution< VT > |
Sharable data distribution. Sampling defaults to 0 step 1. More... | |
class | DataDistributionChanger< VT > |
class | DataDistributionExtracter< vT > |
Extracts a data distribution from input data: TypeSet or simply ptr + size ArrayND (will try to work with the getData() pointer) ValueSeries (will try to work with the arr() pointer) More... | |
class | DataDistributionInfoExtracter< VT > |
class | DataDistributionIter< VT > |
class | DataSqueezer< T > |
Fits values into a pre-defined range. More... | |
class | DelaunayTriangulator |
The parallel triangulation works for only one processor now. More... | |
class | DeSpiker< VT, IT > |
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 | DipPCA |
Base class to calculate Dip/Azimuth using the method of PCA. More... | |
class | Stats::DirectionalData |
A circle of data. More... | |
class | DixConversion |
Rms velocity to interval velocity conversion using the Dix formula. More... | |
class | Vel::DixConversion |
Rms velocity to interval velocity conversion using the Dix formula. 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 | DWT |
Discrete Wavelet Transform. More... | |
class | ElasticLayer |
Elastic Impedance layer implementation: AI + SVel. More... | |
class | ElasticModel |
A table of elastic prop layers with processing utilities Like the RefLayer class, uses SI values exclusively. More... | |
class | ElasticModelOv |
class | ElasticModelSet |
class | EventTracker |
Tracker that tracks Min/Max & Zero crossings between valueseries. More... | |
class | ExpScaler |
Exponential scaling, base e or ten. More... | |
class | ExtensionArray2DInterpol |
Array 2D interpolator that works by extending the data into udf areas. More... | |
class | ExtremeFinder1D |
Finds extreme values in FloatMathFunctions. More... | |
class | ExtremeFinderND |
Finds the nearest local extreme position in ND's. Implementation of Powell's Quadratically Convergent Method. More... | |
class | Fourier::FFTCC1D |
Computes 1D FFT for any size of data. This function is used internally by the ND computation. 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 | Pos::Filter |
Decides whether a given position should be included. More... | |
class | Pos::Filter2D |
Provides a filter related to 2D seismic data. More... | |
class | Pos::Filter3D |
Provides a filter related to 3D data. More... | |
class | Pos::FilterSet |
Set of Filters. Owns the Filters. More... | |
class | Pos::FilterSet2D |
2D FilterSet More... | |
class | Pos::FilterSet3D |
3D FilterSet More... | |
class | DWT::FilterWT1D |
class | FlatTopWindow |
class | FloatVertexAttribList |
Base class for vertex attribute list. 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 | FourierInterpolBase |
Base class for fourier interpolation. More... | |
class | Gaussian1DProbDenFunc |
One dimensional Gaussian PDF. More... | |
class | Gaussian2DProbDenFunc |
Two dimensional Gaussian PDF. More... | |
class | GaussianNDProbDenFunc |
Multi-dimensional pure Gaussian PDF. 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 | Gridder2D |
Generic interface for 2D gridding. More... | |
class | Stats::Grubbs |
Grubbs' test to detect outliers in a univariate data set assumed to come from a normally distributed population. More... | |
class | HammingWindow |
class | HanningWindow |
class | HilbertTransform |
Class to compute Hilbert Transform. More... | |
class | HistEqualizer |
Class to do histogram equalization of datasets. More... | |
class | HTILayer |
class | ImageResizer |
Resizes Image. More... | |
class | InterpolationLayerModel |
class | InverseDistanceArray2DInterpol |
Interpolates 2D arrays using inverse distance method. More... | |
class | InverseDistanceGridder2D |
Uses inverse distance method for 2D gridding. More... | |
class | IsoContourTracer |
Tracing the z-level contour of a 2D scalar field. More... | |
class | KaiserWindow |
Kaiser Window Function. 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 | LinearArray1DInterpol |
Does linear interpolation of one dimensional arrays. More... | |
class | Interpolate::LinearReg2D< T > |
Linear 2D interpolation. More... | |
class | Interpolate::LinearReg2DWithUdf< T > |
Linear 2D interpolation with standard undef handling. More... | |
class | Interpolate::LinearReg3D< T > |
Linear 3D interpolation. More... | |
class | Interpolate::LinearReg3DWithUdf< T > |
Linear 3D interpolation with standard undef handling. More... | |
class | LineFrom2DSpaceHoughTransform |
Finds lines in Array2D<float>'s regions with high values. More... | |
class | LineParameters< T > |
Steepness and intercept. 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 | LinScaler |
Linear scaling. 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 | LinStats2D |
linear stats in 2D. More... | |
class | LinStats3D |
linear stats in 3D. More... | |
class | LogScaler |
Logarithmic scaling, base e or ten. More... | |
class | MathFunction< RT, PT > |
Mathematical function. More... | |
class | MathFunctionND< RT, PT > |
Multidimensional 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 | MoveoutComputer |
Base class for computing a moveout curve. More... | |
class | MuteArrayExtracter< T > |
class | Muter |
Sets start or end part of a float series to 0. More... | |
class | NearestCoordFinder |
Find nearest coordinate in a TypeSet. More... | |
class | NormalMoveout |
Computes moveout with anisotropy, according to the equation by Alkhalifah and Tsvankin 1995. More... | |
class | Stats::NormalRandGen |
Normal (gaussian) Random Generator Not thread-safe to preserve performance. In multi-threaded context, use one generator per thread. More... | |
class | ODPolygon< T > |
(Closed) sequence of connected 2-D coordinates. More... | |
class | OffsetReflectivityModel |
An offset-based TimeDepth model set that may include reflectivities and incidence angles. More... | |
class | Stats::ParallelCalc< T > |
Stats computation running in parallel. More... | |
class | ParallelDTetrahedralator |
Delaunay triangulation for 3D points. More... | |
class | ParallelSorter< T > |
Sorting in parallel. Code is still experimental. More... | |
class | ParamLine2 |
A ParamLine2 is a line in space, with the following equations: 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 | 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 | 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 | PlaneParameters< T > |
Steepnesses and intercept. More... | |
class | PolyArray1DInterpol |
Uses a 3rd degree polynomial for interpolation of one dimensional arrays. 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 | Interpolate::PolyReg1D< T > |
class | Interpolate::PolyReg1DWithUdf< T > |
PolyReg1D which smoothly handles undefined values. 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::PolyReg3D< T > |
Interpolate 3D regularly sampled, using a 3rd order surface. 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 | 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 | Pos::Provider |
Provides a series of positions; can also be used for subselection. More... | |
class | Pos::Provider2D |
Provides a subselection for 2D surveys - requires the line name(s). More... | |
class | Pos::Provider3D |
Provides a subselection for 3D surveys. 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 | Quaternion |
Quaternion is an extension to complex numbers. More... | |
class | RadialBasisFunctionGridder2D |
Uses Radial Basic Function to predict the values. More... | |
class | Stats::RandGen |
Uniform Random Generator Not thread-safe to preserve performance. In multi-threaded context, use one generator per thread. More... | |
class | Pos::RandomFilter |
Passes a percentage of the positions. More... | |
class | Pos::RandomFilter2D |
Passes a percentage of the positions (2D). More... | |
class | Pos::RandomFilter3D |
Passes a percentage of the positions (3D). More... | |
class | Stats::RandomGenerator |
Random Generator. More... | |
class | RangeLimitedDataDistributionExtracter< vT > |
Does some work to limit the range of distribution extraction. More... | |
class | RayTracer1D |
Ray tracer in 1D. More... | |
class | RColLineBuilder< T > |
Creates a line in RowCol space. More... | |
class | RefLayer |
Base class for all Acoustic and Elastic impedance layers This object uses SI values exclusively for all its properties. More... | |
class | ReflCalc1D |
Acoustic and Elastic trace computation in 1D. More... | |
class | ReflectivityModelBase |
A TimeDepth model set that includes reflectivities. Base class for offset and angle based reflectivity models. More... | |
class | ReflectivityModelSet |
class | ReflectivityModelTrace |
A data container for reflection coefficients. 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 timesampling_.start should be a multiple of timesampling_.step. More... | |
class | RegularZValues |
ValueSeries<double> implementation where the Z values are retrieved from a SamplingData object, i.e. the values are never stored, but always calculated when needed. More... | |
class | RMOComputer |
Computes moveout in depth from RMO at a certain reference offset. More... | |
class | Stats::RunCalc< T > |
Calculates mean, min, max etc., as running values. More... | |
class | Sampled1DProbDenFunc |
One dimensional PDF based on binned data. More... | |
class | Sampled2DProbDenFunc |
Two dimensional PDF based on binned data. More... | |
class | SampledExtremeFinderND< T > |
Finds all local maximas/minimas in an ArrayND. 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 | SampledNDProbDenFunc |
Multi-dimensional PDF based on binned data. More... | |
class | ScaledValueSeries< RT, AT > |
ValueSeries implementation where the values are retrieved from another ValueSeries. The input object is never managed, and must remain in memory while this object is being used. Scaling is applied when reading from the source, and unapplied when writing to it. More... | |
class | Scaler |
Scaling of floating point numbers. More... | |
class | SecondOrderPoly |
A class for 2nd order polynomials of the form: a x^2 + b x + c. More... | |
class | Stats::SectorPartData |
Part of a data sector. More... | |
class | TimeDepthModelSet::Setup |
class | AngleReflectivityModel::Setup |
class | ReflectivityModelBase::Setup |
class | OffsetReflectivityModel::Setup |
class | Stats::DirectionalData::Setup |
class | Curvature::Setup |
class | ReflCalc1D::Setup |
class | RayTracer1D::Setup |
class | SincInterpolator |
A sinc interpolator for bandlimited uniformly-sampled functions y(x). More... | |
class | SincInterpolator1D< RT, PT > |
class | SincInterpolator2D< RT, PT > |
class | SincInterpolator3D< RT, PT > |
class | SincTableManager |
A manager used for constructing the table necessary for Sinc interpolations. More... | |
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 | SortedPointers< T > |
A SortedPointers keeps track of ids and their corresponding pointer. Each id can only be present once. More... | |
class | SortedTable< IDT, T > |
A SortedTable keeps track of ids and their corresponding values. Each id can only be present once. 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 | Sphere |
Represents a point in spherical coordinates. The angle phi lies in the horizontal plane, theta in the vertical plane. 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 | Pos::SubsampFilter |
Passes each nth position. More... | |
class | Pos::SubsampFilter2D |
Passes each nth position (2D). More... | |
class | Pos::SubsampFilter3D |
Passes each nth position (3D). More... | |
class | SincTableManager::Table |
class | ThirdOrderPoly |
A class for 3rd order polynomials on the form: a x^3 + b x^2 + c x + d. More... | |
class | TimeDepthConverter |
Converts between time and depth given a model. It expects a valueseries, where unit of value should be SI unit. Scaler provides factor value in case the valueseries in non SI unit. More... | |
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. The times are always TWT, in SI units (seconds). The depths units correspond to SI().depthsInFeet(), and are TVDSS depths (0 at sea-level, not at SRD, positive below sea-level and increasing downwards. More... | |
class | TimeDepthModelSet |
Data holder for all TimeDepthModels that share the same depths distributions. There will always be at least one model in the set. Models may be annotated by a given value, typically offset or angle See the TimeDepthModel class for a description of the units of measure. 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::Transform1D |
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 | TriangulatedGridder2D |
Uses Delaunay triangulation to find a points neighbors and does inverse distance between the neighbors. More... | |
class | TriangulationArray2DInterpol |
Uses triangulation method to interpolate two dimensional arrays. 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 | ValSeriesMathFunc |
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 | ValueSeriesEvent< VT, PT > |
Event in value series. More... | |
class | ValueSeriesEvFinder< VT, PT > |
Event finder in gate. More... | |
class | GaussianNDProbDenFunc::VarDef |
class | VelocityDesc |
class | Vrms2Vint |
Rms velocity to interval velocity conversion. More... | |
class | Vel::Vrms2Vint |
Rms velocity to interval velocity conversion. More... | |
class | VrmsRayTracer1D |
Ray tracer in 1D based on Vrms. More... | |
class | VSEvent |
class | VTILayer |
class | WaveletTransform |
WaveletTransform is a ND wavelet transform. More... | |
class | Stats::WindowedCalc< T > |
RunCalc manager which buffers a part of the data. 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 | ZAxisTransform |
Base class for z-axis transforms. 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 | ZAxisTransformSampler |
Samples Z-axis transformed data. More... | |
class | ZoeppritzCoeff |
Zoeppritz Coefficients. More... | |
class | ZSliceInterpolationModel |
class | ZValueSeries |
Base class for classes derived from ValueSeries<double>, where the values represent a Z value from a given ZDomain::Info. More... | |
Macros | |
#define | mChgTrackGetSet(chtr, obj, getfn, setfn, newval) |
Macro to use when there is no direct access to data members. More... | |
Algebra, Calculus and Geometry related tools.
#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. 1995-2024