]> git.uio.no Git - u/mrichter/AliRoot.git/blobdiff - STEER/AliKalmanTrack.cxx
Bit added to indicate if this track was used to fit the primary vertex.
[u/mrichter/AliRoot.git] / STEER / AliKalmanTrack.cxx
index 95bce32aa27cb11460648a107856b2cf4d2df270..a3d09ffe168ea699e88ede8f3061a230a477e0c2 100644 (file)
 //   that is the base for AliTPCtrack, AliITStrackV2 and AliTRDtrack
 //        Origin: Iouri Belikov, CERN, Jouri.Belikov@cern.ch
 //-------------------------------------------------------------------------
-
+#include <TGeoManager.h>
 #include "AliKalmanTrack.h"
-#include "TGeoManager.h"
 
 ClassImp(AliKalmanTrack)
 
-const AliMagF *AliKalmanTrack::fgkFieldMap=0;
-Double_t AliKalmanTrack::fgConvConst=0.;
-
 //_______________________________________________________________________
-AliKalmanTrack::AliKalmanTrack():
+  AliKalmanTrack::AliKalmanTrack():AliExternalTrackParam(),
   fLab(-3141593),
   fFakeRatio(0),
   fChi2(0),
   fMass(AliPID::ParticleMass(AliPID::kPion)),
   fN(0),
-  fLocalConvConst(0),
   fStartTimeIntegral(kFALSE),
   fIntegratedLength(0)
 {
   //
   // Default constructor
   //
-    if (fgkFieldMap==0) {
-      AliFatal("The magnetic field has not been set!");
-    }
 
-    for(Int_t i=0; i<AliPID::kSPECIES; i++) fIntegratedTime[i] = 0;
+  for(Int_t i=0; i<AliPID::kSPECIES; i++) fIntegratedTime[i] = 0;
 }
 
 //_______________________________________________________________________
 AliKalmanTrack::AliKalmanTrack(const AliKalmanTrack &t):
-  TObject(t),
+  AliExternalTrackParam(t),
   fLab(t.fLab),
   fFakeRatio(t.fFakeRatio),
   fChi2(t.fChi2),
   fMass(t.fMass),
   fN(t.fN),
-  fLocalConvConst(t.fLocalConvConst),
   fStartTimeIntegral(t.fStartTimeIntegral),
   fIntegratedLength(t.fIntegratedLength)
 {
   //
   // Copy constructor
   //
-  if (fgkFieldMap==0) {
-    AliFatal("The magnetic field has not been set!");
-  }
   
   for (Int_t i=0; i<AliPID::kSPECIES; i++)
       fIntegratedTime[i] = t.fIntegratedTime[i];
@@ -90,6 +78,7 @@ void AliKalmanTrack::StartTimeIntegral()
   for(Int_t i=0; i<AliPID::kSPECIES; i++) fIntegratedTime[i] = 0;  
   fIntegratedLength = 0;
 }
+
 //_______________________________________________________________________
 void AliKalmanTrack:: AddTimeStep(Double_t length) 
 {
@@ -141,7 +130,6 @@ void AliKalmanTrack:: AddTimeStep(Double_t length)
 }
 
 //_______________________________________________________________________
-
 Double_t AliKalmanTrack::GetIntegratedTime(Int_t pdg) const 
 {
   // Sylwester Radomski, GSI
@@ -175,190 +163,13 @@ void AliKalmanTrack::SetIntegratedTimes(const Double_t *times) {
   for (Int_t i=0; i<AliPID::kSPECIES; i++) fIntegratedTime[i]=times[i];
 }
 
-//_______________________________________________________________________
-
-void AliKalmanTrack::PrintTime() const
-{
-  // Sylwester Radomski, GSI
-  // S.Radomski@gsi.de
-  //
-  // For testing
-  // Prints time for all hypothesis
-  //
-
-  for (Int_t i=0; i<AliPID::kSPECIES; i++)
-    printf("%d: %.2f  ", AliPID::ParticleCode(i), fIntegratedTime[i]);
-  printf("\n");  
-}
-
-void AliKalmanTrack::External2Helix(Double_t helix[6]) const { 
-  //--------------------------------------------------------------------
-  // External track parameters -> helix parameters 
-  //--------------------------------------------------------------------
-  Double_t alpha,x,cs,sn;
-  GetExternalParameters(x,helix); alpha=GetAlpha();
-
-  cs=TMath::Cos(alpha); sn=TMath::Sin(alpha);
-  helix[5]=x*cs - helix[0]*sn;            // x0
-  helix[0]=x*sn + helix[0]*cs;            // y0
-//helix[1]=                               // z0
-  helix[2]=TMath::ASin(helix[2]) + alpha; // phi0
-//helix[3]=                               // tgl
-  helix[4]=helix[4]/GetLocalConvConst();  // C
-}
-
-static void Evaluate(const Double_t *h, Double_t t,
-                     Double_t r[3],  //radius vector
-                     Double_t g[3],  //first defivatives
-                     Double_t gg[3]) //second derivatives
-{
-  //--------------------------------------------------------------------
-  // Calculate position of a point on a track and some derivatives
-  //--------------------------------------------------------------------
-  Double_t phase=h[4]*t+h[2];
-  Double_t sn=TMath::Sin(phase), cs=TMath::Cos(phase);
-
-  r[0] = h[5] + (sn - h[6])/h[4];
-  r[1] = h[0] - (cs - h[7])/h[4];  
-  r[2] = h[1] + h[3]*t;
-
-  g[0] = cs; g[1]=sn; g[2]=h[3];
-  
-  gg[0]=-h[4]*sn; gg[1]=h[4]*cs; gg[2]=0.;
-}
-
-Double_t AliKalmanTrack::
-GetDCA(const AliKalmanTrack *p, Double_t &xthis, Double_t &xp) const {
-  //------------------------------------------------------------
-  // Returns the (weighed !) distance of closest approach between 
-  // this track and the track passed as the argument.
-  // Other returned values:
-  //   xthis, xt - coordinates of tracks' reference planes at the DCA 
-  //-----------------------------------------------------------
-  Double_t dy2=GetSigmaY2() + p->GetSigmaY2();
-  Double_t dz2=GetSigmaZ2() + p->GetSigmaZ2();
-  Double_t dx2=dy2; 
-
-  //dx2=dy2=dz2=1.;
-
-  Double_t p1[8]; External2Helix(p1);
-  p1[6]=TMath::Sin(p1[2]); p1[7]=TMath::Cos(p1[2]);
-  Double_t p2[8]; p->External2Helix(p2);
-  p2[6]=TMath::Sin(p2[2]); p2[7]=TMath::Cos(p2[2]);
-
-
-  Double_t r1[3],g1[3],gg1[3]; Double_t t1=0.;
-  Evaluate(p1,t1,r1,g1,gg1);
-  Double_t r2[3],g2[3],gg2[3]; Double_t t2=0.;
-  Evaluate(p2,t2,r2,g2,gg2);
-
-  Double_t dx=r2[0]-r1[0], dy=r2[1]-r1[1], dz=r2[2]-r1[2];
-  Double_t dm=dx*dx/dx2 + dy*dy/dy2 + dz*dz/dz2;
-
-  Int_t max=27;
-  while (max--) {
-     Double_t gt1=-(dx*g1[0]/dx2 + dy*g1[1]/dy2 + dz*g1[2]/dz2);
-     Double_t gt2=+(dx*g2[0]/dx2 + dy*g2[1]/dy2 + dz*g2[2]/dz2);
-     Double_t h11=(g1[0]*g1[0] - dx*gg1[0])/dx2 + 
-                  (g1[1]*g1[1] - dy*gg1[1])/dy2 +
-                  (g1[2]*g1[2] - dz*gg1[2])/dz2;
-     Double_t h22=(g2[0]*g2[0] + dx*gg2[0])/dx2 + 
-                  (g2[1]*g2[1] + dy*gg2[1])/dy2 +
-                  (g2[2]*g2[2] + dz*gg2[2])/dz2;
-     Double_t h12=-(g1[0]*g2[0]/dx2 + g1[1]*g2[1]/dy2 + g1[2]*g2[2]/dz2);
-
-     Double_t det=h11*h22-h12*h12;
-
-     Double_t dt1,dt2;
-     if (TMath::Abs(det)<1.e-33) {
-        //(quasi)singular Hessian
-        dt1=-gt1; dt2=-gt2;
-     } else {
-        dt1=-(gt1*h22 - gt2*h12)/det; 
-        dt2=-(h11*gt2 - h12*gt1)/det;
-     }
-
-     if ((dt1*gt1+dt2*gt2)>0) {dt1=-dt1; dt2=-dt2;}
-
-     //check delta(phase1) ?
-     //check delta(phase2) ?
-
-     if (TMath::Abs(dt1)/(TMath::Abs(t1)+1.e-3) < 1.e-4)
-     if (TMath::Abs(dt2)/(TMath::Abs(t2)+1.e-3) < 1.e-4) {
-        if ((gt1*gt1+gt2*gt2) > 1.e-4/dy2/dy2) 
-         AliWarning(" stopped at not a stationary point !");
-        Double_t lmb=h11+h22; lmb=lmb-TMath::Sqrt(lmb*lmb-4*det);
-        if (lmb < 0.) 
-         AliWarning(" stopped at not a minimum !");
-        break;
-     }
-
-     Double_t dd=dm;
-     for (Int_t div=1 ; ; div*=2) {
-        Evaluate(p1,t1+dt1,r1,g1,gg1);
-        Evaluate(p2,t2+dt2,r2,g2,gg2);
-        dx=r2[0]-r1[0]; dy=r2[1]-r1[1]; dz=r2[2]-r1[2];
-        dd=dx*dx/dx2 + dy*dy/dy2 + dz*dz/dz2;
-       if (dd<dm) break;
-        dt1*=0.5; dt2*=0.5;
-        if (div>512) {
-           AliWarning(" overshoot !"); break;
-        }   
-     }
-     dm=dd;
-
-     t1+=dt1;
-     t2+=dt2;
-
-  }
-
-  if (max<=0) AliWarning(" too many iterations !");
-
-  Double_t cs=TMath::Cos(GetAlpha());
-  Double_t sn=TMath::Sin(GetAlpha());
-  xthis=r1[0]*cs + r1[1]*sn;
-
-  cs=TMath::Cos(p->GetAlpha());
-  sn=TMath::Sin(p->GetAlpha());
-  xp=r2[0]*cs + r2[1]*sn;
-
-  return TMath::Sqrt(dm*TMath::Sqrt(dy2*dz2));
-}
-
-Double_t AliKalmanTrack::
-PropagateToDCA(AliKalmanTrack *p, Double_t d, Double_t x0) {
-  //--------------------------------------------------------------
-  // Propagates this track and the argument track to the position of the
-  // distance of closest approach. 
-  // Returns the (weighed !) distance of closest approach.
-  //--------------------------------------------------------------
-  Double_t xthis,xp;
-  Double_t dca=GetDCA(p,xthis,xp);
-
-  if (!PropagateTo(xthis,d,x0)) {
-    //AliWarning(" propagation failed !");
-    return 1e+33;
-  }  
-
-  if (!p->PropagateTo(xp,d,x0)) {
-    //AliWarning(" propagation failed !";
-    return 1e+33;
-  }  
-
-  return dca;
-}
-
-
-
-
-
 Double_t AliKalmanTrack::MeanMaterialBudget(Double_t *start, Double_t *end, Double_t *mparam)
 {
-  //
+  // 
   // calculate mean material budget and material properties beween point start and end
   // mparam - returns parameters used for dEdx and multiple scatering
   //
-  // mparam[0] - density mean 
+  // mparam[0] - density mean
   // mparam[1] - rad length
   // mparam[2] - A mean
   // mparam[3] - Z mean
@@ -366,10 +177,10 @@ Double_t AliKalmanTrack::MeanMaterialBudget(Double_t *start, Double_t *end, Doub
   // mparam[5] - Z/A mean
   // mparam[6] - number of boundary crosses
   //
-    mparam[0]=0; mparam[1]=1; mparam[2] =0; mparam[3] =0, mparam[4]=0, mparam[5]=0; mparam[6]=0; 
+    mparam[0]=0; mparam[1]=1; mparam[2] =0; mparam[3] =0, mparam[4]=0, mparam[5]=0; mparam[6]=0;
   //
   Double_t bparam[6], lparam[6];          // bparam - total param - lparam - local parameters
-  for (Int_t i=0;i<6;i++) bparam[i]=0;    // 
+  for (Int_t i=0;i<6;i++) bparam[i]=0;    //
 
   if (!gGeoManager) {
     printf("ERROR: no TGeo\n");
@@ -379,8 +190,8 @@ Double_t AliKalmanTrack::MeanMaterialBudget(Double_t *start, Double_t *end, Doub
   Double_t length;
   Double_t dir[3];
   length = TMath::Sqrt((end[0]-start[0])*(end[0]-start[0])+
-                      (end[1]-start[1])*(end[1]-start[1])+
-                      (end[2]-start[2])*(end[2]-start[2]));
+                       (end[1]-start[1])*(end[1]-start[1])+
+                       (end[2]-start[2])*(end[2]-start[2]));
   mparam[4]=length;
   if (length<TGeoShape::Tolerance()) return 0.0;
   Double_t invlen = 1./length;
@@ -400,6 +211,7 @@ Double_t AliKalmanTrack::MeanMaterialBudget(Double_t *start, Double_t *end, Doub
   lparam[1]   = material->GetRadLen();
   lparam[2]   = material->GetA();
   lparam[3]   = material->GetZ();
+  lparam[4]   = length;
   lparam[5]   = lparam[3]/lparam[2];
   if (material->IsMixture()) {
     lparam[1]*=lparam[0];  // different normalization in the modeler for mixture
@@ -417,7 +229,7 @@ Double_t AliKalmanTrack::MeanMaterialBudget(Double_t *start, Double_t *end, Doub
   Double_t step = 0.0;
   // If no boundary within proposed length, return current density
   if (snext>=length) {
-    for (Int_t ip=0;ip<5;ip++) mparam[ip] = lparam[ip];  
+    for (Int_t ip=0;ip<5;ip++) mparam[ip] = lparam[ip];
     return lparam[0];
   }
   // Try to cross the boundary and see what is next
@@ -428,7 +240,7 @@ Double_t AliKalmanTrack::MeanMaterialBudget(Double_t *start, Double_t *end, Doub
     bparam[1]    += snext*lparam[1];
     bparam[2]    += snext*lparam[2];
     bparam[3]    += snext*lparam[3];
-    bparam[5]    += snext*lparam[5];    
+    bparam[5]    += snext*lparam[5];
     bparam[0]    += snext*lparam[0];
 
     if (snext>=length) break;
@@ -438,15 +250,15 @@ Double_t AliKalmanTrack::MeanMaterialBudget(Double_t *start, Double_t *end, Doub
       gGeoManager->SetStep(1.E-3);
       currentnode = gGeoManager->Step();
       if (!gGeoManager->IsEntering() || !currentnode) {
-       //      printf("ERROR: cannot cross boundary\n"); 
-       mparam[0] = bparam[0]/step;
-       mparam[1] = bparam[1]/step;
-       mparam[2] = bparam[2]/step;
-       mparam[3] = bparam[3]/step;     
-       mparam[5] = bparam[5]/step;     
-       mparam[4] = step;
-       mparam[0] = 0.;             // if crash of navigation take mean density 0 
-       mparam[1] = 1000000;        // and infinite rad length
+        //      printf("ERROR: cannot cross boundary\n");
+        mparam[0] = bparam[0]/step;
+        mparam[1] = bparam[1]/step;
+        mparam[2] = bparam[2]/step;
+        mparam[3] = bparam[3]/step;
+        mparam[5] = bparam[5]/step;
+        mparam[4] = step;
+        mparam[0] = 0.;             // if crash of navigation take mean density 0
+        mparam[1] = 1000000;        // and infinite rad length
         return bparam[0]/step;
       }
       step += 1.E-3;
@@ -467,22 +279,23 @@ Double_t AliKalmanTrack::MeanMaterialBudget(Double_t *start, Double_t *end, Doub
     if (material->IsMixture()) {
       lparam[1]*=lparam[0];
       TGeoMixture * mixture = (TGeoMixture*)material;
-      lparam[5]=0; 
+      lparam[5]=0;
       Double_t sum =0;
       for (Int_t iel=0;iel<mixture->GetNelements();iel++){
-       sum+= mixture->GetWmixt()[iel];
-       lparam[5]+= mixture->GetZmixt()[iel]*mixture->GetWmixt()[iel]/mixture->GetAmixt()[iel];
+        sum+= mixture->GetWmixt()[iel];
+        lparam[5]+= mixture->GetZmixt()[iel]*mixture->GetWmixt()[iel]/mixture->GetAmixt()[iel];
       }
       lparam[5]/=sum;
     }
     gGeoManager->FindNextBoundary(length);
     snext = gGeoManager->GetStep();
-  }   
+  }
   mparam[0] = bparam[0]/step;
   mparam[1] = bparam[1]/step;
   mparam[2] = bparam[2]/step;
-  mparam[3] = bparam[3]/step;  
-  mparam[5] = bparam[5]/step;  
-  return bparam[0]/step;   
-  
+  mparam[3] = bparam[3]/step;
+  mparam[5] = bparam[5]/step;
+  return bparam[0]/step;
+
 }
+