1.8.0
CCC
 
Loading...
Searching...
No Matches
gstlrn::ModelGeneric Class Reference

Class containing the Model Information describing the formal Spatial (or Temporal) Characteristics of the (set of) random variable(s) under study. More...

#include <ModelGeneric.hpp>

Inheritance diagram for gstlrn::ModelGeneric:
gstlrn::ICloneable gstlrn::ModelCovList gstlrn::Model

Detailed Description

Class containing the Model Information describing the formal Spatial (or Temporal) Characteristics of the (set of) random variable(s) under study.

The Model is essentially a container with two main contents:

  • the covariance part: see ACov.hpp for more information
  • the drift part: see DriftList.hpp for more information

The additional member CovContext only serves in carrying the following information:

  • the number of variables: if more than 1, the Model becomes multivariate
  • the field extension: this information is needed to get a stationary version to any covariance
  • the experimental mean vector and the variance-covariance matrix (used to calibrate the Model)

Public Member Functions

 ModelGeneric (const CovContext &ctxt=CovContext())
 
 ModelGeneric (const ModelGeneric &r)
 
ModelGenericoperator= (const ModelGeneric &r)
 
virtual ~ModelGeneric ()
 
const ACovgetCov () const
 
const CovContextgetContext () const
 
const DriftListgetDriftList () const
 
ACov_getCovModify ()
 ICloneable interface.
 
CovContext_getContextModify ()
 
DriftList_getDriftListModify ()
 
std::vector< covmaptype > & getGradients ()
 
void setField (double field)
 
bool isValid () const
 
void setCov (const ACov *cova)
 
void setDriftList (const DriftList *driftlist)
 
void setDriftIRF (Id order=0, Id nfex=0)
 
void addDrift (const ADrift *drift)
 
void setDrifts (const VectorString &driftSymbols)
 
void initParams (const MatrixSymmetric &vars, double href=1.)
 
std::shared_ptr< ListParamsgenerateListParams () const
 
void updateModel ()
 
double computeLogLikelihood (const Db *db, bool verbose=false)
 
void fitNew (const Db *db=nullptr, Vario *vario=nullptr, const DbGrid *dbmap=nullptr, Constraints *constraints=nullptr, const ModelOptimParam &mop=ModelOptimParam(), Id nb_neighVecchia=30, bool verbose=false, bool trace=false, bool reml=false)
 
MatrixDense evalCovMat (const Db *db1, const Db *db2=nullptr, Id ivar0=-1, Id jvar0=-1, const 1 &nbgh1=1(), const 1 &nbgh2=1(), const CovCalcMode *mode=nullptr, bool cleanOptim=true) const
 Call the method ACov::evalCovMat of the object ACov.
 
Id evalCovMatInPlace (MatrixDense &mat, const Db *db1, const Db *db2=nullptr, Id ivar0=-1, Id jvar0=-1, const 1 &nbgh1=1(), const 1 &nbgh2=1(), const CovCalcMode *mode=nullptr, bool cleanOptim=true) const
 Call the method ACov::evalCovMatInPlace of the object ACov.
 
Id evalCovMatInPlaceFromIdx (MatrixDense &mat, const Db *db1, const Db *db2, const 1 &index1, const 1 &index2, const 1 &nbgh2=1(), const CovCalcMode *mode=nullptr, bool cleanOptim=true) const
 Call the method ACov::evalCovMatInPlaceFromIdx of the object ACov.
 
MatrixSymmetric evalCovMatSym (const Db *db1, const 1 &nbgh1=1(), Id ivar0=-1, const CovCalcMode *mode=nullptr, bool cleanOptim=true) const
 Call the method ACov::evalCovMatSym of the object ACov.
 
Id evalCovMatSymInPlace (MatrixSymmetric &mat, const Db *db1, const 1 &nbgh1=1(), Id ivar0=-1, const CovCalcMode *mode=nullptr, bool cleanOptim=true) const
 Call the method ACov::evalCovMatSymInPlace of the object ACov.
 
Id evalCovMatSymInPlaceFromIdx (MatrixSymmetric &mat, const Db *db1, const 1 &index1, const CovCalcMode *mode=nullptr, bool cleanOptim=true) const
 Call the method ACov::evalCovMatSymInPlaceFromIdx of the object ACov.
 
MatrixSymmetric eval0Mat (const CovCalcMode *mode=nullptr) const
 Call the method ACov::eval0Mat of the object ACov.
 
MatrixSymmetric evalCovMat0 (const Db *db, Id iech, const KrigOpt &krigopt=KrigOpt()) const
 Call the method ACov::evalCovMat0 of the object ACov.
 
Id evalCovMat0InPlace (MatrixSymmetric &mat, const Db *db, Id iech, const KrigOpt &krigopt=KrigOpt()) const
 Call the method ACov::evalCovMat0InPlace of the object ACov.
 
Id evalCovVecRHSInPlace (vect vect, const RankHandler &rank, Id iech2, const KrigOpt &krigopt, SpacePoint &pin, SpacePoint &pout, 1 &tabwork, double lambda=1., const ECalcMember &calcMember=ECalcMember::RHS) const
 Call the method ACov::evalCovVecRHSInPlace of the object ACov.
 
Id evalCovMatOptimInPlace (MatrixDense &mat, const Db *dbin, const RankHandler &rankhandler, const KrigOpt &krigopt, const ECalcMember &calcMember, 1 &tabwork, double lambda=1.) const
 Call the method ACov::evalCovMatOptimInPlace of the object ACov.
 
Id evalCovMatRHSInPlaceFromIdx (MatrixDense &mat, const Db *db1, const Db *db2, const 1 &index1, const Id iech2=-1, const KrigOpt &krigopt=KrigOpt(), bool cleanOptim=true) const
 Call the method ACov::evalCovMatRHSInPlaceFromIdx of the object ACov.
 
MatrixSparseevalCovMatSparse (const Db *db1_arg, const Db *db2_arg=nullptr, Id ivar0=-1, Id jvar0=-1, const 1 &nbgh1=1(), const 1 &nbgh2=1(), const CovCalcMode *mode=nullptr, bool cleanOptim=true, double eps=EPSILON3) const
 Call the method ACov::evalCovMatSparse of the object ACov.
 
virtual double eval0 (Id ivar=0, Id jvar=0, const CovCalcMode *mode=nullptr) const
 Call the method ACov::eval0 of the object ACov.
 
double evalCov (const SpacePoint &p1, const SpacePoint &p2, Id ivar=0, Id jvar=0, const CovCalcMode *mode=nullptr) const
 Call the method ACov::evalCov of the object ACov.
 
MatrixSquare evalNvarIpas (double step, const 1 &dir=1(), const CovCalcMode *mode=nullptr) const
 Call the method ACov::evalNvarIpas of the object ACov.
 
MatrixSquare evalNvarIpasIncr (const 1 &dincr, const CovCalcMode *mode=nullptr) const
 Call the method ACov::evalNvarIpasIncr of the object ACov.
 
 evalIvarNlag (const 1 &vec_step, const 1 &dir=1(), Id ivar=0, Id jvar=0, const CovCalcMode *mode=nullptr) const
 Call the method ACov::evalIvarNlag of the object ACov.
 
double evalIvarIpas (double step, const 1 &dir=1(), Id ivar=0, Id jvar=0, const CovCalcMode *mode=nullptr) const
 Call the method ACov::evalIvarIpas of the object ACov.
 
double evalCvv (const 1 &ext, const 1 &ndisc, const 1 &angles=1(), Id ivar=0, Id jvar=0, const CovCalcMode *mode=nullptr) const
 Call the method ACov::evalCvv of the object ACov.
 
double evalCvvShift (const 1 &ext, const 1 &ndisc, const 1 &shift, const 1 &angles=1(), Id ivar=0, Id jvar=0, const CovCalcMode *mode=nullptr) const
 Call the method ACov::evalCvvShift of the object ACov.
 
MatrixSquare evalCvvM (const 1 &ext, const 1 &ndisc, const 1 &angles=1(), const CovCalcMode *mode=nullptr) const
 Call the method ACov::evalCvvM of the object ACov.
 
double evalCxv (const SpacePoint &p1, const 1 &ext, const 1 &ndisc, const 1 &angles=1(), const 1 &x0=1(), Id ivar=0, Id jvar=0, const CovCalcMode *mode=nullptr) const
 Call the method ACov::evalCxv of the object ACov.
 
MatrixSquare evalCxvM (const SpacePoint &p1, const 1 &ext, const 1 &ndisc, const 1 &angles=1(), const 1 &x0=1(), const CovCalcMode *mode=nullptr) const
 Call the method ACov::evalCxvM of the object ACov.
 
void evalPointToDb (1 &values, const SpacePoint &p1, const Db *db2, Id ivar=0, Id jvar=0, bool useSel=true, const 1 &nbgh2=1(), const CovCalcMode *mode=nullptr) const
 Call the method ACov::evalPointToDb of the object ACov.
 
void evalPointToDbAsSP (1 &values, const std::vector< SpacePoint > &p1s, const SpacePoint &p2, Id ivar=0, Id jvar=0, const CovCalcMode *mode=nullptr) const
 Call the method ACov::evalPointToDbAsSP of the object ACov.
 
double evalAverageDbToDb (const Db *db1, const Db *db2, Id ivar=0, Id jvar=0, double eps=0., Id seed=434132, const CovCalcMode *mode=nullptr) const
 Call the method ACov::evalAverageDbToDb of the object ACov.
 
double evalAverageIncrToIncr (const 1 &d1, const 1 &d2, Id ivar=0, Id jvar=0, const CovCalcMode *mode=nullptr) const
 Call the method ACov::evalAverageIncrToIncr of the object ACov.
 
double evalAveragePointToDb (const SpacePoint &p1, const Db *db2, Id ivar=0, Id jvar=0, const CovCalcMode *mode=nullptr) const
 Call the method ACov::evalAveragePointToDb of the object ACov.
 
double samplingDensityVariance (const Db *db, const 1 &ext, const 1 &ndisc, const 1 &angles=1(), const 1 &x0=1(), Id ivar=0, Id jvar=0) const
 Call the method ACov::samplingDensityVariance of the object ACov.
 
double specificVolume (const Db *db, double mean, const 1 &ext, const 1 &ndisc, const 1 &angles=1(), const 1 &x0=1(), Id ivar=0, Id jvar=0) const
 Call the method ACov::specificVolume of the object ACov.
 
double coefficientOfVariation (const Db *db, double volume, double mean, const 1 &ext, const 1 &ndisc, const 1 &angles=1(), const 1 &x0=1(), Id ivar=0, Id jvar=0) const
 Call the method ACov::coefficientOfVariation of the object ACov.
 
double specificVolumeFromCoV (Db *db, double cov, double mean, const 1 &ext, const 1 &ndisc, const 1 &angles=1(), const 1 &x0=1(), Id ivar=0, Id jvar=0) const
 Call the method ACov::specificVolumeFromCoV of the object ACov.
 
double extensionVariance (const Db *db, const 1 &ext, const 1 &ndisc, const 1 &angles=1(), const 1 &x0=1(), Id ivar=0, Id jvar=0) const
 Call the method ACov::extensionVariance of the object ACov.
 
double calculateStDev (Db *db1, Id iech1, Db *db2, Id iech2, bool verbose=false, double factor=1., const CovCalcMode *mode=nullptr) const
 Call the method ACov::calculateStDev of the object ACov.
 
void evaluateMatInPlace (const CovInternal *covint, const 1 &d1, MatrixSquare &covtab, bool flag_init=false, double weight=1., const CovCalcMode *mode=nullptr) const
 Call the method ACov::evaluateMatInPlace of the object ACov.
 
double evaluateOneGeneric (const CovInternal *covint, const 1 &d1=1(), double weight=1., const CovCalcMode *mode=nullptr) const
 Call the method ACov::evaluateOneGeneric of the object ACov.
 
double evaluateOneIncr (double hh, const 1 &codir=1(), Id ivar=0, Id jvar=0, const CovCalcMode *mode=nullptr) const
 Call the method ACov::evaluateOneIncr of the object ACov.
 
Id buildVmapOnDbGrid (DbGrid *dbgrid, const NamingConvention &namconv=NamingConvention("VMAP")) const
 Call the method ACov::buildVmapOnDbGrid of the object ACov.
 
 sample (const 1 &h, const 1 &codir=1(), Id ivar=0, Id jvar=0, const CovCalcMode *mode=nullptr, const CovInternal *covint=nullptr) const
 Call the method ACov::sample of the object ACov.
 
 sampleUnitary (const 1 &hh, Id ivar=0, Id jvar=0, 1 codir=1(), const CovCalcMode *mode=nullptr) const
 Call the method ACov::sampleUnitary of the object ACov.
 
 envelop (const 1 &hh, Id ivar=0, Id jvar=0, Id isign=1, 1 codir=1(), const CovCalcMode *mode=nullptr) const
 Call the method ACov::envelop of the object ACov.
 
double gofToVario (const Vario *vario, bool verbose=true) const
 Call the method ACov::gofToVario of the object ACov.
 
bool isNoStat () const
 Call the method ACov::isNoStat of the object ACov.
 
void manage (const Db *db1, const Db *db2) const
 Call the method ACov::manage of the object ACov.
 
void optimizationPreProcessForData (const Db *db1=nullptr) const
 Call the method ACov::optimizationPreProcessForData of the object ACov.
 
void optimizationPostProcess () const
 Call the method ACov::optimizationPostProcess of the object ACov.
 
const ADriftgetDrift (Id il) const
 Call the method DriftList::getDrift of the object DriftList.
 
double computeDrift (const Db *db, Id ib, Id iech) const
 Call the method DriftList::computeDrift of the object DriftList.
 
double evalDriftValue (const Db *db, Id iech, Id ivar, Id ib, const ECalcMember &member=ECalcMember::fromKey("LHS")) const
 Call the method DriftList::evalDriftValue of the object DriftList.
 
MatrixDense evalDriftMat (const Db *db, const 1 &nbgh=1(), const ECalcMember &member=ECalcMember::fromKey("LHS")) const
 Call the method DriftList::evalDriftMat of the object DriftList.
 
Id evalDriftMatInPlace (MatrixDense &mat, const Db *db, const 1 &nbgh=1(), const ECalcMember &member=ECalcMember::fromKey("LHS")) const
 Call the method DriftList::evalDriftMatInPlace of the object DriftList.
 
MatrixDense evalDriftMatByRanks (const Db *db, const 1 &sampleRanks=1(), const ECalcMember &member=ECalcMember::fromKey("LHS")) const
 Call the method DriftList::evalDriftMatByRanks of the object DriftList.
 
 evalMeanVecByRanks (const Db *db, const 1 &sampleRanks=1()) const
 Call the method DriftList::evalMeanVecByRanks of the object DriftList.
 
Id evalDriftMatByRanksInPlace (MatrixDense &mat, const Db *db, const 1 &sampleranks=1(), const ECalcMember &member=ECalcMember::fromKey("LHS")) const
 Call the method DriftList::evalDriftMatByRanksInPlace of the object DriftList.
 
Id evalDriftMatByTargetInPlace (MatrixDense &mat, const Db *db, Id iech2, const KrigOpt &krigopt=KrigOpt()) const
 Call the method DriftList::evalDriftMatByTargetInPlace of the object DriftList.
 
Id getNDrift () const
 Call the method DriftList::getNDrift of the object DriftList.
 
Id getNDriftEquation () const
 Call the method DriftList::getNDriftEquation of the object DriftList.
 
Id getNExtDrift () const
 Call the method DriftList::getNExtDrift of the object DriftList.
 
bool isFlagLinked () const
 Call the method DriftList::isFlagLinked of the object DriftList.
 
Id getDriftMaxIRFOrder () const
 Call the method DriftList::getDriftMaxIRFOrder of the object DriftList.
 
Id getRankFex (Id il) const
 Call the method DriftList::getRankFex of the object DriftList.
 
bool isDriftSampleDefined (const Db *db, Id ib, Id nech, const 1 &nbgh, const ELoc &loctype) const
 Call the method DriftList::isDriftSampleDefined of the object DriftList.
 
bool isDriftFiltered (Id i) const
 Call the method DriftList::isDriftFiltered of the object DriftList.
 
bool isDriftDefined (const 1 &powers, Id rank_fex=0) const
 Call the method DriftList::isDriftDefined of the object DriftList.
 
bool isDriftDifferentDefined (const 1 &powers, Id rank_fex=-1) const
 Call the method DriftList::isDriftDifferentDefined of the object DriftList.
 
 getDrifts (const Db *db, bool useSel=true) const
 Call the method DriftList::getDrifts of the object DriftList.
 
double evalDrift (const Db *db, Id iech, Id il, const ECalcMember &member=ECalcMember::fromKey("LHS")) const
 Call the method DriftList::evalDrift of the object DriftList.
 
 evalDriftBySample (const Db *db, Id iech, const ECalcMember &member=ECalcMember::fromKey("LHS")) const
 Call the method DriftList::evalDriftBySample of the object DriftList.
 
void evalDriftBySampleInPlace (const Db *db, Id iech, const ECalcMember &member, 1 &drftab) const
 Call the method DriftList::evalDriftBySampleInPlace of the object DriftList.
 
double evalDriftCoef (const Db *db, Id iech, const 1 &coeffs) const
 Call the method DriftList::evalDriftCoef of the object DriftList.
 
bool hasDrift () const
 Call the method DriftList::hasDrift of the object DriftList.
 
double getMean (Id ivar) const
 Call the method DriftList::getMean of the object DriftList.
 
const & getMeans () const
 Call the method DriftList::getMeans of the object DriftList.
 
double evalDriftVarCoef (const Db *db, Id iech, Id ivar, const 1 &coeffs) const
 Call the method DriftList::evalDriftVarCoef of the object DriftList.
 
 evalDriftVarCoefs (const Db *db, const 1 &coeffs, bool useSel=false) const
 Call the method DriftList::evalDriftVarCoefs of the object DriftList.
 
Id getNVar () const
 Call the method CovContext::getNVar of the object CovContext.
 
size_t getNDim (Id ispace=-1) const
 Call the method CovContext::getNDim of the object CovContext.
 
ASpaceSharedPtr getSpace () const
 Call the method CovContext::getSpace of the object CovContext.
 
const & getCovar0 () const
 Call the method CovContext::getCovar0 of the object CovContext.
 
double getField () const
 Call the method CovContext::getField of the object CovContext.
 
virtual void setOptimEnabled (bool enabled) const
 Call the method ACov::setOptimEnabled of the object ACov.
 
void attachNoStatDb (const Db *db)
 Call the method ACov::attachNoStatDb of the object ACov.
 
void makeStationary ()
 Call the method ACov::makeStationary of the object ACov.
 
void setContext (const CovContext &ctxt)
 Call the method ACov::setContext of the object ACov.
 
std::vector< double > evalCovGrad (const SpacePoint &p1, const SpacePoint &p2, Id ivar=0, Id jvar=0, const CovCalcMode *mode=nullptr)
 Call the method ACov::evalCovGrad of the object ACov.
 
void setFlagLinked (bool flagLinked)
 Call the method DriftList::setFlagLinked of the object DriftList.
 
void setBetaHat (const 1 &betaHat)
 Call the method DriftList::setBetaHat of the object DriftList.
 
void setFiltered (const VectorBool &filtered)
 Call the method DriftList::setFiltered of the object DriftList.
 
void delDrift (size_t rank)
 Call the method DriftList::delDrift of the object DriftList.
 
void delAllDrifts ()
 Call the method DriftList::delAllDrifts of the object DriftList.
 
void copyCovContext (const CovContext &ctxt)
 Call the method DriftList::copyCovContext of the object DriftList.
 
void setMeans (const 1 &mean)
 Call the method DriftList::setMeans of the object DriftList.
 
void setMean (const double mean, Id ivar=0)
 Call the method DriftList::setMean of the object DriftList.
 
void setField (double field)
 Call the method CovContext::setField of the object CovContext.
 
void setCovar0s (const 1 &covar0)
 Call the method CovContext::setCovar0s of the object CovContext.
 
void setCovar0 (Id ivar, Id jvar, double covar0)
 Call the method CovContext::setCovar0 of the object CovContext.
 
- Public Member Functions inherited from gstlrn::ICloneable
 ICloneable ()
 
virtual ~ICloneable ()
 
virtual ICloneableclone () const =0
 
std::shared_ptr< ICloneablecloneShared () const
 
std::unique_ptr< ICloneablecloneUnique () const
 

Static Public Member Functions

static ListParamscreateListParams (std::shared_ptr< ListParams > &lp)
 

Constructor & Destructor Documentation

◆ ModelGeneric() [1/2]

gstlrn::ModelGeneric::ModelGeneric ( const CovContext ctxt = CovContext())

◆ ModelGeneric() [2/2]

gstlrn::ModelGeneric::ModelGeneric ( const ModelGeneric r)

◆ ~ModelGeneric()

gstlrn::ModelGeneric::~ModelGeneric ( )
virtual

Member Function Documentation

◆ _getContextModify()

CovContext * gstlrn::ModelGeneric::_getContextModify ( )
inline

◆ _getCovModify()

ACov * gstlrn::ModelGeneric::_getCovModify ( )
inline

ICloneable interface.

◆ _getDriftListModify()

DriftList * gstlrn::ModelGeneric::_getDriftListModify ( )
inline

◆ addDrift()

void gstlrn::ModelGeneric::addDrift ( const ADrift drift)

◆ attachNoStatDb()

void gstlrn::ModelGeneric::attachNoStatDb ( const Db db)

Call the method ACov::attachNoStatDb of the object ACov.

◆ buildVmapOnDbGrid()

Id gstlrn::ModelGeneric::buildVmapOnDbGrid ( DbGrid dbgrid,
const NamingConvention namconv = NamingConvention("VMAP") 
) const

Call the method ACov::buildVmapOnDbGrid of the object ACov.

◆ calculateStDev()

double gstlrn::ModelGeneric::calculateStDev ( Db db1,
Id  iech1,
Db db2,
Id  iech2,
bool  verbose = false,
double  factor = 1.,
const CovCalcMode mode = nullptr 
) const

Call the method ACov::calculateStDev of the object ACov.

◆ coefficientOfVariation()

double gstlrn::ModelGeneric::coefficientOfVariation ( const Db db,
double  volume,
double  mean,
const 1 &  ext,
const 1 &  ndisc,
const 1 &  angles = 1(),
const 1 &  x0 = 1(),
Id  ivar = 0,
Id  jvar = 0 
) const

Call the method ACov::coefficientOfVariation of the object ACov.

◆ computeDrift()

double gstlrn::ModelGeneric::computeDrift ( const Db db,
Id  ib,
Id  iech 
) const

Call the method DriftList::computeDrift of the object DriftList.

◆ computeLogLikelihood()

double gstlrn::ModelGeneric::computeLogLikelihood ( const Db db,
bool  verbose = false 
)

Compute the log-likelihood (based on covariance)

Parameters
dbDb structure where variable are loaded from
verboseVerbose flag
Remarks
The calculation considers all the active samples.
It can work in multivariate case with or without drift conditions (linked or not)
The algorithm is stopped (with a message) in the heterotopic case // TODO; improve for heterotopic case

◆ copyCovContext()

void gstlrn::ModelGeneric::copyCovContext ( const CovContext ctxt)

Call the method DriftList::copyCovContext of the object DriftList.

◆ createListParams()

ListParams * gstlrn::ModelGeneric::createListParams ( std::shared_ptr< ListParams > &  lp)
static

◆ delAllDrifts()

void gstlrn::ModelGeneric::delAllDrifts ( )

Call the method DriftList::delAllDrifts of the object DriftList.

◆ delDrift()

void gstlrn::ModelGeneric::delDrift ( size_t  rank)

Call the method DriftList::delDrift of the object DriftList.

◆ envelop()

gstlrn::ModelGeneric::envelop ( const 1 &  hh,
Id  ivar = 0,
Id  jvar = 0,
Id  isign = 1,
codir = 1(),
const CovCalcMode mode = nullptr 
) const

Call the method ACov::envelop of the object ACov.

◆ eval0()

virtual double gstlrn::ModelGeneric::eval0 ( Id  ivar = 0,
Id  jvar = 0,
const CovCalcMode mode = nullptr 
) const
virtual

Call the method ACov::eval0 of the object ACov.

◆ eval0Mat()

MatrixSymmetric gstlrn::ModelGeneric::eval0Mat ( const CovCalcMode mode = nullptr) const

Call the method ACov::eval0Mat of the object ACov.

◆ evalAverageDbToDb()

double gstlrn::ModelGeneric::evalAverageDbToDb ( const Db db1,
const Db db2,
Id  ivar = 0,
Id  jvar = 0,
double  eps = 0.,
Id  seed = 434132,
const CovCalcMode mode = nullptr 
) const

Call the method ACov::evalAverageDbToDb of the object ACov.

◆ evalAverageIncrToIncr()

double gstlrn::ModelGeneric::evalAverageIncrToIncr ( const 1 &  d1,
const 1 &  d2,
Id  ivar = 0,
Id  jvar = 0,
const CovCalcMode mode = nullptr 
) const

Call the method ACov::evalAverageIncrToIncr of the object ACov.

◆ evalAveragePointToDb()

double gstlrn::ModelGeneric::evalAveragePointToDb ( const SpacePoint p1,
const Db db2,
Id  ivar = 0,
Id  jvar = 0,
const CovCalcMode mode = nullptr 
) const

Call the method ACov::evalAveragePointToDb of the object ACov.

◆ evalCov()

double gstlrn::ModelGeneric::evalCov ( const SpacePoint p1,
const SpacePoint p2,
Id  ivar = 0,
Id  jvar = 0,
const CovCalcMode mode = nullptr 
) const

Call the method ACov::evalCov of the object ACov.

◆ evalCovGrad()

std::vector< double > gstlrn::ModelGeneric::evalCovGrad ( const SpacePoint p1,
const SpacePoint p2,
Id  ivar = 0,
Id  jvar = 0,
const CovCalcMode mode = nullptr 
)

Call the method ACov::evalCovGrad of the object ACov.

◆ evalCovMat()

MatrixDense gstlrn::ModelGeneric::evalCovMat ( const Db db1,
const Db db2 = nullptr,
Id  ivar0 = -1,
Id  jvar0 = -1,
const 1 &  nbgh1 = 1(),
const 1 &  nbgh2 = 1(),
const CovCalcMode mode = nullptr,
bool  cleanOptim = true 
) const

Call the method ACov::evalCovMat of the object ACov.

◆ evalCovMat0()

MatrixSymmetric gstlrn::ModelGeneric::evalCovMat0 ( const Db db,
Id  iech,
const KrigOpt krigopt = KrigOpt() 
) const

Call the method ACov::evalCovMat0 of the object ACov.

◆ evalCovMat0InPlace()

Id gstlrn::ModelGeneric::evalCovMat0InPlace ( MatrixSymmetric mat,
const Db db,
Id  iech,
const KrigOpt krigopt = KrigOpt() 
) const

Call the method ACov::evalCovMat0InPlace of the object ACov.

◆ evalCovMatInPlace()

Id gstlrn::ModelGeneric::evalCovMatInPlace ( MatrixDense mat,
const Db db1,
const Db db2 = nullptr,
Id  ivar0 = -1,
Id  jvar0 = -1,
const 1 &  nbgh1 = 1(),
const 1 &  nbgh2 = 1(),
const CovCalcMode mode = nullptr,
bool  cleanOptim = true 
) const

Call the method ACov::evalCovMatInPlace of the object ACov.

◆ evalCovMatInPlaceFromIdx()

Id gstlrn::ModelGeneric::evalCovMatInPlaceFromIdx ( MatrixDense mat,
const Db db1,
const Db db2,
const 1 &  index1,
const 1 &  index2,
const 1 &  nbgh2 = 1(),
const CovCalcMode mode = nullptr,
bool  cleanOptim = true 
) const

Call the method ACov::evalCovMatInPlaceFromIdx of the object ACov.

◆ evalCovMatOptimInPlace()

Id gstlrn::ModelGeneric::evalCovMatOptimInPlace ( MatrixDense mat,
const Db dbin,
const RankHandler rankhandler,
const KrigOpt krigopt,
const ECalcMember &  calcMember,
1 &  tabwork,
double  lambda = 1. 
) const

Call the method ACov::evalCovMatOptimInPlace of the object ACov.

◆ evalCovMatRHSInPlaceFromIdx()

Id gstlrn::ModelGeneric::evalCovMatRHSInPlaceFromIdx ( MatrixDense mat,
const Db db1,
const Db db2,
const 1 &  index1,
const Id  iech2 = -1,
const KrigOpt krigopt = KrigOpt(),
bool  cleanOptim = true 
) const

Call the method ACov::evalCovMatRHSInPlaceFromIdx of the object ACov.

◆ evalCovMatSparse()

MatrixSparse * gstlrn::ModelGeneric::evalCovMatSparse ( const Db db1_arg,
const Db db2_arg = nullptr,
Id  ivar0 = -1,
Id  jvar0 = -1,
const 1 &  nbgh1 = 1(),
const 1 &  nbgh2 = 1(),
const CovCalcMode mode = nullptr,
bool  cleanOptim = true,
double  eps = EPSILON3 
) const

Call the method ACov::evalCovMatSparse of the object ACov.

◆ evalCovMatSym()

MatrixSymmetric gstlrn::ModelGeneric::evalCovMatSym ( const Db db1,
const 1 &  nbgh1 = 1(),
Id  ivar0 = -1,
const CovCalcMode mode = nullptr,
bool  cleanOptim = true 
) const

Call the method ACov::evalCovMatSym of the object ACov.

◆ evalCovMatSymInPlace()

Id gstlrn::ModelGeneric::evalCovMatSymInPlace ( MatrixSymmetric mat,
const Db db1,
const 1 &  nbgh1 = 1(),
Id  ivar0 = -1,
const CovCalcMode mode = nullptr,
bool  cleanOptim = true 
) const

Call the method ACov::evalCovMatSymInPlace of the object ACov.

◆ evalCovMatSymInPlaceFromIdx()

Id gstlrn::ModelGeneric::evalCovMatSymInPlaceFromIdx ( MatrixSymmetric mat,
const Db db1,
const 1 &  index1,
const CovCalcMode mode = nullptr,
bool  cleanOptim = true 
) const

Call the method ACov::evalCovMatSymInPlaceFromIdx of the object ACov.

◆ evalCovVecRHSInPlace()

Id gstlrn::ModelGeneric::evalCovVecRHSInPlace ( vect  vect,
const RankHandler rank,
Id  iech2,
const KrigOpt krigopt,
SpacePoint pin,
SpacePoint pout,
1 &  tabwork,
double  lambda = 1.,
const ECalcMember &  calcMember = ECalcMember::RHS 
) const

Call the method ACov::evalCovVecRHSInPlace of the object ACov.

◆ evalCvv()

double gstlrn::ModelGeneric::evalCvv ( const 1 &  ext,
const 1 &  ndisc,
const 1 &  angles = 1(),
Id  ivar = 0,
Id  jvar = 0,
const CovCalcMode mode = nullptr 
) const

Call the method ACov::evalCvv of the object ACov.

◆ evalCvvM()

MatrixSquare gstlrn::ModelGeneric::evalCvvM ( const 1 &  ext,
const 1 &  ndisc,
const 1 &  angles = 1(),
const CovCalcMode mode = nullptr 
) const

Call the method ACov::evalCvvM of the object ACov.

◆ evalCvvShift()

double gstlrn::ModelGeneric::evalCvvShift ( const 1 &  ext,
const 1 &  ndisc,
const 1 &  shift,
const 1 &  angles = 1(),
Id  ivar = 0,
Id  jvar = 0,
const CovCalcMode mode = nullptr 
) const

Call the method ACov::evalCvvShift of the object ACov.

◆ evalCxv()

double gstlrn::ModelGeneric::evalCxv ( const SpacePoint p1,
const 1 &  ext,
const 1 &  ndisc,
const 1 &  angles = 1(),
const 1 &  x0 = 1(),
Id  ivar = 0,
Id  jvar = 0,
const CovCalcMode mode = nullptr 
) const

Call the method ACov::evalCxv of the object ACov.

◆ evalCxvM()

MatrixSquare gstlrn::ModelGeneric::evalCxvM ( const SpacePoint p1,
const 1 &  ext,
const 1 &  ndisc,
const 1 &  angles = 1(),
const 1 &  x0 = 1(),
const CovCalcMode mode = nullptr 
) const

Call the method ACov::evalCxvM of the object ACov.

◆ evalDrift()

double gstlrn::ModelGeneric::evalDrift ( const Db db,
Id  iech,
Id  il,
const ECalcMember &  member = ECalcMember::fromKey("LHS") 
) const

Call the method DriftList::evalDrift of the object DriftList.

◆ evalDriftBySample()

gstlrn::ModelGeneric::evalDriftBySample ( const Db db,
Id  iech,
const ECalcMember &  member = ECalcMember::fromKey("LHS") 
) const

Call the method DriftList::evalDriftBySample of the object DriftList.

◆ evalDriftBySampleInPlace()

void gstlrn::ModelGeneric::evalDriftBySampleInPlace ( const Db db,
Id  iech,
const ECalcMember &  member,
1 &  drftab 
) const

Call the method DriftList::evalDriftBySampleInPlace of the object DriftList.

◆ evalDriftCoef()

double gstlrn::ModelGeneric::evalDriftCoef ( const Db db,
Id  iech,
const 1 &  coeffs 
) const

Call the method DriftList::evalDriftCoef of the object DriftList.

◆ evalDriftMat()

MatrixDense gstlrn::ModelGeneric::evalDriftMat ( const Db db,
const 1 &  nbgh = 1(),
const ECalcMember &  member = ECalcMember::fromKey("LHS") 
) const

Call the method DriftList::evalDriftMat of the object DriftList.

◆ evalDriftMatByRanks()

MatrixDense gstlrn::ModelGeneric::evalDriftMatByRanks ( const Db db,
const 1 &  sampleRanks = 1(),
const ECalcMember &  member = ECalcMember::fromKey("LHS") 
) const

Call the method DriftList::evalDriftMatByRanks of the object DriftList.

◆ evalDriftMatByRanksInPlace()

Id gstlrn::ModelGeneric::evalDriftMatByRanksInPlace ( MatrixDense mat,
const Db db,
const 1 &  sampleranks = 1(),
const ECalcMember &  member = ECalcMember::fromKey("LHS") 
) const

Call the method DriftList::evalDriftMatByRanksInPlace of the object DriftList.

◆ evalDriftMatByTargetInPlace()

Id gstlrn::ModelGeneric::evalDriftMatByTargetInPlace ( MatrixDense mat,
const Db db,
Id  iech2,
const KrigOpt krigopt = KrigOpt() 
) const

Call the method DriftList::evalDriftMatByTargetInPlace of the object DriftList.

◆ evalDriftMatInPlace()

Id gstlrn::ModelGeneric::evalDriftMatInPlace ( MatrixDense mat,
const Db db,
const 1 &  nbgh = 1(),
const ECalcMember &  member = ECalcMember::fromKey("LHS") 
) const

Call the method DriftList::evalDriftMatInPlace of the object DriftList.

◆ evalDriftValue()

double gstlrn::ModelGeneric::evalDriftValue ( const Db db,
Id  iech,
Id  ivar,
Id  ib,
const ECalcMember &  member = ECalcMember::fromKey("LHS") 
) const

Call the method DriftList::evalDriftValue of the object DriftList.

◆ evalDriftVarCoef()

double gstlrn::ModelGeneric::evalDriftVarCoef ( const Db db,
Id  iech,
Id  ivar,
const 1 &  coeffs 
) const

Call the method DriftList::evalDriftVarCoef of the object DriftList.

◆ evalDriftVarCoefs()

gstlrn::ModelGeneric::evalDriftVarCoefs ( const Db db,
const 1 &  coeffs,
bool  useSel = false 
) const

Call the method DriftList::evalDriftVarCoefs of the object DriftList.

◆ evalIvarIpas()

double gstlrn::ModelGeneric::evalIvarIpas ( double  step,
const 1 &  dir = 1(),
Id  ivar = 0,
Id  jvar = 0,
const CovCalcMode mode = nullptr 
) const

Call the method ACov::evalIvarIpas of the object ACov.

◆ evalIvarNlag()

gstlrn::ModelGeneric::evalIvarNlag ( const 1 &  vec_step,
const 1 &  dir = 1(),
Id  ivar = 0,
Id  jvar = 0,
const CovCalcMode mode = nullptr 
) const

Call the method ACov::evalIvarNlag of the object ACov.

◆ evalMeanVecByRanks()

gstlrn::ModelGeneric::evalMeanVecByRanks ( const Db db,
const 1 &  sampleRanks = 1() 
) const

Call the method DriftList::evalMeanVecByRanks of the object DriftList.

◆ evalNvarIpas()

MatrixSquare gstlrn::ModelGeneric::evalNvarIpas ( double  step,
const 1 &  dir = 1(),
const CovCalcMode mode = nullptr 
) const

Call the method ACov::evalNvarIpas of the object ACov.

◆ evalNvarIpasIncr()

MatrixSquare gstlrn::ModelGeneric::evalNvarIpasIncr ( const 1 &  dincr,
const CovCalcMode mode = nullptr 
) const

Call the method ACov::evalNvarIpasIncr of the object ACov.

◆ evalPointToDb()

void gstlrn::ModelGeneric::evalPointToDb ( 1 &  values,
const SpacePoint p1,
const Db db2,
Id  ivar = 0,
Id  jvar = 0,
bool  useSel = true,
const 1 &  nbgh2 = 1(),
const CovCalcMode mode = nullptr 
) const

Call the method ACov::evalPointToDb of the object ACov.

◆ evalPointToDbAsSP()

void gstlrn::ModelGeneric::evalPointToDbAsSP ( 1 &  values,
const std::vector< SpacePoint > &  p1s,
const SpacePoint p2,
Id  ivar = 0,
Id  jvar = 0,
const CovCalcMode mode = nullptr 
) const

Call the method ACov::evalPointToDbAsSP of the object ACov.

◆ evaluateMatInPlace()

void gstlrn::ModelGeneric::evaluateMatInPlace ( const CovInternal covint,
const 1 &  d1,
MatrixSquare covtab,
bool  flag_init = false,
double  weight = 1.,
const CovCalcMode mode = nullptr 
) const

Call the method ACov::evaluateMatInPlace of the object ACov.

◆ evaluateOneGeneric()

double gstlrn::ModelGeneric::evaluateOneGeneric ( const CovInternal covint,
const 1 &  d1 = 1(),
double  weight = 1.,
const CovCalcMode mode = nullptr 
) const

Call the method ACov::evaluateOneGeneric of the object ACov.

◆ evaluateOneIncr()

double gstlrn::ModelGeneric::evaluateOneIncr ( double  hh,
const 1 &  codir = 1(),
Id  ivar = 0,
Id  jvar = 0,
const CovCalcMode mode = nullptr 
) const

Call the method ACov::evaluateOneIncr of the object ACov.

◆ extensionVariance()

double gstlrn::ModelGeneric::extensionVariance ( const Db db,
const 1 &  ext,
const 1 &  ndisc,
const 1 &  angles = 1(),
const 1 &  x0 = 1(),
Id  ivar = 0,
Id  jvar = 0 
) const

Call the method ACov::extensionVariance of the object ACov.

◆ fitNew()

void gstlrn::ModelGeneric::fitNew ( const Db db = nullptr,
Vario vario = nullptr,
const DbGrid dbmap = nullptr,
Constraints constraints = nullptr,
const ModelOptimParam mop = ModelOptimParam(),
Id  nb_neighVecchia = 30,
bool  verbose = false,
bool  trace = false,
bool  reml = false 
)

◆ generateListParams()

std::shared_ptr< ListParams > gstlrn::ModelGeneric::generateListParams ( ) const

◆ getContext()

const CovContext * gstlrn::ModelGeneric::getContext ( ) const
inline

◆ getCov()

const ACov * gstlrn::ModelGeneric::getCov ( ) const
inline

◆ getCovar0()

const & gstlrn::ModelGeneric::getCovar0 ( ) const

Call the method CovContext::getCovar0 of the object CovContext.

◆ getDrift()

const ADrift * gstlrn::ModelGeneric::getDrift ( Id  il) const

Call the method DriftList::getDrift of the object DriftList.

◆ getDriftList()

const DriftList * gstlrn::ModelGeneric::getDriftList ( ) const
inline

◆ getDriftMaxIRFOrder()

Id gstlrn::ModelGeneric::getDriftMaxIRFOrder ( ) const

Call the method DriftList::getDriftMaxIRFOrder of the object DriftList.

◆ getDrifts()

gstlrn::ModelGeneric::getDrifts ( const Db db,
bool  useSel = true 
) const

Call the method DriftList::getDrifts of the object DriftList.

◆ getField()

double gstlrn::ModelGeneric::getField ( ) const

Call the method CovContext::getField of the object CovContext.

◆ getGradients()

std::vector< covmaptype > & gstlrn::ModelGeneric::getGradients ( )
inline

◆ getMean()

double gstlrn::ModelGeneric::getMean ( Id  ivar) const

Call the method DriftList::getMean of the object DriftList.

◆ getMeans()

const & gstlrn::ModelGeneric::getMeans ( ) const

Call the method DriftList::getMeans of the object DriftList.

◆ getNDim()

size_t gstlrn::ModelGeneric::getNDim ( Id  ispace = -1) const

Call the method CovContext::getNDim of the object CovContext.

◆ getNDrift()

Id gstlrn::ModelGeneric::getNDrift ( ) const

Call the method DriftList::getNDrift of the object DriftList.

◆ getNDriftEquation()

Id gstlrn::ModelGeneric::getNDriftEquation ( ) const

Call the method DriftList::getNDriftEquation of the object DriftList.

◆ getNExtDrift()

Id gstlrn::ModelGeneric::getNExtDrift ( ) const

Call the method DriftList::getNExtDrift of the object DriftList.

◆ getNVar()

Id gstlrn::ModelGeneric::getNVar ( ) const

Call the method CovContext::getNVar of the object CovContext.

◆ getRankFex()

Id gstlrn::ModelGeneric::getRankFex ( Id  il) const

Call the method DriftList::getRankFex of the object DriftList.

◆ getSpace()

ASpaceSharedPtr gstlrn::ModelGeneric::getSpace ( ) const

Call the method CovContext::getSpace of the object CovContext.

◆ gofToVario()

double gstlrn::ModelGeneric::gofToVario ( const Vario vario,
bool  verbose = true 
) const

Call the method ACov::gofToVario of the object ACov.

◆ hasDrift()

bool gstlrn::ModelGeneric::hasDrift ( ) const

Call the method DriftList::hasDrift of the object DriftList.

◆ initParams()

void gstlrn::ModelGeneric::initParams ( const MatrixSymmetric vars,
double  href = 1. 
)

◆ isDriftDefined()

bool gstlrn::ModelGeneric::isDriftDefined ( const 1 &  powers,
Id  rank_fex = 0 
) const

Call the method DriftList::isDriftDefined of the object DriftList.

◆ isDriftDifferentDefined()

bool gstlrn::ModelGeneric::isDriftDifferentDefined ( const 1 &  powers,
Id  rank_fex = -1 
) const

Call the method DriftList::isDriftDifferentDefined of the object DriftList.

◆ isDriftFiltered()

bool gstlrn::ModelGeneric::isDriftFiltered ( Id  i) const

Call the method DriftList::isDriftFiltered of the object DriftList.

◆ isDriftSampleDefined()

bool gstlrn::ModelGeneric::isDriftSampleDefined ( const Db db,
Id  ib,
Id  nech,
const 1 &  nbgh,
const ELoc &  loctype 
) const

Call the method DriftList::isDriftSampleDefined of the object DriftList.

◆ isFlagLinked()

bool gstlrn::ModelGeneric::isFlagLinked ( ) const

Call the method DriftList::isFlagLinked of the object DriftList.

◆ isNoStat()

bool gstlrn::ModelGeneric::isNoStat ( ) const

Call the method ACov::isNoStat of the object ACov.

◆ isValid()

bool gstlrn::ModelGeneric::isValid ( ) const

◆ makeStationary()

void gstlrn::ModelGeneric::makeStationary ( )

Call the method ACov::makeStationary of the object ACov.

◆ manage()

void gstlrn::ModelGeneric::manage ( const Db db1,
const Db db2 
) const

Call the method ACov::manage of the object ACov.

◆ operator=()

ModelGeneric & gstlrn::ModelGeneric::operator= ( const ModelGeneric r)

◆ optimizationPostProcess()

void gstlrn::ModelGeneric::optimizationPostProcess ( ) const

Call the method ACov::optimizationPostProcess of the object ACov.

◆ optimizationPreProcessForData()

void gstlrn::ModelGeneric::optimizationPreProcessForData ( const Db db1 = nullptr) const

Call the method ACov::optimizationPreProcessForData of the object ACov.

◆ sample()

gstlrn::ModelGeneric::sample ( const 1 &  h,
const 1 &  codir = 1(),
Id  ivar = 0,
Id  jvar = 0,
const CovCalcMode mode = nullptr,
const CovInternal covint = nullptr 
) const

Call the method ACov::sample of the object ACov.

◆ sampleUnitary()

gstlrn::ModelGeneric::sampleUnitary ( const 1 &  hh,
Id  ivar = 0,
Id  jvar = 0,
codir = 1(),
const CovCalcMode mode = nullptr 
) const

Call the method ACov::sampleUnitary of the object ACov.

◆ samplingDensityVariance()

double gstlrn::ModelGeneric::samplingDensityVariance ( const Db db,
const 1 &  ext,
const 1 &  ndisc,
const 1 &  angles = 1(),
const 1 &  x0 = 1(),
Id  ivar = 0,
Id  jvar = 0 
) const

Call the method ACov::samplingDensityVariance of the object ACov.

◆ setBetaHat()

void gstlrn::ModelGeneric::setBetaHat ( const 1 &  betaHat)

Call the method DriftList::setBetaHat of the object DriftList.

◆ setContext()

void gstlrn::ModelGeneric::setContext ( const CovContext ctxt)

Call the method ACov::setContext of the object ACov.

◆ setCov()

void gstlrn::ModelGeneric::setCov ( const ACov cova)

◆ setCovar0()

void gstlrn::ModelGeneric::setCovar0 ( Id  ivar,
Id  jvar,
double  covar0 
)

Call the method CovContext::setCovar0 of the object CovContext.

◆ setCovar0s()

void gstlrn::ModelGeneric::setCovar0s ( const 1 &  covar0)

Call the method CovContext::setCovar0s of the object CovContext.

◆ setDriftIRF()

void gstlrn::ModelGeneric::setDriftIRF ( Id  order = 0,
Id  nfex = 0 
)

Define the list of drift functions for:

  • a given degree of the IRF
  • a given number of external drifts
    Parameters
    orderOrder of the IRF
    nfexNumber of External Drifts
    Remarks
    This method deletes any pre-existing drift functions and replaces them by the new definition
    This replacement is performed accounting for information stored in 'model', such as:
  • the space dimension
  • the number of variables

◆ setDriftList()

void gstlrn::ModelGeneric::setDriftList ( const DriftList driftlist)

Add a list of Drifts. This operation cleans any previously stored drift function

Parameters
driftlistList of Drifts to be added
Remarks
This method deletes any pre-existing drift functions

◆ setDrifts()

void gstlrn::ModelGeneric::setDrifts ( const VectorString driftSymbols)

◆ setField() [1/2]

void gstlrn::ModelGeneric::setField ( double  field)

Call the method CovContext::setField of the object CovContext.

◆ setField() [2/2]

void gstlrn::ModelGeneric::setField ( double  field)

◆ setFiltered()

void gstlrn::ModelGeneric::setFiltered ( const VectorBool filtered)

Call the method DriftList::setFiltered of the object DriftList.

◆ setFlagLinked()

void gstlrn::ModelGeneric::setFlagLinked ( bool  flagLinked)

Call the method DriftList::setFlagLinked of the object DriftList.

◆ setMean()

void gstlrn::ModelGeneric::setMean ( const double  mean,
Id  ivar = 0 
)

Call the method DriftList::setMean of the object DriftList.

◆ setMeans()

void gstlrn::ModelGeneric::setMeans ( const 1 &  mean)

Call the method DriftList::setMeans of the object DriftList.

◆ setOptimEnabled()

virtual void gstlrn::ModelGeneric::setOptimEnabled ( bool  enabled) const
virtual

Call the method ACov::setOptimEnabled of the object ACov.

◆ specificVolume()

double gstlrn::ModelGeneric::specificVolume ( const Db db,
double  mean,
const 1 &  ext,
const 1 &  ndisc,
const 1 &  angles = 1(),
const 1 &  x0 = 1(),
Id  ivar = 0,
Id  jvar = 0 
) const

Call the method ACov::specificVolume of the object ACov.

◆ specificVolumeFromCoV()

double gstlrn::ModelGeneric::specificVolumeFromCoV ( Db db,
double  cov,
double  mean,
const 1 &  ext,
const 1 &  ndisc,
const 1 &  angles = 1(),
const 1 &  x0 = 1(),
Id  ivar = 0,
Id  jvar = 0 
) const

Call the method ACov::specificVolumeFromCoV of the object ACov.

◆ updateModel()

void gstlrn::ModelGeneric::updateModel ( )

The documentation for this class was generated from the following files: