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

#include <DTrackFitterKalmanSIMD.h>

+ Inheritance diagram for DTrackFitterKalmanSIMD:

Public Types

enum  fit_type_t { kWireBased, kTimeBased }
 
enum  fit_status_t { kFitNotDone, kFitSuccess, kFitFailed, kFitNoImprovement }
 

Public Member Functions

 DTrackFitterKalmanSIMD (JEventLoop *loop)
 
 ~DTrackFitterKalmanSIMD ()
 
string Name (void) const
 
fit_status_t FitTrack (void)
 
double ChiSq (fit_type_t fit_type, DReferenceTrajectory *rt, double *chisq_ptr=NULL, int *dof_ptr=NULL, vector< pull_t > *pulls_ptr=NULL)
 
unsigned int GetRatioMeasuredPotentialFDCHits (void) const
 
unsigned int GetRatioMeasuredPotentialCDCHits (void) const
 
jerror_t AddCDCHit (const DCDCTrackHit *cdchit)
 
jerror_t AddFDCHit (const DFDCPseudo *fdchit)
 
jerror_t KalmanLoop (void)
 
virtual kalman_error_t KalmanForward (double fdc_anneal, double cdc_anneal, DMatrix5x1 &S, DMatrix5x5 &C, double &chisq, unsigned int &numdof)
 
virtual jerror_t SmoothForward (vector< pull_t > &mypulls)
 
virtual jerror_t ExtrapolateForwardToOtherDetectors (void)
 
jerror_t ExtrapolateCentralToOtherDetectors (void)
 
kalman_error_t KalmanForwardCDC (double anneal, DMatrix5x1 &S, DMatrix5x5 &C, double &chisq, unsigned int &numdof)
 
kalman_error_t KalmanCentral (double anneal_factor, DMatrix5x1 &S, DMatrix5x5 &C, DVector2 &xy, double &chisq, unsigned int &myndf)
 
jerror_t ExtrapolateToVertex (DVector2 &xy, DMatrix5x1 &Sc, DMatrix5x5 &Cc)
 
jerror_t ExtrapolateToVertex (DVector2 &xy, DMatrix5x1 &Sc)
 
jerror_t ExtrapolateToVertex (DMatrix5x1 &S, DMatrix5x5 &C)
 
jerror_t ExtrapolateToVertex (DMatrix5x1 &S)
 
jerror_t SetReferenceTrajectory (DMatrix5x1 &S)
 
jerror_t SetCDCForwardReferenceTrajectory (DMatrix5x1 &S)
 
jerror_t SetCDCReferenceTrajectory (const DVector2 &xy, DMatrix5x1 &Sc)
 
void GetMomentum (DVector3 &mom)
 
void GetPosition (DVector3 &pos)
 
void GetCovarianceMatrix (vector< vector< double > > &mycov)
 
void GetForwardCovarianceMatrix (vector< vector< double > > &mycov)
 
double GetCharge (void)
 
double GetChiSq (void)
 
unsigned int GetNDF (void)
 
double GetdEdx (double q_over_p, double K_rho_Z_over_A, double rho_Z_over_A, double rho_Z_over_A_LnI, double Z)
 
double GetEnergyVariance (double ds, double beta2, double K_rho_Z_over_A)
 
double GetFDCDriftDistance (double time, double Bz) const
 
 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 Types

enum  hit_status { good_hit, bad_hit, late_hit }
 
enum  fit_region { kForward, kForwardCDC, kCentral }
 
enum  state_types_forward {
  state_x, state_y, state_tx, state_ty,
  state_q_over_p
}
 
enum  state_types_central {
  state_q_over_pt, state_phi, state_tanl, state_D,
  state_z
}
 
enum  state_cartesian {
  state_Px, state_Py, state_Pz, state_X,
  state_Y, state_Z, state_T
}
 

Protected Member Functions

void locate (const double *xx, int n, double x, int *j)
 
unsigned int locate (vector< double > &xx, double x)
 
double fdc_drift_variance (double t) const
 
double fdc_drift_distance (double t, double Bz) const
 
void ResetKalmanSIMD (void)
 
jerror_t GetProcessNoise (double z, double ds, double chi2c_factor, double chi2a_factor, double chi2a_corr, const DMatrix5x1 &S, DMatrix5x5 &Q)
 
double Step (double oldz, double newz, double dEdx, DMatrix5x1 &S)
 
double FasterStep (double oldz, double newz, double dEdx, DMatrix5x1 &S)
 
void FastStep (double &z, double ds, double dEdx, DMatrix5x1 &S)
 
void FastStep (DVector2 &xy, double ds, double dEdx, DMatrix5x1 &S)
 
jerror_t StepJacobian (double oldz, double newz, const DMatrix5x1 &S, double dEdx, DMatrix5x5 &J)
 
jerror_t CalcDerivAndJacobian (double z, double dz, const DMatrix5x1 &S, double dEdx, DMatrix5x5 &J, DMatrix5x1 &D)
 
jerror_t CalcJacobian (double z, double dz, const DMatrix5x1 &S, double dEdx, DMatrix5x5 &J)
 
jerror_t CalcDeriv (double z, const DMatrix5x1 &S, double dEdx, DMatrix5x1 &D)
 
jerror_t CalcDeriv (DVector2 &dxy, const DMatrix5x1 &S, double dEdx, DMatrix5x1 &D1)
 
jerror_t StepJacobian (const DVector2 &xy, double ds, const DMatrix5x1 &S, double dEdx, DMatrix5x5 &J)
 
jerror_t StepJacobian (const DVector2 &xy, const DVector2 &dxy, double ds, const DMatrix5x1 &S, double dEdx, DMatrix5x5 &J)
 
jerror_t StepStateAndCovariance (DVector2 &xy, double ds, double dEdx, DMatrix5x1 &S, DMatrix5x5 &J, DMatrix5x5 &C)
 
jerror_t Step (DVector2 &xy, double ds, DMatrix5x1 &S, double dEdx)
 
jerror_t FasterStep (DVector2 &xy, double ds, DMatrix5x1 &S, double dEdx)
 
jerror_t CalcDerivAndJacobian (const DVector2 &xy, DVector2 &dxy, const DMatrix5x1 &S, double dEdx, DMatrix5x5 &J1, DMatrix5x1 &D1)
 
jerror_t GetProcessNoiseCentral (double ds, double chi2c_factor, double chi2a_factor, double chi2a_corr, const DMatrix5x1 &S, DMatrix5x5 &Q)
 
jerror_t SmoothForwardCDC (vector< pull_t > &mypulls)
 
jerror_t SmoothCentral (vector< pull_t > &cdc_pulls)
 
jerror_t FillPullsVectorEntry (const DMatrix5x1 &Ss, const DMatrix5x5 &Cs, const DKalmanForwardTrajectory_t &traj, const DKalmanSIMDCDCHit_t *hit, const DKalmanUpdate_t &update, vector< pull_t > &mypulls)
 
jerror_t SwimToPlane (DMatrix5x1 &S)
 
jerror_t FindCentralResiduals (vector< DKalmanUpdate_t >updates)
 
jerror_t SwimCentral (DVector3 &pos, DMatrix5x1 &Sc)
 
jerror_t BrentsAlgorithm (double ds1, double ds2, double dedx, DVector2 &pos, const double z0wire, const DVector2 &origin, const DVector2 &dir, DMatrix5x1 &Sc, double &ds_out)
 
jerror_t BrentsAlgorithm (double z, double dz, double dedx, const double z0wire, const DVector2 &origin, const DVector2 &dir, DMatrix5x1 &S, double &dz_out)
 
jerror_t BrentForward (double z, double dedx, const double z0w, const DVector2 &origin, const DVector2 &dir, DMatrix5x1 &S, double &dz)
 
jerror_t BrentCentral (double dedx, DVector2 &xy, const double z0w, const DVector2 &origin, const DVector2 &dir, DMatrix5x1 &Sc, double &ds)
 
jerror_t PropagateForwardCDC (int length, int &index, double &z, double &r2, DMatrix5x1 &S, bool &stepped_to_boundary)
 
jerror_t PropagateForward (int length, int &index, double &z, double zhit, DMatrix5x1 &S, bool &done, bool &stepped_to_boundary, bool &stepped_to_endplate)
 
jerror_t PropagateCentral (int length, int &index, DVector2 &my_xy, double &var_t_factor, DMatrix5x1 &Sc, bool &stepped_to_boundary)
 
shared_ptr< TMatrixFSym > Get7x7ErrorMatrix (DMatrixDSym C)
 
shared_ptr< TMatrixFSym > Get7x7ErrorMatrixForward (DMatrixDSym C)
 
kalman_error_t ForwardFit (const DMatrix5x1 &S, const DMatrix5x5 &C0)
 
kalman_error_t ForwardCDCFit (const DMatrix5x1 &S, const DMatrix5x5 &C0)
 
kalman_error_t CentralFit (const DVector2 &startpos, const DMatrix5x1 &Sc, const DMatrix5x5 &C0)
 
kalman_error_t RecoverBrokenTracks (double anneal_factor, DMatrix5x1 &S, DMatrix5x5 &C, const DMatrix5x5 &C0, double &chisq, unsigned int &numdof)
 
kalman_error_t RecoverBrokenTracks (double anneal_factor, DMatrix5x1 &S, DMatrix5x5 &C, const DMatrix5x5 &C0, DVector2 &pos, double &chisq, unsigned int &numdof)
 
kalman_error_t RecoverBrokenForwardTracks (double fdc_anneal_factor, double cdc_anneal_factor, DMatrix5x1 &S, DMatrix5x5 &C, const DMatrix5x5 &C0, double &chisq, unsigned int &numdof)
 
void ComputeCDCDrift (double dphi, double delta, double t, double B, double &d, double &V, double &tcorr)
 
void TransformCovariance (DMatrix5x5 &C)
 

Protected Attributes

vector< DKalmanSIMDCDCHit_t * > my_cdchits
 
vector< DKalmanSIMDFDCHit_t * > my_fdchits
 
vector< unsigned int > used_fdc_indices
 
vector< unsigned int > used_cdc_indices
 
double mStepSizeZ
 
double mStepSizeS
 
double mCentralStepSize
 
double mCDCInternalStepSize
 
double x_
 
double y_
 
double tx_
 
double ty_
 
double q_over_p_
 
double z_
 
double phi_
 
double tanl_
 
double q_over_pt_
 
double D_
 
double chisq_
 
unsigned int ndf_
 
vector< vector< double > > cov
 
vector< vector< double > > fcov
 
deque< DKalmanCentralTrajectory_tcentral_traj
 
deque< DKalmanForwardTrajectory_tforward_traj
 
vector< DKalmanUpdate_tfdc_updates
 
vector< DKalmanUpdate_tcdc_updates
 
vector< bool > cdc_used_in_fit
 
vector< bool > fdc_used_in_fit
 
double ftime
 
double len
 
double var_ftime
 
double Bx
 
double By
 
double Bz
 
double dBxdx
 
double dBxdy
 
double dBxdz
 
double dBydx
 
double dBydy
 
double dBydz
 
double dBzdx
 
double dBzdy
 
double dBzdz
 
bool get_field
 
double FactorForSenseOfRotation
 
double endplate_z
 
double endplate_dz
 
double endplate_r2min
 
double endplate_r2max
 
double endplate_z_downstream
 
vector< double > cdc_origin
 
double dTOFz
 
double dFCALz
 
double dDIRCz
 
double MASS
 
double mass2
 
double m_ratio
 
double m_ratio_sq
 
double two_m_e
 
double m_e_sq
 
double LORENTZ_NR_PAR1
 
double LORENTZ_NR_PAR2
 
double LORENTZ_NZ_PAR1
 
double LORENTZ_NZ_PAR2
 
double MOLIERE_FRACTION
 
double MOLIERE_RATIO1
 
double MOLIERE_RATIO2
 
double MS_SCALE_FACTOR
 
vector< double > cdc_drift_table
 
vector< double > fdc_drift_table
 
double long_drift_func [3][3]
 
double short_drift_func [3][3]
 
double long_drift_Bscale_par1
 
double long_drift_Bscale_par2
 
double short_drift_Bscale_par1
 
double short_drift_Bscale_par2
 
double mT0
 
double mT0MinimumDriftTime
 
double mVarT0
 
DetectorSystem_t mT0Detector
 
unsigned int break_point_cdc_index
 
unsigned int break_point_step_index
 
unsigned int break_point_fdc_index
 
bool DEBUG_HISTS
 
bool ENABLE_BOUNDARY_CHECK
 
int DEBUG_LEVEL
 
bool USE_T0_FROM_WIRES
 
bool ESTIMATE_T0_TB
 
bool USE_MULS_COVARIANCE
 
double FDC_CATHODE_SIGMA
 
bool RECOVER_BROKEN_TRACKS
 
bool FORWARD_PARMS_COV
 
double TARGET_Z
 
bool ADD_VERTEX_POINT
 
unsigned int MIN_HITS_FOR_REFIT
 
double THETA_CUT
 
double MINIMUM_HIT_FRACTION
 
bool USE_PASS1_TIME_MODE
 
int RING_TO_SKIP
 
int PLANE_TO_SKIP
 
double PHOTON_ENERGY_CUTOFF
 
bool USE_FDC_DRIFT_TIMES
 
bool ALIGNMENT
 
bool ALIGNMENT_CENTRAL
 
bool ALIGNMENT_FORWARD
 
double COVARIANCE_SCALE_FACTOR_FORWARD
 
double COVARIANCE_SCALE_FACTOR_CENTRAL
 
bool USE_CDC_HITS
 
bool USE_FDC_HITS
 
double NUM_CDC_SIGMA_CUT
 
double NUM_FDC_SIGMA_CUT
 
double ANNEAL_POW_CONST
 
double ANNEAL_SCALE
 
double FORWARD_ANNEAL_POW_CONST
 
double FORWARD_ANNEAL_SCALE
 
double PT_MIN
 
double Q_OVER_P_MAX
 
double CDC_DRIFT_BSCALE_PAR1
 
double CDC_DRIFT_BSCALE_PAR2
 
double CDC_RES_PAR1
 
double CDC_RES_PAR2
 
double CDC_RES_PAR3
 
double CDC_VAR_SCALE_FACTOR
 
double CDC_T_DRIFT_MIN
 
vector< vector< double > > max_sag
 
vector< vector< double > > sag_phi_offset
 
vector< vector< DCDCWire * > > cdcwires
 
vector< double > cdc_rmid
 
double FDC_DRIFT_BSCALE_PAR1
 
double FDC_DRIFT_BSCALE_PAR2
 
double DRIFT_RES_PARMS [3]
 
double DRIFT_FUNC_PARMS [6]
 
DMatrix5x5 I5x5
 
DMatrix5x5 Zero5x5
 
DMatrix5x1 Zero5x1
 
vector< double > fdc_z_wires
 
double fdc_package_size
 
double fdc_rmax
 
vector< double > fdc_rmin_packages
 
vector< vector< DVector3 > > sc_dir
 
vector< vector< DVector3 > > sc_pos
 
vector< vector< DVector3 > > sc_norm
 
double SC_BARREL_R2
 
double SC_END_NOSE_Z
 
double SC_PHI_SECTOR1
 
DVector2 beam_center
 
DVector2 beam_dir
 
double beam_z0
 
bool IsHadron
 
bool IsElectron
 
bool IsPositron
 
TH1I * alignDerivHists [46]
 
TH2I * brentCheckHists [2]
 
bool WRITE_ML_TRAINING_OUTPUT
 
ofstream mlfile
 
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 Attributes

unsigned int last_material_map
 
shared_ptr< DResourcePool
< TMatrixFSym > > 
dResourcePool_TMatrixFSym
 

Detailed Description

Definition at line 133 of file DTrackFitterKalmanSIMD.h.

Member Enumeration Documentation

Enumerator
kForward 
kForwardCDC 
kCentral 

Definition at line 232 of file DTrackFitterKalmanSIMD.h.

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
good_hit 
bad_hit 
late_hit 

Definition at line 227 of file DTrackFitterKalmanSIMD.h.

Enumerator
state_Px 
state_Py 
state_Pz 
state_X 
state_Y 
state_Z 
state_T 

Definition at line 252 of file DTrackFitterKalmanSIMD.h.

Enumerator
state_q_over_pt 
state_phi 
state_tanl 
state_D 
state_z 

Definition at line 245 of file DTrackFitterKalmanSIMD.h.

Enumerator
state_x 
state_y 
state_tx 
state_ty 
state_q_over_p 

Definition at line 238 of file DTrackFitterKalmanSIMD.h.

Constructor & Destructor Documentation

DTrackFitterKalmanSIMD::DTrackFitterKalmanSIMD ( JEventLoop *  loop)

Definition at line 265 of file DTrackFitterKalmanSIMD.cc.

References ADD_VERTEX_POINT, alignDerivHists, ALIGNMENT, ALIGNMENT_CENTRAL, ALIGNMENT_FORWARD, ANNEAL_POW_CONST, ANNEAL_SCALE, beam_center, beam_dir, beam_z0, DTrackFitter::bfield, brentCheckHists, CDC_DRIFT_BSCALE_PAR1, CDC_DRIFT_BSCALE_PAR2, cdc_drift_table, cdc_origin, CDC_RES_PAR1, CDC_RES_PAR2, CDC_RES_PAR3, cdc_rmid, CDC_T_DRIFT_MIN, cdc_updates, cdc_used_in_fit, CDC_VAR_SCALE_FACTOR, cdcwires, COVARIANCE_SCALE_FACTOR_CENTRAL, COVARIANCE_SCALE_FACTOR_FORWARD, dapp, dDIRCz, DEBUG_HISTS, DEBUG_LEVEL, dFCALz, dResourcePool_TMatrixFSym, DRIFT_FUNC_PARMS, DRIFT_RES_PARMS, dTOFz, ELECTRON_MASS, ENABLE_BOUNDARY_CHECK, endplate_dz, endplate_r2max, endplate_r2min, endplate_z, endplate_z_downstream, ESTIMATE_T0_TB, FactorForSenseOfRotation, FDC_DRIFT_BSCALE_PAR1, FDC_DRIFT_BSCALE_PAR2, fdc_package_size, fdc_rmax, fdc_rmin_packages, fdc_updates, fdc_used_in_fit, fdc_z_wires, FORWARD_ANNEAL_POW_CONST, FORWARD_ANNEAL_SCALE, FORWARD_PARMS_COV, DTrackFitter::geom, DGeometry::Get(), DMagneticFieldMap::GetBz(), DGeometry::GetCDCEndplate(), DGeometry::GetCDCWires(), DGeometry::GetDIRCZ(), DGeometry::GetFCALZ(), DGeometry::GetFDCRmax(), DGeometry::GetFDCRmin(), DGeometry::GetFDCZ(), DGeometry::GetStartCounterGeom(), DGeometry::GetTargetZ(), I5x5, long_drift_Bscale_par1, long_drift_Bscale_par2, long_drift_func, LORENTZ_NR_PAR1, LORENTZ_NR_PAR2, LORENTZ_NZ_PAR1, LORENTZ_NZ_PAR2, m_e_sq, max, max_sag, min, MIN_HITS_FOR_REFIT, MINIMUM_HIT_FRACTION, mlfile, MOLIERE_FRACTION, MOLIERE_RATIO1, MOLIERE_RATIO2, MS_SCALE_FACTOR, my_cdchits, my_fdchits, NUM_CDC_SIGMA_CUT, NUM_FDC_SIGMA_CUT, PHOTON_ENERGY_CUTOFF, PLANE_TO_SKIP, RECOVER_BROKEN_TRACKS, RING_TO_SKIP, sag_phi_offset, SC_BARREL_R2, sc_dir, SC_END_NOSE_Z, sc_norm, SC_PHI_SECTOR1, sc_pos, short_drift_Bscale_par1, short_drift_Bscale_par2, short_drift_func, TARGET_Z, temp, THETA_CUT, two_m_e, USE_CDC_HITS, USE_FDC_DRIFT_TIMES, USE_FDC_HITS, USE_MULS_COVARIANCE, USE_PASS1_TIME_MODE, USE_T0_FROM_WIRES, and WRITE_ML_TRAINING_OUTPUT.

DTrackFitterKalmanSIMD::~DTrackFitterKalmanSIMD ( )
inline

Definition at line 140 of file DTrackFitterKalmanSIMD.h.

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.

jerror_t DTrackFitterKalmanSIMD::BrentCentral ( double  dedx,
DVector2 xy,
const double  z0w,
const DVector2 origin,
const DVector2 dir,
DMatrix5x1 Sc,
double &  ds 
)
protected
jerror_t DTrackFitterKalmanSIMD::BrentForward ( double  z,
double  dedx,
const double  z0w,
const DVector2 origin,
const DVector2 dir,
DMatrix5x1 S,
double &  dz 
)
protected
jerror_t DTrackFitterKalmanSIMD::BrentsAlgorithm ( double  ds1,
double  ds2,
double  dedx,
DVector2 pos,
const double  z0wire,
const DVector2 origin,
const DVector2 dir,
DMatrix5x1 Sc,
double &  ds_out 
)
protected
jerror_t DTrackFitterKalmanSIMD::BrentsAlgorithm ( double  z,
double  dz,
double  dedx,
const double  z0wire,
const DVector2 origin,
const DVector2 dir,
DMatrix5x1 S,
double &  dz_out 
)
protected
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 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.

jerror_t DTrackFitterKalmanSIMD::CalcDeriv ( double  z,
const DMatrix5x1 S,
double  dEdx,
DMatrix5x1 D 
)
protected
jerror_t DTrackFitterKalmanSIMD::CalcDeriv ( DVector2 dxy,
const DMatrix5x1 S,
double  dEdx,
DMatrix5x1 D1 
)
protected
jerror_t DTrackFitterKalmanSIMD::CalcDerivAndJacobian ( double  z,
double  dz,
const DMatrix5x1 S,
double  dEdx,
DMatrix5x5 J,
DMatrix5x1 D 
)
protected
jerror_t DTrackFitterKalmanSIMD::CalcDerivAndJacobian ( const DVector2 xy,
DVector2 dxy,
const DMatrix5x1 S,
double  dEdx,
DMatrix5x5 J1,
DMatrix5x1 D1 
)
protected
jerror_t DTrackFitterKalmanSIMD::CalcJacobian ( double  z,
double  dz,
const DMatrix5x1 S,
double  dEdx,
DMatrix5x5 J 
)
protected
double DTrackFitterKalmanSIMD::ChiSq ( fit_type_t  fit_type,
DReferenceTrajectory rt,
double *  chisq_ptr = NULL,
int *  dof_ptr = NULL,
vector< pull_t > *  pulls_ptr = NULL 
)
virtual

Implements DTrackFitter.

Definition at line 1034 of file DTrackFitterKalmanSIMD.cc.

References DTrackFitter::chisq, GetChiSq(), GetNDF(), and DTrackFitter::pulls.

void DTrackFitter::ClearExtrapolations ( void  )
inlineinherited
void DTrackFitterKalmanSIMD::ComputeCDCDrift ( double  dphi,
double  delta,
double  t,
double  B,
double &  d,
double &  V,
double &  tcorr 
)
protected
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.

double DTrackFitterKalmanSIMD::FasterStep ( double  oldz,
double  newz,
double  dEdx,
DMatrix5x1 S 
)
protected
jerror_t DTrackFitterKalmanSIMD::FasterStep ( DVector2 xy,
double  ds,
DMatrix5x1 S,
double  dEdx 
)
protected
void DTrackFitterKalmanSIMD::FastStep ( double &  z,
double  ds,
double  dEdx,
DMatrix5x1 S 
)
protected
void DTrackFitterKalmanSIMD::FastStep ( DVector2 xy,
double  ds,
double  dEdx,
DMatrix5x1 S 
)
protected
double DTrackFitterKalmanSIMD::fdc_drift_distance ( double  t,
double  Bz 
) const
protected
double DTrackFitterKalmanSIMD::fdc_drift_variance ( double  t) const
protected

Definition at line 104 of file DTrackFitterKalmanSIMD.cc.

References DRIFT_RES_PARMS, and sigma.

Referenced by KalmanForward().

jerror_t DTrackFitterKalmanSIMD::FillPullsVectorEntry ( const DMatrix5x1 Ss,
const DMatrix5x5 Cs,
const DKalmanForwardTrajectory_t traj,
const DKalmanSIMDCDCHit_t hit,
const DKalmanUpdate_t update,
vector< pull_t > &  mypulls 
)
protected
jerror_t DTrackFitterKalmanSIMD::FindCentralResiduals ( vector< DKalmanUpdate_t updates)
protected
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 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().

DTrackFitter::fit_status_t DTrackFitterKalmanSIMD::FitTrack ( void  )
virtual

Implements DTrackFitter.

Definition at line 727 of file DTrackFitterKalmanSIMD.cc.

References _DBG_, AddCDCHit(), AddFDCHit(), cdc_hit(), cdc_rmid, cdc_updates, cdc_used_in_fit, DTrackFitter::cdchits, cdcwires, DKinematicData::charge(), DTrackFitter::chisq, chisq_, cov, D_, DEBUG_LEVEL, DKalmanSIMDCDCHit_cmp(), DKalmanSIMDFDCHit_cmp(), dResourcePool_TMatrixFSym, ELECTRON_MASS, EPS, DTrackFitter::extrapolations, fcov, fdc_package_size, fdc_rmin_packages, fdc_updates, fdc_used_in_fit, fdc_z_wires, DTrackFitter::fdchits, DTrackFitter::fit_params, DTrackFitter::fit_status, DTrackFitter::fit_type, FORWARD_PARMS_COV, Get7x7ErrorMatrix(), Get7x7ErrorMatrixForward(), GetCharge(), GetChiSq(), GetMomentum(), GetNDF(), GetPosition(), IDTrack(), DTrackFitter::input_params, IsElectron, IsHadron, IsPositron, KalmanLoop(), DTrackFitter::kFitFailed, DTrackFitter::kFitNotDone, DTrackFitter::kFitSuccess, DTrackFitter::kTimeBased, late_hit, m_ratio, m_ratio_sq, DKinematicData::mass(), MASS, mass2, mT0, mT0Detector, mT0MinimumDriftTime, mVarT0, my_cdchits, my_fdchits, DTrackFitter::Ndof, phi_, DTrackFitter::potential_cdc_hits_on_track, DTrackFitter::potential_fdc_hits_on_track, DTrackFitter::pulls, q_over_p_, q_over_pt_, ResetKalmanSIMD(), DKinematicData::setErrorMatrix(), DTrackingData::setForwardParmFlag(), DKinematicData::setMomentum(), DKinematicData::setPID(), DKinematicData::setPosition(), DTrackingData::setT0(), DKinematicData::setTime(), DTrackingData::setTrackingErrorMatrix(), DTrackingData::setTrackingStateVector(), sin(), SYS_BCAL, SYS_CDC, SYS_FDC, SYS_TOF, DTrackingData::t0(), DTrackingData::t0_detector(), tanl_, tx_, ty_, USE_CDC_HITS, USE_FDC_HITS, x_, y_, and z_.

shared_ptr< TMatrixFSym > DTrackFitterKalmanSIMD::Get7x7ErrorMatrix ( DMatrixDSym  C)
protected
shared_ptr< TMatrixFSym > DTrackFitterKalmanSIMD::Get7x7ErrorMatrixForward ( DMatrixDSym  C)
protected
const vector<const DCDCTrackHit*>& DTrackFitter::GetCDCInputHits ( void  ) const
inlineinherited

Definition at line 137 of file DTrackFitter.h.

double DTrackFitterKalmanSIMD::GetCharge ( void  )
inline

Definition at line 215 of file DTrackFitterKalmanSIMD.h.

Referenced by FitTrack().

double DTrackFitterKalmanSIMD::GetChiSq ( void  )
inline

Definition at line 216 of file DTrackFitterKalmanSIMD.h.

Referenced by ChiSq(), and FitTrack().

void DTrackFitterKalmanSIMD::GetCovarianceMatrix ( vector< vector< double > > &  mycov)
inline

Definition at line 207 of file DTrackFitterKalmanSIMD.h.

const DMagneticFieldMap* DTrackFitter::GetDMagneticFieldMap ( void  ) const
inlineinherited
double DTrackFitterKalmanSIMD::GetEnergyVariance ( double  ds,
double  beta2,
double  K_rho_Z_over_A 
)
double DTrackFitterKalmanSIMD::GetFDCDriftDistance ( double  time,
double  Bz 
) const
inline

Definition at line 222 of file DTrackFitterKalmanSIMD.h.

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.

void DTrackFitterKalmanSIMD::GetForwardCovarianceMatrix ( vector< vector< double > > &  mycov)
inline

Definition at line 210 of file DTrackFitterKalmanSIMD.h.

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

Definition at line 152 of file DTrackFitter.h.

void DTrackFitterKalmanSIMD::GetMomentum ( DVector3 mom)
inline

Definition at line 1050 of file DTrackFitterKalmanSIMD.cc.

References phi_, q_over_pt_, sin(), and tanl_.

Referenced by FitTrack().

unsigned int DTrackFitterKalmanSIMD::GetNDF ( void  )
inline

Definition at line 217 of file DTrackFitterKalmanSIMD.h.

Referenced by ChiSq(), and FitTrack().

unsigned int DTrackFitter::GetNumPotentialCDCHits ( void  ) const
inlineinherited
unsigned int DTrackFitter::GetNumPotentialFDCHits ( void  ) const
inlineinherited
void DTrackFitterKalmanSIMD::GetPosition ( DVector3 pos)
inline

Definition at line 1056 of file DTrackFitterKalmanSIMD.cc.

References x_, y_, and z_.

Referenced by FitTrack().

jerror_t DTrackFitterKalmanSIMD::GetProcessNoise ( double  z,
double  ds,
double  chi2c_factor,
double  chi2a_factor,
double  chi2a_corr,
const DMatrix5x1 S,
DMatrix5x5 Q 
)
protected
jerror_t DTrackFitterKalmanSIMD::GetProcessNoiseCentral ( double  ds,
double  chi2c_factor,
double  chi2a_factor,
double  chi2a_corr,
const DMatrix5x1 S,
DMatrix5x5 Q 
)
protected
unsigned int DTrackFitterKalmanSIMD::GetRatioMeasuredPotentialCDCHits ( void  ) const
inline

Definition at line 180 of file DTrackFitterKalmanSIMD.h.

unsigned int DTrackFitterKalmanSIMD::GetRatioMeasuredPotentialFDCHits ( void  ) const
inline

Definition at line 179 of file DTrackFitterKalmanSIMD.h.

DTrackFitter::JOBJECT_PUBLIC ( DTrackFitter  )
inherited
kalman_error_t DTrackFitterKalmanSIMD::KalmanForward ( double  fdc_anneal,
double  cdc_anneal,
DMatrix5x1 S,
DMatrix5x5 C,
double &  chisq,
unsigned int &  numdof 
)
virtual

Vtemp=V+H*C*H_T;

Reimplemented in DTrackFitterKalmanSIMD_ALT1.

Definition at line 4261 of file DTrackFitterKalmanSIMD.cc.

References _DBG_, ADD_VERTEX_POINT, DMatrix5x5::AddSym(), ALIGNMENT_FORWARD, alpha, DTrackFitter::bfield, BIG, break_point_cdc_index, break_point_fdc_index, BREAK_POINT_FOUND, break_point_step_index, BrentForward(), BROKEN_COVARIANCE_MATRIX, CDC_T_DRIFT_MIN, cdc_updates, cdc_used_in_fit, CDC_VAR_SCALE_FACTOR, DMatrix2x2::Chi2(), ComputeCDCDrift(), DTrackFitter::CORRECT_FOR_ELOSS, dDdt0, DEBUG_LEVEL, DMatrix2x2::Determinant(), dir, e, endplate_z, EPS, FDC_CATHODE_VARIANCE, fdc_drift_distance(), fdc_drift_variance(), fdc_updates, fdc_used_in_fit, FIT_FAILED, FIT_SUCCEEDED, DTrackFitter::fit_type, forward_traj, DMagneticFieldMap::GetBz(), GetdEdx(), good_hit, H, I5x5, DMatrix2x2::Invert(), DMatrix5x1::IsFinite(), DMatrix5x5::IsPosDef(), DTrackFitter::kTimeBased, M_TWO_PI, max_sag, MIN_HITS_FOR_REFIT, MINIMUM_HIT_FRACTION, MOMENTUM_OUT_OF_RANGE, mStepSizeZ, mT0, my_cdchits, my_fdchits, NEGATIVE_VARIANCE, NUM_CDC_SIGMA_CUT, NUM_FDC_SIGMA_CUT, DCoordinateSystem::origin, PLANE_TO_SKIP, DMatrix5x1::Print(), DMatrix5x5::Print(), printf(), PRUNED_TOO_MANY_HITS, Q_OVER_P_MAX, qBr2p, DCDCWire::ring, RING_TO_SKIP, S, sag_phi_offset, sin(), sqrt(), state_q_over_p, state_tx, state_ty, state_x, state_y, Step(), StepJacobian(), DCDCWire::straw, DMatrix5x5::SubSym(), sum, TARGET_Z, temp, TIME_UNIT_CONVERSION, DMatrix5x5::Transpose(), Transpose(), tx, u, USE_FDC_DRIFT_TIMES, x, x_, y, y_, and z_.

Referenced by ForwardFit(), and RecoverBrokenForwardTracks().

void DTrackFitterKalmanSIMD::locate ( const double *  xx,
int  n,
double  x,
int *  j 
)
protected

Definition at line 66 of file DTrackFitterKalmanSIMD.cc.

Referenced by ComputeCDCDrift().

unsigned int DTrackFitterKalmanSIMD::locate ( vector< double > &  xx,
double  x 
)
protected

Definition at line 85 of file DTrackFitterKalmanSIMD.cc.

string DTrackFitterKalmanSIMD::Name ( void  ) const
inlinevirtual

Implements DTrackFitter.

Reimplemented in DTrackFitterKalmanSIMD_ALT1.

Definition at line 175 of file DTrackFitterKalmanSIMD.h.

References string.

jerror_t DTrackFitterKalmanSIMD::PropagateCentral ( int  length,
int &  index,
DVector2 my_xy,
double &  var_t_factor,
DMatrix5x1 Sc,
bool &  stepped_to_boundary 
)
protected
kalman_error_t DTrackFitterKalmanSIMD::RecoverBrokenForwardTracks ( double  fdc_anneal_factor,
double  cdc_anneal_factor,
DMatrix5x1 S,
DMatrix5x5 C,
const DMatrix5x5 C0,
double &  chisq,
unsigned int &  numdof 
)
protected
kalman_error_t DTrackFitterKalmanSIMD::RecoverBrokenTracks ( double  anneal_factor,
DMatrix5x1 S,
DMatrix5x5 C,
const DMatrix5x5 C0,
double &  chisq,
unsigned int &  numdof 
)
protected
kalman_error_t DTrackFitterKalmanSIMD::RecoverBrokenTracks ( double  anneal_factor,
DMatrix5x1 S,
DMatrix5x5 C,
const DMatrix5x5 C0,
DVector2 pos,
double &  chisq,
unsigned int &  numdof 
)
protected
void DTrackFitter::SetInputParameters ( const DTrackingData starting_params)
inlineinherited

Definition at line 171 of file DTrackFitter.h.

jerror_t DTrackFitterKalmanSIMD::SmoothForwardCDC ( vector< pull_t > &  mypulls)
protected
jerror_t DTrackFitterKalmanSIMD::Step ( DVector2 xy,
double  ds,
DMatrix5x1 S,
double  dEdx 
)
protected
jerror_t DTrackFitterKalmanSIMD::StepJacobian ( const DVector2 xy,
double  ds,
const DMatrix5x1 S,
double  dEdx,
DMatrix5x5 J 
)
protected
jerror_t DTrackFitterKalmanSIMD::StepJacobian ( const DVector2 xy,
const DVector2 dxy,
double  ds,
const DMatrix5x1 S,
double  dEdx,
DMatrix5x5 J 
)
protected
jerror_t DTrackFitterKalmanSIMD::StepStateAndCovariance ( DVector2 xy,
double  ds,
double  dEdx,
DMatrix5x1 S,
DMatrix5x5 J,
DMatrix5x5 C 
)
protected
jerror_t DTrackFitterKalmanSIMD::SwimCentral ( DVector3 pos,
DMatrix5x1 Sc 
)
protected
jerror_t DTrackFitterKalmanSIMD::SwimToPlane ( DMatrix5x1 S)
protected
void DTrackFitterKalmanSIMD::TransformCovariance ( DMatrix5x5 C)
protected

Member Data Documentation

bool DTrackFitterKalmanSIMD::ADD_VERTEX_POINT
protected
TH1I* DTrackFitterKalmanSIMD::alignDerivHists[46]
protected
bool DTrackFitterKalmanSIMD::ALIGNMENT
protected

Definition at line 495 of file DTrackFitterKalmanSIMD.h.

Referenced by DTrackFitterKalmanSIMD().

bool DTrackFitterKalmanSIMD::ALIGNMENT_CENTRAL
protected

Definition at line 495 of file DTrackFitterKalmanSIMD.h.

Referenced by DTrackFitterKalmanSIMD(), KalmanCentral(), and SmoothCentral().

bool DTrackFitterKalmanSIMD::ALIGNMENT_FORWARD
protected
double DTrackFitterKalmanSIMD::ANNEAL_POW_CONST
protected
double DTrackFitterKalmanSIMD::ANNEAL_SCALE
protected
DVector2 DTrackFitterKalmanSIMD::beam_center
protected
DVector2 DTrackFitterKalmanSIMD::beam_dir
protected
double DTrackFitterKalmanSIMD::beam_z0
protected
unsigned int DTrackFitterKalmanSIMD::break_point_cdc_index
protected
unsigned int DTrackFitterKalmanSIMD::break_point_fdc_index
protected
TH2I* DTrackFitterKalmanSIMD::brentCheckHists[2]
protected
double DTrackFitterKalmanSIMD::CDC_DRIFT_BSCALE_PAR1
protected

Definition at line 512 of file DTrackFitterKalmanSIMD.h.

Referenced by DTrackFitterKalmanSIMD().

double DTrackFitterKalmanSIMD::CDC_DRIFT_BSCALE_PAR2
protected

Definition at line 512 of file DTrackFitterKalmanSIMD.h.

Referenced by DTrackFitterKalmanSIMD().

vector<double> DTrackFitterKalmanSIMD::cdc_drift_table
protected

Definition at line 459 of file DTrackFitterKalmanSIMD.h.

Referenced by ComputeCDCDrift(), and DTrackFitterKalmanSIMD().

vector<double> DTrackFitterKalmanSIMD::cdc_origin
protected
double DTrackFitterKalmanSIMD::CDC_RES_PAR1
protected

Definition at line 514 of file DTrackFitterKalmanSIMD.h.

Referenced by ComputeCDCDrift(), and DTrackFitterKalmanSIMD().

double DTrackFitterKalmanSIMD::CDC_RES_PAR2
protected

Definition at line 514 of file DTrackFitterKalmanSIMD.h.

Referenced by ComputeCDCDrift(), and DTrackFitterKalmanSIMD().

double DTrackFitterKalmanSIMD::CDC_RES_PAR3
protected

Definition at line 514 of file DTrackFitterKalmanSIMD.h.

Referenced by ComputeCDCDrift(), and DTrackFitterKalmanSIMD().

vector<double> DTrackFitterKalmanSIMD::cdc_rmid
protected

Definition at line 524 of file DTrackFitterKalmanSIMD.h.

Referenced by DTrackFitterKalmanSIMD(), and FitTrack().

double DTrackFitterKalmanSIMD::CDC_T_DRIFT_MIN
protected
double DTrackFitterKalmanSIMD::CDC_VAR_SCALE_FACTOR
protected

Definition at line 516 of file DTrackFitterKalmanSIMD.h.

Referenced by DTrackFitterKalmanSIMD(), and KalmanForward().

vector<vector<DCDCWire *> > DTrackFitterKalmanSIMD::cdcwires
protected

Definition at line 523 of file DTrackFitterKalmanSIMD.h.

Referenced by DTrackFitterKalmanSIMD(), and FitTrack().

double DTrackFitterKalmanSIMD::chisq_
protected
vector< vector <double> > DTrackFitterKalmanSIMD::cov
protected

Definition at line 412 of file DTrackFitterKalmanSIMD.h.

Referenced by CentralFit(), FitTrack(), and ResetKalmanSIMD().

double DTrackFitterKalmanSIMD::COVARIANCE_SCALE_FACTOR_CENTRAL
protected

Definition at line 496 of file DTrackFitterKalmanSIMD.h.

Referenced by DTrackFitterKalmanSIMD(), and KalmanLoop().

double DTrackFitterKalmanSIMD::COVARIANCE_SCALE_FACTOR_FORWARD
protected

Definition at line 496 of file DTrackFitterKalmanSIMD.h.

Referenced by DTrackFitterKalmanSIMD(), and KalmanLoop().

double DTrackFitterKalmanSIMD::D_
protected
double DTrackFitterKalmanSIMD::dDIRCz
protected
bool DTrackFitterKalmanSIMD::DEBUG_HISTS
protected
double DTrackFitterKalmanSIMD::dFCALz
protected
shared_ptr<DResourcePool<TMatrixFSym> > DTrackFitterKalmanSIMD::dResourcePool_TMatrixFSym
private
double DTrackFitterKalmanSIMD::DRIFT_FUNC_PARMS[6]
protected

Definition at line 532 of file DTrackFitterKalmanSIMD.h.

Referenced by DTrackFitterKalmanSIMD(), and fdc_drift_distance().

double DTrackFitterKalmanSIMD::DRIFT_RES_PARMS[3]
protected

Definition at line 530 of file DTrackFitterKalmanSIMD.h.

Referenced by DTrackFitterKalmanSIMD(), and fdc_drift_variance().

double DTrackFitterKalmanSIMD::dTOFz
protected
bool DTrackFitterKalmanSIMD::ENABLE_BOUNDARY_CHECK
protected
double DTrackFitterKalmanSIMD::endplate_dz
protected

Definition at line 437 of file DTrackFitterKalmanSIMD.h.

Referenced by DTrackFitterKalmanSIMD(), and PropagateForward().

double DTrackFitterKalmanSIMD::endplate_r2max
protected
double DTrackFitterKalmanSIMD::endplate_r2min
protected
double DTrackFitterKalmanSIMD::endplate_z_downstream
protected
bool DTrackFitterKalmanSIMD::ESTIMATE_T0_TB
protected

Definition at line 482 of file DTrackFitterKalmanSIMD.h.

Referenced by DTrackFitterKalmanSIMD().

double DTrackFitterKalmanSIMD::FactorForSenseOfRotation
protected
vector< vector <double> > DTrackFitterKalmanSIMD::fcov
protected
double DTrackFitterKalmanSIMD::FDC_CATHODE_SIGMA
protected

Definition at line 484 of file DTrackFitterKalmanSIMD.h.

double DTrackFitterKalmanSIMD::FDC_DRIFT_BSCALE_PAR1
protected

Definition at line 527 of file DTrackFitterKalmanSIMD.h.

Referenced by DTrackFitterKalmanSIMD(), and fdc_drift_distance().

double DTrackFitterKalmanSIMD::FDC_DRIFT_BSCALE_PAR2
protected

Definition at line 527 of file DTrackFitterKalmanSIMD.h.

Referenced by DTrackFitterKalmanSIMD(), and fdc_drift_distance().

vector<double> DTrackFitterKalmanSIMD::fdc_drift_table
protected

Definition at line 460 of file DTrackFitterKalmanSIMD.h.

double DTrackFitterKalmanSIMD::fdc_package_size
protected

Definition at line 542 of file DTrackFitterKalmanSIMD.h.

Referenced by DTrackFitterKalmanSIMD(), and FitTrack().

double DTrackFitterKalmanSIMD::fdc_rmax
protected

Definition at line 543 of file DTrackFitterKalmanSIMD.h.

Referenced by DTrackFitterKalmanSIMD().

vector<double> DTrackFitterKalmanSIMD::fdc_rmin_packages
protected

Definition at line 544 of file DTrackFitterKalmanSIMD.h.

Referenced by DTrackFitterKalmanSIMD(), and FitTrack().

vector<double> DTrackFitterKalmanSIMD::fdc_z_wires
protected
vector<const DFDCPseudo*> DTrackFitter::fdchits_used_in_fit
protectedinherited
fit_status_t DTrackFitter::fit_status
protectedinherited

Definition at line 240 of file DTrackFitter.h.

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

double DTrackFitterKalmanSIMD::FORWARD_ANNEAL_POW_CONST
protected

Definition at line 505 of file DTrackFitterKalmanSIMD.h.

Referenced by DTrackFitterKalmanSIMD(), and ForwardFit().

double DTrackFitterKalmanSIMD::FORWARD_ANNEAL_SCALE
protected

Definition at line 505 of file DTrackFitterKalmanSIMD.h.

Referenced by DTrackFitterKalmanSIMD(), and ForwardFit().

bool DTrackFitterKalmanSIMD::FORWARD_PARMS_COV
protected
double DTrackFitterKalmanSIMD::ftime
protected
bool DTrackFitterKalmanSIMD::get_field
protected

Definition at line 433 of file DTrackFitterKalmanSIMD.h.

bool DTrackFitterKalmanSIMD::IsElectron
protected

Definition at line 556 of file DTrackFitterKalmanSIMD.h.

Referenced by FitTrack(), GetdEdx(), and ResetKalmanSIMD().

bool DTrackFitterKalmanSIMD::IsHadron
protected

Definition at line 556 of file DTrackFitterKalmanSIMD.h.

Referenced by FitTrack(), GetdEdx(), and ResetKalmanSIMD().

bool DTrackFitterKalmanSIMD::IsPositron
protected

Definition at line 556 of file DTrackFitterKalmanSIMD.h.

Referenced by FitTrack(), and ResetKalmanSIMD().

bool DTrackFitter::IsSmoothed
protectedinherited
double DTrackFitterKalmanSIMD::len
protected
double DTrackFitterKalmanSIMD::long_drift_Bscale_par1
protected

Definition at line 464 of file DTrackFitterKalmanSIMD.h.

Referenced by ComputeCDCDrift(), and DTrackFitterKalmanSIMD().

double DTrackFitterKalmanSIMD::long_drift_Bscale_par2
protected

Definition at line 464 of file DTrackFitterKalmanSIMD.h.

Referenced by ComputeCDCDrift(), and DTrackFitterKalmanSIMD().

double DTrackFitterKalmanSIMD::long_drift_func[3][3]
protected

Definition at line 462 of file DTrackFitterKalmanSIMD.h.

Referenced by ComputeCDCDrift(), and DTrackFitterKalmanSIMD().

JEventLoop* DTrackFitter::loop
protectedinherited
double DTrackFitterKalmanSIMD::LORENTZ_NR_PAR1
protected

Definition at line 452 of file DTrackFitterKalmanSIMD.h.

Referenced by DTrackFitterKalmanSIMD(), and SetReferenceTrajectory().

double DTrackFitterKalmanSIMD::LORENTZ_NR_PAR2
protected

Definition at line 452 of file DTrackFitterKalmanSIMD.h.

Referenced by DTrackFitterKalmanSIMD(), and SetReferenceTrajectory().

double DTrackFitterKalmanSIMD::LORENTZ_NZ_PAR1
protected

Definition at line 452 of file DTrackFitterKalmanSIMD.h.

Referenced by DTrackFitterKalmanSIMD(), and SetReferenceTrajectory().

double DTrackFitterKalmanSIMD::LORENTZ_NZ_PAR2
protected

Definition at line 452 of file DTrackFitterKalmanSIMD.h.

Referenced by DTrackFitterKalmanSIMD(), and SetReferenceTrajectory().

double DTrackFitterKalmanSIMD::m_e_sq
protected

Definition at line 449 of file DTrackFitterKalmanSIMD.h.

Referenced by DTrackFitterKalmanSIMD(), and GetdEdx().

double DTrackFitterKalmanSIMD::m_ratio
protected

Definition at line 446 of file DTrackFitterKalmanSIMD.h.

Referenced by FitTrack().

double DTrackFitterKalmanSIMD::m_ratio_sq
protected

Definition at line 447 of file DTrackFitterKalmanSIMD.h.

Referenced by FitTrack(), GetdEdx(), and GetEnergyVariance().

double DTrackFitterKalmanSIMD::MASS
protected

Definition at line 445 of file DTrackFitterKalmanSIMD.h.

Referenced by FitTrack(), GetdEdx(), and ResetKalmanSIMD().

vector<vector<double> > DTrackFitterKalmanSIMD::max_sag
protected
double DTrackFitterKalmanSIMD::mCDCInternalStepSize
protected
double DTrackFitterKalmanSIMD::mCentralStepSize
protected

Definition at line 400 of file DTrackFitterKalmanSIMD.h.

Referenced by KalmanLoop(), PropagateForward(), and ResetKalmanSIMD().

double DTrackFitterKalmanSIMD::MINIMUM_HIT_FRACTION
protected
ofstream DTrackFitterKalmanSIMD::mlfile
protected

Definition at line 561 of file DTrackFitterKalmanSIMD.h.

Referenced by DTrackFitterKalmanSIMD(), and SmoothForward().

double DTrackFitterKalmanSIMD::MOLIERE_FRACTION
protected

Definition at line 455 of file DTrackFitterKalmanSIMD.h.

Referenced by DTrackFitterKalmanSIMD().

double DTrackFitterKalmanSIMD::MOLIERE_RATIO1
protected
double DTrackFitterKalmanSIMD::MOLIERE_RATIO2
protected
double DTrackFitterKalmanSIMD::MS_SCALE_FACTOR
protected

Definition at line 456 of file DTrackFitterKalmanSIMD.h.

Referenced by DTrackFitterKalmanSIMD().

double DTrackFitterKalmanSIMD::mStepSizeZ
protected
double DTrackFitterKalmanSIMD::mT0
protected
DetectorSystem_t DTrackFitterKalmanSIMD::mT0Detector
protected
double DTrackFitterKalmanSIMD::mT0MinimumDriftTime
protected
double DTrackFitterKalmanSIMD::mVarT0
protected

Definition at line 470 of file DTrackFitterKalmanSIMD.h.

Referenced by ComputeCDCDrift(), FitTrack(), and ResetKalmanSIMD().

unsigned int DTrackFitterKalmanSIMD::ndf_
protected
double DTrackFitterKalmanSIMD::NUM_CDC_SIGMA_CUT
protected
double DTrackFitterKalmanSIMD::NUM_FDC_SIGMA_CUT
protected
double DTrackFitterKalmanSIMD::phi_
protected
double DTrackFitterKalmanSIMD::PHOTON_ENERGY_CUTOFF
protected

Definition at line 493 of file DTrackFitterKalmanSIMD.h.

Referenced by DTrackFitterKalmanSIMD(), and GetdEdx().

unsigned int DTrackFitter::potential_cdc_hits_on_track
protectedinherited

Definition at line 247 of file DTrackFitter.h.

Referenced by FitTrack().

unsigned int DTrackFitter::potential_fdc_hits_on_track
protectedinherited

Definition at line 246 of file DTrackFitter.h.

Referenced by FitTrack().

double DTrackFitterKalmanSIMD::PT_MIN
protected
double DTrackFitterKalmanSIMD::q_over_p_
protected
double DTrackFitterKalmanSIMD::q_over_pt_
protected
bool DTrackFitterKalmanSIMD::RECOVER_BROKEN_TRACKS
protected
const DRootGeom* DTrackFitter::RootGeom
protectedinherited

Definition at line 230 of file DTrackFitter.h.

Referenced by DTrackFitterALT1::DTrackFitterALT1().

vector<vector<double> > DTrackFitterKalmanSIMD::sag_phi_offset
protected
double DTrackFitterKalmanSIMD::SC_BARREL_R2
protected
vector<vector<DVector3> > DTrackFitterKalmanSIMD::sc_dir
protected

Definition at line 547 of file DTrackFitterKalmanSIMD.h.

Referenced by DTrackFitterKalmanSIMD().

double DTrackFitterKalmanSIMD::SC_END_NOSE_Z
protected
vector<vector<DVector3> > DTrackFitterKalmanSIMD::sc_norm
protected
double DTrackFitterKalmanSIMD::SC_PHI_SECTOR1
protected
vector<vector<DVector3> > DTrackFitterKalmanSIMD::sc_pos
protected
double DTrackFitterKalmanSIMD::short_drift_Bscale_par1
protected

Definition at line 465 of file DTrackFitterKalmanSIMD.h.

Referenced by DTrackFitterKalmanSIMD().

double DTrackFitterKalmanSIMD::short_drift_Bscale_par2
protected

Definition at line 465 of file DTrackFitterKalmanSIMD.h.

Referenced by DTrackFitterKalmanSIMD().

double DTrackFitterKalmanSIMD::short_drift_func[3][3]
protected

Definition at line 463 of file DTrackFitterKalmanSIMD.h.

Referenced by ComputeCDCDrift(), and DTrackFitterKalmanSIMD().

double DTrackFitterKalmanSIMD::tanl_
protected
double DTrackFitterKalmanSIMD::TARGET_Z
protected
double DTrackFitterKalmanSIMD::THETA_CUT
protected

Definition at line 490 of file DTrackFitterKalmanSIMD.h.

Referenced by DTrackFitterKalmanSIMD(), and KalmanLoop().

double DTrackFitterKalmanSIMD::two_m_e
protected

Definition at line 448 of file DTrackFitterKalmanSIMD.h.

Referenced by DTrackFitterKalmanSIMD(), GetdEdx(), and GetEnergyVariance().

double DTrackFitterKalmanSIMD::tx_
protected
double DTrackFitterKalmanSIMD::ty_
protected
bool DTrackFitterKalmanSIMD::USE_CDC_HITS
protected

Definition at line 498 of file DTrackFitterKalmanSIMD.h.

Referenced by DTrackFitterKalmanSIMD(), and FitTrack().

bool DTrackFitterKalmanSIMD::USE_FDC_DRIFT_TIMES
protected

Definition at line 494 of file DTrackFitterKalmanSIMD.h.

Referenced by DTrackFitterKalmanSIMD(), KalmanForward(), and SmoothForward().

bool DTrackFitterKalmanSIMD::USE_FDC_HITS
protected

Definition at line 498 of file DTrackFitterKalmanSIMD.h.

Referenced by DTrackFitterKalmanSIMD(), and FitTrack().

bool DTrackFitterKalmanSIMD::USE_MULS_COVARIANCE
protected
bool DTrackFitterKalmanSIMD::USE_PASS1_TIME_MODE
protected
bool DTrackFitterKalmanSIMD::USE_T0_FROM_WIRES
protected

Definition at line 481 of file DTrackFitterKalmanSIMD.h.

Referenced by DTrackFitterKalmanSIMD().

vector<unsigned int> DTrackFitterKalmanSIMD::used_cdc_indices
protected

Definition at line 396 of file DTrackFitterKalmanSIMD.h.

vector<unsigned int> DTrackFitterKalmanSIMD::used_fdc_indices
protected

Definition at line 395 of file DTrackFitterKalmanSIMD.h.

double DTrackFitterKalmanSIMD::var_ftime
protected
bool DTrackFitterKalmanSIMD::WRITE_ML_TRAINING_OUTPUT
protected

Definition at line 560 of file DTrackFitterKalmanSIMD.h.

Referenced by DTrackFitterKalmanSIMD(), and SmoothForward().

DMatrix5x1 DTrackFitterKalmanSIMD::Zero5x1
protected
DMatrix5x5 DTrackFitterKalmanSIMD::Zero5x5
protected

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