GBL trajectory. More...
#include <GblTrajectory.h>
Public Member Functions | |
unsigned int | fit (double &Chi2, int &Ndf, double &lostWeight, const std::string &optionList="", unsigned int aLabel=0) |
Perform fit of (valid) trajectory. More... | |
GblTrajectory (const std::vector< GblPoint > &aPointList, bool flagCurv=true, bool flagU1dir=true, bool flagU2dir=true) | |
Create new (simple) trajectory from list of points. More... | |
template<typename Seed > | |
GblTrajectory (const std::vector< GblPoint > &aPointList, unsigned int aLabel, const Eigen::MatrixBase< Seed > &aSeed, bool flagCurv=true, bool flagU1dir=true, bool flagU2dir=true) | |
Create new (simple) trajectory from list of points with external seed. More... | |
GblTrajectory (const std::vector< std::pair< std::vector< GblPoint >, Eigen::MatrixXd > > &aPointsAndTransList) | |
template<typename Derivatives , typename Measurements , typename Precision , typename std::enable_if<(Measurements::ColsAtCompileTime==1)>::type * = nullptr, typename std::enable_if<(Precision::ColsAtCompileTime!=1)>::type * = nullptr> | |
GblTrajectory (const std::vector< std::pair< std::vector< GblPoint >, Eigen::MatrixXd > > &aPointsAndTransList, const Eigen::MatrixBase< Derivatives > &extDerivatives, const Eigen::MatrixBase< Measurements > &extMeasurements, const Eigen::MatrixBase< Precision > &extPrecisions) | |
Create new composed trajectory from list of points and transformations with (independent or correlated) external measurements. More... | |
template<typename Derivatives , typename Measurements , typename Precision , typename std::enable_if<(Measurements::ColsAtCompileTime==1)>::type * = nullptr, typename std::enable_if<(Precision::ColsAtCompileTime==1)>::type * = nullptr> | |
GblTrajectory (const std::vector< std::pair< std::vector< GblPoint >, Eigen::MatrixXd > > &aPointsAndTransList, const Eigen::MatrixBase< Derivatives > &extDerivatives, const Eigen::MatrixBase< Measurements > &extMeasurements, const Eigen::MatrixBase< Precision > &extPrecisions) | |
unsigned int | getLabels (std::vector< unsigned int > &aLabelList) |
Get (list of) labels of points on (simple) valid trajectory. More... | |
unsigned int | getLabels (std::vector< std::vector< unsigned int > > &aLabelList) |
Get (list of lists of) labels of points on (composed) valid trajectory. More... | |
unsigned int | getMeasResults (unsigned int aLabel, unsigned int &numRes, Eigen::VectorXd &aResiduals, Eigen::VectorXd &aMeasErrors, Eigen::VectorXd &aResErrors, Eigen::VectorXd &aDownWeights) |
Get residuals from fit at point for measurement. More... | |
unsigned int | getNumPoints () const |
Retrieve number of point from trajectory. More... | |
unsigned int | getResults (int aSignedLabel, Eigen::VectorXd &localPar, Eigen::MatrixXd &localCov) const |
Get fit results at point. More... | |
unsigned int | getScatResults (unsigned int aLabel, unsigned int &numRes, Eigen::VectorXd &aResiduals, Eigen::VectorXd &aMeasErrors, Eigen::VectorXd &aResErrors, Eigen::VectorXd &aDownWeights) |
Get (kink) residuals from fit at point for scatterer. More... | |
bool | isValid () const |
Retrieve validity of trajectory. More... | |
void | milleOut (MilleBinary &aMille) |
Write valid trajectory to Millepede-II binary file. More... | |
void | printData () |
Print GblData blocks for trajectory. More... | |
void | printPoints (unsigned int level=0) |
Print GblPoints on trajectory. More... | |
void | printTrajectory (unsigned int level=0) |
Print GblTrajectory. More... | |
virtual | ~GblTrajectory () |
Private Member Functions | |
void | buildLinearEquationSystem () |
Build linear equation system from data (blocks). More... | |
void | calcJacobians () |
Calculate Jacobians to previous/next scatterer from point to point ones. More... | |
void | construct () |
Construct trajectory from list of points. More... | |
void | defineOffsets () |
Define offsets from list of points. More... | |
double | downWeight (unsigned int aMethod) |
Down-weight all points. More... | |
void | getFitToKinkJacobian (std::array< unsigned int, 7 > &anIndex, Matrix27d &aJacobian, const GblPoint &aPoint) const |
Get jacobian for transformation from (trajectory) fit to kink parameters at point. More... | |
void | getFitToLocalJacobian (std::array< unsigned int, 5 > &anIndex, Matrix5d &aJacobian, const GblPoint &aPoint, unsigned int measDim, unsigned int nJacobian=1) const |
Get (part of) jacobian for transformation from (trajectory) fit to track parameters at point. More... | |
std::pair< std::vector< unsigned int >, Eigen::MatrixXd > | getJacobian (int aSignedLabel) const |
Get jacobian for transformation from fit to track parameters at point. More... | |
void | getResAndErr (unsigned int aData, bool used, double &aResidual, double &aMeadsError, double &aResError, double &aDownWeight) |
Get residual and errors from data block. More... | |
void | predict () |
Calculate predictions for all points. More... | |
void | prepare () |
Prepare fit for simple or composed trajectory. More... | |
Private Attributes | |
bool | constructOK |
Trajectory has been successfully constructed (ready for fit/output) More... | |
Eigen::MatrixXd | externalDerivatives |
Eigen::VectorXd | externalMeasurements |
unsigned int | externalPoint |
Label of external point (or 0) More... | |
Eigen::VectorXd | externalPrecisions |
Eigen::MatrixXd | externalSeed |
Precision (inverse covariance matrix) of external seed. More... | |
bool | fitOK |
Trajectory has been successfully fitted (results are valid) More... | |
std::vector< Eigen::MatrixXd > | innerTransformations |
Transformations at innermost points of. More... | |
unsigned int | maxNumGlobals |
Max. number of global labels/derivatives per point. More... | |
std::vector< unsigned int > | measDataIndex |
mapping points to data blocks from measurements More... | |
unsigned int | numAllPoints |
Number of all points on trajectory. More... | |
unsigned int | numCurvature |
Number of curvature parameters (0 or 1) or external parameters. More... | |
unsigned int | numInnerTrans |
Number of inner transformations to external parameters. More... | |
unsigned int | numLocals |
Total number of (additional) local parameters. More... | |
unsigned int | numMeasurements |
Total number of measurements. More... | |
unsigned int | numOffsets |
Number of (points with) offsets on trajectory. More... | |
unsigned int | numParameters |
Number of fit parameters. More... | |
std::vector< unsigned int > | numPoints |
Number of points on (sub)trajectory. More... | |
unsigned int | numTrajectories |
Number of trajectories (in composed trajectory) More... | |
std::vector< unsigned int > | scatDataIndex |
mapping points to data blocks from scatterers More... | |
unsigned int | skippedMeasLabel |
Label of point with measurements skipped in fit (for unbiased residuals) (or 0) More... | |
std::vector< GblData > | theData |
List of data blocks. More... | |
std::vector< unsigned int > | theDimension |
List of active dimensions (0=u1, 1=u2) in fit. More... | |
BorderedBandMatrix | theMatrix |
(Bordered band) matrix of linear equation system More... | |
std::vector< std::vector< GblPoint > > | thePoints |
(list of) List of points on trajectory More... | |
VVector | theVector |
Vector of linear equation system. More... | |
GBL trajectory.
List of GblPoints ordered by arc length. Can be fitted and optionally written to MP-II binary file.
Definition at line 47 of file GblTrajectory.h.
gbl::GblTrajectory::GblTrajectory | ( | const std::vector< GblPoint > & | aPointList, |
bool | flagCurv = true , |
||
bool | flagU1dir = true , |
||
bool | flagU2dir = true |
||
) |
Create new (simple) trajectory from list of points.
Curved trajectory in space (default) or without curvature (q/p) or in one plane (u-direction) only.
[in] | aPointList | List of points |
[in] | flagCurv | Use q/p |
[in] | flagU1dir | Use in u1 direction |
[in] | flagU2dir | Use in u2 direction |
Definition at line 153 of file GblTrajectory.cc.
References construct(), externalDerivatives, externalMeasurements, externalPoint, externalPrecisions, externalSeed, plotBeamSpotDB::first, mps_fire::i, innerTransformations, maxNumGlobals, measDataIndex, eostools::move(), numAllPoints, numCurvature, numInnerTrans, numLocals, numMeasurements, numOffsets, numParameters, numPoints, scatDataIndex, edm::second(), skippedMeasLabel, theData, theDimension, and thePoints.
Referenced by GblTrajectory().
gbl::GblTrajectory::GblTrajectory | ( | const std::vector< GblPoint > & | aPointList, |
unsigned int | aLabel, | ||
const Eigen::MatrixBase< Seed > & | aSeed, | ||
bool | flagCurv = true , |
||
bool | flagU1dir = true , |
||
bool | flagU2dir = true |
||
) |
Create new (simple) trajectory from list of points with external seed.
Curved trajectory in space (default) or without curvature (q/p) or in one plane (u-direction) only.
[in] | aPointList | List of points |
[in] | aLabel | (Signed) label of point for external seed (<0: in front, >0: after point, slope changes at scatterer!) |
[in] | aSeed | Precision matrix of external seed |
[in] | flagCurv | Use q/p |
[in] | flagU1dir | Use in u1 direction |
[in] | flagU2dir | Use in u2 direction |
Definition at line 175 of file GblTrajectory.h.
References construct(), numAllPoints, numPoints, theDimension, and thePoints.
gbl::GblTrajectory::GblTrajectory | ( | const std::vector< std::pair< std::vector< GblPoint >, Eigen::MatrixXd > > & | aPointsAndTransList | ) |
gbl::GblTrajectory::GblTrajectory | ( | const std::vector< std::pair< std::vector< GblPoint >, Eigen::MatrixXd > > & | aPointsAndTransList, |
const Eigen::MatrixBase< Derivatives > & | extDerivatives, | ||
const Eigen::MatrixBase< Measurements > & | extMeasurements, | ||
const Eigen::MatrixBase< Precision > & | extPrecisions | ||
) |
Create new composed trajectory from list of points and transformations with (independent or correlated) external measurements.
Composed of curved trajectories in space. The precision matrix for the external measurements can specified as a vector for independent measurements or as arbitrary matrix which will be diagonalized.
[in] | aPointsAndTransList | List containing pairs with list of points and transformation (at inner (first) point) |
[in] | extDerivatives | Derivatives of external measurements vs external parameters |
[in] | extMeasurements | External measurements (residuals) |
[in] | extPrecisions | Precision of external measurements (matrix) |
Composed of curved trajectories in space. The precision matrix for the external measurements can specified as a vector for independent measurements or as arbitrary matrix which will be diagonalized.
[in] | aPointsAndTransList | List containing pairs with list of points and transformation (at inner (first) point) |
[in] | extDerivatives | Derivatives of external measurements vs external parameters |
[in] | extMeasurements | External measurements (residuals) |
[in] | extPrecisions | Precision of external measurements (diagonal) |
Definition at line 212 of file GblTrajectory.h.
References construct(), externalDerivatives, externalMeasurements, externalPoint, externalPrecisions, externalSeed, plotBeamSpotDB::first, GblTrajectory(), innerTransformations, maxNumGlobals, measDataIndex, numAllPoints, numCurvature, numInnerTrans, numLocals, numMeasurements, numOffsets, numParameters, numPoints, scatDataIndex, edm::second(), skippedMeasLabel, theData, theDimension, and thePoints.
gbl::GblTrajectory::GblTrajectory | ( | const std::vector< std::pair< std::vector< GblPoint >, Eigen::MatrixXd > > & | aPointsAndTransList, |
const Eigen::MatrixBase< Derivatives > & | extDerivatives, | ||
const Eigen::MatrixBase< Measurements > & | extMeasurements, | ||
const Eigen::MatrixBase< Precision > & | extPrecisions | ||
) |
|
virtual |
Definition at line 392 of file GblTrajectory.cc.
|
private |
Build linear equation system from data (blocks).
Definition at line 994 of file GblTrajectory.cc.
References gbl::BorderedBandMatrix::addBlockMatrix(), gbl::InternalMeasurement, numCurvature, numLocals, numParameters, gbl::VVector::resize(), gbl::BorderedBandMatrix::resize(), skippedMeasLabel, theData, theMatrix, and theVector.
Referenced by fit().
|
private |
Calculate Jacobians to previous/next scatterer from point to point ones.
Definition at line 474 of file GblTrajectory.cc.
References gbl::GblPoint::addNextJacobian(), begin, end, gbl::GblPoint::getP2pJacobian(), numTrajectories, and thePoints.
Referenced by construct().
|
private |
Construct trajectory from list of points.
Trajectory is prepared for fit or output to binary file, may consists of sub-trajectories.
Definition at line 409 of file GblTrajectory.cc.
References begin, calcJacobians(), constructOK, gather_cfg::cout, defineOffsets(), MillePedeFileConverter_cfg::e, fitOK, hpstanc_transforms::max, numAllPoints, numCurvature, numInnerTrans, numLocals, numMeasurements, numOffsets, numParameters, numTrajectories, prepare(), theDimension, and thePoints.
Referenced by GblTrajectory().
|
private |
Define offsets from list of points.
Define offsets at points with scatterers and first and last point. All other points need interpolation from adjacent points with offsets.
Definition at line 452 of file GblTrajectory.cc.
References begin, numOffsets, numTrajectories, and thePoints.
Referenced by construct().
|
private |
Down-weight all points.
[in] | aMethod | M-estimator (1: Tukey, 2:Huber, 3:Cauchy) |
Definition at line 1253 of file GblTrajectory.cc.
References theData.
Referenced by fit().
unsigned int gbl::GblTrajectory::fit | ( | double & | Chi2, |
int & | Ndf, | ||
double & | lostWeight, | ||
const std::string & | optionList = "" , |
||
unsigned int | aLabel = 0 |
||
) |
Perform fit of (valid) trajectory.
Optionally iterate for outlier down-weighting. Fit may fail due to singular or not positive definite matrices (internal exceptions 1-3).
[out] | Chi2 | Chi2 sum (corrected for down-weighting) |
[out] | Ndf | Number of degrees of freedom |
[out] | lostWeight | Sum of weights lost due to down-weighting |
[in] | optionList | Iterations for down-weighting (One character per iteration: t,h,c (or T,H,C) for Tukey, Huber or Cauchy function) |
[in] | aLabel | Label of point where to skip measurements (for unbiased residuals) |
Definition at line 1275 of file GblTrajectory.cc.
References buildLinearEquationSystem(), constructOK, gather_cfg::cout, downWeight(), MillePedeFileConverter_cfg::e, fitOK, mps_fire::i, gbl::InternalMeasurement, numParameters, predict(), skippedMeasLabel, gbl::BorderedBandMatrix::solveAndInvertBorderedBand(), AlCaHLTBitMon_QueryRunRegistry::string, theData, theMatrix, and theVector.
Referenced by trackingPlots.Iteration::modules().
|
private |
Get jacobian for transformation from (trajectory) fit to kink parameters at point.
Jacobian broken lines (q/p,..,u_i-1,u_i,u_i+1..) to kink (du') parameters.
[out] | anIndex | List of fit parameters with non zero derivatives |
[out] | aJacobian | Corresponding transformation matrix |
[in] | aPoint | Point to use |
Definition at line 691 of file GblTrajectory.cc.
References gbl::GblPoint::getDerivatives(), gbl::GblPoint::getOffset(), mps_fire::i, numCurvature, numLocals, and theDimension.
Referenced by prepare().
|
private |
Get (part of) jacobian for transformation from (trajectory) fit to track parameters at point.
Jacobian broken lines (q/p,..,u_i,u_i+1..) to local (q/p,u',u) parameters.
[out] | anIndex | List of fit parameters with non zero derivatives |
[out] | aJacobian | Corresponding transformation matrix |
[in] | aPoint | Point to use |
[in] | measDim | Dimension of 'measurement' (<=2: calculate only offset part, >2: complete matrix) |
[in] | nJacobian | Direction (0: to previous offset, 1: to next offset) |
Definition at line 596 of file GblTrajectory.cc.
References gbl::GblPoint::getDerivatives(), gbl::GblPoint::getOffset(), mps_fire::i, numCurvature, numLocals, Validation_hcalonly_cfi::sign, and theDimension.
Referenced by getJacobian(), and prepare().
|
private |
Get jacobian for transformation from fit to track parameters at point.
Jacobian broken lines (q/p,..,u_i,u_i+1..) to track (q/p,u',u) parameters including additional local parameters.
[in] | aSignedLabel | (Signed) label of point for external seed (<0: in front, >0: after point, slope changes at scatterer!) |
Definition at line 520 of file GblTrajectory.cc.
References funct::abs(), getFitToLocalJacobian(), mps_fire::i, numCurvature, numLocals, numPoints, numTrajectories, theDimension, and thePoints.
Referenced by getResults(), getScatResults(), and prepare().
unsigned int gbl::GblTrajectory::getLabels | ( | std::vector< unsigned int > & | aLabelList | ) |
Get (list of) labels of points on (simple) valid trajectory.
[out] | aLabelList | List of labels (aLabelList[i] = i+1) |
Definition at line 924 of file GblTrajectory.cc.
References constructOK, mps_fire::i, and thePoints.
unsigned int gbl::GblTrajectory::getLabels | ( | std::vector< std::vector< unsigned int > > & | aLabelList | ) |
Get (list of lists of) labels of points on (composed) valid trajectory.
[out] | aLabelList | List of of lists of labels |
Definition at line 942 of file GblTrajectory.cc.
References constructOK, mps_fire::i, numTrajectories, and thePoints.
unsigned int gbl::GblTrajectory::getMeasResults | ( | unsigned int | aLabel, |
unsigned int & | numRes, | ||
Eigen::VectorXd & | aResiduals, | ||
Eigen::VectorXd & | aMeasErrors, | ||
Eigen::VectorXd & | aResErrors, | ||
Eigen::VectorXd & | aDownWeights | ||
) |
Get residuals from fit at point for measurement.
Get (diagonalized) residual, error of measurement and residual and down-weighting factor for measurement at point
[in] | aLabel | Label of point on trajectory |
[out] | numData | Number of data blocks from measurement at point |
[out] | aResiduals | Measurements-Predictions |
[out] | aMeasErrors | Errors of Measurements |
[out] | aResErrors | Errors of Residuals (including correlations from track fit) |
[out] | aDownWeights | Down-Weighting factors |
Definition at line 772 of file GblTrajectory.cc.
References fitOK, getResAndErr(), mps_fire::i, measDataIndex, and skippedMeasLabel.
Referenced by getScatResults().
unsigned int gbl::GblTrajectory::getNumPoints | ( | ) | const |
Retrieve number of point from trajectory.
Definition at line 401 of file GblTrajectory.cc.
References numAllPoints.
|
private |
Get residual and errors from data block.
Get residual, error of measurement and residual and down-weighting factor for (single) data block
[in] | aData | Label of data block |
[in] | used | Flag for usage of data block in fit |
[out] | aResidual | Measurement-Prediction |
[out] | aMeasError | Error of Measurement |
[out] | aResError | Error of Residual (including correlations from track fit) |
[out] | aDownWeight | Down-Weighting factor |
Definition at line 970 of file GblTrajectory.cc.
References gbl::BorderedBandMatrix::getBlockMatrix(), mathSSE::sqrt(), theData, and theMatrix.
Referenced by getMeasResults(), and getScatResults().
unsigned int gbl::GblTrajectory::getResults | ( | int | aSignedLabel, |
Eigen::VectorXd & | localPar, | ||
Eigen::MatrixXd & | localCov | ||
) | const |
Get fit results at point.
Get corrections and covariance matrix for local track and additional parameters in forward or backward direction.
The point is identified by its label (1..number(points)), the sign distinguishes the backward (facing previous point) and forward 'side' (facing next point). For scatterers the track direction may change in between.
[in] | aSignedLabel | (Signed) label of point on trajectory (<0: in front, >0: after point, slope changes at scatterer!) |
[out] | localPar | Corrections for local parameters |
[out] | localCov | Covariance for local parameters |
Definition at line 741 of file GblTrajectory.cc.
References fitOK, gbl::BorderedBandMatrix::getBlockMatrix(), getJacobian(), mps_fire::i, theMatrix, and theVector.
Referenced by getScatResults().
unsigned int gbl::GblTrajectory::getScatResults | ( | unsigned int | aLabel, |
unsigned int & | numRes, | ||
Eigen::VectorXd & | aResiduals, | ||
Eigen::VectorXd & | aMeasErrors, | ||
Eigen::VectorXd & | aResErrors, | ||
Eigen::VectorXd & | aDownWeights | ||
) |
Get (kink) residuals from fit at point for scatterer.
Get (diagonalized) residual, error of measurement and residual and down-weighting factor for scatterering kinks at point
[in] | aLabel | Label of point on trajectory |
[out] | numData | Number of data blocks from scatterer at point |
[out] | aResiduals | (kink)Measurements-(kink)Predictions |
[out] | aMeasErrors | Errors of (kink)Measurements |
[out] | aResErrors | Errors of Residuals (including correlations from track fit) |
[out] | aDownWeights | Down-Weighting factors |
Definition at line 801 of file GblTrajectory.cc.
References fitOK, gbl::BorderedBandMatrix::getBlockMatrix(), getJacobian(), getMeasResults(), getResAndErr(), getResults(), mps_fire::i, measDataIndex, scatDataIndex, skippedMeasLabel, theMatrix, and theVector.
bool gbl::GblTrajectory::isValid | ( | void | ) | const |
Retrieve validity of trajectory.
Definition at line 396 of file GblTrajectory.cc.
References constructOK.
Referenced by ntupleDataFormat._Object::_checkIsValid(), and core.AutoHandle.AutoHandle::ReallyLoad().
void gbl::GblTrajectory::milleOut | ( | MilleBinary & | aMille | ) |
Write valid trajectory to Millepede-II binary file.
Definition at line 1329 of file GblTrajectory.cc.
References gbl::MilleBinary::addData(), constructOK, gbl::InternalMeasurement, maxNumGlobals, theData, thePoints, and gbl::MilleBinary::writeRecord().
Referenced by MillePedeAlignmentAlgorithm::addReferenceTrajectory().
|
private |
Calculate predictions for all points.
Definition at line 1242 of file GblTrajectory.cc.
References theData, and theVector.
Referenced by fit().
|
private |
Prepare fit for simple or composed trajectory.
Generate data (blocks) from measurements, kinks, external seed and measurements.
Definition at line 1021 of file GblTrajectory.cc.
References gbl::GblData::addDerivatives(), begin, externalDerivatives, gbl::ExternalMeasurement, externalMeasurements, externalPoint, externalPrecisions, gbl::ExternalSeed, externalSeed, getFitToKinkJacobian(), getFitToLocalJacobian(), getJacobian(), mps_fire::i, diffTreeTool::index, innerTransformations, gbl::InternalKink, gbl::InternalMeasurement, gen::k, hpstanc_transforms::max, maxNumGlobals, measDataIndex, eostools::move(), numAllPoints, numCurvature, numInnerTrans, numLocals, numMeasurements, numOffsets, numTrajectories, scatDataIndex, theData, theDimension, thePoints, and mitigatedMETSequence_cff::U.
Referenced by construct().
void gbl::GblTrajectory::printData | ( | ) |
Print GblData blocks for trajectory.
Definition at line 1446 of file GblTrajectory.cc.
References gather_cfg::cout, and theData.
void gbl::GblTrajectory::printPoints | ( | unsigned int | level = 0 | ) |
Print GblPoints on trajectory.
[in] | level | print level (0: minimum, >0: more) |
Definition at line 1434 of file GblTrajectory.cc.
References begin, gather_cfg::cout, numTrajectories, and thePoints.
void gbl::GblTrajectory::printTrajectory | ( | unsigned int | level = 0 | ) |
Print GblTrajectory.
[in] | level | print level (0: minimum, >0: more) |
Definition at line 1366 of file GblTrajectory.cc.
References constructOK, gather_cfg::cout, externalDerivatives, externalMeasurements, externalPoint, externalPrecisions, externalSeed, fitOK, mps_fire::i, innerTransformations, numAllPoints, numInnerTrans, numMeasurements, numOffsets, numParameters, gbl::VVector::print(), gbl::BorderedBandMatrix::printMatrix(), theDimension, theMatrix, and theVector.
|
private |
Trajectory has been successfully constructed (ready for fit/output)
Definition at line 127 of file GblTrajectory.h.
Referenced by construct(), fit(), getLabels(), isValid(), milleOut(), and printTrajectory().
|
private |
Definition at line 137 of file GblTrajectory.h.
Referenced by GblTrajectory(), prepare(), and printTrajectory().
|
private |
Definition at line 138 of file GblTrajectory.h.
Referenced by GblTrajectory(), prepare(), and printTrajectory().
|
private |
Label of external point (or 0)
Definition at line 124 of file GblTrajectory.h.
Referenced by GblTrajectory(), prepare(), and printTrajectory().
|
private |
Definition at line 139 of file GblTrajectory.h.
Referenced by GblTrajectory(), prepare(), and printTrajectory().
|
private |
Precision (inverse covariance matrix) of external seed.
Definition at line 134 of file GblTrajectory.h.
Referenced by GblTrajectory(), prepare(), and printTrajectory().
|
private |
Trajectory has been successfully fitted (results are valid)
Definition at line 128 of file GblTrajectory.h.
Referenced by construct(), fit(), getMeasResults(), getResults(), getScatResults(), and printTrajectory().
|
private |
Transformations at innermost points of.
Definition at line 135 of file GblTrajectory.h.
Referenced by GblTrajectory(), prepare(), and printTrajectory().
|
private |
Max. number of global labels/derivatives per point.
Definition at line 126 of file GblTrajectory.h.
Referenced by GblTrajectory(), milleOut(), and prepare().
|
private |
mapping points to data blocks from measurements
Definition at line 132 of file GblTrajectory.h.
Referenced by GblTrajectory(), getMeasResults(), getScatResults(), and prepare().
|
private |
Number of all points on trajectory.
Definition at line 115 of file GblTrajectory.h.
Referenced by construct(), GblTrajectory(), getNumPoints(), prepare(), and printTrajectory().
|
private |
Number of curvature parameters (0 or 1) or external parameters.
Definition at line 120 of file GblTrajectory.h.
Referenced by buildLinearEquationSystem(), construct(), GblTrajectory(), getFitToKinkJacobian(), getFitToLocalJacobian(), getJacobian(), and prepare().
|
private |
Number of inner transformations to external parameters.
Definition at line 119 of file GblTrajectory.h.
Referenced by construct(), GblTrajectory(), prepare(), and printTrajectory().
|
private |
Total number of (additional) local parameters.
Definition at line 122 of file GblTrajectory.h.
Referenced by buildLinearEquationSystem(), construct(), GblTrajectory(), getFitToKinkJacobian(), getFitToLocalJacobian(), getJacobian(), and prepare().
|
private |
Total number of measurements.
Definition at line 123 of file GblTrajectory.h.
Referenced by construct(), GblTrajectory(), prepare(), and printTrajectory().
|
private |
Number of (points with) offsets on trajectory.
Definition at line 118 of file GblTrajectory.h.
Referenced by construct(), defineOffsets(), GblTrajectory(), prepare(), and printTrajectory().
|
private |
Number of fit parameters.
Definition at line 121 of file GblTrajectory.h.
Referenced by buildLinearEquationSystem(), construct(), fit(), GblTrajectory(), and printTrajectory().
|
private |
Number of points on (sub)trajectory.
Definition at line 116 of file GblTrajectory.h.
Referenced by GblTrajectory(), and getJacobian().
|
private |
Number of trajectories (in composed trajectory)
Definition at line 117 of file GblTrajectory.h.
Referenced by calcJacobians(), construct(), defineOffsets(), getJacobian(), getLabels(), prepare(), and printPoints().
|
private |
mapping points to data blocks from scatterers
Definition at line 133 of file GblTrajectory.h.
Referenced by GblTrajectory(), getScatResults(), and prepare().
|
private |
Label of point with measurements skipped in fit (for unbiased residuals) (or 0)
Definition at line 125 of file GblTrajectory.h.
Referenced by buildLinearEquationSystem(), fit(), GblTrajectory(), getMeasResults(), and getScatResults().
|
private |
List of data blocks.
Definition at line 131 of file GblTrajectory.h.
Referenced by buildLinearEquationSystem(), downWeight(), fit(), GblTrajectory(), getResAndErr(), milleOut(), predict(), prepare(), and printData().
|
private |
List of active dimensions (0=u1, 1=u2) in fit.
Definition at line 129 of file GblTrajectory.h.
Referenced by construct(), GblTrajectory(), getFitToKinkJacobian(), getFitToLocalJacobian(), getJacobian(), prepare(), and printTrajectory().
|
private |
(Bordered band) matrix of linear equation system
Definition at line 141 of file GblTrajectory.h.
Referenced by buildLinearEquationSystem(), fit(), getResAndErr(), getResults(), getScatResults(), and printTrajectory().
|
private |
(list of) List of points on trajectory
Definition at line 130 of file GblTrajectory.h.
Referenced by calcJacobians(), construct(), defineOffsets(), GblTrajectory(), getJacobian(), getLabels(), milleOut(), prepare(), and printPoints().
|
private |
Vector of linear equation system.
Definition at line 140 of file GblTrajectory.h.
Referenced by buildLinearEquationSystem(), fit(), getResults(), getScatResults(), predict(), and printTrajectory().