]> git.uio.no Git - u/mrichter/AliRoot.git/blobdiff - TRD/AliTRDtrack.h
Cleaned-up version of AliTRDCalibra
[u/mrichter/AliRoot.git] / TRD / AliTRDtrack.h
index d592e9174e35260f3df82cd9b68f062024147643..dd5aaf3888f33217860f0f8383faab795b0ecc42 100644 (file)
 /* Copyright(c) 1998-1999, ALICE Experiment at CERN, All rights reserved. *
  * See cxx source for full Copyright notice                               */
 
-#include <AliKalmanTrack.h>
-#include <TMath.h>
+/* $Id$ */
 
-#include "AliTRDgeometry.h"
-#include "AliESDtrack.h"
-#include "TVector2.h"
+///////////////////////////////////////////////////////////////////////////////
+//                                                                           //
+//  Represents a reconstructed TRD track                                     //
+//                                                                           //
+///////////////////////////////////////////////////////////////////////////////
+
+#include "AliKalmanTrack.h"
+
+#include "AliTRDtracklet.h"
 
-class AliTRDcluster;
-class AliTPCtrack;
 class AliESDtrack;
+class AliTrackReference;
 
-const unsigned kMAX_CLUSTERS_PER_TRACK=210; 
+const unsigned kMAXCLUSTERSPERTRACK = 210; 
+
+class AliTRDtrack : public AliKalmanTrack {
 
-class AliTRDtracklet :public TObject{
-  friend class AliTRDtrack;
  public:
-  AliTRDtracklet();
-  void Set(Float_t x, Float_t y, Float_t z, Float_t alpha, Float_t error2){fX=x; fY=y; fZ=z; fAlpha=alpha; fSigma2= error2;}
-  void SetP0(Float_t p0){fP0=p0;}
-  void SetP1(Float_t p1){fP1=p1;}
-  void SetN(Int_t n){fNFound=n;}
-  void SetNCross(Int_t nc){fNCross=nc;}
-  void SetPlane(Int_t plane){fPlane=plane;}
-  void SetSigma2(Float_t sigma2){fExpectedSigma2=sigma2;}
-  void SetChi2(Float_t chi2){fChi2=chi2;}
-  void SetTilt(Float_t tilt){fTilt=tilt;}
-  Float_t GetX() const { return fX;}
-  Float_t GetY() const { return fY;}
-  Float_t GetZ() const {return fZ;}
-  Float_t GetAlpha() const { return fAlpha;}
-  Float_t GetTrackletSigma2() const { return fSigma2;}
-  //
-  Float_t GetP0() const {return fP0;}
-  Float_t GetP1() const {return fP1;}
-  Int_t GetN() const {return fNFound;}
-  Int_t GetNCross() const {return fNCross;}  
-  Int_t GetPlane() const {return fPlane;}
-  Float_t GetClusterSigma2() const {return fExpectedSigma2;}
-  Float_t GetChi2() const {return fChi2;}
-  Float_t GetTilt() const {return fTilt;}
+   
+  enum { kNdet      = 540
+       , kNstacks   =  90
+       , kNplane    =   6
+       , kNcham     =   5
+       , kNsect     =  18
+       , kNslice    =   3
+       , kNtimeBins =  22 };
+
+   AliTRDtrack();
+   AliTRDtrack(const AliTRDcluster *c, Int_t index, const Double_t xx[5]
+              ,const Double_t cc[15], Double_t xr, Double_t alpha);  
+   AliTRDtrack(const AliTRDtrack &t);    
+   AliTRDtrack(const AliESDtrack &t);
+   ~AliTRDtrack();
+   AliTRDtrack(const AliKalmanTrack &t, Double_t alpha); 
+
+           void     ResetClusters()                                         { SetChi2(0.0); 
+                                                                              SetNumberOfClusters(0);              }
+           Int_t    Compare(const TObject *o) const;
+           void     AddNWrong()                                             { fNWrong++;                           }  
+           void     IncCross()                                              { fNCross++; 
+                                                                              if (fBackupTrack) fBackupTrack->IncCross();  }
+
+           Int_t    GetSector() const;
+           Float_t  GetClusterdQdl(Int_t i) const                           { return fdQdl[i];                     }    
+           Double_t GetdEdx() const                                         { return fdEdx;                        }
+           Int_t    GetNdedx() const                                        { return fNdedx;                       }
+           Double_t GetPIDsignal() const                                    { return GetdEdx();                    }
+           Int_t    GetClusterIndex(Int_t i) const                          { return fIndex[i];                    }
+           Double_t GetC() const                                            { return AliExternalTrackParam::GetC(GetBz()); }
+           Double_t GetPredictedChi2(const AliTRDcluster *c, Double_t h01) const;
+           Float_t  GetPIDsignals(Int_t iPlane, Int_t iSlice) const         { return fdEdxPlane[iPlane][iSlice];   }
+           Int_t    GetPIDTimBin(Int_t i) const                             { return fTimBinPlane[i];              }
+           Double_t GetLikelihoodElectron() const                           { return fLhElectron;                  }
+           Int_t    GetSeedLabel() const                                    { return fSeedLab;                     }
+           Int_t   *GetBackupIndexes()                                      { return fIndexBackup;                 }
+           Int_t   *GetIndexes()                                            { return fIndex;                       }
+           Int_t    GetProlongation(Double_t xk, Double_t &y, Double_t &z);
+           Bool_t   GetStop() const                                         { return fStopped;                     }
+           Int_t    GetNRotate() const                                      { return fNRotate;                     }
+           Int_t    GetNWrong() const                                       { return fNWrong;                      }
+           Int_t    GetNCross() const                                       { return fNCross;                      }
+           Int_t    GetNExpected() const                                    { return fNExpected;                   }
+           Int_t    GetNLast() const                                        { return fNLast;                       }
+           Int_t    GetNExpectedLast() const                                { return fNExpectedLast;               }
+  AliTRDtracklet    GetTracklets(Int_t i) const                             { return fTracklets[i];                }
+           Float_t  GetBudget(Int_t i) const                                { return fBudget[i];                   }
+           Float_t  GetChi2Last() const                                     { return fChi2Last;                    }
+  AliTRDtrack      *GetBackupTrack()                                        { return fBackupTrack;                 }
+
+           void     SetdEdx(Double_t dedx)                                  { fdEdx                      = dedx;   }
+           void     SetStop(Bool_t stop)                                    { fStopped                   = stop;   }
+           void     SetPIDsignals(Float_t dedx, Int_t iPlane, Int_t iSlice) { fdEdxPlane[iPlane][iSlice] = dedx;   }
+           void     SetPIDTimBin(Int_t timbin, Int_t i)                     { fTimBinPlane[i]            = timbin; }
+           void     SetLikelihoodElectron(Float_t l)                        { fLhElectron                = l;      }
+           void     SetSampledEdx(Float_t q, Int_t i);
+           void     SetSampledEdx(Float_t q);
+           void     SetSeedLabel(Int_t lab)                                 { fSeedLab                   = lab;    }
+           void     SetNWrong(Int_t nwrong)                                 { fNWrong                    = nwrong; }
+           void     SetNCross(Int_t ncross)                                 { fNCross                    = ncross; }
+           void     SetNExpected(Int_t nexp)                                { fNExpected                 = nexp;   }
+           void     SetNLast(Int_t nlast)                                   { fNLast                     = nlast;  }
+           void     SetNExpectedLast(Int_t nexp)                            { fNExpectedLast             = nexp;   }
+           void     SetChi2Last(Float_t chi2)                               { fChi2Last                  = chi2;   }
+           void     SetTracklets(Int_t i, AliTRDtracklet t)                 { fTracklets[i]              = t;      }
+           void     SetBudget(Int_t i, Float_t budget)                      { fBudget[i]                 = budget; }
+
+           Int_t    PropagateToX(Double_t xr, Double_t step);
+           Int_t    PropagateToR(Double_t xr, Double_t step);
+           Int_t    UpdateMI(const AliTRDcluster *c, Double_t chi2, Int_t i, Double_t h01, Int_t plane);
+           void     MakeBackupTrack();
+           Bool_t   PropagateTo(Double_t xr, Double_t x0 = 8.72, Double_t rho = 5.86e-3);
+           Bool_t   Update(const AliTRDcluster *c, Double_t chi2, Int_t i, Double_t h01);
+           Bool_t   Rotate(Double_t angle, Bool_t absolute = kFALSE);
+           void     CookdEdx(Double_t low = 0.05, Double_t up = 0.7);   
+           Float_t  StatusForTOF();
  protected:
-  Float_t fY;                 // y position
-  Float_t fZ;                 // z position
-  Float_t fX;                 // x position
-  Float_t fAlpha;             // rotation angle
-  Float_t fSigma2;            // expected error of tracklet position
-  Float_t fP0;                // offset in y
-  Float_t fP1;                // offset in tangent
-  Int_t   fNFound;            // number of found clusters
-  Int_t   fNCross;            // number of crosses
-  Int_t   fPlane;             // plane number
-  Float_t fExpectedSigma2;    // expected sigma of residual distribution of clusters
-  Float_t fChi2;              // chi2 of the tracklet
-  Float_t fTilt;              // tilt factor 
-  ClassDef(AliTRDtracklet,2)
-};
 
+  AliTRDtrack      &operator=(const AliTRDtrack &t);
 
+           Double_t GetBz() const;
+           Bool_t   Update(const AliCluster */*c*/, Double_t /*chi2*/, Int_t /*idx*/) { return 0;   }
+           Double_t GetPredictedChi2(const AliCluster* /*c*/) const                   { return 0.0; }
 
+           Int_t    fSeedLab;                           //  Track label taken from seeding  
+           Float_t  fdEdx;                              //  dE/dx (truncated mean)
+           Float_t  fDE;                                //  Integrated delta energy
+           Float_t  fdEdxPlane[kNplane][kNslice];       //  dE/dx from all 6 planes in 3 slices each
+           Int_t    fTimBinPlane[kNplane];              //  Time bin of Max cluster from all 6 planes
 
-class AliTRDtrack : public AliKalmanTrack {
-
-// Represents reconstructed TRD track
-  friend class AliTRDtracker;
-public:
-
-   AliTRDtrack():AliKalmanTrack(){fBackupTrack=0;}
-   AliTRDtrack(const AliTRDcluster *c, UInt_t index, const Double_t xx[5],
-               const Double_t cc[15], Double_t xr, Double_t alpha);  
-   AliTRDtrack(const AliTRDtrack& t);    
-   AliTRDtrack(const AliKalmanTrack& t, Double_t alpha); 
-   AliTRDtrack(const AliESDtrack& t);    
-   ~AliTRDtrack();
-   Int_t    Compare(const TObject *o) const;
-   void     CookdEdx(Double_t low=0.05, Double_t up=0.55);   
-   Float_t    StatusForTOF();
-   Double_t GetAlpha() const {return fAlpha;}
-   Int_t    GetSector() const {
-     //if (fabs(fAlpha) < AliTRDgeometry::GetAlpha()/2) return 0;
-     return Int_t(TVector2::Phi_0_2pi(fAlpha)/AliTRDgeometry::GetAlpha())%AliTRDgeometry::kNsect;}
-
-   Double_t GetC()     const {return fC;}
-   Int_t    GetClusterIndex(Int_t i) const {return fIndex[i];}    
-   Float_t  GetClusterdQdl(Int_t i) const {return fdQdl[i];}    
-
-   void     GetCovariance(Double_t cov[15]) const;  
-   Double_t GetdEdx()  const {return fdEdx;}
-   Double_t GetPIDsignal()  const {return GetdEdx();}
-   Float_t GetPIDsignals(Int_t i) const {return fdEdxPlane[i];}
-   Int_t  GetPIDTimBin(Int_t i) const {return fTimBinPlane[i];}
-   Double_t GetEta()   const {return fE;}
-
-   void     GetExternalCovariance(Double_t cov[15]) const ;   
-   void     GetExternalParameters(Double_t& xr, Double_t x[5]) const ;
-
-   Double_t GetLikelihoodElectron() const { return fLhElectron; };
-
-   Double_t Get1Pt()   const {return (1e-9*TMath::Abs(fC)/fC + fC)*GetConvConst(); } 
-   Double_t GetP()     const {  
-     return TMath::Abs(GetPt())*sqrt(1.+GetTgl()*GetTgl());
-   }
-   Double_t GetPredictedChi2(const AliTRDcluster*, Double_t h01) const ;
-   Double_t GetPt()    const {return 1./Get1Pt();}   
-   void     GetPxPyPz(Double_t &px, Double_t &py, Double_t &pz) const ;
-   void     GetGlobalXYZ(Double_t &x, Double_t &y, Double_t &z) const ;
-   Int_t    GetSeedLabel() const { return fSeedLab; }
-   Double_t GetSigmaC2()   const {return fCcc;}
-   Double_t GetSigmaTgl2() const {return fCtt;}
-   Double_t GetSigmaY2()   const {return fCyy;}
-   Double_t GetSigmaZ2()   const {return fCzz;}
-   Double_t GetSnp()  const {return fX*fC - fE;}
-   Double_t GetTgl()  const {return fT;}
-   Double_t GetX()    const {return fX;}
-   Double_t GetY()    const {return fY;}
-   Double_t GetZ()    const {return fZ;}
-   UInt_t * GetBackupIndexes()  {return fIndexBackup;}
-   UInt_t * GetIndexes()  {return fIndex;}
-   Double_t GetYat(Double_t xk) const {     
-//-----------------------------------------------------------------
-// This function calculates the Y-coordinate of a track at the plane x=xk.
-// Needed for matching with the TOF (I.Belikov)
-//-----------------------------------------------------------------
-      Double_t c1=fC*fX - fE, r1=TMath::Sqrt(1.- c1*c1);
-      Double_t c2=fC*xk - fE, r2=TMath::Sqrt(1.- c2*c2);
-      return fY + (xk-fX)*(c1+c2)/(r1+r2);
-   }
-   Int_t GetProlongation(Double_t xk, Double_t &y, Double_t &z);
-
-   void SetStop(Bool_t stop) {fStopped=stop;}
-   Bool_t GetStop() const {return fStopped;}
-
-   Int_t    PropagateTo(Double_t xr, Double_t x0=8.72, Double_t rho=5.86e-3);
-   void     ResetCovariance();   
-   void     ResetCovariance(Float_t mult);   
-   void ResetClusters() { SetChi2(0.); SetNumberOfClusters(0); }
-   Int_t    Rotate(Double_t angle);
-
-   void     SetdEdx(Float_t dedx) {fdEdx=dedx;}  
-   void SetPIDsignals(Float_t dedx, Int_t i) {fdEdxPlane[i]=dedx;}
-   void  SetPIDTimBin(Int_t timbin, Int_t i) {fTimBinPlane[i]=timbin;}
-   void     SetLikelihoodElectron(Float_t l) { fLhElectron = l; };  
-
-   void     SetSampledEdx(Float_t q, Int_t i) {
-               Double_t s=GetSnp(), t=GetTgl();
-               q*= TMath::Sqrt((1-s*s)/(1+t*t));
-               fdQdl[i]=q;
-            }     
-   void     SetSampledEdx(Float_t q) {
-              Double_t s=GetSnp(), t=GetTgl();
-              q*= TMath::Sqrt((1-s*s)/(1+t*t));
-              fdQdl[fNdedx]=q;
-             fNdedx++;
-            }     
-
-   void     SetSeedLabel(Int_t lab) { fSeedLab=lab; }
-
-   Int_t    Update(const AliTRDcluster* c, Double_t chi2, UInt_t i, 
-                   Double_t h01);
-   Int_t    UpdateMI(const AliTRDcluster* c, Double_t chi2, UInt_t i, 
-                   Double_t h01, Int_t plane);
-   Int_t    UpdateMI(const AliTRDtracklet & tracklet);
-
-  //
-  void AddNWrong() {fNWrong++;}
-  
-  Int_t GetNWrong() const {return fNWrong;}
-  Int_t GetNRotate() const {return fNRotate;}
-  Int_t GetNCross() const {return fNCross;}
-  void  IncCross() {fNCross++; if (fBackupTrack) fBackupTrack->IncCross();}
-  AliTRDtrack *  GetBackupTrack(){return fBackupTrack;}
-  void    MakeBackupTrack();
-  //
-
-
-protected:
-
-   Int_t    fSeedLab;     // track label taken from seeding  
-   Float_t  fdEdx;        // dE/dx 
-   Float_t  fdEdxPlane[kNPlane];  // dE/dx from all 6 planes
-   Int_t  fTimBinPlane[kNPlane];  // time bin of Max cluster from all 6 planes
-
-   Double_t fAlpha;       // rotation angle
-   Double_t fX;           // running local X-coordinate of the track (time bin)
-   Bool_t   fStopped;     // track stop indication
-
-   Double_t fY;             // Y-coordinate of the track
-   Double_t fZ;             // Z-coordinate of the track
-   Double_t fE;             // C*x0
-   Double_t fT;             // tangent of the track momentum dip angle
-   Double_t fC;             // track curvature
-
-   Double_t fCyy;                         // covariance
-   Double_t fCzy, fCzz;                   // matrix
-   Double_t fCey, fCez, fCee;             // of the
-   Double_t fCty, fCtz, fCte, fCtt;       // track
-   Double_t fCcy, fCcz, fCce, fCct, fCcc; // parameters   
-   
-   UInt_t  fIndex[kMAX_CLUSTERS_PER_TRACK];  // global indexes of clusters  
-   UInt_t  fIndexBackup[kMAX_CLUSTERS_PER_TRACK]; //backup indexes of clusters - used in iterations
-   Float_t fdQdl[kMAX_CLUSTERS_PER_TRACK];   // cluster amplitudes corrected 
-                                             // for track angles    
+           Bool_t   fStopped;                           //  Track stop indication
+           Int_t    fIndex[kMAXCLUSTERSPERTRACK];       //  Global indexes of clusters  
+           Int_t    fIndexBackup[kMAXCLUSTERSPERTRACK]; //  Backup indexes of clusters - used in iterations
+           Float_t  fdQdl[kMAXCLUSTERSPERTRACK];        //  Cluster amplitudes corrected for track angles    
                            
-   Float_t fLhElectron;    // Likelihood to be an electron    
-   Int_t fNWrong;    // number of wrong clusters
-   Int_t fNRotate;   // number of rotation
-   Int_t fNCross;     // number of the cross materials
-   Int_t fNExpected;  //expected number of cluster
-   Int_t fNLast;      //number of clusters in last 2 layers
-   Int_t fNExpectedLast; //number of expected clusters on last 2 layers
-   Int_t      fNdedx;      //number of clusters for dEdx measurment
-   Float_t fChi2Last;      //chi2 in the  last 2 layers
-   AliTRDtracklet fTracklets[6]; //tracklets
-   AliTRDtrack * fBackupTrack; //! backup track
-   ClassDef(AliTRDtrack,2) // TRD reconstructed tracks
-};                     
+           Float_t  fLhElectron;                        //  Likelihood to be an electron    
+           Int_t    fNWrong;                            //  Number of wrong clusters
+           Int_t    fNRotate;                           //  Number of rotation
+           Int_t    fNCross;                            //  Number of the cross materials
+           Int_t    fNExpected;                         //  Expected number of cluster
+           Int_t    fNLast;                             //  Number of clusters in last 2 layers
+           Int_t    fNExpectedLast;                     //  Number of expected clusters on last 2 layers
+           Int_t    fNdedx;                             //  Number of clusters for dEdx measurment
+           Float_t  fChi2Last;                          //  Chi2 in the  last 2 layers
+   AliTRDtracklet   fTracklets[6];                      //  Tracklets
+           Float_t  fBudget[3];                         //  Integrated material budget
+   AliTRDtrack     *fBackupTrack;                       //! Backup track
+
+   ClassDef(AliTRDtrack,8)                              //  TRD reconstructed tracks
 
+};                     
 
 #endif