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

#include <DTrackFitterKalmanSIMD_ALT1.h>

+ Inheritance diagram for DTrackFitterKalmanSIMD_ALT1:

Public Types

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

Public Member Functions

 DTrackFitterKalmanSIMD_ALT1 (JEventLoop *loop)
 
virtual ~DTrackFitterKalmanSIMD_ALT1 ()
 
kalman_error_t KalmanForward (double fdc_anneal, double cdc_anneal, DMatrix5x1 &S, DMatrix5x5 &C, double &chisq, unsigned int &numdof)
 
jerror_t SmoothForward (void)
 
string Name (void) const
 
fit_status_t FitTrack (void)
 
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)
 
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 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 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)
 
jerror_t Step (DVector2 &xy, double ds, DMatrix5x1 &S, double dEdx)
 
double FasterStep (double oldz, double newz, double dEdx, DMatrix5x1 &S)
 
jerror_t FasterStep (DVector2 &xy, double ds, DMatrix5x1 &S, double dEdx)
 
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 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 CalcDerivAndJacobian (double z, double dz, const DMatrix5x1 &S, double dEdx, DMatrix5x5 &J, DMatrix5x1 &D)
 
jerror_t CalcDerivAndJacobian (const DVector2 &xy, DVector2 &dxy, const DMatrix5x1 &S, double dEdx, DMatrix5x5 &J1, DMatrix5x1 &D1)
 
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 StepStateAndCovariance (DVector2 &xy, double ds, double dEdx, DMatrix5x1 &S, DMatrix5x5 &J, DMatrix5x5 &C)
 
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
 

Detailed Description

Definition at line 14 of file DTrackFitterKalmanSIMD_ALT1.h.

Member Enumeration Documentation

enum DTrackFitterKalmanSIMD::fit_region
protectedinherited
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.

enum DTrackFitterKalmanSIMD::hit_status
protectedinherited
Enumerator
good_hit 
bad_hit 
late_hit 

Definition at line 227 of file DTrackFitterKalmanSIMD.h.

enum DTrackFitterKalmanSIMD::state_cartesian
protectedinherited
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_ALT1::DTrackFitterKalmanSIMD_ALT1 ( JEventLoop *  loop)
inline

Definition at line 16 of file DTrackFitterKalmanSIMD_ALT1.h.

virtual DTrackFitterKalmanSIMD_ALT1::~DTrackFitterKalmanSIMD_ALT1 ( )
inlinevirtual

Definition at line 18 of file DTrackFitterKalmanSIMD_ALT1.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 
)
protectedinherited
jerror_t DTrackFitterKalmanSIMD::BrentForward ( double  z,
double  dedx,
const double  z0w,
const DVector2 origin,
const DVector2 dir,
DMatrix5x1 S,
double &  dz 
)
protectedinherited
jerror_t DTrackFitterKalmanSIMD::BrentsAlgorithm ( double  z,
double  dz,
double  dedx,
const double  z0wire,
const DVector2 origin,
const DVector2 dir,
DMatrix5x1 S,
double &  dz_out 
)
protectedinherited
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.

jerror_t DTrackFitterKalmanSIMD::CalcDerivAndJacobian ( double  z,
double  dz,
const DMatrix5x1 S,
double  dEdx,
DMatrix5x5 J,
DMatrix5x1 D 
)
protectedinherited
jerror_t DTrackFitterKalmanSIMD::CalcJacobian ( double  z,
double  dz,
const DMatrix5x1 S,
double  dEdx,
DMatrix5x5 J 
)
protectedinherited
kalman_error_t DTrackFitterKalmanSIMD::CentralFit ( const DVector2 startpos,
const DMatrix5x1 Sc,
const DMatrix5x5 C0 
)
protectedinherited

Definition at line 7432 of file DTrackFitterKalmanSIMD.cc.

References _DBG_, DTrackFitterKalmanSIMD::ANNEAL_POW_CONST, DTrackFitterKalmanSIMD::ANNEAL_SCALE, DTrackFitterKalmanSIMD::beam_center, DTrackFitterKalmanSIMD::beam_dir, DTrackFitterKalmanSIMD::beam_z0, DTrackFitterKalmanSIMD::break_point_cdc_index, BREAK_POINT_FOUND, DTrackFitterKalmanSIMD::break_point_step_index, BROKEN_COVARIANCE_MATRIX, C0, DTrackFitterKalmanSIMD::cdc_used_in_fit, DTrackFitter::cdchits_used_in_fit, DTrackFitter::chisq, DTrackFitterKalmanSIMD::chisq_, CHISQ_DELTA, DTrackFitter::ClearExtrapolations(), DTrackFitterKalmanSIMD::cov, DTrackFitterKalmanSIMD::D_, DTrackFitterKalmanSIMD::DEBUG_LEVEL, EPS, DTrackFitterKalmanSIMD::ExtrapolateCentralToOtherDetectors(), DTrackFitterKalmanSIMD::ExtrapolateToVertex(), EXTRAPOLATION_FAILED, DTrackFitter::extrapolations, DTrackFitterKalmanSIMD::fcov, FIT_FAILED, FIT_NOT_DONE, FIT_SUCCEEDED, DTrackFitter::fit_type, DTrackFitterKalmanSIMD::ftime, DTrackFitterKalmanSIMD::good_hit, DTrackFitterKalmanSIMD::I5x5, INVALID_FIT, DTrackFitter::IsSmoothed, DTrackFitterKalmanSIMD::KalmanCentral(), DTrackFitter::kTimeBased, DTrackFitterKalmanSIMD::last_material_map, DTrackFitterKalmanSIMD::late_hit, DTrackFitterKalmanSIMD::len, MAX_TB_PASSES, MAX_WB_PASSES, DTrackFitterKalmanSIMD::MIN_HITS_FOR_REFIT, MIN_ITER, MOMENTUM_OUT_OF_RANGE, DTrackFitterKalmanSIMD::my_cdchits, DTrackFitterKalmanSIMD::ndf_, DTrackFitterKalmanSIMD::phi_, POSITION_OUT_OF_RANGE, PRUNED_TOO_MANY_HITS, DTrackFitter::pulls, DTrackFitterKalmanSIMD::Q_OVER_P_MAX, DTrackFitterKalmanSIMD::q_over_pt_, DTrackFitterKalmanSIMD::RECOVER_BROKEN_TRACKS, DTrackFitterKalmanSIMD::RecoverBrokenTracks(), DTrackFitterKalmanSIMD::SetCDCReferenceTrajectory(), sin(), DTrackFitterKalmanSIMD::SmoothCentral(), sqrt(), DTrackFitterKalmanSIMD::state_D, DTrackFitterKalmanSIMD::state_phi, DTrackFitterKalmanSIMD::state_q_over_pt, DTrackFitterKalmanSIMD::state_tanl, DTrackFitterKalmanSIMD::state_z, SYS_BCAL, DTrackFitterKalmanSIMD::tanl_, DMatrix5x5::Transpose(), DTrackFitterKalmanSIMD::var_ftime, DTrackFitterKalmanSIMD::x_, DTrackFitterKalmanSIMD::y_, and DTrackFitterKalmanSIMD::z_.

Referenced by DTrackFitterKalmanSIMD::KalmanLoop().

double DTrackFitterKalmanSIMD::ChiSq ( fit_type_t  fit_type,
DReferenceTrajectory rt,
double *  chisq_ptr = NULL,
int *  dof_ptr = NULL,
vector< pull_t > *  pulls_ptr = NULL 
)
virtualinherited
double DTrackFitter::DistToWire ( const DCoordinateSystem wire,
const vector< Extrapolation_t > &  extrapolations,
DVector3 pos = NULL,
DVector3 mom = NULL,
DVector3 position_along_wire = NULL 
) const
inherited
jerror_t DTrackFitterKalmanSIMD::ExtrapolateForwardToOtherDetectors ( void  )
virtualinherited

Definition at line 9067 of file DTrackFitterKalmanSIMD.cc.

References _DBG_, DTrackFitter::bfield, BIG, DTrackFitterKalmanSIMD::Bx, DTrackFitterKalmanSIMD::By, DTrackFitterKalmanSIMD::Bz, DTrackFitter::CORRECT_FOR_ELOSS, DTrackFitterKalmanSIMD::dDIRCz, DE_PER_STEP, DTrackFitterKalmanSIMD::DEBUG_LEVEL, DTrackFitterKalmanSIMD::dFCALz, dir, DTrackFitterKalmanSIMD::dTOFz, DTrackFitterKalmanSIMD::endplate_z_downstream, EPS, EPS2, DTrackFitter::extrapolations, DTrackFitterKalmanSIMD::FastStep(), DTrackFitterKalmanSIMD::fdc_z_wires, DGeometry::FindMatKalman(), DTrackFitterKalmanSIMD::forward_traj, DTrackFitter::geom, DTrackFitterKalmanSIMD::GetdEdx(), DMagneticFieldMap::GetField(), DTrackFitterKalmanSIMD::GetProcessNoise(), xstream::base64::index(), DTrackFitterKalmanSIMD::last_material_map, DTrackFitterKalmanSIMD::mass2, MIN_STEP_SIZE, DTrackFitterKalmanSIMD::mStepSizeS, DTrackFitterKalmanSIMD::mT0Detector, DTrackFitterKalmanSIMD::mT0MinimumDriftTime, DTrackFitterKalmanSIMD::my_cdchits, DTrackFitterKalmanSIMD::my_fdchits, DTrackFitterKalmanSIMD::Q_OVER_P_MAX, S, DTrackFitterKalmanSIMD::SC_BARREL_R2, DTrackFitterKalmanSIMD::SC_END_NOSE_Z, DTrackFitterKalmanSIMD::sc_norm, DTrackFitterKalmanSIMD::SC_PHI_SECTOR1, DTrackFitterKalmanSIMD::sc_pos, sin(), size, sqrt(), DTrackFitterKalmanSIMD::state_q_over_p, DTrackFitterKalmanSIMD::state_tx, DTrackFitterKalmanSIMD::state_ty, DTrackFitterKalmanSIMD::state_x, DTrackFitterKalmanSIMD::state_y, DTrackFitterKalmanSIMD::Step(), SYS_BCAL, SYS_CDC, SYS_DIRC, SYS_FCAL, SYS_FDC, SYS_NULL, SYS_START, SYS_TOF, TIME_UNIT_CONVERSION, and Z_MIN.

Referenced by DTrackFitterKalmanSIMD::ForwardCDCFit(), and DTrackFitterKalmanSIMD::ForwardFit().

bool DTrackFitter::ExtrapolateToRadius ( double  R,
const vector< Extrapolation_t > &  extraps,
DVector3 pos 
) const
inherited

Definition at line 527 of file DTrackFitter.cc.

jerror_t DTrackFitterKalmanSIMD::ExtrapolateToVertex ( DVector2 xy,
DMatrix5x1 Sc,
DMatrix5x5 Cc 
)
inherited

Definition at line 6241 of file DTrackFitterKalmanSIMD.cc.

References _DBG_, DMatrix5x5::AddSym(), DTrackFitterKalmanSIMD::beam_center, DTrackFitterKalmanSIMD::beam_dir, DTrackFitterKalmanSIMD::beam_z0, DTrackFitter::bfield, DTrackFitterKalmanSIMD::BrentsAlgorithm(), DTrackFitterKalmanSIMD::Bx, DTrackFitterKalmanSIMD::By, DTrackFitterKalmanSIMD::Bz, DTrackFitterKalmanSIMD::central_traj, DTrackFitter::CORRECT_FOR_ELOSS, DTrackFitterKalmanSIMD::dBxdx, DTrackFitterKalmanSIMD::dBxdy, DTrackFitterKalmanSIMD::dBxdz, DTrackFitterKalmanSIMD::dBydx, DTrackFitterKalmanSIMD::dBydy, DTrackFitterKalmanSIMD::dBydz, DTrackFitterKalmanSIMD::dBzdx, DTrackFitterKalmanSIMD::dBzdy, DTrackFitterKalmanSIMD::dBzdz, DE_PER_STEP, DTrackFitterKalmanSIMD::DEBUG_LEVEL, EPS, DGeometry::FindMatKalman(), DTrackFitter::geom, DTrackFitterKalmanSIMD::GetdEdx(), DTrackFitterKalmanSIMD::GetEnergyVariance(), DMagneticFieldMap::GetFieldAndGradient(), DTrackFitterKalmanSIMD::GetProcessNoiseCentral(), DTrackFitterKalmanSIMD::I5x5, DTrackFitterKalmanSIMD::last_material_map, DTrackFitterKalmanSIMD::mass2, MIN_STEP_SIZE, DTrackFitterKalmanSIMD::mStepSizeS, Q_OVER_PT_MAX, R2_MAX, DTrackFitterKalmanSIMD::state_D, DTrackFitterKalmanSIMD::state_q_over_pt, DTrackFitterKalmanSIMD::state_tanl, DTrackFitterKalmanSIMD::state_z, DTrackFitterKalmanSIMD::Step(), DTrackFitterKalmanSIMD::StepJacobian(), DTrackFitterKalmanSIMD::StepStateAndCovariance(), DMatrix5x5::Transpose(), Z_MAX, and Z_MIN.

Referenced by DTrackFitterKalmanSIMD::CentralFit(), DTrackFitterKalmanSIMD::ForwardCDCFit(), DTrackFitterKalmanSIMD::ForwardFit(), and DTrackFitterKalmanSIMD::KalmanLoop().

double DTrackFitterKalmanSIMD::fdc_drift_distance ( double  t,
double  Bz 
) const
protectedinherited
double DTrackFitterKalmanSIMD::fdc_drift_variance ( double  t) const
protectedinherited
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 
)
protectedinherited

Definition at line 8508 of file DTrackFitterKalmanSIMD.cc.

References _DBG_, DTrackFitter::pull_t::AddTrackDerivatives(), DTrackFitterKalmanSIMD::alignDerivHists, DTrackFitterKalmanSIMD::ALIGNMENT_FORWARD, DTrackFitter::bfield, DTrackFitterKalmanSIMD::brentCheckHists, DTrackFitterKalmanSIMD::BrentForward(), DTrackFitterKalmanSIMD::Bx, DTrackFitterKalmanSIMD::By, DTrackFitterKalmanSIMD::Bz, DKalmanSIMDCDCHit_t::cosstereo, DTrackFitterKalmanSIMD::dBxdx, DTrackFitterKalmanSIMD::dBxdy, DTrackFitterKalmanSIMD::dBxdz, DTrackFitterKalmanSIMD::dBydx, DTrackFitterKalmanSIMD::dBydy, DTrackFitterKalmanSIMD::dBydz, DTrackFitterKalmanSIMD::dBzdx, DTrackFitterKalmanSIMD::dBzdy, DTrackFitterKalmanSIMD::dBzdz, dDdt0, DKalmanUpdate_t::dDdt0, dDOCAdDirX, dDOCAdDirY, dDOCAdDirZ, dDOCAdOriginX, dDOCAdOriginY, dDOCAdOriginZ, dDOCAdS0, dDOCAdS1, dDOCAdS2, dDOCAdS3, dDOCAdS4, DTrackFitterKalmanSIMD::DEBUG_HISTS, DTrackFitterKalmanSIMD::DEBUG_LEVEL, dir, DKalmanSIMDCDCHit_t::dir, DKalmanUpdate_t::doca, EPS, DTrackFitterKalmanSIMD::GetdEdx(), DMagneticFieldMap::GetFieldAndGradient(), H, DKalmanSIMDCDCHit_t::hit, DKalmanForwardTrajectory_t::K_rho_Z_over_A, DKalmanForwardTrajectory_t::LnI, DKalmanSIMDCDCHit_t::origin, DKalmanForwardTrajectory_t::rho_Z_over_A, DCDCWire::ring, DTrackFitterKalmanSIMD::RING_TO_SKIP, DKalmanForwardTrajectory_t::s, sqrt(), DTrackFitterKalmanSIMD::state_q_over_p, DTrackFitterKalmanSIMD::state_tx, DTrackFitterKalmanSIMD::state_ty, DTrackFitterKalmanSIMD::state_x, DTrackFitterKalmanSIMD::state_y, DTrackFitterKalmanSIMD::StepJacobian(), DKalmanUpdate_t::tcorr, DKalmanUpdate_t::tdrift, DMatrix5x5::Transpose(), tx, DCoordinateSystem::udir, DKalmanUpdate_t::variance, DCDCTrackHit::wire, DKalmanForwardTrajectory_t::z, DKalmanForwardTrajectory_t::Z, and DKalmanSIMDCDCHit_t::z0wire.

Referenced by SmoothForward(), DTrackFitterKalmanSIMD::SmoothForward(), and DTrackFitterKalmanSIMD::SmoothForwardCDC().

jerror_t DTrackFitterKalmanSIMD::FindCentralResiduals ( vector< DKalmanUpdate_t updates)
protectedinherited
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  )
virtualinherited

Implements DTrackFitter.

Definition at line 727 of file DTrackFitterKalmanSIMD.cc.

References _DBG_, DTrackFitterKalmanSIMD::AddCDCHit(), DTrackFitterKalmanSIMD::AddFDCHit(), cdc_hit(), DTrackFitterKalmanSIMD::cdc_rmid, DTrackFitterKalmanSIMD::cdc_updates, DTrackFitterKalmanSIMD::cdc_used_in_fit, DTrackFitter::cdchits, DTrackFitterKalmanSIMD::cdcwires, DKinematicData::charge(), DTrackFitter::chisq, DTrackFitterKalmanSIMD::chisq_, DTrackFitterKalmanSIMD::cov, DTrackFitterKalmanSIMD::D_, DTrackFitterKalmanSIMD::DEBUG_LEVEL, DKalmanSIMDCDCHit_cmp(), DKalmanSIMDFDCHit_cmp(), DTrackFitterKalmanSIMD::dResourcePool_TMatrixFSym, ELECTRON_MASS, EPS, DTrackFitter::extrapolations, DTrackFitterKalmanSIMD::fcov, DTrackFitterKalmanSIMD::fdc_package_size, DTrackFitterKalmanSIMD::fdc_rmin_packages, DTrackFitterKalmanSIMD::fdc_updates, DTrackFitterKalmanSIMD::fdc_used_in_fit, DTrackFitterKalmanSIMD::fdc_z_wires, DTrackFitter::fdchits, DTrackFitter::fit_params, DTrackFitter::fit_status, DTrackFitter::fit_type, DTrackFitterKalmanSIMD::FORWARD_PARMS_COV, DTrackFitterKalmanSIMD::Get7x7ErrorMatrix(), DTrackFitterKalmanSIMD::Get7x7ErrorMatrixForward(), DTrackFitterKalmanSIMD::GetCharge(), DTrackFitterKalmanSIMD::GetChiSq(), DTrackFitterKalmanSIMD::GetMomentum(), DTrackFitterKalmanSIMD::GetNDF(), DTrackFitterKalmanSIMD::GetPosition(), IDTrack(), DTrackFitter::input_params, DTrackFitterKalmanSIMD::IsElectron, DTrackFitterKalmanSIMD::IsHadron, DTrackFitterKalmanSIMD::IsPositron, DTrackFitterKalmanSIMD::KalmanLoop(), DTrackFitter::kFitFailed, DTrackFitter::kFitNotDone, DTrackFitter::kFitSuccess, DTrackFitter::kTimeBased, DTrackFitterKalmanSIMD::late_hit, DTrackFitterKalmanSIMD::m_ratio, DTrackFitterKalmanSIMD::m_ratio_sq, DKinematicData::mass(), DTrackFitterKalmanSIMD::MASS, DTrackFitterKalmanSIMD::mass2, DTrackFitterKalmanSIMD::mT0, DTrackFitterKalmanSIMD::mT0Detector, DTrackFitterKalmanSIMD::mT0MinimumDriftTime, DTrackFitterKalmanSIMD::mVarT0, DTrackFitterKalmanSIMD::my_cdchits, DTrackFitterKalmanSIMD::my_fdchits, DTrackFitter::Ndof, DTrackFitterKalmanSIMD::phi_, DTrackFitter::potential_cdc_hits_on_track, DTrackFitter::potential_fdc_hits_on_track, DTrackFitter::pulls, DTrackFitterKalmanSIMD::q_over_p_, DTrackFitterKalmanSIMD::q_over_pt_, DTrackFitterKalmanSIMD::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(), DTrackFitterKalmanSIMD::tanl_, DTrackFitterKalmanSIMD::tx_, DTrackFitterKalmanSIMD::ty_, DTrackFitterKalmanSIMD::USE_CDC_HITS, DTrackFitterKalmanSIMD::USE_FDC_HITS, DTrackFitterKalmanSIMD::x_, DTrackFitterKalmanSIMD::y_, and DTrackFitterKalmanSIMD::z_.

kalman_error_t DTrackFitterKalmanSIMD::ForwardCDCFit ( const DMatrix5x1 S,
const DMatrix5x5 C0 
)
protectedinherited

Definition at line 7186 of file DTrackFitterKalmanSIMD.cc.

References _DBG_, DTrackFitterKalmanSIMD::ANNEAL_POW_CONST, DTrackFitterKalmanSIMD::ANNEAL_SCALE, DTrackFitterKalmanSIMD::beam_center, DTrackFitterKalmanSIMD::beam_dir, DTrackFitterKalmanSIMD::beam_z0, DTrackFitterKalmanSIMD::break_point_cdc_index, BREAK_POINT_FOUND, DTrackFitterKalmanSIMD::break_point_step_index, BROKEN_COVARIANCE_MATRIX, C0, DTrackFitterKalmanSIMD::cdc_used_in_fit, DTrackFitter::cdchits_used_in_fit, DTrackFitter::chisq, DTrackFitterKalmanSIMD::chisq_, CHISQ_DELTA, DTrackFitter::ClearExtrapolations(), DTrackFitterKalmanSIMD::D_, DTrackFitterKalmanSIMD::DEBUG_LEVEL, EPS, EPS2, DTrackFitterKalmanSIMD::ExtrapolateForwardToOtherDetectors(), DTrackFitterKalmanSIMD::ExtrapolateToVertex(), EXTRAPOLATION_FAILED, DTrackFitter::extrapolations, DTrackFitterKalmanSIMD::fcov, FIT_FAILED, FIT_NOT_DONE, FIT_SUCCEEDED, DTrackFitter::fit_type, DTrackFitterKalmanSIMD::FORWARD_PARMS_COV, DTrackFitterKalmanSIMD::ftime, DTrackFitterKalmanSIMD::good_hit, INVALID_FIT, DTrackFitter::IsSmoothed, DTrackFitterKalmanSIMD::KalmanForwardCDC(), DTrackFitter::kTimeBased, DTrackFitterKalmanSIMD::last_material_map, DTrackFitterKalmanSIMD::late_hit, DTrackFitterKalmanSIMD::len, MAX_TB_PASSES, MAX_WB_PASSES, DTrackFitterKalmanSIMD::MIN_HITS_FOR_REFIT, MIN_ITER, MOMENTUM_OUT_OF_RANGE, DTrackFitterKalmanSIMD::my_cdchits, DTrackFitterKalmanSIMD::ndf_, DTrackFitterKalmanSIMD::phi_, POSITION_OUT_OF_RANGE, PRUNED_TOO_MANY_HITS, DTrackFitter::pulls, DTrackFitterKalmanSIMD::q_over_p_, DTrackFitterKalmanSIMD::Q_OVER_P_MAX, DTrackFitterKalmanSIMD::q_over_pt_, DTrackFitterKalmanSIMD::RECOVER_BROKEN_TRACKS, DTrackFitterKalmanSIMD::RecoverBrokenTracks(), S, DTrackFitterKalmanSIMD::SetCDCForwardReferenceTrajectory(), sin(), DTrackFitterKalmanSIMD::SmoothForwardCDC(), sqrt(), DTrackFitterKalmanSIMD::state_q_over_p, DTrackFitterKalmanSIMD::state_tx, DTrackFitterKalmanSIMD::state_ty, DTrackFitterKalmanSIMD::state_x, DTrackFitterKalmanSIMD::state_y, SYS_BCAL, DTrackFitterKalmanSIMD::tanl_, DTrackFitterKalmanSIMD::TransformCovariance(), DTrackFitterKalmanSIMD::tx_, DTrackFitterKalmanSIMD::ty_, DTrackFitterKalmanSIMD::var_ftime, x, DTrackFitterKalmanSIMD::x_, y, DTrackFitterKalmanSIMD::y_, and DTrackFitterKalmanSIMD::z_.

Referenced by DTrackFitterKalmanSIMD::KalmanLoop().

kalman_error_t DTrackFitterKalmanSIMD::ForwardFit ( const DMatrix5x1 S,
const DMatrix5x5 C0 
)
protectedinherited

Definition at line 6942 of file DTrackFitterKalmanSIMD.cc.

References _DBG_, DTrackFitterKalmanSIMD::ANNEAL_POW_CONST, DTrackFitterKalmanSIMD::ANNEAL_SCALE, DTrackFitterKalmanSIMD::beam_center, DTrackFitterKalmanSIMD::beam_dir, DTrackFitterKalmanSIMD::beam_z0, DTrackFitterKalmanSIMD::break_point_cdc_index, DTrackFitterKalmanSIMD::break_point_fdc_index, BREAK_POINT_FOUND, DTrackFitterKalmanSIMD::break_point_step_index, C0, DTrackFitterKalmanSIMD::cdc_used_in_fit, DTrackFitter::cdchits_used_in_fit, DTrackFitter::chisq, DTrackFitterKalmanSIMD::chisq_, CHISQ_DELTA, DTrackFitter::ClearExtrapolations(), DTrackFitterKalmanSIMD::D_, DTrackFitterKalmanSIMD::DEBUG_LEVEL, EPS, EPS2, DTrackFitterKalmanSIMD::ExtrapolateForwardToOtherDetectors(), DTrackFitterKalmanSIMD::ExtrapolateToVertex(), DTrackFitter::extrapolations, DTrackFitterKalmanSIMD::fcov, DTrackFitterKalmanSIMD::fdc_used_in_fit, DTrackFitter::fdchits_used_in_fit, FIT_FAILED, FIT_NOT_DONE, FIT_SUCCEEDED, DTrackFitter::fit_type, DTrackFitterKalmanSIMD::FORWARD_ANNEAL_POW_CONST, DTrackFitterKalmanSIMD::FORWARD_ANNEAL_SCALE, DTrackFitterKalmanSIMD::FORWARD_PARMS_COV, DTrackFitterKalmanSIMD::forward_traj, DTrackFitterKalmanSIMD::ftime, DTrackFitterKalmanSIMD::good_hit, INVALID_FIT, DTrackFitter::IsSmoothed, DTrackFitterKalmanSIMD::KalmanForward(), DTrackFitter::kTimeBased, DTrackFitterKalmanSIMD::last_material_map, DTrackFitterKalmanSIMD::late_hit, DTrackFitterKalmanSIMD::len, MAX_TB_PASSES, MAX_WB_PASSES, DTrackFitterKalmanSIMD::MIN_HITS_FOR_REFIT, MIN_ITER, MOMENTUM_OUT_OF_RANGE, DTrackFitterKalmanSIMD::my_cdchits, DTrackFitterKalmanSIMD::my_fdchits, DTrackFitterKalmanSIMD::ndf_, DTrackFitterKalmanSIMD::phi_, POSITION_OUT_OF_RANGE, PRUNED_TOO_MANY_HITS, DTrackFitter::pulls, DTrackFitterKalmanSIMD::q_over_p_, DTrackFitterKalmanSIMD::Q_OVER_P_MAX, DTrackFitterKalmanSIMD::q_over_pt_, DTrackFitterKalmanSIMD::RECOVER_BROKEN_TRACKS, DTrackFitterKalmanSIMD::RecoverBrokenForwardTracks(), S, DTrackFitterKalmanSIMD::SetReferenceTrajectory(), sin(), DTrackFitterKalmanSIMD::SmoothForward(), sqrt(), DTrackFitterKalmanSIMD::state_q_over_p, DTrackFitterKalmanSIMD::state_tx, DTrackFitterKalmanSIMD::state_ty, DTrackFitterKalmanSIMD::state_x, DTrackFitterKalmanSIMD::state_y, SYS_BCAL, DTrackFitterKalmanSIMD::tanl_, DTrackFitterKalmanSIMD::TransformCovariance(), DTrackFitterKalmanSIMD::tx_, DTrackFitterKalmanSIMD::ty_, DTrackFitterKalmanSIMD::var_ftime, x, DTrackFitterKalmanSIMD::x_, y, DTrackFitterKalmanSIMD::y_, and DTrackFitterKalmanSIMD::z_.

Referenced by DTrackFitterKalmanSIMD::KalmanLoop().

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

Definition at line 137 of file DTrackFitter.h.

double DTrackFitterKalmanSIMD::GetCharge ( void  )
inlineinherited

Definition at line 215 of file DTrackFitterKalmanSIMD.h.

Referenced by DTrackFitterKalmanSIMD::FitTrack().

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

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 
)
inherited
double DTrackFitterKalmanSIMD::GetFDCDriftDistance ( double  time,
double  Bz 
) const
inlineinherited

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)
inlineinherited

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)
inlineinherited
unsigned int DTrackFitterKalmanSIMD::GetNDF ( void  )
inlineinherited
unsigned int DTrackFitter::GetNumPotentialCDCHits ( void  ) const
inlineinherited
unsigned int DTrackFitter::GetNumPotentialFDCHits ( void  ) const
inlineinherited
void DTrackFitterKalmanSIMD::GetPosition ( DVector3 pos)
inlineinherited
unsigned int DTrackFitterKalmanSIMD::GetRatioMeasuredPotentialCDCHits ( void  ) const
inlineinherited

Definition at line 180 of file DTrackFitterKalmanSIMD.h.

unsigned int DTrackFitterKalmanSIMD::GetRatioMeasuredPotentialFDCHits ( void  ) const
inlineinherited

Definition at line 179 of file DTrackFitterKalmanSIMD.h.

DTrackFitter::JOBJECT_PUBLIC ( DTrackFitter  )
inherited
kalman_error_t DTrackFitterKalmanSIMD::KalmanCentral ( double  anneal_factor,
DMatrix5x1 S,
DMatrix5x5 C,
DVector2 xy,
double &  chisq,
unsigned int &  myndf 
)
inherited

Definition at line 3834 of file DTrackFitterKalmanSIMD.cc.

References _DBG_, DMatrix5x5::AddSym(), DTrackFitterKalmanSIMD::ALIGNMENT_CENTRAL, BIG, DTrackFitterKalmanSIMD::break_point_cdc_index, BREAK_POINT_FOUND, DTrackFitterKalmanSIMD::break_point_step_index, DTrackFitterKalmanSIMD::BrentCentral(), BROKEN_COVARIANCE_MATRIX, DTrackFitterKalmanSIMD::cdc_origin, DTrackFitterKalmanSIMD::CDC_T_DRIFT_MIN, DTrackFitterKalmanSIMD::cdc_updates, DTrackFitterKalmanSIMD::cdc_used_in_fit, DTrackFitterKalmanSIMD::central_traj, DTrackFitterKalmanSIMD::ComputeCDCDrift(), DTrackFitter::CORRECT_FOR_ELOSS, dDdt0, DTrackFitterKalmanSIMD::DEBUG_LEVEL, dir, EPS, DTrackFitterKalmanSIMD::FactorForSenseOfRotation, FIT_SUCCEEDED, DTrackFitter::fit_type, DTrackFitterKalmanSIMD::GetdEdx(), DTrackFitterKalmanSIMD::good_hit, H, DMatrix5x5::IsPosDef(), DTrackFitter::kTimeBased, DTrackFitterKalmanSIMD::max_sag, DTrackFitterKalmanSIMD::MIN_HITS_FOR_REFIT, DTrackFitterKalmanSIMD::MINIMUM_HIT_FRACTION, MOMENTUM_OUT_OF_RANGE, DTrackFitterKalmanSIMD::mT0, DTrackFitterKalmanSIMD::my_cdchits, NEGATIVE_VARIANCE, DTrackFitterKalmanSIMD::NUM_CDC_SIGMA_CUT, DCoordinateSystem::origin, POSITION_OUT_OF_RANGE, PRUNED_TOO_MANY_HITS, Q_OVER_PT_MAX, qBr2p, R2_MAX, DCDCWire::ring, DTrackFitterKalmanSIMD::RING_TO_SKIP, DTrackFitterKalmanSIMD::sag_phi_offset, sin(), sqrt(), DTrackFitterKalmanSIMD::state_D, DTrackFitterKalmanSIMD::state_phi, DTrackFitterKalmanSIMD::state_q_over_pt, DTrackFitterKalmanSIMD::state_tanl, DTrackFitterKalmanSIMD::state_z, DTrackFitterKalmanSIMD::StepStateAndCovariance(), DCDCWire::straw, DMatrix5x5::SubSym(), TIME_UNIT_CONVERSION, DMatrix5x5::Transpose(), DTrackFitterKalmanSIMD::USE_PASS1_TIME_MODE, Z_MAX, and Z_MIN.

Referenced by DTrackFitterKalmanSIMD::CentralFit(), and DTrackFitterKalmanSIMD::RecoverBrokenTracks().

kalman_error_t DTrackFitterKalmanSIMD_ALT1::KalmanForward ( double  fdc_anneal,
double  cdc_anneal,
DMatrix5x1 S,
DMatrix5x5 C,
double &  chisq,
unsigned int &  numdof 
)
virtual

Reimplemented from DTrackFitterKalmanSIMD.

Definition at line 12 of file DTrackFitterKalmanSIMD_ALT1.cc.

References _DBG_, DTrackFitterKalmanSIMD::ADD_VERTEX_POINT, DMatrix5x5::AddSym(), alpha, DTrackFitter::bfield, DTrackFitterKalmanSIMD::break_point_cdc_index, DTrackFitterKalmanSIMD::break_point_fdc_index, BREAK_POINT_FOUND, DTrackFitterKalmanSIMD::break_point_step_index, DTrackFitterKalmanSIMD::BrentsAlgorithm(), BROKEN_COVARIANCE_MATRIX, DTrackFitterKalmanSIMD::cdc_updates, DTrackFitterKalmanSIMD::cdc_used_in_fit, DTrackFitterKalmanSIMD::ComputeCDCDrift(), DTrackFitter::CORRECT_FOR_ELOSS, DTrackFitterKalmanSIMD::DEBUG_LEVEL, dir, e, DTrackFitterKalmanSIMD::endplate_z, EPS, EPS3, DTrackFitterKalmanSIMD::fdc_updates, DTrackFitterKalmanSIMD::fdc_used_in_fit, FIT_SUCCEEDED, DTrackFitter::fit_type, DTrackFitterKalmanSIMD::forward_traj, DMagneticFieldMap::GetBz(), DTrackFitterKalmanSIMD::GetdEdx(), DTrackFitterKalmanSIMD::good_hit, H, DTrackFitterKalmanSIMD::I5x5, DTrackFitter::kTimeBased, M_TWO_PI, MAX_CHI2, DTrackFitterKalmanSIMD::max_sag, DTrackFitterKalmanSIMD::MIN_HITS_FOR_REFIT, DTrackFitterKalmanSIMD::MINIMUM_HIT_FRACTION, MOMENTUM_OUT_OF_RANGE, DTrackFitterKalmanSIMD::mStepSizeZ, DTrackFitterKalmanSIMD::mT0, MultiplyTranspose(), DTrackFitterKalmanSIMD::my_cdchits, DTrackFitterKalmanSIMD::my_fdchits, NEGATIVE_VARIANCE, DTrackFitterKalmanSIMD::NUM_CDC_SIGMA_CUT, DTrackFitterKalmanSIMD::NUM_FDC_SIGMA_CUT, DCoordinateSystem::origin, DTrackFitterKalmanSIMD::PLANE_TO_SKIP, DMatrix5x1::Print(), DMatrix5x5::Print(), printf(), PRUNED_TOO_MANY_HITS, DTrackFitterKalmanSIMD::Q_OVER_P_MAX, qBr2p, DCDCWire::ring, DTrackFitterKalmanSIMD::RING_TO_SKIP, S, DTrackFitterKalmanSIMD::sag_phi_offset, DMatrix5x5::SandwichMultiply(), sin(), sqrt(), DTrackFitterKalmanSIMD::state_q_over_p, DTrackFitterKalmanSIMD::state_tx, DTrackFitterKalmanSIMD::state_ty, DTrackFitterKalmanSIMD::state_x, DTrackFitterKalmanSIMD::state_y, DTrackFitterKalmanSIMD::Step(), DTrackFitterKalmanSIMD::StepJacobian(), DCDCWire::straw, DMatrix5x5::SubSym(), sum, DTrackFitterKalmanSIMD::TARGET_Z, temp, TIME_UNIT_CONVERSION, tx, u, DTrackFitterKalmanSIMD::USE_PASS1_TIME_MODE, x, DTrackFitterKalmanSIMD::x_, y, DTrackFitterKalmanSIMD::y_, and DTrackFitterKalmanSIMD::z_.

kalman_error_t DTrackFitterKalmanSIMD::KalmanForwardCDC ( double  anneal,
DMatrix5x1 S,
DMatrix5x5 C,
double &  chisq,
unsigned int &  numdof 
)
inherited

Definition at line 5305 of file DTrackFitterKalmanSIMD.cc.

References _DBG_, DMatrix5x5::AddSym(), DTrackFitterKalmanSIMD::ALIGNMENT_FORWARD, BIG, DTrackFitterKalmanSIMD::break_point_cdc_index, BREAK_POINT_FOUND, DTrackFitterKalmanSIMD::break_point_step_index, DTrackFitterKalmanSIMD::BrentForward(), BROKEN_COVARIANCE_MATRIX, DTrackFitterKalmanSIMD::CDC_T_DRIFT_MIN, DTrackFitterKalmanSIMD::cdc_updates, DTrackFitterKalmanSIMD::cdc_used_in_fit, DTrackFitterKalmanSIMD::ComputeCDCDrift(), DTrackFitter::CORRECT_FOR_ELOSS, dDdt0, DTrackFitterKalmanSIMD::DEBUG_LEVEL, dir, DTrackFitterKalmanSIMD::endplate_z, DTrackFitterKalmanSIMD::endplate_z_downstream, EPS, FIT_FAILED, FIT_SUCCEEDED, DTrackFitter::fit_type, DTrackFitterKalmanSIMD::forward_traj, DTrackFitterKalmanSIMD::GetdEdx(), DTrackFitterKalmanSIMD::good_hit, H, DMatrix5x1::IsFinite(), DMatrix5x5::IsPosDef(), DTrackFitter::kTimeBased, DTrackFitterKalmanSIMD::max_sag, DTrackFitterKalmanSIMD::MIN_HITS_FOR_REFIT, DTrackFitterKalmanSIMD::MINIMUM_HIT_FRACTION, MOMENTUM_OUT_OF_RANGE, DTrackFitterKalmanSIMD::mStepSizeZ, DTrackFitterKalmanSIMD::mT0, DTrackFitterKalmanSIMD::my_cdchits, NEGATIVE_VARIANCE, DTrackFitterKalmanSIMD::NUM_CDC_SIGMA_CUT, DCoordinateSystem::origin, POSITION_OUT_OF_RANGE, printf(), PRUNED_TOO_MANY_HITS, DTrackFitterKalmanSIMD::Q_OVER_P_MAX, qBr2p, R2_MAX, DCDCWire::ring, DTrackFitterKalmanSIMD::RING_TO_SKIP, S, DTrackFitterKalmanSIMD::sag_phi_offset, sin(), sqrt(), DTrackFitterKalmanSIMD::state_q_over_p, DTrackFitterKalmanSIMD::state_tx, DTrackFitterKalmanSIMD::state_ty, DTrackFitterKalmanSIMD::state_x, DTrackFitterKalmanSIMD::state_y, DTrackFitterKalmanSIMD::Step(), DTrackFitterKalmanSIMD::StepJacobian(), DCDCWire::straw, DMatrix5x5::SubSym(), TIME_UNIT_CONVERSION, DMatrix5x5::Transpose(), tx, DTrackFitterKalmanSIMD::USE_PASS1_TIME_MODE, DTrackFitterKalmanSIMD::x_, DTrackFitterKalmanSIMD::y_, and DTrackFitterKalmanSIMD::z_.

Referenced by DTrackFitterKalmanSIMD::ForwardCDCFit(), and DTrackFitterKalmanSIMD::RecoverBrokenTracks().

jerror_t DTrackFitterKalmanSIMD::KalmanLoop ( void  )
inherited

Definition at line 3113 of file DTrackFitterKalmanSIMD.cc.

References _DBG_, DTrackFitter::bfield, DTrackFitterKalmanSIMD::Bz, C0, DTrackFitter::cdchits_used_in_fit, DTrackFitterKalmanSIMD::CentralFit(), DKinematicData::charge(), DTrackFitterKalmanSIMD::chisq_, DTrackFitter::ClearExtrapolations(), DTrackFitterKalmanSIMD::COVARIANCE_SCALE_FACTOR_CENTRAL, DTrackFitterKalmanSIMD::COVARIANCE_SCALE_FACTOR_FORWARD, DTrackFitterKalmanSIMD::DEBUG_LEVEL, DTrackFitterKalmanSIMD::ExtrapolateToVertex(), DTrackFitter::extrapolations, DTrackFitterKalmanSIMD::FactorForSenseOfRotation, DTrackFitterKalmanSIMD::fcov, DTrackFitter::fdchits_used_in_fit, FIT_FAILED, FIT_NOT_DONE, FIT_SUCCEEDED, DTrackFitter::fit_type, DTrackFitterKalmanSIMD::ForwardCDCFit(), DTrackFitterKalmanSIMD::ForwardFit(), DMagneticFieldMap::GetBz(), DTrackFitter::input_params, INVALID_FIT, DTrackFitter::IsSmoothed, DTrackFitter::kWireBased, DTrackFitterKalmanSIMD::mCDCInternalStepSize, DTrackFitterKalmanSIMD::mCentralStepSize, DKinematicData::momentum(), DTrackFitterKalmanSIMD::mStepSizeS, DTrackFitterKalmanSIMD::my_cdchits, DTrackFitterKalmanSIMD::my_fdchits, DTrackFitterKalmanSIMD::ndf_, DTrackFitterKalmanSIMD::phi_, DKinematicData::position(), DTrackFitter::pulls, py, DTrackFitterKalmanSIMD::q_over_p_, DTrackFitterKalmanSIMD::q_over_pt_, qBr2p, sin(), DTrackFitterKalmanSIMD::state_D, DTrackFitterKalmanSIMD::state_phi, DTrackFitterKalmanSIMD::state_q_over_p, DTrackFitterKalmanSIMD::state_q_over_pt, DTrackFitterKalmanSIMD::state_tanl, DTrackFitterKalmanSIMD::state_tx, DTrackFitterKalmanSIMD::state_ty, DTrackFitterKalmanSIMD::state_x, DTrackFitterKalmanSIMD::state_y, DTrackFitterKalmanSIMD::state_z, DTrackFitterKalmanSIMD::tanl_, temp, DTrackFitterKalmanSIMD::THETA_CUT, DTrackFitterKalmanSIMD::tx_, DTrackFitterKalmanSIMD::ty_, x, DTrackFitterKalmanSIMD::x_, y, DTrackFitterKalmanSIMD::y_, DTrackFitterKalmanSIMD::z_, and Z_MIN.

Referenced by DTrackFitterKalmanSIMD::FitTrack().

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

Definition at line 66 of file DTrackFitterKalmanSIMD.cc.

Referenced by DTrackFitterKalmanSIMD::ComputeCDCDrift().

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

Definition at line 85 of file DTrackFitterKalmanSIMD.cc.

string DTrackFitterKalmanSIMD_ALT1::Name ( void  ) const
inlinevirtual

Reimplemented from DTrackFitterKalmanSIMD.

Definition at line 25 of file DTrackFitterKalmanSIMD_ALT1.h.

References string.

jerror_t DTrackFitterKalmanSIMD::PropagateCentral ( int  length,
int &  index,
DVector2 my_xy,
double &  var_t_factor,
DMatrix5x1 Sc,
bool &  stepped_to_boundary 
)
protectedinherited

Definition at line 1386 of file DTrackFitterKalmanSIMD.cc.

References DKalmanCentralTrajectory_t::B, DTrackFitter::bfield, BIG, DTrackFitterKalmanSIMD::Bx, DTrackFitterKalmanSIMD::By, DTrackFitterKalmanSIMD::Bz, DTrackFitterKalmanSIMD::central_traj, DKalmanCentralTrajectory_t::chi2a_corr, DKalmanCentralTrajectory_t::chi2a_factor, DKalmanCentralTrajectory_t::chi2c_factor, DKalmanCentralTrajectory_t::Ckk, DTrackFitter::CORRECT_FOR_ELOSS, DTrackFitterKalmanSIMD::dBxdx, DTrackFitterKalmanSIMD::dBxdy, DTrackFitterKalmanSIMD::dBxdz, DTrackFitterKalmanSIMD::dBydx, DTrackFitterKalmanSIMD::dBydy, DTrackFitterKalmanSIMD::dBydz, DTrackFitterKalmanSIMD::dBzdx, DTrackFitterKalmanSIMD::dBzdy, DTrackFitterKalmanSIMD::dBzdz, DE_PER_STEP, DTrackFitterKalmanSIMD::ENABLE_BOUNDARY_CHECK, DTrackFitterKalmanSIMD::endplate_r2min, EPS, EPS3, DTrackFitterKalmanSIMD::FasterStep(), DGeometry::FindMatKalman(), DTrackFitter::fit_type, DTrackFitterKalmanSIMD::ftime, DTrackFitter::geom, DTrackFitterKalmanSIMD::GetdEdx(), DTrackFitterKalmanSIMD::GetEnergyVariance(), DMagneticFieldMap::GetFieldAndGradient(), DTrackFitterKalmanSIMD::GetProcessNoiseCentral(), DKalmanCentralTrajectory_t::h_id, xstream::base64::index(), DKalmanCentralTrajectory_t::J, DKalmanCentralTrajectory_t::K_rho_Z_over_A, DTrackFitter::kTimeBased, DTrackFitterKalmanSIMD::last_material_map, DTrackFitterKalmanSIMD::len, DKalmanCentralTrajectory_t::LnI, DTrackFitterKalmanSIMD::mass2, DTrackFitterKalmanSIMD::mCDCInternalStepSize, MIN_STEP_SIZE, DTrackFitterKalmanSIMD::mStepSizeS, DKalmanCentralTrajectory_t::Q, DKalmanCentralTrajectory_t::rho_Z_over_A, DKalmanCentralTrajectory_t::S, DKalmanCentralTrajectory_t::s, sin(), DKalmanCentralTrajectory_t::Skk, sqrt(), DTrackFitterKalmanSIMD::state_D, DTrackFitterKalmanSIMD::state_phi, DTrackFitterKalmanSIMD::state_q_over_pt, DTrackFitterKalmanSIMD::state_tanl, DTrackFitterKalmanSIMD::state_z, DTrackFitterKalmanSIMD::StepJacobian(), DKalmanCentralTrajectory_t::t, temp, DTrackFitterKalmanSIMD::var_ftime, DKalmanCentralTrajectory_t::xy, DKalmanCentralTrajectory_t::Z, DTrackFitterKalmanSIMD::Zero5x1, and DTrackFitterKalmanSIMD::Zero5x5.

Referenced by DTrackFitterKalmanSIMD::SetCDCReferenceTrajectory().

jerror_t DTrackFitterKalmanSIMD::PropagateForward ( int  length,
int &  index,
double &  z,
double  zhit,
DMatrix5x1 S,
bool &  done,
bool &  stepped_to_boundary,
bool &  stepped_to_endplate 
)
protectedinherited

Definition at line 1629 of file DTrackFitterKalmanSIMD.cc.

References DKalmanForwardTrajectory_t::B, BIG, DTrackFitterKalmanSIMD::Bx, DTrackFitterKalmanSIMD::By, DTrackFitterKalmanSIMD::Bz, DTrackFitterKalmanSIMD::cdc_origin, DKalmanForwardTrajectory_t::chi2a_corr, DKalmanForwardTrajectory_t::chi2a_factor, DKalmanForwardTrajectory_t::chi2c_factor, DKalmanForwardTrajectory_t::Ckk, DTrackFitter::CORRECT_FOR_ELOSS, DE_PER_STEP, DTrackFitterKalmanSIMD::ENABLE_BOUNDARY_CHECK, DTrackFitterKalmanSIMD::endplate_dz, DTrackFitterKalmanSIMD::endplate_r2min, DTrackFitterKalmanSIMD::endplate_z, EPS, EPS3, DTrackFitterKalmanSIMD::FasterStep(), DGeometry::FindMatKalman(), DTrackFitter::fit_type, DTrackFitterKalmanSIMD::forward_traj, DTrackFitterKalmanSIMD::ftime, DTrackFitter::geom, DTrackFitterKalmanSIMD::GetdEdx(), DTrackFitterKalmanSIMD::GetEnergyVariance(), DTrackFitterKalmanSIMD::GetProcessNoise(), DKalmanForwardTrajectory_t::h_id, DKalmanForwardTrajectory_t::J, DKalmanForwardTrajectory_t::K_rho_Z_over_A, DTrackFitter::kTimeBased, DTrackFitterKalmanSIMD::last_material_map, DTrackFitterKalmanSIMD::len, DKalmanForwardTrajectory_t::LnI, DTrackFitterKalmanSIMD::mass2, DTrackFitterKalmanSIMD::mCentralStepSize, MIN_STEP_SIZE, DTrackFitterKalmanSIMD::mStepSizeS, DKalmanForwardTrajectory_t::num_hits, DKalmanForwardTrajectory_t::Q, DKalmanForwardTrajectory_t::rho_Z_over_A, S, DKalmanForwardTrajectory_t::S, DKalmanForwardTrajectory_t::s, DKalmanForwardTrajectory_t::Skk, sqrt(), DTrackFitterKalmanSIMD::state_q_over_p, DTrackFitterKalmanSIMD::state_tx, DTrackFitterKalmanSIMD::state_ty, DTrackFitterKalmanSIMD::state_x, DTrackFitterKalmanSIMD::state_y, DTrackFitterKalmanSIMD::StepJacobian(), DKalmanForwardTrajectory_t::t, temp, DKalmanForwardTrajectory_t::z, DKalmanForwardTrajectory_t::Z, DTrackFitterKalmanSIMD::Zero5x1, and DTrackFitterKalmanSIMD::Zero5x5.

Referenced by DTrackFitterKalmanSIMD::SetReferenceTrajectory().

jerror_t DTrackFitterKalmanSIMD::PropagateForwardCDC ( int  length,
int &  index,
double &  z,
double &  r2,
DMatrix5x1 S,
bool &  stepped_to_boundary 
)
protectedinherited

Definition at line 1241 of file DTrackFitterKalmanSIMD.cc.

References DKalmanForwardTrajectory_t::B, BIG, DTrackFitterKalmanSIMD::Bx, DTrackFitterKalmanSIMD::By, DTrackFitterKalmanSIMD::Bz, DTrackFitterKalmanSIMD::cdc_origin, DKalmanForwardTrajectory_t::chi2a_corr, DKalmanForwardTrajectory_t::chi2a_factor, DKalmanForwardTrajectory_t::chi2c_factor, DKalmanForwardTrajectory_t::Ckk, DTrackFitter::CORRECT_FOR_ELOSS, DE_PER_STEP, DTrackFitterKalmanSIMD::ENABLE_BOUNDARY_CHECK, DTrackFitterKalmanSIMD::endplate_r2min, DTrackFitterKalmanSIMD::endplate_z, EPS, EPS3, DTrackFitterKalmanSIMD::FasterStep(), DGeometry::FindMatKalman(), DTrackFitter::fit_type, DTrackFitterKalmanSIMD::forward_traj, DTrackFitterKalmanSIMD::ftime, DTrackFitter::geom, DTrackFitterKalmanSIMD::GetdEdx(), DTrackFitterKalmanSIMD::GetEnergyVariance(), DTrackFitterKalmanSIMD::GetProcessNoise(), DKalmanForwardTrajectory_t::h_id, xstream::base64::index(), DKalmanForwardTrajectory_t::J, DKalmanForwardTrajectory_t::K_rho_Z_over_A, DTrackFitter::kTimeBased, DTrackFitterKalmanSIMD::last_material_map, DTrackFitterKalmanSIMD::len, DKalmanForwardTrajectory_t::LnI, DTrackFitterKalmanSIMD::mass2, DTrackFitterKalmanSIMD::mCDCInternalStepSize, MIN_STEP_SIZE, DTrackFitterKalmanSIMD::mStepSizeS, DKalmanForwardTrajectory_t::num_hits, DKalmanForwardTrajectory_t::Q, DKalmanForwardTrajectory_t::rho_Z_over_A, S, DKalmanForwardTrajectory_t::S, DKalmanForwardTrajectory_t::s, DKalmanForwardTrajectory_t::Skk, sqrt(), DTrackFitterKalmanSIMD::state_q_over_p, DTrackFitterKalmanSIMD::state_tx, DTrackFitterKalmanSIMD::state_ty, DTrackFitterKalmanSIMD::state_x, DTrackFitterKalmanSIMD::state_y, DTrackFitterKalmanSIMD::StepJacobian(), DKalmanForwardTrajectory_t::t, temp, DKalmanForwardTrajectory_t::z, DKalmanForwardTrajectory_t::Z, DTrackFitterKalmanSIMD::Zero5x1, and DTrackFitterKalmanSIMD::Zero5x5.

Referenced by DTrackFitterKalmanSIMD::SetCDCForwardReferenceTrajectory().

void DTrackFitterKalmanSIMD::ResetKalmanSIMD ( void  )
protectedinherited

Definition at line 654 of file DTrackFitterKalmanSIMD.cc.

References DTrackFitterKalmanSIMD::break_point_cdc_index, DTrackFitterKalmanSIMD::break_point_fdc_index, DTrackFitterKalmanSIMD::break_point_step_index, DTrackFitterKalmanSIMD::Bx, DTrackFitterKalmanSIMD::By, DTrackFitterKalmanSIMD::Bz, DTrackFitterKalmanSIMD::cdc_updates, DTrackFitterKalmanSIMD::cdc_used_in_fit, DTrackFitterKalmanSIMD::central_traj, DTrackFitterKalmanSIMD::chisq_, DTrackFitterKalmanSIMD::cov, DTrackFitterKalmanSIMD::D_, DTrackFitterKalmanSIMD::dBxdx, DTrackFitterKalmanSIMD::dBxdy, DTrackFitterKalmanSIMD::dBxdz, DTrackFitterKalmanSIMD::dBydx, DTrackFitterKalmanSIMD::dBydy, DTrackFitterKalmanSIMD::dBzdx, DTrackFitterKalmanSIMD::dBzdy, DTrackFitterKalmanSIMD::dBzdz, DTrackFitterKalmanSIMD::fcov, DTrackFitterKalmanSIMD::fdc_updates, DTrackFitterKalmanSIMD::fdc_used_in_fit, DTrackFitterKalmanSIMD::forward_traj, DTrackFitterKalmanSIMD::ftime, DTrackFitterKalmanSIMD::IsElectron, DTrackFitterKalmanSIMD::IsHadron, DTrackFitterKalmanSIMD::IsPositron, DTrackFitterKalmanSIMD::last_material_map, DTrackFitterKalmanSIMD::len, DTrackFitterKalmanSIMD::MASS, DTrackFitterKalmanSIMD::mass2, DTrackFitterKalmanSIMD::mCDCInternalStepSize, DTrackFitterKalmanSIMD::mCentralStepSize, DTrackFitterKalmanSIMD::mStepSizeS, DTrackFitterKalmanSIMD::mStepSizeZ, DTrackFitterKalmanSIMD::mT0, DTrackFitterKalmanSIMD::mT0Detector, DTrackFitterKalmanSIMD::mT0MinimumDriftTime, DTrackFitterKalmanSIMD::mVarT0, DTrackFitterKalmanSIMD::my_cdchits, DTrackFitterKalmanSIMD::my_fdchits, DTrackFitterKalmanSIMD::ndf_, DTrackFitterKalmanSIMD::phi_, DTrackFitterKalmanSIMD::PT_MIN, DTrackFitterKalmanSIMD::q_over_p_, DTrackFitterKalmanSIMD::Q_OVER_P_MAX, DTrackFitterKalmanSIMD::q_over_pt_, SYS_CDC, DTrackFitterKalmanSIMD::tanl_, DTrackFitterKalmanSIMD::tx_, DTrackFitterKalmanSIMD::ty_, DTrackFitterKalmanSIMD::var_ftime, DTrackFitterKalmanSIMD::x_, DTrackFitterKalmanSIMD::y_, and DTrackFitterKalmanSIMD::z_.

Referenced by DTrackFitterKalmanSIMD::FitTrack().

void DTrackFitter::SetInputParameters ( const DTrackingData starting_params)
inlineinherited

Definition at line 171 of file DTrackFitter.h.

jerror_t DTrackFitterKalmanSIMD::SetReferenceTrajectory ( DMatrix5x1 S)
inherited

Definition at line 1795 of file DTrackFitterKalmanSIMD.cc.

References DKalmanForwardTrajectory_t::B, DTrackFitter::bfield, BIG, DTrackFitterKalmanSIMD::Bx, DTrackFitterKalmanSIMD::By, DTrackFitterKalmanSIMD::Bz, DKalmanForwardTrajectory_t::Ckk, DTrackFitterKalmanSIMD::dBxdx, DTrackFitterKalmanSIMD::dBxdy, DTrackFitterKalmanSIMD::dBxdz, DTrackFitterKalmanSIMD::dBydx, DTrackFitterKalmanSIMD::dBydy, DTrackFitterKalmanSIMD::dBydz, DTrackFitterKalmanSIMD::dBzdx, DTrackFitterKalmanSIMD::dBzdy, DTrackFitterKalmanSIMD::dBzdz, DTrackFitterKalmanSIMD::DEBUG_LEVEL, EPS, EPS2, DTrackFitterKalmanSIMD::forward_traj, DMagneticFieldMap::GetField(), DMagneticFieldMap::GetFieldAndGradient(), DKalmanForwardTrajectory_t::h_id, DTrackFitterKalmanSIMD::I5x5, DKalmanForwardTrajectory_t::J, DKalmanForwardTrajectory_t::K_rho_Z_over_A, DKalmanForwardTrajectory_t::LnI, DTrackFitterKalmanSIMD::LORENTZ_NR_PAR1, DTrackFitterKalmanSIMD::LORENTZ_NR_PAR2, DTrackFitterKalmanSIMD::LORENTZ_NZ_PAR1, DTrackFitterKalmanSIMD::LORENTZ_NZ_PAR2, DTrackFitterKalmanSIMD::mass2, DTrackFitterKalmanSIMD::my_fdchits, DKalmanForwardTrajectory_t::num_hits, DTrackFitterKalmanSIMD::PropagateForward(), DKalmanForwardTrajectory_t::Q, DTrackFitterKalmanSIMD::Q_OVER_P_MAX, DKalmanForwardTrajectory_t::rho_Z_over_A, S, DKalmanForwardTrajectory_t::S, DKalmanForwardTrajectory_t::s, sin(), DKalmanForwardTrajectory_t::Skk, SPEED_OF_LIGHT, sqrt(), DTrackFitterKalmanSIMD::state_q_over_p, DTrackFitterKalmanSIMD::state_tx, DTrackFitterKalmanSIMD::state_ty, DTrackFitterKalmanSIMD::state_x, DTrackFitterKalmanSIMD::state_y, DTrackFitterKalmanSIMD::Step(), DKalmanForwardTrajectory_t::t, TAN_MAX, temp, tx, DTrackFitterKalmanSIMD::x_, DTrackFitterKalmanSIMD::y_, DKalmanForwardTrajectory_t::z, DTrackFitterKalmanSIMD::z_, Z_MIN, DTrackFitterKalmanSIMD::Zero5x1, and DTrackFitterKalmanSIMD::Zero5x5.

Referenced by DTrackFitterKalmanSIMD::ForwardFit().

jerror_t DTrackFitterKalmanSIMD::SmoothCentral ( vector< pull_t > &  cdc_pulls)
protectedinherited

Definition at line 8026 of file DTrackFitterKalmanSIMD.cc.

References _DBG_, DTrackFitter::pull_t::AddTrackDerivatives(), DTrackFitterKalmanSIMD::alignDerivHists, DTrackFitterKalmanSIMD::ALIGNMENT_CENTRAL, DTrackFitter::bfield, DTrackFitterKalmanSIMD::BrentCentral(), DTrackFitterKalmanSIMD::brentCheckHists, DTrackFitterKalmanSIMD::Bx, DTrackFitterKalmanSIMD::By, DTrackFitterKalmanSIMD::Bz, DTrackFitterKalmanSIMD::cdc_updates, DTrackFitterKalmanSIMD::cdc_used_in_fit, DTrackFitterKalmanSIMD::central_traj, DTrackFitterKalmanSIMD::dBxdx, DTrackFitterKalmanSIMD::dBxdy, DTrackFitterKalmanSIMD::dBxdz, DTrackFitterKalmanSIMD::dBydx, DTrackFitterKalmanSIMD::dBydy, DTrackFitterKalmanSIMD::dBydz, DTrackFitterKalmanSIMD::dBzdx, DTrackFitterKalmanSIMD::dBzdy, DTrackFitterKalmanSIMD::dBzdz, dDdt0, dDOCAdDirX, dDOCAdDirY, dDOCAdDirZ, dDOCAdOriginX, dDOCAdOriginY, dDOCAdOriginZ, dDOCAdS0, dDOCAdS1, dDOCAdS2, dDOCAdS3, dDOCAdS4, DTrackFitterKalmanSIMD::DEBUG_HISTS, DTrackFitterKalmanSIMD::DEBUG_LEVEL, dir, EPS, DTrackFitterKalmanSIMD::GetdEdx(), DMagneticFieldMap::GetFieldAndGradient(), DTrackFitterKalmanSIMD::good_hit, H, DMatrix5x5::InvertSym(), DMatrix5x1::IsFinite(), max, DTrackFitterKalmanSIMD::my_cdchits, DMatrix5x1::Print(), DMatrix5x5::Print(), DTrackFitterKalmanSIMD::RING_TO_SKIP, S, sin(), sqrt(), DTrackFitterKalmanSIMD::state_D, DTrackFitterKalmanSIMD::state_phi, DTrackFitterKalmanSIMD::state_q_over_pt, DTrackFitterKalmanSIMD::state_tanl, DTrackFitterKalmanSIMD::state_z, DTrackFitterKalmanSIMD::StepJacobian(), and DMatrix5x5::Transpose().

Referenced by DTrackFitterKalmanSIMD::CentralFit().

jerror_t DTrackFitterKalmanSIMD::SmoothForward ( vector< pull_t > &  mypulls)
virtualinherited
jerror_t DTrackFitterKalmanSIMD::SwimCentral ( DVector3 pos,
DMatrix5x1 Sc 
)
protectedinherited
jerror_t DTrackFitterKalmanSIMD::SwimToPlane ( DMatrix5x1 S)
protectedinherited

Member Data Documentation

bool DTrackFitterKalmanSIMD::ADD_VERTEX_POINT
protectedinherited
TH1I* DTrackFitterKalmanSIMD::alignDerivHists[46]
protectedinherited
bool DTrackFitterKalmanSIMD::ALIGNMENT
protectedinherited
bool DTrackFitterKalmanSIMD::ALIGNMENT_CENTRAL
protectedinherited
double DTrackFitterKalmanSIMD::ANNEAL_POW_CONST
protectedinherited
TH2I* DTrackFitterKalmanSIMD::brentCheckHists[2]
protectedinherited
double DTrackFitterKalmanSIMD::CDC_DRIFT_BSCALE_PAR1
protectedinherited
double DTrackFitterKalmanSIMD::CDC_DRIFT_BSCALE_PAR2
protectedinherited
vector<double> DTrackFitterKalmanSIMD::cdc_drift_table
protectedinherited
double DTrackFitterKalmanSIMD::CDC_RES_PAR1
protectedinherited
double DTrackFitterKalmanSIMD::CDC_RES_PAR2
protectedinherited
double DTrackFitterKalmanSIMD::CDC_RES_PAR3
protectedinherited
vector<double> DTrackFitterKalmanSIMD::cdc_rmid
protectedinherited
double DTrackFitterKalmanSIMD::CDC_VAR_SCALE_FACTOR
protectedinherited
vector<vector<DCDCWire *> > DTrackFitterKalmanSIMD::cdcwires
protectedinherited
vector< vector <double> > DTrackFitterKalmanSIMD::cov
protectedinherited
double DTrackFitterKalmanSIMD::COVARIANCE_SCALE_FACTOR_CENTRAL
protectedinherited
double DTrackFitterKalmanSIMD::COVARIANCE_SCALE_FACTOR_FORWARD
protectedinherited
double DTrackFitterKalmanSIMD::dDIRCz
protectedinherited
bool DTrackFitterKalmanSIMD::DEBUG_HISTS
protectedinherited
double DTrackFitterKalmanSIMD::dFCALz
protectedinherited
double DTrackFitterKalmanSIMD::DRIFT_FUNC_PARMS[6]
protectedinherited
double DTrackFitterKalmanSIMD::DRIFT_RES_PARMS[3]
protectedinherited
double DTrackFitterKalmanSIMD::dTOFz
protectedinherited
double DTrackFitterKalmanSIMD::endplate_dz
protectedinherited
double DTrackFitterKalmanSIMD::endplate_z_downstream
protectedinherited
bool DTrackFitterKalmanSIMD::ESTIMATE_T0_TB
protectedinherited
double DTrackFitterKalmanSIMD::FactorForSenseOfRotation
protectedinherited
double DTrackFitterKalmanSIMD::FDC_CATHODE_SIGMA
protectedinherited

Definition at line 484 of file DTrackFitterKalmanSIMD.h.

double DTrackFitterKalmanSIMD::FDC_DRIFT_BSCALE_PAR1
protectedinherited
double DTrackFitterKalmanSIMD::FDC_DRIFT_BSCALE_PAR2
protectedinherited
vector<double> DTrackFitterKalmanSIMD::fdc_drift_table
protectedinherited

Definition at line 460 of file DTrackFitterKalmanSIMD.h.

double DTrackFitterKalmanSIMD::fdc_package_size
protectedinherited
double DTrackFitterKalmanSIMD::fdc_rmax
protectedinherited
vector<double> DTrackFitterKalmanSIMD::fdc_rmin_packages
protectedinherited
vector<double> DTrackFitterKalmanSIMD::fdc_z_wires
protectedinherited
fit_status_t DTrackFitter::fit_status
protectedinherited
double DTrackFitterKalmanSIMD::FORWARD_ANNEAL_POW_CONST
protectedinherited
double DTrackFitterKalmanSIMD::FORWARD_ANNEAL_SCALE
protectedinherited
bool DTrackFitterKalmanSIMD::FORWARD_PARMS_COV
protectedinherited
bool DTrackFitterKalmanSIMD::get_field
protectedinherited

Definition at line 433 of file DTrackFitterKalmanSIMD.h.

bool DTrackFitterKalmanSIMD::IsElectron
protectedinherited
bool DTrackFitterKalmanSIMD::IsHadron
protectedinherited
bool DTrackFitterKalmanSIMD::IsPositron
protectedinherited
double DTrackFitterKalmanSIMD::long_drift_Bscale_par1
protectedinherited
double DTrackFitterKalmanSIMD::long_drift_Bscale_par2
protectedinherited
double DTrackFitterKalmanSIMD::long_drift_func[3][3]
protectedinherited
JEventLoop* DTrackFitter::loop
protectedinherited
double DTrackFitterKalmanSIMD::LORENTZ_NR_PAR1
protectedinherited
double DTrackFitterKalmanSIMD::LORENTZ_NR_PAR2
protectedinherited
double DTrackFitterKalmanSIMD::LORENTZ_NZ_PAR1
protectedinherited
double DTrackFitterKalmanSIMD::LORENTZ_NZ_PAR2
protectedinherited
double DTrackFitterKalmanSIMD::m_e_sq
protectedinherited
double DTrackFitterKalmanSIMD::m_ratio
protectedinherited

Definition at line 446 of file DTrackFitterKalmanSIMD.h.

Referenced by DTrackFitterKalmanSIMD::FitTrack().

double DTrackFitterKalmanSIMD::m_ratio_sq
protectedinherited
double DTrackFitterKalmanSIMD::MASS
protectedinherited
double DTrackFitterKalmanSIMD::mCDCInternalStepSize
protectedinherited
double DTrackFitterKalmanSIMD::mCentralStepSize
protectedinherited
ofstream DTrackFitterKalmanSIMD::mlfile
protectedinherited
double DTrackFitterKalmanSIMD::MOLIERE_FRACTION
protectedinherited
double DTrackFitterKalmanSIMD::MOLIERE_RATIO1
protectedinherited
double DTrackFitterKalmanSIMD::MOLIERE_RATIO2
protectedinherited
double DTrackFitterKalmanSIMD::MS_SCALE_FACTOR
protectedinherited
double DTrackFitterKalmanSIMD::mVarT0
protectedinherited
double DTrackFitterKalmanSIMD::NUM_FDC_SIGMA_CUT
protectedinherited
double DTrackFitterKalmanSIMD::PHOTON_ENERGY_CUTOFF
protectedinherited
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().

bool DTrackFitterKalmanSIMD::RECOVER_BROKEN_TRACKS
protectedinherited
const DRootGeom* DTrackFitter::RootGeom
protectedinherited

Definition at line 230 of file DTrackFitter.h.

Referenced by DTrackFitterALT1::DTrackFitterALT1().

vector<vector<double> > DTrackFitterKalmanSIMD::sag_phi_offset
protectedinherited
vector<vector<DVector3> > DTrackFitterKalmanSIMD::sc_dir
protectedinherited
double DTrackFitterKalmanSIMD::short_drift_Bscale_par1
protectedinherited
double DTrackFitterKalmanSIMD::short_drift_Bscale_par2
protectedinherited
double DTrackFitterKalmanSIMD::short_drift_func[3][3]
protectedinherited
double DTrackFitterKalmanSIMD::TARGET_Z
protectedinherited
double DTrackFitterKalmanSIMD::THETA_CUT
protectedinherited
double DTrackFitterKalmanSIMD::two_m_e
protectedinherited
bool DTrackFitterKalmanSIMD::USE_CDC_HITS
protectedinherited
bool DTrackFitterKalmanSIMD::USE_FDC_DRIFT_TIMES
protectedinherited
bool DTrackFitterKalmanSIMD::USE_FDC_HITS
protectedinherited
bool DTrackFitterKalmanSIMD::USE_MULS_COVARIANCE
protectedinherited
bool DTrackFitterKalmanSIMD::USE_PASS1_TIME_MODE
protectedinherited
bool DTrackFitterKalmanSIMD::USE_T0_FROM_WIRES
protectedinherited
vector<unsigned int> DTrackFitterKalmanSIMD::used_cdc_indices
protectedinherited

Definition at line 396 of file DTrackFitterKalmanSIMD.h.

vector<unsigned int> DTrackFitterKalmanSIMD::used_fdc_indices
protectedinherited

Definition at line 395 of file DTrackFitterKalmanSIMD.h.

bool DTrackFitterKalmanSIMD::WRITE_ML_TRAINING_OUTPUT
protectedinherited

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