Hall-D Software  alpha
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Groups Pages
DTrackFitterALT1 Class Reference

More...

#include <DTrackFitterALT1.h>

+ Inheritance diagram for DTrackFitterALT1:

Classes

class  hitInfo
 
class  resiInfo
 

Public Types

typedef
DReferenceTrajectory::swim_step_t 
swim_step_t
 
enum  fit_type_t { kWireBased, kTimeBased }
 
enum  fit_status_t { kFitNotDone, kFitSuccess, kFitFailed, kFitNoImprovement }
 

Public Member Functions

 DTrackFitterALT1 (JEventLoop *loop)
 
 ~DTrackFitterALT1 ()
 
string Name (void) const
 
fit_status_t FitTrack (void)
 
 JOBJECT_PUBLIC (DTrackFitter)
 
void Reset (void)
 
void AddHit (const DCDCTrackHit *cdchit)
 
void AddHit (const DFDCPseudo *fdchit)
 
void AddHits (vector< const DCDCTrackHit * > cdchits)
 
void AddHits (vector< const DFDCPseudo * > fdchits)
 
const vector< const
DCDCTrackHit * > & 
GetCDCInputHits (void) const
 
const vector< const DFDCPseudo * > & GetFDCInputHits (void) const
 
const vector< const
DCDCTrackHit * > & 
GetCDCFitHits (void) const
 
const vector< const DFDCPseudo * > & GetFDCFitHits (void) const
 
void ClearExtrapolations (void)
 
const DKinematicDataGetInputParameters (void) const
 
const DTrackingDataGetFitParameters (void) const
 
double GetChisq (void) const
 
int GetNdof (void) const
 
unsigned int GetNumPotentialFDCHits (void) const
 
unsigned int GetNumPotentialCDCHits (void) const
 
bool GetIsSmoothed (void) const
 
vector< pull_t > & GetPulls (void)
 
const map< DetectorSystem_t,
vector< Extrapolation_t > > & 
GetExtrapolations (void) const
 
fit_type_t GetFitType (void) const
 
const DMagneticFieldMapGetDMagneticFieldMap (void) const
 
void SetFitType (fit_type_t type)
 
void SetInputParameters (const DTrackingData &starting_params)
 
fit_status_t FitTrack (const DVector3 &pos, const DVector3 &mom, double q, double mass, double t0=QuietNaN, DetectorSystem_t t0_det=SYS_NULL)
 
fit_status_t FitTrack (const DTrackingData &starting_params)
 
fit_status_t FindHitsAndFitTrack (const DKinematicData &starting_params, const DReferenceTrajectory *rt, JEventLoop *loop, double mass=-1.0, int N=0, double t0=QuietNaN, DetectorSystem_t t0_det=SYS_NULL)
 mass<0 means get it from starting_params More...
 
fit_status_t FindHitsAndFitTrack (const DKinematicData &starting_params, const map< DetectorSystem_t, vector< DTrackFitter::Extrapolation_t > > &extrapolations, JEventLoop *loop, double mass, int N, double t0, DetectorSystem_t t0_det)
 
jerror_t CorrectForELoss (const DKinematicData &starting_params, DReferenceTrajectory *rt, DVector3 &pos, DVector3 &mom, double mass)
 
double CalcDensityEffect (double p, double mass, double density, double Z_over_A, double I)
 
double CalcDensityEffect (double p, double mass, double rho_Z_over_A, double LnI)
 
double CalcDensityEffect (double betagamma, double rho_Z_over_A, double LnI)
 
bool ExtrapolateToRadius (double R, const vector< Extrapolation_t > &extraps, DVector3 &pos, DVector3 &mom, double &t, double &s) const
 
bool ExtrapolateToRadius (double R, const vector< Extrapolation_t > &extraps, DVector3 &pos) const
 
double DistToWire (const DCoordinateSystem *wire, const vector< Extrapolation_t > &extrapolations, DVector3 *pos=NULL, DVector3 *mom=NULL, DVector3 *position_along_wire=NULL) const
 

Protected Attributes

vector< const DCDCTrackHit * > cdchits
 
vector< const DFDCPseudo * > fdchits
 
DTrackingData input_params
 
fit_type_t fit_type
 
const DMagneticFieldMapbfield
 
const DGeometrygeom
 
const DRootGeomRootGeom
 
JEventLoop * loop
 
DTrackingData fit_params
 
double chisq
 
int Ndof
 
vector< pull_tpulls
 
map< DetectorSystem_t, vector
< Extrapolation_t > > 
extrapolations
 
fit_status_t fit_status
 
vector< const DCDCTrackHit * > cdchits_used_in_fit
 
vector< const DFDCPseudo * > fdchits_used_in_fit
 
bool IsSmoothed
 
unsigned int potential_fdc_hits_on_track
 
unsigned int potential_cdc_hits_on_track
 
bool CORRECT_FOR_ELOSS
 

Private Types

enum  state_types {
  state_px, state_py, state_pz, state_x,
  state_v
}
 
enum  resi_types { resi_type_cdc_anode, resi_type_fdc_anode, resi_type_fdc_cathode, resi_type_other }
 
typedef vector< hitInfohitsInfo
 

Private Member Functions

double ChiSq (fit_type_t fit_type, DReferenceTrajectory *rt, double *chisq_ptr=NULL, int *dof_ptr=NULL, vector< pull_t > *pulls_ptr=NULL)
 
double ChiSq (vector< resiInfo > &residuals, double *chisq_ptr=NULL, int *dof_ptr=NULL)
 
void GetHits (fit_type_t fit_type, DReferenceTrajectory *rt, hitsInfo &hinfo)
 
vector< bool > GetResiInfo (DMatrix &state, const swim_step_t *start_step, DReferenceTrajectory *rt, hitsInfo &hinfo, vector< resiInfo > &residuals)
 
vector< bool > GetResiInfo (DReferenceTrajectory *rt, hitsInfo &hinfo, vector< resiInfo > &residuals)
 
fit_status_t LeastSquaresB (hitsInfo &hinfo, DReferenceTrajectory *rt)
 
void FilterGood (DMatrix &my_resiv, vector< bool > &my_good, vector< bool > &good_all)
 
void PrintChisqElements (DMatrix &resiv, DMatrix &cov_meas, DMatrix &cov_muls, DMatrix &weights)
 
void ForceLRTruth (JEventLoop *loop, DReferenceTrajectory *rt, hitsInfo &hinfo)
 
void FillDebugHists (DReferenceTrajectory *rt, DVector3 &vertex_pos, DVector3 &vertex_mom)
 

Private Attributes

DMatrix resiv
 residuals vector (Nmeasurements x 1) More...
 
DMatrix cov_meas
 Measurement errors of hits (diagonal Nmeasurements x Nmeasurements) More...
 
DMatrix cov_muls
 Covariance of hits due to multiple scattering (Nmeasurements x Nmeasurements) More...
 
DMatrix weights
 Inverse of cov_meas + cov_muls. More...
 
DMatrix cov_parm
 Covariance of fit parameters (Nparms x Nparms (where Nparms=5)) More...
 
DCoordinateSystemtarget
 
uint64_t eventnumber
 
vector< DReferenceTrajectory * > rtv
 
DReferenceTrajectoryrt
 
DReferenceTrajectorytmprt
 
bool DEBUG_HISTS
 
int DEBUG_LEVEL
 
double MAX_CHISQ_DIFF
 
int MAX_FIT_ITERATIONS
 
double SIGMA_CDC
 
bool CDC_USE_PARAMETERIZED_SIGMA
 
double SIGMA_FDC_ANODE
 
double SIGMA_FDC_CATHODE
 
double CHISQ_GOOD_LIMIT
 
double LEAST_SQUARES_DP
 
double LEAST_SQUARES_DX
 
unsigned int LEAST_SQUARES_MIN_HITS
 
double LEAST_SQUARES_MAX_E2NORM
 
double DEFAULT_MASS
 
bool TARGET_CONSTRAINT
 
bool LR_FORCE_TRUTH
 
bool USE_MULS_COVARIANCE
 
bool USE_FDC
 
bool USE_FDC_CATHODE
 
bool USE_CDC
 
string MATERIAL_MAP_MODEL
 
TH3F * cdcdoca_vs_dist_vs_ring
 
TH2F * cdcdoca_vs_dist
 
TH2F * fdcdoca_vs_dist
 
TH2F * fdcu_vs_s
 
TH1F * dist_stereo
 
TH1F * dist_axial
 
TH1F * doca_stereo
 
TH1F * doca_axial
 
TH2F * chisq_final_vs_initial
 
TH2F * nhits_final_vs_initial
 
TH1F * Npasses
 
TH1F * ptotal
 
TH2F * residuals_cdc
 
TH2F * residuals_fdc_anode
 
TH2F * residuals_fdc_cathode
 
TH2F * initial_chisq_vs_Npasses
 
TH2F * chisq_vs_pass
 
TH2F * dchisq_vs_pass
 
TH3F * residuals_cdc_vs_s
 
TH3F * residuals_fdc_anode_vs_s
 
TH3F * residuals_fdc_cathode_vs_s
 
TH1F * cdc_single_hit_prob
 
TH1F * cdc_double_hit_prob
 
TH1F * fdc_single_hit_prob
 
TH1F * fdc_double_hit_prob
 
TH1F * cdc_can_resi
 
TH1F * fdc_can_resi
 
TH1F * fdc_can_resi_cath
 
TH2F * chisq_vs_p_vs_theta
 
TH1F * lambda
 

Detailed Description

A global least-squares track fitter. This has been superceded by the DTrackFitterKalmanSIMD class.

Definition at line 41 of file DTrackFitterALT1.h.

Member Typedef Documentation

typedef vector<hitInfo> DTrackFitterALT1::hitsInfo
private

Definition at line 80 of file DTrackFitterALT1.h.

Member Enumeration Documentation

Enumerator
kFitNotDone 
kFitSuccess 
kFitFailed 
kFitNoImprovement 

Definition at line 70 of file DTrackFitter.h.

enum DTrackFitter::fit_type_t
inherited
Enumerator
kWireBased 
kTimeBased 

Definition at line 65 of file DTrackFitter.h.

Enumerator
resi_type_cdc_anode 
resi_type_fdc_anode 
resi_type_fdc_cathode 
resi_type_other 

Definition at line 61 of file DTrackFitterALT1.h.

Enumerator
state_px 

x-momentum in RT coordinate system in GeV/c

state_py 

y-momentum in RT coordinate system in GeV/c

state_pz 

z-momentum in RT coordinate system in GeV/c

state_x 

x-coordinate in RT coordinate system in cm

state_v 

position-coordinate in RT coordinate system in cm perpendicular to x both and momentum direction

Definition at line 53 of file DTrackFitterALT1.h.

Constructor & Destructor Documentation

DTrackFitterALT1::~DTrackFitterALT1 ( )

Definition at line 217 of file DTrackFitterALT1.cc.

References rt, target, and tmprt.

Member Function Documentation

void DTrackFitter::AddHit ( const DFDCPseudo fdchit)
inherited

Definition at line 138 of file DTrackFitter.cc.

void DTrackFitter::AddHits ( vector< const DFDCPseudo * >  fdchits)
inherited

Definition at line 147 of file DTrackFitter.cc.

double DTrackFitter::CalcDensityEffect ( double  p,
double  mass,
double  density,
double  Z_over_A,
double  I 
)
inherited

Definition at line 412 of file DTrackFitter.cc.

Referenced by DTrackFitterKalmanSIMD::GetdEdx().

double DTrackFitter::CalcDensityEffect ( double  p,
double  mass,
double  rho_Z_over_A,
double  LnI 
)
inherited

Definition at line 422 of file DTrackFitter.cc.

double DTrackFitter::CalcDensityEffect ( double  betagamma,
double  rho_Z_over_A,
double  LnI 
)
inherited

Definition at line 430 of file DTrackFitter.cc.

References e, sqrt(), X, and X0.

double DTrackFitterALT1::ChiSq ( fit_type_t  fit_type,
DReferenceTrajectory rt,
double *  chisq_ptr = NULL,
int *  dof_ptr = NULL,
vector< pull_t > *  pulls_ptr = NULL 
)
privatevirtual

Calculate the chisq for the given reference trajectory based on the hits currently registered through the DTrackFitter base class into the cdchits and fdchits vectors. This does not get called by the core part of the fitter, but is used, rather, to give an "independent" value of the chisq based only on a reference trajectory and the input hits. It is called after the fit to calculate the final chisq.

Implements DTrackFitter.

Definition at line 443 of file DTrackFitterALT1.cc.

References ForceLRTruth(), GetHits(), GetResiInfo(), DTrackFitter::kTimeBased, DTrackFitter::loop, LR_FORCE_TRUTH, and DTrackFitter::pulls.

Referenced by FitTrack(), and LeastSquaresB().

double DTrackFitter::DistToWire ( const DCoordinateSystem wire,
const vector< Extrapolation_t > &  extrapolations,
DVector3 pos = NULL,
DVector3 mom = NULL,
DVector3 position_along_wire = NULL 
) const
inherited
bool DTrackFitter::ExtrapolateToRadius ( double  R,
const vector< Extrapolation_t > &  extraps,
DVector3 pos 
) const
inherited

Definition at line 527 of file DTrackFitter.cc.

void DTrackFitterALT1::FilterGood ( DMatrix my_resiv,
vector< bool > &  my_good,
vector< bool > &  good_all 
)
private

Remove elements from my_resiv that are not "good" according to the good_all list. The my_good and good_all vectors should be the same size. The number of "true" entries in my_good should be the size of the my_resiv vector. For entries in the my_good vector that are true, but have an entry in good_all that is false, the corresponding entry in my_resiv will be removed. The my_resiv matrix (which should be N x 1) will be resized upon exit. The my_good vector will be set equal to good_all upon exit also so that my_resiv and my_good stay in sync.

Definition at line 1279 of file DTrackFitterALT1.cc.

References Ncols.

Referenced by LeastSquaresB().

DTrackFitter::fit_status_t DTrackFitter::FindHitsAndFitTrack ( const DKinematicData starting_params,
const DReferenceTrajectory rt,
JEventLoop *  loop,
double  mass = -1.0,
int  N = 0,
double  t0 = QuietNaN,
DetectorSystem_t  t0_det = SYS_NULL 
)
inherited

mass<0 means get it from starting_params

Fit a DTrackCandidate using a given mass hypothesis.

This will perform a full wire-based and time-based fit using the given mass and starting from the given candidate. The given DReferenceTrajectory is used to swim the track numerous times during the various stages but will be left with the final time-based fit result. The JEventLoop given will be used to get the hits (CDC and FDC) and default DTrackHitSelector to use for the fit.

Definition at line 271 of file DTrackFitter.cc.

References _DBG_, DKinematicData::charge(), DTrackHitSelector::GetAllHits(), IDTrack(), DTrackHitSelector::kHelical, DTrackHitSelector::kWireBased, DKinematicData::mass(), DKinematicData::momentum(), DKinematicData::position(), start_time, and prof_time::TimeDiffNow().

Referenced by DTrackTimeBased_factory::AddMissingTrackHypothesis(), DTrackWireBased_factory::DoFit(), and DTrackTimeBased_factory::DoFit().

DTrackFitter::fit_status_t DTrackFitter::FindHitsAndFitTrack ( const DKinematicData starting_params,
const map< DetectorSystem_t, vector< DTrackFitter::Extrapolation_t > > &  extrapolations,
JEventLoop *  loop,
double  mass,
int  N,
double  t0,
DetectorSystem_t  t0_det 
)
inherited
DTrackFitter::fit_status_t DTrackFitterALT1::FitTrack ( void  )
virtual

Fit a track candidate

Implements DTrackFitter.

Definition at line 227 of file DTrackFitterALT1.cc.

References _DBG_, DTrackFitter::cdchits, DTrackFitter::cdchits_used_in_fit, DKinematicData::charge(), ChiSq(), DTrackFitter::chisq, CHISQ_GOOD_LIMIT, chisq_vs_pass, dchisq_vs_pass, DEBUG_HISTS, DEBUG_LEVEL, DReferenceTrajectory::DistToRT(), eventnumber, DTrackFitter::fdchits, DTrackFitter::fdchits_used_in_fit, FillDebugHists(), DReferenceTrajectory::FindClosestSwimStep(), DTrackFitter::fit_params, DTrackFitter::fit_status, DTrackFitter::fit_type, ForceLRTruth(), GetHits(), DReferenceTrajectory::GetLastDOCAPoint(), IDTrack(), initial_chisq_vs_Npasses, DTrackFitter::input_params, DReferenceTrajectory::kBackward, DTrackFitter::kFitFailed, DTrackFitter::kFitNoImprovement, DTrackFitter::kFitNotDone, DTrackFitter::kFitSuccess, DReferenceTrajectory::kForward, DTrackFitter::kTimeBased, DTrackFitter::kWireBased, LeastSquaresB(), DTrackFitter::loop, LR_FORCE_TRUTH, DKinematicData::mass(), MAX_CHISQ_DIFF, MAX_FIT_ITERATIONS, DReferenceTrajectory::swim_step_t::mom, DKinematicData::momentum(), DTrackFitter::Ndof, Npasses, DReferenceTrajectory::Nswim_steps, DCoordinateSystem::origin, DKinematicData::position(), DReferenceTrajectory::q, rt, DReferenceTrajectory::swim_step_t::s, DReferenceTrajectory::SetCheckMaterialBoundaries(), DReferenceTrajectory::SetMass(), DKinematicData::setMomentum(), DKinematicData::setPID(), DReferenceTrajectory::SetPLossDirection(), DKinematicData::setPosition(), DReferenceTrajectory::Swim(), DReferenceTrajectory::swim_steps, target, and tmprt.

DTrackFitter::fit_status_t DTrackFitter::FitTrack ( const DVector3 pos,
const DVector3 mom,
double  q,
double  mass,
double  t0 = QuietNaN,
DetectorSystem_t  t0_det = SYS_NULL 
)
inherited
DTrackFitter::fit_status_t DTrackFitter::FitTrack ( const DTrackingData starting_params)
inherited

Definition at line 179 of file DTrackFitter.cc.

References start_time, and prof_time::TimeDiffNow().

void DTrackFitterALT1::ForceLRTruth ( JEventLoop *  loop,
DReferenceTrajectory rt,
hitsInfo hinfo 
)
private

This routine is called when the TRKFIT:LR_FORCE_TRUTH parameters is set to a non-zero value (e.g. -PTRKFIT:LR_FORCE_TRUTH=1 is passed on the command line). This is used only for debugging and only with Monte Carlo data.

This routine will adjust the left-right choice of each hit based on the current fit track (represented by rt), and the truth information contained in the the DMCTruthPoint objects. It assumes the hits in hinfo correspond to the track represented by rt.

Definition at line 1341 of file DTrackFitterALT1.cc.

References _DBG_, DEBUG_LEVEL, DTrackFitterALT1::hitInfo::dist, DReferenceTrajectory::DistToRT(), DTrackFitterALT1::hitInfo::err, DReferenceTrajectory::GetLastDistAlongWire(), DReferenceTrajectory::GetLastDOCAPoint(), DTrackHitSelectorTHROWN::GetMCTrackHit(), DCoordinateSystem::origin, DMCTrackHit::phi, DMCTrackHit::r, sin(), target, u, DTrackFitterALT1::hitInfo::u_err, DCoordinateSystem::udir, DTrackFitterALT1::hitInfo::wire, and DMCTrackHit::z.

Referenced by ChiSq(), and FitTrack().

const vector<const DCDCTrackHit*>& DTrackFitter::GetCDCInputHits ( void  ) const
inlineinherited

Definition at line 137 of file DTrackFitter.h.

const DMagneticFieldMap* DTrackFitter::GetDMagneticFieldMap ( void  ) const
inlineinherited
const vector<const DFDCPseudo*>& DTrackFitter::GetFDCInputHits ( void  ) const
inlineinherited

Definition at line 138 of file DTrackFitter.h.

fit_type_t DTrackFitter::GetFitType ( void  ) const
inlineinherited

Definition at line 167 of file DTrackFitter.h.

const DKinematicData& DTrackFitter::GetInputParameters ( void  ) const
inlineinherited

Definition at line 152 of file DTrackFitter.h.

unsigned int DTrackFitter::GetNumPotentialCDCHits ( void  ) const
inlineinherited
unsigned int DTrackFitter::GetNumPotentialFDCHits ( void  ) const
inlineinherited
vector< bool > DTrackFitterALT1::GetResiInfo ( DMatrix state,
const swim_step_t start_step,
DReferenceTrajectory rt,
hitsInfo hinfo,
vector< resiInfo > &  residuals 
)
private

Calculate the chi-squared for a track specified by state relative to the given reference trajectory. This is just a wrapper for ChiSq(DReferenceTrajectory rt, vector<const DCoordinateSystem> &wires, vector<DVector3> &shifts, vector<double> &errs, vector<double> &chisqv) that accepts the state vector and re-swims the trajectory.

Definition at line 771 of file DTrackFitterALT1.cc.

References _DBG_, DEBUG_LEVEL, DReferenceTrajectory::swim_step_t::mom, DReferenceTrajectory::Nswim_steps, DCoordinateSystem::origin, DCoordinateSystem::sdir, state_px, state_py, state_pz, state_v, state_x, DReferenceTrajectory::Swim(), DCoordinateSystem::tdir, and DCoordinateSystem::udir.

Referenced by ChiSq(), and LeastSquaresB().

DTrackFitter::JOBJECT_PUBLIC ( DTrackFitter  )
inherited
DTrackFitterALT1::fit_status_t DTrackFitterALT1::LeastSquaresB ( hitsInfo hinfo,
DReferenceTrajectory rt 
)
private

Fit the track with starting parameters given in the first step of the reference trajectory rt. On return, the reference trajectory rt will represent the final fit parameters and chisq, Ndof, resiv, cov_meas, cov_muls, and cov_parm will be filled based on the fit results.

This determines the best fit of the track using the least squares method described by R. Mankel Rep. Prog. Phys. 67 (2004) 553-622 pg 565. Since it uses a linear approximation for the chisq dependance on the fit parameters, several calls may be required for convergence.

Definition at line 908 of file DTrackFitterALT1.cc.

References _DBG_, ChiSq(), DTrackFitter::chisq, cov_meas, cov_muls, cov_parm, DEBUG_HISTS, DEBUG_LEVEL, F, FilterGood(), GetResiInfo(), DTrackFitter::kFitFailed, DTrackFitter::kFitNoImprovement, DTrackFitter::kFitSuccess, lambda, LEAST_SQUARES_DP, LEAST_SQUARES_DX, LEAST_SQUARES_MAX_E2NORM, LEAST_SQUARES_MIN_HITS, DReferenceTrajectory::swim_step_t::mom, DTrackFitter::Ndof, DReferenceTrajectory::Nswim_steps, DCoordinateSystem::origin, DReferenceTrajectory::q, resiv, DCoordinateSystem::sdir, sqrt(), state_px, state_py, state_pz, state_v, state_x, DReferenceTrajectory::swim_steps, DCoordinateSystem::tdir, tmprt, DCoordinateSystem::udir, and weights.

Referenced by FitTrack().

string DTrackFitterALT1::Name ( void  ) const
inlinevirtual

Implements DTrackFitter.

Definition at line 49 of file DTrackFitterALT1.h.

References string.

void DTrackFitterALT1::PrintChisqElements ( DMatrix resiv,
DMatrix cov_meas,
DMatrix cov_muls,
DMatrix weights 
)
private

This is for debugging only.

Definition at line 1317 of file DTrackFitterALT1.cc.

References _DBG_, DTrackFitter::Ndof, and sqrt().

Referenced by ChiSq().

void DTrackFitter::SetInputParameters ( const DTrackingData starting_params)
inlineinherited

Definition at line 171 of file DTrackFitter.h.

Member Data Documentation

TH1F* DTrackFitterALT1::cdc_can_resi
private

Definition at line 157 of file DTrackFitterALT1.h.

Referenced by DTrackFitterALT1().

TH1F * DTrackFitterALT1::cdc_double_hit_prob
private

Definition at line 155 of file DTrackFitterALT1.h.

Referenced by DTrackFitterALT1().

TH1F* DTrackFitterALT1::cdc_single_hit_prob
private

Definition at line 155 of file DTrackFitterALT1.h.

Referenced by DTrackFitterALT1().

bool DTrackFitterALT1::CDC_USE_PARAMETERIZED_SIGMA
private

Definition at line 126 of file DTrackFitterALT1.h.

Referenced by DTrackFitterALT1(), and GetHits().

TH2F* DTrackFitterALT1::cdcdoca_vs_dist
private

Definition at line 144 of file DTrackFitterALT1.h.

Referenced by DTrackFitterALT1(), and FillDebugHists().

TH3F* DTrackFitterALT1::cdcdoca_vs_dist_vs_ring
private

Definition at line 143 of file DTrackFitterALT1.h.

Referenced by DTrackFitterALT1(), and FillDebugHists().

TH2F* DTrackFitterALT1::chisq_final_vs_initial
private

Definition at line 148 of file DTrackFitterALT1.h.

Referenced by DTrackFitterALT1().

double DTrackFitterALT1::CHISQ_GOOD_LIMIT
private

Definition at line 129 of file DTrackFitterALT1.h.

Referenced by DTrackFitterALT1(), and FitTrack().

TH2F* DTrackFitterALT1::chisq_vs_p_vs_theta
private

Definition at line 158 of file DTrackFitterALT1.h.

Referenced by DTrackFitterALT1().

TH2F * DTrackFitterALT1::chisq_vs_pass
private

Definition at line 153 of file DTrackFitterALT1.h.

Referenced by DTrackFitterALT1(), and FitTrack().

DMatrix DTrackFitterALT1::cov_meas
private

Measurement errors of hits (diagonal Nmeasurements x Nmeasurements)

Definition at line 106 of file DTrackFitterALT1.h.

Referenced by ChiSq(), and LeastSquaresB().

DMatrix DTrackFitterALT1::cov_muls
private

Covariance of hits due to multiple scattering (Nmeasurements x Nmeasurements)

Definition at line 107 of file DTrackFitterALT1.h.

Referenced by ChiSq(), and LeastSquaresB().

DMatrix DTrackFitterALT1::cov_parm
private

Covariance of fit parameters (Nparms x Nparms (where Nparms=5))

Definition at line 111 of file DTrackFitterALT1.h.

Referenced by LeastSquaresB().

TH2F * DTrackFitterALT1::dchisq_vs_pass
private

Definition at line 153 of file DTrackFitterALT1.h.

Referenced by DTrackFitterALT1(), and FitTrack().

bool DTrackFitterALT1::DEBUG_HISTS
private

Definition at line 121 of file DTrackFitterALT1.h.

Referenced by DTrackFitterALT1(), FitTrack(), and LeastSquaresB().

int DTrackFitterALT1::DEBUG_LEVEL
private
double DTrackFitterALT1::DEFAULT_MASS
private

Definition at line 134 of file DTrackFitterALT1.h.

Referenced by DTrackFitterALT1().

TH1F * DTrackFitterALT1::dist_axial
private

Definition at line 146 of file DTrackFitterALT1.h.

Referenced by DTrackFitterALT1(), and FillDebugHists().

TH1F* DTrackFitterALT1::dist_stereo
private

Definition at line 146 of file DTrackFitterALT1.h.

Referenced by DTrackFitterALT1(), and FillDebugHists().

TH1F * DTrackFitterALT1::doca_axial
private

Definition at line 147 of file DTrackFitterALT1.h.

Referenced by DTrackFitterALT1(), and FillDebugHists().

TH1F* DTrackFitterALT1::doca_stereo
private

Definition at line 147 of file DTrackFitterALT1.h.

Referenced by DTrackFitterALT1(), and FillDebugHists().

uint64_t DTrackFitterALT1::eventnumber
private

Definition at line 116 of file DTrackFitterALT1.h.

Referenced by FitTrack().

TH1F * DTrackFitterALT1::fdc_can_resi
private

Definition at line 157 of file DTrackFitterALT1.h.

Referenced by DTrackFitterALT1().

TH1F * DTrackFitterALT1::fdc_can_resi_cath
private

Definition at line 157 of file DTrackFitterALT1.h.

Referenced by DTrackFitterALT1().

TH1F * DTrackFitterALT1::fdc_double_hit_prob
private

Definition at line 156 of file DTrackFitterALT1.h.

Referenced by DTrackFitterALT1().

TH1F* DTrackFitterALT1::fdc_single_hit_prob
private

Definition at line 156 of file DTrackFitterALT1.h.

Referenced by DTrackFitterALT1().

TH2F* DTrackFitterALT1::fdcdoca_vs_dist
private

Definition at line 145 of file DTrackFitterALT1.h.

Referenced by DTrackFitterALT1(), and FillDebugHists().

vector<const DFDCPseudo*> DTrackFitter::fdchits_used_in_fit
protectedinherited
TH2F * DTrackFitterALT1::fdcu_vs_s
private

Definition at line 145 of file DTrackFitterALT1.h.

Referenced by DTrackFitterALT1(), and FillDebugHists().

fit_status_t DTrackFitter::fit_status
protectedinherited
TH2F* DTrackFitterALT1::initial_chisq_vs_Npasses
private

Definition at line 153 of file DTrackFitterALT1.h.

Referenced by DTrackFitterALT1(), and FitTrack().

TH1F* DTrackFitterALT1::lambda
private

Definition at line 159 of file DTrackFitterALT1.h.

Referenced by DTrackFitterALT1(), and LeastSquaresB().

double DTrackFitterALT1::LEAST_SQUARES_DP
private

Definition at line 130 of file DTrackFitterALT1.h.

Referenced by DTrackFitterALT1(), and LeastSquaresB().

double DTrackFitterALT1::LEAST_SQUARES_DX
private

Definition at line 131 of file DTrackFitterALT1.h.

Referenced by DTrackFitterALT1(), and LeastSquaresB().

double DTrackFitterALT1::LEAST_SQUARES_MAX_E2NORM
private

Definition at line 133 of file DTrackFitterALT1.h.

Referenced by DTrackFitterALT1(), and LeastSquaresB().

unsigned int DTrackFitterALT1::LEAST_SQUARES_MIN_HITS
private

Definition at line 132 of file DTrackFitterALT1.h.

Referenced by DTrackFitterALT1(), and LeastSquaresB().

JEventLoop* DTrackFitter::loop
protectedinherited

Definition at line 231 of file DTrackFitter.h.

Referenced by ChiSq(), DTrackFitterALT1(), FitTrack(), and DTrackLSFitter::FitTrack().

bool DTrackFitterALT1::LR_FORCE_TRUTH
private

Definition at line 136 of file DTrackFitterALT1.h.

Referenced by ChiSq(), DTrackFitterALT1(), and FitTrack().

string DTrackFitterALT1::MATERIAL_MAP_MODEL
private

Definition at line 141 of file DTrackFitterALT1.h.

Referenced by DTrackFitterALT1().

double DTrackFitterALT1::MAX_CHISQ_DIFF
private

Definition at line 123 of file DTrackFitterALT1.h.

Referenced by DTrackFitterALT1(), and FitTrack().

int DTrackFitterALT1::MAX_FIT_ITERATIONS
private

Definition at line 124 of file DTrackFitterALT1.h.

Referenced by DTrackFitterALT1(), and FitTrack().

TH2F* DTrackFitterALT1::nhits_final_vs_initial
private

Definition at line 149 of file DTrackFitterALT1.h.

Referenced by DTrackFitterALT1().

TH1F* DTrackFitterALT1::Npasses
private

Definition at line 150 of file DTrackFitterALT1.h.

Referenced by DTrackFitterALT1(), and FitTrack().

unsigned int DTrackFitter::potential_cdc_hits_on_track
protectedinherited

Definition at line 247 of file DTrackFitter.h.

Referenced by DTrackFitterKalmanSIMD::FitTrack().

unsigned int DTrackFitter::potential_fdc_hits_on_track
protectedinherited

Definition at line 246 of file DTrackFitter.h.

Referenced by DTrackFitterKalmanSIMD::FitTrack().

TH1F* DTrackFitterALT1::ptotal
private

Definition at line 151 of file DTrackFitterALT1.h.

Referenced by DTrackFitterALT1(), and FillDebugHists().

TH2F* DTrackFitterALT1::residuals_cdc
private

Definition at line 152 of file DTrackFitterALT1.h.

Referenced by DTrackFitterALT1(), and FillDebugHists().

TH3F* DTrackFitterALT1::residuals_cdc_vs_s
private

Definition at line 154 of file DTrackFitterALT1.h.

Referenced by DTrackFitterALT1(), and FillDebugHists().

TH2F * DTrackFitterALT1::residuals_fdc_anode
private

Definition at line 152 of file DTrackFitterALT1.h.

Referenced by DTrackFitterALT1(), and FillDebugHists().

TH3F * DTrackFitterALT1::residuals_fdc_anode_vs_s
private

Definition at line 154 of file DTrackFitterALT1.h.

Referenced by DTrackFitterALT1(), and FillDebugHists().

TH2F * DTrackFitterALT1::residuals_fdc_cathode
private

Definition at line 152 of file DTrackFitterALT1.h.

Referenced by DTrackFitterALT1(), and FillDebugHists().

TH3F * DTrackFitterALT1::residuals_fdc_cathode_vs_s
private

Definition at line 154 of file DTrackFitterALT1.h.

Referenced by DTrackFitterALT1(), and FillDebugHists().

DMatrix DTrackFitterALT1::resiv
private

residuals vector (Nmeasurements x 1)

Definition at line 105 of file DTrackFitterALT1.h.

Referenced by ChiSq(), and LeastSquaresB().

const DRootGeom* DTrackFitter::RootGeom
protectedinherited

Definition at line 230 of file DTrackFitter.h.

Referenced by DTrackFitterALT1().

DReferenceTrajectory* DTrackFitterALT1::rt
private

Definition at line 119 of file DTrackFitterALT1.h.

Referenced by DTrackFitterALT1(), FitTrack(), and ~DTrackFitterALT1().

vector<DReferenceTrajectory*> DTrackFitterALT1::rtv
private

Definition at line 118 of file DTrackFitterALT1.h.

double DTrackFitterALT1::SIGMA_CDC
private

Definition at line 125 of file DTrackFitterALT1.h.

Referenced by DTrackFitterALT1(), and GetHits().

double DTrackFitterALT1::SIGMA_FDC_ANODE
private

Definition at line 127 of file DTrackFitterALT1.h.

Referenced by DTrackFitterALT1(), and GetHits().

double DTrackFitterALT1::SIGMA_FDC_CATHODE
private

Definition at line 128 of file DTrackFitterALT1.h.

Referenced by DTrackFitterALT1().

DCoordinateSystem* DTrackFitterALT1::target
private
bool DTrackFitterALT1::TARGET_CONSTRAINT
private

Definition at line 135 of file DTrackFitterALT1.h.

Referenced by DTrackFitterALT1(), and GetHits().

DReferenceTrajectory * DTrackFitterALT1::tmprt
private

Definition at line 119 of file DTrackFitterALT1.h.

Referenced by DTrackFitterALT1(), FitTrack(), LeastSquaresB(), and ~DTrackFitterALT1().

bool DTrackFitterALT1::USE_CDC
private

Definition at line 140 of file DTrackFitterALT1.h.

Referenced by DTrackFitterALT1(), and GetHits().

bool DTrackFitterALT1::USE_FDC
private

Definition at line 138 of file DTrackFitterALT1.h.

Referenced by DTrackFitterALT1(), and GetHits().

bool DTrackFitterALT1::USE_FDC_CATHODE
private

Definition at line 139 of file DTrackFitterALT1.h.

Referenced by DTrackFitterALT1().

bool DTrackFitterALT1::USE_MULS_COVARIANCE
private

Definition at line 137 of file DTrackFitterALT1.h.

Referenced by ChiSq(), and DTrackFitterALT1().

DMatrix DTrackFitterALT1::weights
private

Inverse of cov_meas + cov_muls.

Definition at line 108 of file DTrackFitterALT1.h.

Referenced by ChiSq(), and LeastSquaresB().


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