Belle II Software development
UncertainHelix Class Reference

This class represents an ideal helix in perigee parameterization including the covariance matrix of the 5 perigee parameters. More...

#include <UncertainHelix.h>

Inheritance diagram for UncertainHelix:
Helix

Public Member Functions

 UncertainHelix ()
 Default constuctor initialising all members to zero.
 
 UncertainHelix (const ROOT::Math::XYZVector &position, const ROOT::Math::XYZVector &momentum, const short int charge, const double bZ, const TMatrixDSym &cartesianCovariance, const double pValue)
 Constructor initializing class with fit result.
 
 UncertainHelix (const double &d0, const double &phi0, const double &omega, const double &z0, const double &tanLambda, const TMatrixDSym &covariance, const double pValue)
 Constructor initializing class with perigee parameters.
 
TMatrixDSym getCartesianCovariance (const double bZ_tesla=1.5) const
 Getter for the position and momentum covariance matrix.
 
double getPValue () const
 Getter for Chi2 Probability of the track fit.
 
const TMatrixDSym & getCovariance () const
 Getter for covariance matrix of perigee parameters in matrix form.
 
void reverse ()
 Reverses the direction of travel of the helix in place.
 
double passiveMoveBy (const ROOT::Math::XYZVector &by)
 Moves origin of the coordinate system (passive transformation) by the given vector.
 
double passiveMoveBy (const double &byX, const double &byY, const double &byZ)
 Moves origin of the coordinate system (passive transformation) by the given vector.
 
const HepPoint3Dcenter (void) const
 returns position of helix center(z = 0.);
 
const HepPoint3Dpivot (void) const
 returns pivot position.
 
const HepPoint3Dpivot (const HepPoint3D &newPivot)
 Sets pivot position.
 
double radius (void) const
 returns radious of helix.
 
HepPoint3D x (double dPhi=0.) const
 returns position after rotating angle dPhi in phi direction.
 
double * x (double dPhi, double p[3]) const
 returns position after rotating angle dPhi in phi direction.
 
HepPoint3D x (double dPhi, HepSymMatrix &Ex) const
 returns position and convariance matrix(Ex) after rotation.
 
Hep3Vector direction (double dPhi=0.) const
 returns direction vector after rotating angle dPhi in phi direction.
 
Hep3Vector momentum (double dPhi=0.) const
 returns momentum vector after rotating angle dPhi in phi direction.
 
Hep3Vector momentum (double dPhi, HepSymMatrix &Em) const
 returns momentum vector after rotating angle dPhi in phi direction.
 
HepLorentzVector momentum (double dPhi, double mass) const
 returns 4momentum vector after rotating angle dPhi in phi direction.
 
HepLorentzVector momentum (double dPhi, double mass, HepSymMatrix &Em) const
 returns 4momentum vector after rotating angle dPhi in phi direction.
 
HepLorentzVector momentum (double dPhi, double mass, HepPoint3D &x, HepSymMatrix &Emx) const
 returns 4momentum vector after rotating angle dPhi in phi direction.
 
double dr (void) const
 Return helix parameter dr.
 
double phi0 (void) const
 Return helix parameter phi0.
 
double kappa (void) const
 Return helix parameter kappa.
 
double dz (void) const
 Return helix parameter dz.
 
double tanl (void) const
 Return helix parameter tangent lambda.
 
double curv (void) const
 Return curvature of helix.
 
double sinPhi0 (void) const
 Return sin phi0.
 
double cosPhi0 (void) const
 Return cos phi0.
 
const HepVector & a (void) const
 Returns helix parameters.
 
const HepVector & a (const HepVector &newA)
 Sets helix parameters.
 
const HepSymMatrix & Ea (void) const
 Returns error matrix.
 
const HepSymMatrix & Ea (const HepSymMatrix &newdA)
 Sets helix paramters and error matrix.
 
void set (const HepPoint3D &pivot, const HepVector &a, const HepSymMatrix &Ea)
 Sets helix pivot position, parameters, and error matrix.
 
void ignoreErrorMatrix (void)
 Unsets error matrix.
 
double bFieldZ (double bz)
 Sets/returns z componet of the magnetic field.
 
double bFieldZ (void) const
 Returns z componet of the magnetic field.
 
HepMatrix delApDelA (const HepVector &ap) const
 DAp/DA.
 
HepMatrix delXDelA (double phi) const
 DX/DA.
 
HepMatrix delMDelA (double phi) const
 DM/DA.
 
HepMatrix del4MDelA (double phi, double mass) const
 DM4/DA.
 
HepMatrix del4MXDelA (double phi, double mass) const
 DMX4/DA.
 

Static Public Member Functions

static void set_limits (const HepVector &a_min, const HepVector &a_max)
 set limit for parameter "a"
 
static bool set_exception (bool)
 set exception
 
static bool set_print (bool)
 Set print option for debugging.
 

Static Public Attributes

static const double ConstantAlpha = 222.376063
 Constant alpha for uniform field.
 

Private Member Functions

 ClassDef (UncertainHelix, 2)
 represents an ideal helix in perigee parameterization including covariance matrix
 
void updateCache (void)
 updateCache
 
void checkValid (void)
 Check whether helix parameters is valid or not.
 
void debugPrint (void) const
 Print the helix parameters to stdout.
 
void debugHelix (void) const
 Debug Helix.
 

Private Attributes

TMatrixDSym m_covariance
 5x5 covariance of the perigee parameters.
 
Double32_t m_pValue
 Chi2 Probability of the fit.
 
bool m_matrixValid
 True: matrix valid, False: matrix not valid.
 
bool m_helixValid
 True: helix valid, False: helix not valid.
 
double m_bField
 Magnetic field, assuming uniform Bz in the unit of kG.
 
double m_alpha
 10000.0/(speed of light)/B.
 
HepPoint3D m_pivot
 Pivot.
 
HepVector m_a
 Helix parameter.
 
HepSymMatrix m_Ea
 Error of the helix parameter.
 
HepPoint3D m_center
 Cache of the center position of Helix.
 
double m_cp
 Cache of the cos phi0.
 
double m_sp
 Cache of the sin phi0.
 
double m_pt
 Cache of the pt.
 
double m_r
 Cache of the r.
 
double m_ac [5]
 Cache of the helix parameter.
 

Static Private Attributes

static HepVector ms_amin
 minimum limit of Helix parameter a
 
static HepVector ms_amax
 maxiimum limit of Helix parameter a
 
static bool ms_check_range
 Check the helix parameter's range.
 
static bool ms_print_debug
 Debug option flag.
 
static bool ms_throw_exception
 Throw exception flag.
 
static const std::string invalidhelix
 String "Invalid Helix".
 

Detailed Description

This class represents an ideal helix in perigee parameterization including the covariance matrix of the 5 perigee parameters.

The used perigee parameters are:

  1. $ d_0 $ - the signed distance from the origin to the perigee. The sign is positive (negative), if the angle from the xy perigee position vector to the transverse momentum vector is +pi/2 (-pi/2). $d_0$ has the same sign as getPerigee().Cross(getMomentum()).Z().
  2. $ \phi_0 $ - the angle in the xy projection between the transverse momentum and the x axis, which is in [-pi, pi]
  3. $ \omega $ - the signed curvature of the track where the sign is given by the charge of the particle
  4. $ z_0 $ - z coordinate of the perigee
  5. $ \tan \lambda $ - the slope of the track in the sz plane (dz/ds)

in that exact order.

It may also store a p-value obtained from the fit of the helix.

Definition at line 36 of file UncertainHelix.h.

Constructor & Destructor Documentation

◆ UncertainHelix() [1/3]

Default constuctor initialising all members to zero.

Definition at line 17 of file UncertainHelix.cc.

17 :
18 Helix(),
19 m_covariance(5),
20 m_pValue(0)
21{
22}
Helix parameter class.
Definition: Helix.h:48
Double32_t m_pValue
Chi2 Probability of the fit.
TMatrixDSym m_covariance
5x5 covariance of the perigee parameters.

◆ UncertainHelix() [2/3]

UncertainHelix ( const ROOT::Math::XYZVector &  position,
const ROOT::Math::XYZVector &  momentum,
const short int  charge,
const double  bZ,
const TMatrixDSym &  cartesianCovariance,
const double  pValue 
)

Constructor initializing class with fit result.

The given position, momentum and their covariance matrix are extrapolated to the perigee assuming a homogeneous magnetic field in the z direction.

Parameters
positionPosition of the track at the perigee.
momentumMomentum of the track at the perigee.
chargeCharge of the particle.
bZMagnetic field to be used for the calculation of the curvature;
cartesianCovariance6x6 Covariance matrix for position and momentum of the track at the perigee.
pValuep-value of the fit. It is assumed, that the B-field is parallel to the z-Axis.

Definition at line 24 of file UncertainHelix.cc.

29 :
30 Helix(ROOT::Math::XYZVector(0.0, 0.0, position.Z()), momentum, charge, bZ),
31 m_covariance(cartesianCovariance), // Initialize the covariance matrix to the 6x6 covariance and reduce it afterwards
32 m_pValue(pValue)
33{
34 // Maybe push these out of this function:
35 // Indices of the cartesian coordinates
36 const int iX = 0;
37 const int iY = 1;
38 const int iZ = 2;
39 const int iPx = 3;
40 const int iPy = 4;
41 const int iPz = 5;
42
43 // We initialised the m_covariance to the cartesian covariance and
44 // reduce it now to the real 5x5 matrix that should be there.
45
46 // 1. Rotate to a system where phi0 = 0
47 TMatrixD jacobianRot(6, 6);
48 jacobianRot.Zero();
49
50 const double px = momentum.X();
51 const double py = momentum.Y();
52 const double pt = hypot(px, py);
53 const double cosPhi0 = px / pt;
54 const double sinPhi0 = py / pt;
55
56 // Passive rotation matrix by phi0:
57 jacobianRot(iX, iX) = cosPhi0;
58 jacobianRot(iX, iY) = sinPhi0;
59 jacobianRot(iY, iX) = -sinPhi0;
60 jacobianRot(iY, iY) = cosPhi0;
61 jacobianRot(iZ, iZ) = 1.0;
62
63 jacobianRot(iPx, iPx) = cosPhi0;
64 jacobianRot(iPx, iPy) = sinPhi0;
65 jacobianRot(iPy, iPx) = -sinPhi0;
66 jacobianRot(iPy, iPy) = cosPhi0;
67 jacobianRot(iPz, iPz) = 1.0;
68
69 m_covariance.Similarity(jacobianRot);
70
71 // 2. Translate to perigee parameters on the position
72 const double pz = momentum.Z();
73 const double invPt = 1 / pt;
74 const double invPtSquared = invPt * invPt;
75 const double alpha = getAlpha(bZ);
76
77 TMatrixD jacobianToHelixParameters(5, 6);
78 jacobianToHelixParameters.Zero();
79
80 jacobianToHelixParameters(iD0, iY) = -1;
81 jacobianToHelixParameters(iPhi0, iX) = charge * invPt / alpha;
82 jacobianToHelixParameters(iPhi0, iPy) = invPt;
83 jacobianToHelixParameters(iOmega, iPx) = -charge * invPtSquared / alpha;
84 jacobianToHelixParameters(iTanLambda, iPx) = - pz * invPtSquared;
85 jacobianToHelixParameters(iTanLambda, iPz) = invPt;
86 jacobianToHelixParameters(iZ0, iX) = - pz * invPt;
87 jacobianToHelixParameters(iZ0, iZ) = 1;
88 m_covariance.Similarity(jacobianToHelixParameters);
89
90 // The covariance m_covariance is now the correct 5x5 covariance matrix.
91 assert(m_covariance.GetNrows() == 5);
92
93 // 3. Extrapolate to the origin.
94 /* const double arcLength2D = */ passiveMoveBy(-position.X(), -position.Y(), 0.0);
95}
Hep3Vector momentum(double dPhi=0.) const
returns momentum vector after rotating angle dPhi in phi direction.
Definition: Helix.cc:259
double cosPhi0(void) const
Return cos phi0.
Definition: Helix.h:500
double sinPhi0(void) const
Return sin phi0.
Definition: Helix.h:492
double passiveMoveBy(const ROOT::Math::XYZVector &by)
Moves origin of the coordinate system (passive transformation) by the given vector.
double charge(int pdgCode)
Returns electric charge of a particle with given pdg code.
Definition: EvtPDLUtil.cc:44

◆ UncertainHelix() [3/3]

UncertainHelix ( const double &  d0,
const double &  phi0,
const double &  omega,
const double &  z0,
const double &  tanLambda,
const TMatrixDSym &  covariance,
const double  pValue 
)

Constructor initializing class with perigee parameters.

Parameters
d0The signed distance from the origin to the perigee. The sign is positive (negative), if the angle from the xy perigee position vector to the transverse momentum vector is +pi/2 (-pi/2). d0 has the same sign as getPosition().Cross(getMomentum()).Z().
phi0The angle between the transverse momentum and the x axis and in [-pi, pi]
omegaThe signed curvature of the track where the sign is given by the charge of the particle
z0The z coordinate of the perigee.
tanLambdaThe slope of the track in the sz plane (dz/ds)
covariance5x5 Covariance matrix for the five helix parameters. Indices correspond to the order d0, phi0, omega, z0, tanLambda.
pValuep-value of the Helix fit

Definition at line 98 of file UncertainHelix.cc.

104 :
105 Helix(d0, phi0, omega, z0, tanLambda),
106 m_covariance(covariance),
107 m_pValue(pValue)
108{
109}
double phi0(void) const
Return helix parameter phi0.
Definition: Helix.h:388

Member Function Documentation

◆ a() [1/2]

const HepVector & a ( const HepVector &  newA)
inlineinherited

Sets helix parameters.

Definition at line 444 of file Helix.h.

445 {
446 if (i.num_row() == 5) {
447 m_a = i;
448 m_helixValid = false;
449 updateCache();
450#if defined(BELLE_DEBUG)
451 DEBUG_HELIX;
452 } else {
453 {
454 std::cout << "Helix::input vector's num_row is not 5" << std::endl;
455 DEBUG_PRINT;
457 }
458#endif
459 }
460 return m_a;
461 }
void updateCache(void)
updateCache
Definition: Helix.cc:508
bool m_helixValid
True: helix valid, False: helix not valid.
Definition: Helix.h:290
static bool ms_throw_exception
Throw exception flag.
Definition: Helix.h:239
HepVector m_a
Helix parameter.
Definition: Helix.h:298
static const std::string invalidhelix
String "Invalid Helix".
Definition: Helix.h:318

◆ a() [2/2]

const HepVector & a ( void  ) const
inlineinherited

Returns helix parameters.

Definition at line 428 of file Helix.h.

429 {
430 DEBUG_HELIX;
431 return m_a;
432 }

◆ bFieldZ() [1/2]

double bFieldZ ( double  bz)
inlineinherited

Sets/returns z componet of the magnetic field.

Parameters
[in]bzz-component of the magnetic field.
Attention
Helix param. alpha is also stored.

Definition at line 473 of file Helix.h.

474 {
475 DEBUG_HELIX;
476 m_bField = a;
477 m_alpha = 10000. / 2.99792458 / m_bField;
478 updateCache();
479 return m_bField;
480 }
const HepVector & a(void) const
Returns helix parameters.
Definition: Helix.h:428
double m_alpha
10000.0/(speed of light)/B.
Definition: Helix.h:294
double m_bField
Magnetic field, assuming uniform Bz in the unit of kG.
Definition: Helix.h:292

◆ bFieldZ() [2/2]

double bFieldZ ( void  ) const
inlineinherited

Returns z componet of the magnetic field.

Definition at line 484 of file Helix.h.

485 {
486 DEBUG_HELIX;
487 return m_bField;
488 }

◆ center()

const HepPoint3D & center ( void  ) const
inlineinherited

returns position of helix center(z = 0.);

Definition at line 343 of file Helix.h.

344 {
345#if defined(BELLE_DEBUG)
346 if (!m_helixValid) {
347 DEBUG_PRINT;
348 if (msthrow_exception) throw invalidhelix;
349 }
350#endif
351 return m_center;
352 }
HepPoint3D m_center
Cache of the center position of Helix.
Definition: Helix.h:305

◆ checkValid()

void checkValid ( void  )
privateinherited

Check whether helix parameters is valid or not.

Sets m_helixValid.

Definition at line 895 of file Helix.cc.

896{
897
898 if (!ms_check_range) return;
899 const double adr = fabs(m_a[0]);
900 const double acpa = fabs(m_a[2]);
901 if (!(adr >= ms_amin[0] && adr <= ms_amax[0])) {
902 m_helixValid = false;
903 } else if (!(acpa >= ms_amin[2] && acpa <= ms_amax[2])) {
904 m_helixValid = false;
905 } else {
906 m_helixValid = true;
907 }
908 if (!m_helixValid) {
909 if (m_a[0] != 0.0 || m_a[1] != 0.0 || m_a[2] != 0.0 ||
910 m_a[3] != 0.0 || m_a[4] != 0.0) {
911 DEBUG_PRINT;
912 }
913 }
914
915}
static bool ms_check_range
Check the helix parameter's range.
Definition: Helix.h:235
static HepVector ms_amin
minimum limit of Helix parameter a
Definition: Helix.h:231
static HepVector ms_amax
maxiimum limit of Helix parameter a
Definition: Helix.h:233

◆ cosPhi0()

double cosPhi0 ( void  ) const
inlineinherited

Return cos phi0.

Definition at line 500 of file Helix.h.

501 {
502 DEBUG_HELIX;
503 return m_cp;
504 }
double m_cp
Cache of the cos phi0.
Definition: Helix.h:307

◆ curv()

double curv ( void  ) const
inlineinherited

Return curvature of helix.

Definition at line 420 of file Helix.h.

421 {
422 DEBUG_HELIX;
423 return m_r;
424 }
double m_r
Cache of the r.
Definition: Helix.h:313

◆ debugHelix()

void debugHelix ( void  ) const
privateinherited

Debug Helix.

Definition at line 917 of file Helix.cc.

918{
919 if (!m_helixValid) {
920 if (ms_check_range) {DEBUG_PRINT;}
921 if (ms_throw_exception) { throw invalidhelix;}
922 }
923}

◆ debugPrint()

void debugPrint ( void  ) const
privateinherited

Print the helix parameters to stdout.

Definition at line 879 of file Helix.cc.

880{
881
882 const double dr = m_a[0];
883 const double phi0 = m_a[1];
884 const double cpa = m_a[2];
885 const double dz = m_a[3];
886 const double tnl = m_a[4];
887 if (ms_print_debug) {
888 std::cout << "Helix::dr = " << dr << " phi0 = " << phi0 << " cpa = " << cpa
889 << " dz = " << dz << " tnl = " << tnl << std::endl;
890 std::cout << " pivot = " << m_pivot << std::endl;
891 }
892}
static bool ms_print_debug
Debug option flag.
Definition: Helix.h:237
double dr(void) const
Return helix parameter dr.
Definition: Helix.h:380
double dz(void) const
Return helix parameter dz.
Definition: Helix.h:404
HepPoint3D m_pivot
Pivot.
Definition: Helix.h:296

◆ del4MDelA()

HepMatrix del4MDelA ( double  phi,
double  mass 
) const
inherited

DM4/DA.

Definition at line 749 of file Helix.cc.

750{
751 DEBUG_HELIX;
752
753 //
754 // Calculate Jacobian (@4m/@a)
755 // Vector a is helix parameters and phi is internal parameter.
756 // Vector 4m is 4 momentum.
757 //
758
759 HepMatrix d4MDA(4, 5, 0);
760
761 double phi0 = m_ac[1];
762 double cpa = m_ac[2];
763 double tnl = m_ac[4];
764
765 double cosf0phi = cos(phi0 + phi);
766 double sinf0phi = sin(phi0 + phi);
767
768 double rho;
769 if (cpa != 0.)rho = 1. / cpa;
770 else rho = (DBL_MAX);
771
772 double charge = 1.;
773 if (cpa < 0.)charge = -1.;
774
775 double E = sqrt(rho * rho * (1. + tnl * tnl) + mass * mass);
776
777 d4MDA[0][1] = -fabs(rho) * cosf0phi;
778 d4MDA[0][2] = charge * rho * rho * sinf0phi;
779
780 d4MDA[1][1] = -fabs(rho) * sinf0phi;
781 d4MDA[1][2] = -charge * rho * rho * cosf0phi;
782
783 d4MDA[2][2] = -charge * rho * rho * tnl;
784 d4MDA[2][4] = fabs(rho);
785
786 if (cpa != 0.0 && E != 0.0) {
787 d4MDA[3][2] = (-1. - tnl * tnl) / (cpa * cpa * cpa * E);
788 d4MDA[3][4] = tnl / (cpa * cpa * E);
789 } else {
790 d4MDA[3][2] = (DBL_MAX);
791 d4MDA[3][4] = (DBL_MAX);
792 }
793 return d4MDA;
794}
R E
internal precision of FFTW codelets
double m_ac[5]
Cache of the helix parameter.
Definition: Helix.h:315
double sqrt(double a)
sqrt for double
Definition: beamHelpers.h:28

◆ del4MXDelA()

HepMatrix del4MXDelA ( double  phi,
double  mass 
) const
inherited

DMX4/DA.

Definition at line 798 of file Helix.cc.

799{
800 DEBUG_HELIX;
801
802 //
803 // Calculate Jacobian (@4mx/@a)
804 // Vector a is helix parameters and phi is internal parameter.
805 // Vector 4xm is 4 momentum and position.
806 //
807
808 HepMatrix d4MXDA(7, 5, 0);
809
810 const double& dr = m_ac[0];
811 const double& phi0 = m_ac[1];
812 const double& cpa = m_ac[2];
813 //const double & dz = m_ac[3];
814 const double& tnl = m_ac[4];
815
816 double cosf0phi = cos(phi0 + phi);
817 double sinf0phi = sin(phi0 + phi);
818
819 double rho;
820 if (cpa != 0.)rho = 1. / cpa;
821 else rho = (DBL_MAX);
822
823 double charge = 1.;
824 if (cpa < 0.)charge = -1.;
825
826 double E = sqrt(rho * rho * (1. + tnl * tnl) + mass * mass);
827
828 d4MXDA[0][1] = - fabs(rho) * cosf0phi;
829 d4MXDA[0][2] = charge * rho * rho * sinf0phi;
830
831 d4MXDA[1][1] = - fabs(rho) * sinf0phi;
832 d4MXDA[1][2] = - charge * rho * rho * cosf0phi;
833
834 d4MXDA[2][2] = - charge * rho * rho * tnl;
835 d4MXDA[2][4] = fabs(rho);
836
837 if (cpa != 0.0 && E != 0.0) {
838 d4MXDA[3][2] = (- 1. - tnl * tnl) / (cpa * cpa * cpa * E);
839 d4MXDA[3][4] = tnl / (cpa * cpa * E);
840 } else {
841 d4MXDA[3][2] = (DBL_MAX);
842 d4MXDA[3][4] = (DBL_MAX);
843 }
844
845 d4MXDA[4][0] = m_cp;
846 d4MXDA[4][1] = - dr * m_sp + m_r * (- m_sp + sinf0phi);
847 if (cpa != 0.0) {
848 d4MXDA[4][2] = - (m_r / cpa) * (m_cp - cosf0phi);
849 } else {
850 d4MXDA[4][2] = (DBL_MAX);
851 }
852
853 d4MXDA[5][0] = m_sp;
854 d4MXDA[5][1] = dr * m_cp + m_r * (m_cp - cosf0phi);
855 if (cpa != 0.0) {
856 d4MXDA[5][2] = - (m_r / cpa) * (m_sp - sinf0phi);
857
858 d4MXDA[6][2] = (m_r / cpa) * tnl * phi;
859 } else {
860 d4MXDA[5][2] = (DBL_MAX);
861
862 d4MXDA[6][2] = (DBL_MAX);
863 }
864
865 d4MXDA[6][3] = 1.;
866 d4MXDA[6][4] = - m_r * phi;
867
868 return d4MXDA;
869}
double m_sp
Cache of the sin phi0.
Definition: Helix.h:309

◆ delApDelA()

HepMatrix delApDelA ( const HepVector &  ap) const
inherited

DAp/DA.

Definition at line 584 of file Helix.cc.

585{
586 DEBUG_HELIX;
587 //
588 // Calculate Jacobian (@ap/@a)
589 // Vector ap is new helix parameters and a is old helix parameters.
590 //
591
592 HepMatrix dApDA(5, 5, 0);
593
594 const double& dr = m_ac[0];
595 const double& phi0 = m_ac[1];
596 const double& cpa = m_ac[2];
597 //const double & dz = m_ac[3];
598 const double& tnl = m_ac[4];
599
600 double drp = ap[0];
601 double phi0p = ap[1];
602 //double cpap = ap[2];
603 //double dzp = ap[3];
604 //double tnlp = ap[4];
605
606 double rdr = m_r + dr;
607 double rdrpr;
608 if ((m_r + drp) != 0.0) {
609 rdrpr = 1. / (m_r + drp);
610 } else {
611 rdrpr = (DBL_MAX);
612 }
613 // double csfd = cos(phi0)*cos(phi0p) + sin(phi0)*sin(phi0p);
614 // double snfd = cos(phi0)*sin(phi0p) - sin(phi0)*cos(phi0p);
615 double csfd = cos(phi0p - phi0);
616 double snfd = sin(phi0p - phi0);
617 double phid = fmod(phi0p - phi0 + M_PI8, M_PI2);
618 if (phid > M_PI) phid = phid - M_PI2;
619
620 dApDA[0][0] = csfd;
621 dApDA[0][1] = rdr * snfd;
622 if (cpa != 0.0) {
623 dApDA[0][2] = (m_r / cpa) * (1.0 - csfd);
624 } else {
625 dApDA[0][2] = (DBL_MAX);
626 }
627
628 dApDA[1][0] = - rdrpr * snfd;
629 dApDA[1][1] = rdr * rdrpr * csfd;
630 if (cpa != 0.0) {
631 dApDA[1][2] = (m_r / cpa) * rdrpr * snfd;
632 } else {
633 dApDA[1][2] = (DBL_MAX);
634 }
635
636 dApDA[2][2] = 1.0;
637
638 dApDA[3][0] = m_r * rdrpr * tnl * snfd;
639 dApDA[3][1] = m_r * tnl * (1.0 - rdr * rdrpr * csfd);
640 if (cpa != 0.0) {
641 dApDA[3][2] = (m_r / cpa) * tnl * (phid - m_r * rdrpr * snfd);
642 } else {
643 dApDA[3][2] = (DBL_MAX);
644 }
645 dApDA[3][3] = 1.0;
646 dApDA[3][4] = - m_r * phid;
647
648 dApDA[4][4] = 1.0;
649
650 return dApDA;
651}
const double M_PI8
8*PI
Definition: Helix.cc:39
const double M_PI2
2*PI
Definition: Helix.cc:31

◆ delMDelA()

HepMatrix delMDelA ( double  phi) const
inherited

DM/DA.

Definition at line 710 of file Helix.cc.

711{
712 DEBUG_HELIX;
713 //
714 // Calculate Jacobian (@m/@a)
715 // Vector a is helix parameters and phi is internal parameter.
716 // Vector m is momentum.
717 //
718
719 HepMatrix dMDA(3, 5, 0);
720
721 const double& phi0 = m_ac[1];
722 const double& cpa = m_ac[2];
723 const double& tnl = m_ac[4];
724
725 double cosf0phi = cos(phi0 + phi);
726 double sinf0phi = sin(phi0 + phi);
727
728 double rho;
729 if (cpa != 0.)rho = 1. / cpa;
730 else rho = (DBL_MAX);
731
732 double charge = 1.;
733 if (cpa < 0.)charge = -1.;
734
735 dMDA[0][1] = -fabs(rho) * cosf0phi;
736 dMDA[0][2] = charge * rho * rho * sinf0phi;
737
738 dMDA[1][1] = -fabs(rho) * sinf0phi;
739 dMDA[1][2] = -charge * rho * rho * cosf0phi;
740
741 dMDA[2][2] = -charge * rho * rho * tnl;
742 dMDA[2][4] = fabs(rho);
743
744 return dMDA;
745}

◆ delXDelA()

HepMatrix delXDelA ( double  phi) const
inherited

DX/DA.

Definition at line 654 of file Helix.cc.

655{
656 DEBUG_HELIX;
657 //
658 // Calculate Jacobian (@x/@a)
659 // Vector a is helix parameters and phi is internal parameter
660 // which specifys the point to be calculated for Ex(phi).
661 //
662
663 HepMatrix dXDA(3, 5, 0);
664
665 const double& dr = m_ac[0];
666 const double& phi0 = m_ac[1];
667 const double& cpa = m_ac[2];
668 //const double & dz = m_ac[3];
669 const double& tnl = m_ac[4];
670
671 double cosf0phi = cos(phi0 + phi);
672 double sinf0phi = sin(phi0 + phi);
673
674 dXDA[0][0] = m_cp;
675 dXDA[0][1] = - dr * m_sp + m_r * (- m_sp + sinf0phi);
676 if (cpa != 0.0) {
677 dXDA[0][2] = - (m_r / cpa) * (m_cp - cosf0phi);
678 } else {
679 dXDA[0][2] = (DBL_MAX);
680 }
681 // dXDA[0][3] = 0.0;
682 // dXDA[0][4] = 0.0;
683
684 dXDA[1][0] = m_sp;
685 dXDA[1][1] = dr * m_cp + m_r * (m_cp - cosf0phi);
686 if (cpa != 0.0) {
687 dXDA[1][2] = - (m_r / cpa) * (m_sp - sinf0phi);
688 } else {
689 dXDA[1][2] = (DBL_MAX);
690 }
691 // dXDA[1][3] = 0.0;
692 // dXDA[1][4] = 0.0;
693
694 // dXDA[2][0] = 0.0;
695 // dXDA[2][1] = 0.0;
696 if (cpa != 0.0) {
697 dXDA[2][2] = (m_r / cpa) * tnl * phi;
698 } else {
699 dXDA[2][2] = (DBL_MAX);
700 }
701 dXDA[2][3] = 1.0;
702 dXDA[2][4] = - m_r * phi;
703
704 return dXDA;
705}

◆ direction()

Hep3Vector direction ( double  dPhi = 0.) const
inlineinherited

returns direction vector after rotating angle dPhi in phi direction.

Definition at line 372 of file Helix.h.

373 {
374 DEBUG_HELIX;
375 return momentum(phi).unit();
376 }

◆ dr()

double dr ( void  ) const
inlineinherited

Return helix parameter dr.

Definition at line 380 of file Helix.h.

381 {
382 DEBUG_HELIX;
383 return m_ac[0];
384 }

◆ dz()

double dz ( void  ) const
inlineinherited

Return helix parameter dz.

Definition at line 404 of file Helix.h.

405 {
406 DEBUG_HELIX;
407 return m_ac[3];
408 }

◆ Ea() [1/2]

const HepSymMatrix & Ea ( const HepSymMatrix &  newdA)
inlineinherited

Sets helix paramters and error matrix.

Definition at line 465 of file Helix.h.

466 {
467 DEBUG_HELIX;
468 return m_Ea = i;
469 }
HepSymMatrix m_Ea
Error of the helix parameter.
Definition: Helix.h:300

◆ Ea() [2/2]

const HepSymMatrix & Ea ( void  ) const
inlineinherited

Returns error matrix.

Definition at line 436 of file Helix.h.

437 {
438 DEBUG_HELIX;
439 return m_Ea;
440 }

◆ getCartesianCovariance()

TMatrixDSym getCartesianCovariance ( const double  bZ_tesla = 1.5) const

Getter for the position and momentum covariance matrix.

Note
Because the position and momentum covariance matrix is regenerated from a 5x5 perigee parameter covariance matrix there is necessarily a missing rank in the resulting matrix. The rank has to be filled by a convention essentially expressing, which points around the perigee are considered to be at s = 0. For backwards compatability with the original Belle experiment we apply the convention used there. See the Belle II note for more details.
Parameters
bZ_teslaMagnetic field to be used for the calculation from the curvature;
  1. Rotate to the right phi0

Definition at line 113 of file UncertainHelix.cc.

114{
115 // 0. Define indices
116 // Maybe push these out of this function:
117 // Indices of the cartesian coordinates
118 const int iX = 0;
119 const int iY = 1;
120 const int iZ = 2;
121 const int iPx = 3;
122 const int iPy = 4;
123 const int iPz = 5;
124
125 // Transform covariance matrix
126 TMatrixD jacobianInflate(6, 5);
127 jacobianInflate.Zero();
128
129 // 1. Inflate the perigee covariance to a cartesian covariance where phi0 == 0 is assumed
130 // The real phi0 is a simple rotation which can be handled in the next step.
131 // Jacobian matrix for the translation
132
133 const double& d0 = getD0();
134 const double& omega = getOmega();
135 const double& tanLambda = getTanLambda();
136
137 const double alpha = getAlpha(bZ_tesla);
138 const double absAlphaOmega = alpha * std::fabs(omega);
139 const double signedAlphaOmega2 = absAlphaOmega * omega;
140
141 const double invAbsAlphaOmega = 1.0 / absAlphaOmega;
142 const double invSignedAlphaOmega2 = 1.0 / signedAlphaOmega2;
143
144 // Position after the move.
145 jacobianInflate(iX, iPhi0) = d0;
146 jacobianInflate(iY, iD0) = -1.0;
147 jacobianInflate(iZ, iZ0) = 1.0;
148
149 // Momentum
150 jacobianInflate(iPx, iOmega) = -invSignedAlphaOmega2;
151 jacobianInflate(iPy, iPhi0) = invAbsAlphaOmega;
152 jacobianInflate(iPz, iOmega) = -tanLambda * invSignedAlphaOmega2;
153 jacobianInflate(iPz, iTanLambda) = invAbsAlphaOmega;
154
155 TMatrixDSym cov6 = m_covariance; //copy
156 cov6.Similarity(jacobianInflate);
157
159 const double& cosPhi0 = getCosPhi0();
160 const double& sinPhi0 = getSinPhi0();
161
162 TMatrixD jacobianRot(6, 6);
163 jacobianRot.Zero();
164
165 // Active rotation matrix by phi0:
166 jacobianRot(iX, iX) = cosPhi0;
167 jacobianRot(iX, iY) = -sinPhi0;
168 jacobianRot(iY, iX) = sinPhi0;
169 jacobianRot(iY, iY) = cosPhi0;
170 jacobianRot(iZ, iZ) = 1.0;
171
172 jacobianRot(iPx, iPx) = cosPhi0;
173 jacobianRot(iPx, iPy) = -sinPhi0;
174 jacobianRot(iPy, iPx) = sinPhi0;
175 jacobianRot(iPy, iPy) = cosPhi0;
176 jacobianRot(iPz, iPz) = 1.0;
177
178 cov6.Similarity(jacobianRot);
179 return cov6;
180}

◆ getCovariance()

const TMatrixDSym & getCovariance ( ) const
inline

Getter for covariance matrix of perigee parameters in matrix form.

Definition at line 100 of file UncertainHelix.h.

101 { return m_covariance; }

◆ getPValue()

double getPValue ( ) const
inline

Getter for Chi2 Probability of the track fit.

Definition at line 94 of file UncertainHelix.h.

95 { return m_pValue; }

◆ ignoreErrorMatrix()

void ignoreErrorMatrix ( void  )
inherited

Unsets error matrix.

Error calculations will be ignored after this function call until an error matrix be set again. 0 matrix will be return as a return value for error matrix when you call functions which returns an error matrix.

Definition at line 872 of file Helix.cc.

873{
874 m_matrixValid = false;
875 m_Ea *= 0.;
876}
bool m_matrixValid
True: matrix valid, False: matrix not valid.
Definition: Helix.h:288

◆ kappa()

double kappa ( void  ) const
inlineinherited

Return helix parameter kappa.

Definition at line 396 of file Helix.h.

397 {
398 DEBUG_HELIX;
399 return m_ac[2];
400 }

◆ momentum() [1/5]

HepLorentzVector momentum ( double  dPhi,
double  mass 
) const
inherited

returns 4momentum vector after rotating angle dPhi in phi direction.

Definition at line 306 of file Helix.cc.

307{
308 DEBUG_HELIX;
309 //
310 // Calculate momentum.
311 //
312 // Pt = | 1/kappa | (GeV/c)
313 //
314 // Px = -Pt * sin(phi0 + phi)
315 // Py = Pt * cos(phi0 + phi)
316 // Pz = Pt * tan(lambda)
317 //
318 // E = sqrt( 1/kappa/kappa * (1+tan(lambda)*tan(lambda)) + mass*mass )
319
320 double pt = fabs(m_pt);
321 double px = - pt * sin(m_ac[1] + phi);
322 double py = pt * cos(m_ac[1] + phi);
323 double pz = pt * m_ac[4];
324 double E = sqrt(pt * pt * (1. + m_ac[4] * m_ac[4]) + mass * mass);
325
326 return HepLorentzVector(px, py, pz, E);
327}
double m_pt
Cache of the pt.
Definition: Helix.h:311

◆ momentum() [2/5]

HepLorentzVector momentum ( double  dPhi,
double  mass,
HepPoint3D x,
HepSymMatrix &  Emx 
) const
inherited

returns 4momentum vector after rotating angle dPhi in phi direction.

Definition at line 358 of file Helix.cc.

362{
363 DEBUG_HELIX;
364 //
365 // Calculate momentum.
366 //
367 // Pt = | 1/kappa | (GeV/c)
368 //
369 // Px = -Pt * sin(phi0 + phi)
370 // Py = Pt * cos(phi0 + phi)
371 // Pz = Pt * tan(lambda)
372 //
373 // E = sqrt( 1/kappa/kappa * (1+tan(lambda)*tan(lambda)) + mass*mass )
374
375 double pt = fabs(m_pt);
376 double px = - pt * sin(m_ac[1] + phi);
377 double py = pt * cos(m_ac[1] + phi);
378 double pz = pt * m_ac[4];
379 double E = sqrt(pt * pt * (1. + m_ac[4] * m_ac[4]) + mass * mass);
380
381 x.setX(m_pivot.x() + m_ac[0] * m_cp + m_r * (m_cp - cos(m_ac[1] + phi)));
382 x.setY(m_pivot.y() + m_ac[0] * m_sp + m_r * (m_sp - sin(m_ac[1] + phi)));
383 x.setZ(m_pivot.z() + m_ac[3] - m_r * m_ac[4] * phi);
384
385 if (m_matrixValid) Emx = m_Ea.similarity(del4MXDelA(phi, mass));
386 else Emx = m_Ea;
387
388 return HepLorentzVector(px, py, pz, E);
389}
HepMatrix del4MXDelA(double phi, double mass) const
DMX4/DA.
Definition: Helix.cc:798
HepPoint3D x(double dPhi=0.) const
returns position after rotating angle dPhi in phi direction.
Definition: Helix.cc:197

◆ momentum() [3/5]

HepLorentzVector momentum ( double  dPhi,
double  mass,
HepSymMatrix &  Em 
) const
inherited

returns 4momentum vector after rotating angle dPhi in phi direction.

Definition at line 331 of file Helix.cc.

332{
333 DEBUG_HELIX;
334 //
335 // Calculate momentum.
336 //
337 // Pt = | 1/kappa | (GeV/c)
338 //
339 // Px = -Pt * sin(phi0 + phi)
340 // Py = Pt * cos(phi0 + phi)
341 // Pz = Pt * tan(lambda)
342 //
343 // E = sqrt( 1/kappa/kappa * (1+tan(lambda)*tan(lambda)) + mass*mass )
344
345 double pt = fabs(m_pt);
346 double px = - pt * sin(m_ac[1] + phi);
347 double py = pt * cos(m_ac[1] + phi);
348 double pz = pt * m_ac[4];
349 double E = sqrt(pt * pt * (1. + m_ac[4] * m_ac[4]) + mass * mass);
350
351 if (m_matrixValid) Em = m_Ea.similarity(del4MDelA(phi, mass));
352 else Em = m_Ea;
353
354 return HepLorentzVector(px, py, pz, E);
355}
HepMatrix del4MDelA(double phi, double mass) const
DM4/DA.
Definition: Helix.cc:749

◆ momentum() [4/5]

Hep3Vector momentum ( double  dPhi,
HepSymMatrix &  Em 
) const
inherited

returns momentum vector after rotating angle dPhi in phi direction.

Definition at line 281 of file Helix.cc.

282{
283 DEBUG_HELIX;
284 //
285 // Calculate momentum.
286 //
287 // Pt = | 1/kappa | (GeV/c)
288 //
289 // Px = -Pt * sin(phi0 + phi)
290 // Py = Pt * cos(phi0 + phi)
291 // Pz = Pt * tan(lambda)
292 //
293
294 double pt = fabs(m_pt);
295 double px = - pt * sin(m_ac[1] + phi);
296 double py = pt * cos(m_ac[1] + phi);
297 double pz = pt * m_ac[4];
298
299 if (m_matrixValid) Em = m_Ea.similarity(delMDelA(phi));
300 else Em = m_Ea;
301
302 return Hep3Vector(px, py, pz);
303}
HepMatrix delMDelA(double phi) const
DM/DA.
Definition: Helix.cc:710

◆ momentum() [5/5]

Hep3Vector momentum ( double  dPhi = 0.) const
inherited

returns momentum vector after rotating angle dPhi in phi direction.

Definition at line 259 of file Helix.cc.

260{
261 DEBUG_HELIX;
262 //
263 // Calculate momentum.
264 //
265 // Pt = | 1/kappa | (GeV/c)
266 //
267 // Px = -Pt * sin(phi0 + phi)
268 // Py = Pt * cos(phi0 + phi)
269 // Pz = Pt * tan(lambda)
270 //
271
272 double pt = fabs(m_pt);
273 double px = - pt * sin(m_ac[1] + phi);
274 double py = pt * cos(m_ac[1] + phi);
275 double pz = pt * m_ac[4];
276
277 return Hep3Vector(px, py, pz);
278}

◆ passiveMoveBy() [1/2]

double passiveMoveBy ( const double &  byX,
const double &  byY,
const double &  byZ 
)

Moves origin of the coordinate system (passive transformation) by the given vector.

Updates the helix inplace.

Parameters
byXX displacement by which the origin of the coordinate system should be moved.
byYY displacement by which the origin of the coordinate system should be moved.
byZZ displacement by which the origin of the coordinate system should be moved.
Returns
The double value is the two dimensional arc length, which has the be traversed from the old perigee to the new.

Definition at line 198 of file UncertainHelix.cc.

201{
202 // Move the covariance matrix first to have access to the original parameters
203 TMatrixD jacobianPassiveMove(5, 5);
204 calcPassiveMoveByJacobian(byX, byY, jacobianPassiveMove);
205 m_covariance.Similarity(jacobianPassiveMove);
206 return Helix::passiveMoveBy(byX, byY, byZ);
207}
double passiveMoveBy(const ROOT::Math::XYZVector &by)
Moves origin of the coordinate system (passive transformation) by the given vector.
Definition: Helix.h:245

◆ passiveMoveBy() [2/2]

double passiveMoveBy ( const ROOT::Math::XYZVector &  by)
inline

Moves origin of the coordinate system (passive transformation) by the given vector.

Updates the helix inplace.

Parameters
byVector by which the origin of the coordinate system should be moved.
Returns
The double value is the two dimensional arc length, which has the be traversed from the old perigee to the new.

Definition at line 117 of file UncertainHelix.h.

118 { return passiveMoveBy(by.X(), by.Y(), by.Z()); }

◆ phi0()

double phi0 ( void  ) const
inlineinherited

Return helix parameter phi0.

Definition at line 388 of file Helix.h.

389 {
390 DEBUG_HELIX;
391 return m_ac[1];
392 }

◆ pivot() [1/2]

const HepPoint3D & pivot ( const HepPoint3D newPivot)
inherited

Sets pivot position.

Definition at line 393 of file Helix.cc.

394{
395 DEBUG_HELIX;
396#if defined(BELLE_DEBUG)
397 try {
398#endif
399 const double& dr = m_ac[0];
400 const double& phi0 = m_ac[1];
401 const double& kappa = m_ac[2];
402 const double& dz = m_ac[3];
403 const double& tanl = m_ac[4];
404
405 double rdr = dr + m_r;
406 double phi = fmod(phi0 + M_PI4, M_PI2);
407 double csf0 = cos(phi);
408 double snf0 = (1. - csf0) * (1. + csf0);
409 snf0 = sqrt((snf0 > 0.) ? snf0 : 0.);
410 if (phi > M_PI) snf0 = - snf0;
411
412 double xc = m_pivot.x() + rdr * csf0;
413 double yc = m_pivot.y() + rdr * snf0;
414 double csf, snf;
415 if (m_r != 0.0) {
416 csf = (xc - newPivot.x()) / m_r;
417 snf = (yc - newPivot.y()) / m_r;
418 double anrm = sqrt(csf * csf + snf * snf);
419 if (anrm != 0.0) {
420 csf /= anrm;
421 snf /= anrm;
422 phi = atan2(snf, csf);
423 } else {
424 csf = 1.0;
425 snf = 0.0;
426 phi = 0.0;
427 }
428 } else {
429 csf = 1.0;
430 snf = 0.0;
431 phi = 0.0;
432 }
433 double phid = fmod(phi - phi0 + M_PI8, M_PI2);
434 if (phid > M_PI) phid = phid - M_PI2;
435 double drp = (m_pivot.x() + dr * csf0 + m_r * (csf0 - csf) - newPivot.x())
436 * csf
437 + (m_pivot.y() + dr * snf0 + m_r * (snf0 - snf) - newPivot.y()) * snf;
438 double dzp = m_pivot.z() + dz - m_r * tanl * phid - newPivot.z();
439
440 HepVector ap(5);
441 ap[0] = drp;
442 ap[1] = fmod(phi + M_PI4, M_PI2);
443 ap[2] = kappa;
444 ap[3] = dzp;
445 ap[4] = tanl;
446
447 // if (m_matrixValid) m_Ea.assign(delApDelA(ap) * m_Ea * delApDelA(ap).T());
448 if (m_matrixValid) m_Ea = m_Ea.similarity(delApDelA(ap));
449
450 m_a = ap;
451 m_pivot = newPivot;
452
453 //...Are these needed?...iw...
454 updateCache();
455 return m_pivot;
456#if defined(BELLE_DEBUG)
457 } catch (...) {
458 m_helixValid = false;
459 DEBUG_PRINT;
461 }
462#endif
463 return m_pivot;
464}
double tanl(void) const
Return helix parameter tangent lambda.
Definition: Helix.h:412
HepMatrix delApDelA(const HepVector &ap) const
DAp/DA.
Definition: Helix.cc:584
double kappa(void) const
Return helix parameter kappa.
Definition: Helix.h:396
const double M_PI4
4*PI
Definition: Helix.cc:35

◆ pivot() [2/2]

const HepPoint3D & pivot ( void  ) const
inlineinherited

returns pivot position.

Definition at line 356 of file Helix.h.

357 {
358 DEBUG_HELIX;
359 return m_pivot;
360 }

◆ radius()

double radius ( void  ) const
inlineinherited

returns radious of helix.

Definition at line 364 of file Helix.h.

365 {
366 DEBUG_HELIX;
367 return m_r;
368 }

◆ reverse()

void reverse ( )

Reverses the direction of travel of the helix in place.

The same points that are located on the helix stay are the same after the transformation, but have the opposite two dimensional arc length associated to them. The momentum at each point is reversed. The charge sign is changed to its opposite by this transformation.

Definition at line 182 of file UncertainHelix.cc.

183{
185
186 // D0, omega and tan lambda have to be taken to their opposites
187 // Phi0 is augmented by pi which does not change its covariances
188 // Z0 stays the same
189 TMatrixD jacobianReverse(5, 5);
190 jacobianReverse.UnitMatrix();
191 jacobianReverse(iD0, iD0) = -1;
192 jacobianReverse(iOmega, iOmega) = -1;
193 jacobianReverse(iTanLambda, iTanLambda) = -1;
194
195 m_covariance.Similarity(jacobianReverse);
196}
void reverse()
Reverses the direction of travel of the helix in place.

◆ set()

void set ( const HepPoint3D pivot,
const HepVector &  a,
const HepSymMatrix &  Ea 
)
inherited

Sets helix pivot position, parameters, and error matrix.

Definition at line 467 of file Helix.cc.

470{
471 m_pivot = pivot;
472 m_a = a;
473 m_Ea = Ea;
474 m_matrixValid = true;
475 m_helixValid = false;
476 updateCache();
477 DEBUG_HELIX;
478}
const HepPoint3D & pivot(void) const
returns pivot position.
Definition: Helix.h:356
const HepSymMatrix & Ea(void) const
Returns error matrix.
Definition: Helix.h:436

◆ set_exception()

bool set_exception ( bool  t)
staticinherited

set exception

Definition at line 112 of file Helix.cc.

113{
114 return ms_throw_exception = t;
115}

◆ set_limits()

void set_limits ( const HepVector &  a_min,
const HepVector &  a_max 
)
staticinherited

set limit for parameter "a"

Definition at line 123 of file Helix.cc.

124{
125 if (a_min.num_row() != 5 || a_max.num_row() != 5) return;
126 ms_amin = a_min;
127 ms_amax = a_max;
128 ms_check_range = true;
129}

◆ set_print()

bool set_print ( bool  t)
staticinherited

Set print option for debugging.

Definition at line 117 of file Helix.cc.

118{
119 return ms_print_debug = t;
120}

◆ sinPhi0()

double sinPhi0 ( void  ) const
inlineinherited

Return sin phi0.

Definition at line 492 of file Helix.h.

493 {
494 DEBUG_HELIX;
495 return m_sp;
496 }

◆ tanl()

double tanl ( void  ) const
inlineinherited

Return helix parameter tangent lambda.

Definition at line 412 of file Helix.h.

413 {
414 DEBUG_HELIX;
415 return m_ac[4];
416 }

◆ updateCache()

void updateCache ( void  )
privateinherited

updateCache

Definition at line 508 of file Helix.cc.

509{
510
511#if defined(BELLE_DEBUG)
512 checkValid();
513 if (m_helixValid) {
514#endif
515
516 //
517 // Calculate Helix center( xc, yc ).
518 //
519 // xc = x0 + (dr + (alpha / kappa)) * cos(phi0) (cm)
520 // yc = y0 + (dr + (alpha / kappa)) * sin(phi0) (cm)
521 //
522
523 m_ac[0] = m_a[0];
524 m_ac[1] = m_a[1];
525 m_ac[2] = m_a[2];
526 m_ac[3] = m_a[3];
527 m_ac[4] = m_a[4];
528
529 m_cp = cos(m_ac[1]);
530 m_sp = sin(m_ac[1]);
531 if (m_ac[2] != 0.0) {
532 if (m_ac[2] == DBL_MAX || m_ac[2] == (-DBL_MAX)) {
533 m_pt = m_r = 0;
534 return;
535 } else {
536 m_pt = 1. / m_ac[2];
537 m_r = m_alpha / m_ac[2];
538 }
539 } else {
540 m_pt = (DBL_MAX);
541 m_r = (DBL_MAX);
542 return;
543 }
544
545 double x = m_pivot.x() + (m_ac[0] + m_r) * m_cp;
546 double y = m_pivot.y() + (m_ac[0] + m_r) * m_sp;
547 m_center.setX(x);
548 m_center.setY(y);
549 m_center.setZ(0.);
550#if defined(BELLE_DEBUG)
551 } else {
552 m_ac[0] = m_a[0];
553 m_ac[1] = m_a[1];
554 m_ac[2] = m_a[2];
555 m_ac[3] = m_a[3];
556 m_ac[4] = m_a[4];
557
558 m_cp = cos(m_ac[1]);
559 m_sp = sin(m_ac[1]);
560 if (m_ac[2] != 0.0) {
561 if (m_ac[2] == DBL_MAX || m_ac[2] == (-DBL_MAX)) {
562 m_pt = m_r = 0;
563 return;
564 } else {
565 m_pt = 1. / m_ac[2];
566 m_r = m_alpha / m_ac[2];
567 }
568 } else {
569 m_pt = (DBL_MAX);
570 m_r = (DBL_MAX);
571 return;
572 }
573
574 double x = m_pivot.x() + (m_ac[0] + m_r) * m_cp;
575 double y = m_pivot.y() + (m_ac[0] + m_r) * m_sp;
576 m_center.setX(x);
577 m_center.setY(y);
578 m_center.setZ(0.);
579 }
580#endif
581}
void checkValid(void)
Check whether helix parameters is valid or not.
Definition: Helix.cc:895

◆ x() [1/3]

double * x ( double  dPhi,
double  p[3] 
) const
inherited

returns position after rotating angle dPhi in phi direction.

x = x0 + dr * cos(phi0) + (alpha / kappa) * (cos(phi0) - cos(phi0+phi)) y = y0 + dr * sin(phi0) + (alpha / kappa) * (sin(phi0) - sin(phi0+phi)) z = z0 + dz - (alpha / kappa) * tan(lambda) * phi

Returns
double[3]

Definition at line 216 of file Helix.cc.

217{
218 DEBUG_HELIX;
219 //
220 // Calculate position (x,y,z) along helix.
221 //
222 // x = x0 + dr * cos(phi0) + (alpha / kappa) * (cos(phi0) - cos(phi0+phi))
223 // y = y0 + dr * sin(phi0) + (alpha / kappa) * (sin(phi0) - sin(phi0+phi))
224 // z = z0 + dz - (alpha / kappa) * tan(lambda) * phi
225 //
226
227 p[0] = m_pivot.x() + m_ac[0] * m_cp + m_r * (m_cp - cos(m_ac[1] + phi));
228 p[1] = m_pivot.y() + m_ac[0] * m_sp + m_r * (m_sp - sin(m_ac[1] + phi));
229 p[2] = m_pivot.z() + m_ac[3] - m_r * m_ac[4] * phi;
230
231 return p;
232}

◆ x() [2/3]

HepPoint3D x ( double  dPhi,
HepSymMatrix &  Ex 
) const
inherited

returns position and convariance matrix(Ex) after rotation.

Definition at line 235 of file Helix.cc.

236{
237 DEBUG_HELIX;
238
239 double x = m_pivot.x() + m_ac[0] * m_cp + m_r * (m_cp - cos(m_ac[1] + phi));
240 double y = m_pivot.y() + m_ac[0] * m_sp + m_r * (m_sp - sin(m_ac[1] + phi));
241 double z = m_pivot.z() + m_ac[3] - m_r * m_ac[4] * phi;
242
243 //
244 // Calculate position error matrix.
245 // Ex(phi) = (@x/@a)(Ea)(@x/@a)^T, phi is deflection angle to specify the
246 // point to be calcualted.
247 //
248 // HepMatrix dXDA(3, 5, 0);
249 // dXDA = delXDelA(phi);
250 // Ex.assign(dXDA * m_Ea * dXDA.T());
251
252 if (m_matrixValid) Ex = m_Ea.similarity(delXDelA(phi));
253 else Ex = m_Ea;
254
255 return HepPoint3D(x, y, z);
256}
HepMatrix delXDelA(double phi) const
DX/DA.
Definition: Helix.cc:654

◆ x() [3/3]

HepPoint3D x ( double  dPhi = 0.) const
inherited

returns position after rotating angle dPhi in phi direction.

x = x0 + dr * cos(phi0) + (alpha / kappa) * (cos(phi0) - cos(phi0+phi)) y = y0 + dr * sin(phi0) + (alpha / kappa) * (sin(phi0) - sin(phi0+phi)) z = z0 + dz - (alpha / kappa) * tan(lambda) * phi

Returns
HepPoint3D

Definition at line 197 of file Helix.cc.

198{
199 DEBUG_HELIX;
200 //
201 // Calculate position (x,y,z) along helix.
202 //
203 // x = x0 + dr * cos(phi0) + (alpha / kappa) * (cos(phi0) - cos(phi0+phi))
204 // y = y0 + dr * sin(phi0) + (alpha / kappa) * (sin(phi0) - sin(phi0+phi))
205 // z = z0 + dz - (alpha / kappa) * tan(lambda) * phi
206 //
207
208 double x = m_pivot.x() + m_ac[0] * m_cp + m_r * (m_cp - cos(m_ac[1] + phi));
209 double y = m_pivot.y() + m_ac[0] * m_sp + m_r * (m_sp - sin(m_ac[1] + phi));
210 double z = m_pivot.z() + m_ac[3] - m_r * m_ac[4] * phi;
211
212 return HepPoint3D(x, y, z);
213}

Member Data Documentation

◆ ConstantAlpha

const double ConstantAlpha = 222.376063
staticinherited

Constant alpha for uniform field.

Definition at line 283 of file Helix.h.

◆ invalidhelix

const std::string invalidhelix
staticprivateinherited

String "Invalid Helix".

Definition at line 318 of file Helix.h.

◆ m_a

HepVector m_a
privateinherited

Helix parameter.

Definition at line 298 of file Helix.h.

◆ m_ac

double m_ac[5]
privateinherited

Cache of the helix parameter.

Definition at line 315 of file Helix.h.

◆ m_alpha

double m_alpha
privateinherited

10000.0/(speed of light)/B.

Definition at line 294 of file Helix.h.

◆ m_bField

double m_bField
privateinherited

Magnetic field, assuming uniform Bz in the unit of kG.

Definition at line 292 of file Helix.h.

◆ m_center

HepPoint3D m_center
privateinherited

Cache of the center position of Helix.

Definition at line 305 of file Helix.h.

◆ m_covariance

TMatrixDSym m_covariance
private

5x5 covariance of the perigee parameters.

Definition at line 134 of file UncertainHelix.h.

◆ m_cp

double m_cp
privateinherited

Cache of the cos phi0.

Definition at line 307 of file Helix.h.

◆ m_Ea

HepSymMatrix m_Ea
privateinherited

Error of the helix parameter.

Definition at line 300 of file Helix.h.

◆ m_helixValid

bool m_helixValid
privateinherited

True: helix valid, False: helix not valid.

Definition at line 290 of file Helix.h.

◆ m_matrixValid

bool m_matrixValid
privateinherited

True: matrix valid, False: matrix not valid.

Definition at line 288 of file Helix.h.

◆ m_pivot

HepPoint3D m_pivot
privateinherited

Pivot.

Definition at line 296 of file Helix.h.

◆ m_pt

double m_pt
privateinherited

Cache of the pt.

Definition at line 311 of file Helix.h.

◆ m_pValue

Double32_t m_pValue
private

Chi2 Probability of the fit.

Definition at line 137 of file UncertainHelix.h.

◆ m_r

double m_r
privateinherited

Cache of the r.

Definition at line 313 of file Helix.h.

◆ m_sp

double m_sp
privateinherited

Cache of the sin phi0.

Definition at line 309 of file Helix.h.

◆ ms_amax

HepVector ms_amax
staticprivateinherited

maxiimum limit of Helix parameter a

Definition at line 233 of file Helix.h.

◆ ms_amin

HepVector ms_amin
staticprivateinherited

minimum limit of Helix parameter a

Definition at line 231 of file Helix.h.

◆ ms_check_range

bool ms_check_range
staticprivateinherited

Check the helix parameter's range.

Definition at line 235 of file Helix.h.

◆ ms_print_debug

bool ms_print_debug
staticprivateinherited

Debug option flag.

Definition at line 237 of file Helix.h.

◆ ms_throw_exception

bool ms_throw_exception
staticprivateinherited

Throw exception flag.

Definition at line 239 of file Helix.h.


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