]> git.uio.no Git - u/mrichter/AliRoot.git/blobdiff - ITS/AliITStrackV2.h
commented define _ClusterTopology_ - to be used only for the special productions
[u/mrichter/AliRoot.git] / ITS / AliITStrackV2.h
index c8441d6da6b2583116d683cbdb67e1f76ea5eb06..f3c8501269c1e61df6f9ecb72fda32c68130cee1 100644 (file)
 //     dEdx analysis by: Boris Batyunya, JINR, Boris.Batiounia@cern.ch
 //-------------------------------------------------------------------------
 
-
-/*****************************************************************************
- *                          December 18, 2000                                *
- *  Internal view of the ITS track parametrisation as well as the order of   *
- *           track parameters are subject for possible changes !             *
- *  Use GetExternalParameters() and GetExternalCovariance() to access ITS    *
- *      track information regardless of its internal representation.         *
- * This formation is now fixed in the following way:                         *
- *      external param0:   local Y-coordinate of a track (cm)                *
- *      external param1:   local Z-coordinate of a track (cm)                *
- *      external param2:   local sine of the track momentum azimuthal angle  *
- *      external param3:   tangent of the track momentum dip angle           *
- *      external param4:   1/pt (1/(GeV/c))                                  *
- *****************************************************************************/
-
 #include <AliKalmanTrack.h>
+#include "AliITSRecoParam.h"
+#include "AliITSgeomTGeo.h"
+#include "AliESDtrack.h"
 
-#include "AliITSrecoV2.h"
+/* $Id$ */
 
-class AliESDtrack;
-class AliITSStrLine;
+class AliESDVertex;
+class AliTracker;
 
 //_____________________________________________________________________________
 class AliITStrackV2 : public AliKalmanTrack {
 public:
   AliITStrackV2();
-  AliITStrackV2(AliESDtrack& t,Bool_t c=kFALSE) throw (const Char_t *);
+  AliITStrackV2(AliESDtrack& t,Bool_t c=kFALSE);
   AliITStrackV2(const AliITStrackV2& t);
-  Int_t PropagateToVertex(Double_t d=0., Double_t x0=0.);
-  Int_t Propagate(Double_t alpha, Double_t xr);
-  virtual Int_t CorrectForMaterial(Double_t d, Double_t x0=21.82);
-  Int_t PropagateTo(Double_t xr, Double_t d, Double_t x0=21.82);
-  Double_t PropagateToDCA(AliKalmanTrack *p, Double_t d=0., Double_t x0=0.); 
-  Int_t Update(const AliCluster* cl,Double_t chi2,UInt_t i);
-  Int_t Improve(Double_t x0,Double_t xyz[3],Double_t ers[3]);
+  ~AliITStrackV2(){fESDtrack=0;}
+
+  void   SetCheckInvariant(Bool_t check=kTRUE) {fCheckInvariant=check;}
+  Bool_t CorrectForMeanMaterial(Double_t xOverX0, Double_t xTimesRho,
+                               Bool_t anglecorr=kFALSE) {
+    return AliExternalTrackParam::CorrectForMeanMaterial(xOverX0,xTimesRho,GetMass(),anglecorr);
+  }
+  Bool_t CorrectForMaterial(Double_t d, Double_t x0=AliITSRecoParam::GetX0Air()) {
+    // deprecated: use CorrectForMeanMaterial instead
+    return AliExternalTrackParam::CorrectForMaterial(d,x0,GetMass());
+  }
+  Bool_t PropagateTo(Double_t xr, Double_t d, Double_t x0=AliITSRecoParam::GetX0Air());
+  Bool_t PropagateToTGeo(Double_t xToGo, Int_t nstep, Double_t &xOverX0, Double_t &xTimesRho, Bool_t addTime=kTRUE);
+  Bool_t PropagateToTGeo(Double_t xToGo, Int_t nstep=1, Bool_t addTime=kTRUE) {
+    Double_t dummy1,dummy2; return PropagateToTGeo(xToGo,nstep,dummy1,dummy2,addTime);
+  }
+  Double_t GetPredictedChi2(const AliCluster *cluster) const;
+  Bool_t Update(const AliCluster *cl, Double_t chi2, Int_t i);
+
+  Bool_t PropagateToVertex(const AliESDVertex *v,Double_t d=0.,Double_t x0=0.);
+  Bool_t Propagate(Double_t alpha, Double_t xr);
+  Bool_t Propagate(Double_t xr) { return Propagate(GetAlpha(),xr); }
+  Bool_t MeanBudgetToPrimVertex(Double_t xyz[3], Double_t step, Double_t &d) const;
+  Bool_t Improve(Double_t x0,Double_t xyz[3],Double_t ers[3]);
+  Bool_t ImproveKalman(Double_t xyz[3],Double_t ers[3], const Double_t* xlMS, const Double_t* x2X0MS, Int_t nMS);
   void SetdEdx(Double_t dedx) {fdEdx=dedx;}
   void SetSampledEdx(Float_t q, Int_t i);
+  Float_t GetSampledEdx(Int_t i) const {return fdEdxSample[i];}
   void CookdEdx(Double_t low=0., Double_t up=0.51);
   void SetDetectorIndex(Int_t i) {SetLabel(i);}
-  void ResetCovariance();
-  void ResetClusters() { SetChi2(0.); SetNumberOfClusters(0); }
+  void ResetClusters();
   void UpdateESDtrack(ULong_t flags) const;
   
   AliESDtrack *GetESDtrack() const {return fESDtrack;}
+  virtual ULong_t  GetStatus() const {
+    if(fESDtrack){return fESDtrack->GetStatus();} 
+    else { AliWarning("null ESD track pointer - status 0"); return 0;} }
 
   Int_t GetDetectorIndex() const {return GetLabel();}
-  Double_t GetX()    const {return fX;}
-  Double_t GetAlpha()const {return fAlpha;}
   Double_t GetdEdx() const {return fdEdx;}
   Double_t GetPIDsignal() const {return GetdEdx();}
-  Double_t GetY()    const {return fP0;}
-  Double_t GetZ()    const {return fP1;}
-  Double_t GetSnp()  const {return fP2;}
-  Double_t GetTgl()  const {return fP3;}
-  Double_t GetC()    const {return fP4;}
-  Double_t Get1Pt() const {
-      return (TMath::Sign(1e-9,fP4) + fP4)*GetLocalConvConst();
+  using AliExternalTrackParam::GetC;
+  Double_t GetC() const {return AliExternalTrackParam::GetC(GetBz());}
+  Double_t GetD(Double_t x, Double_t y) const {
+    return AliExternalTrackParam::GetD(x,y,GetBz());
+  }
+  void GetDZ(Double_t xv, Double_t yv, Double_t zv, Float_t dz[2]) const {
+    return AliExternalTrackParam::GetDZ(xv,yv,zv,GetBz(),dz);
   }
-  Double_t GetD(Double_t x=0, Double_t y=0) const;
-  Double_t GetZat(Double_t x=0) const;
 
-  Double_t GetSigmaY2() const {return fC00;}
-  Double_t GetSigmaZ2() const {return fC11;}
+  Bool_t GetGlobalXYZat(Double_t xloc,Double_t &x,Double_t &y,Double_t &z) const;
+  Bool_t GetPhiZat(Double_t r,Double_t &phi,Double_t &z) const;
+  Bool_t GetLocalXat(Double_t r,Double_t &xloc) const;
+
   Int_t Compare(const TObject *o) const;
-  void GetExternalParameters(Double_t& xr, Double_t x[5]) const ;
-  void GetExternalCovariance(Double_t cov[15]) const ;
   Int_t GetClusterIndex(Int_t i) const {return fIndex[i];}
-  Int_t GetGlobalXYZat(Double_t r,Double_t &x,Double_t &y,Double_t &z) const;
-  void ApproximateHelixWithLine(Double_t xk, AliITSStrLine *line);
-  Double_t GetPredictedChi2(const AliCluster *cluster) const;
-   Int_t Invariant() const;
+  void  SetModuleIndex(Int_t ilayer,Int_t idx) {fModule[ilayer]=idx;}
+  Int_t GetModuleIndex(Int_t ilayer) const {return fModule[ilayer];}
+  void  SetModuleIndexInfo(Int_t ilayer,Int_t idet,Int_t status=1,Float_t xloc=0,Float_t zloc=0);
+  Bool_t GetModuleIndexInfo(Int_t ilayer,Int_t &idet,Int_t &status,Float_t &xloc,Float_t &zloc) const;
+  void    SetSharedWeight(Int_t ilayer,Float_t w) {fSharedWeight[ilayer]=w;}
+  Float_t GetSharedWeight(Int_t ilayer) const {return fSharedWeight[ilayer];}
+  Bool_t Invariant() const;
+
+  void  SetExtraCluster(Int_t ilayer, Int_t idx) {fIndex[AliITSgeomTGeo::kNLayers+ilayer]=idx;}
+  Int_t GetExtraCluster(Int_t ilayer) const {return fIndex[AliITSgeomTGeo::kNLayers+ilayer];}
+
+  void  SetExtraModule(Int_t ilayer, Int_t idx) {fModule[AliITSgeomTGeo::kNLayers+ilayer]=idx;}
+  Int_t GetExtraModule(Int_t ilayer) const {return fModule[AliITSgeomTGeo::kNLayers+ilayer];}
+
 protected:
-  void GetXYZ(Float_t r[3]) const;
 
-  Double_t fX;              // X-coordinate of this track (reference plane)
-  Double_t fAlpha;          // rotation angle
+  Bool_t fCheckInvariant;  // check the covariance matrix
 
-  Double_t fdEdx;           // dE/dx
+  Double_t fdEdx;            // dE/dx
 
-  Double_t fP0;             // Y-coordinate of a track 
-  Double_t fP1;             // Z-coordinate of a track
-  Double_t fP2;             // sine of the track momentum azimuthal angle
-  Double_t fP3;             // tangent of the track momentum dip angle
-  Double_t fP4;             // track curvature
+  static const Int_t fgkWARN; //! used for debugging purposes
+  Float_t fdEdxSample[4];    // array of dE/dx samples b.b.
 
-  Double_t fC00;                         // covariance
-  Double_t fC10, fC11;                   // matrix
-  Double_t fC20, fC21, fC22;             // of the
-  Double_t fC30, fC31, fC32, fC33;       // track
-  Double_t fC40, fC41, fC42, fC43, fC44; // parameters 
+  Int_t fIndex[2*AliITSgeomTGeo::kNLayers]; // indices of associated clusters 
 
-  UInt_t fIndex[kMaxLayer]; // indices of associated clusters 
-  Float_t fdEdxSample[4];   // array of dE/dx samples b.b.
+  Int_t fModule[2*AliITSgeomTGeo::kNLayers]; // indices of crossed modules: 
+                                             // see SetModuleIndexInfo()
 
-  AliESDtrack *fESDtrack;   //! pointer to the connected ESD track
-  ClassDef(AliITStrackV2,4)   //ITS reconstructed track
-};
+  Float_t fSharedWeight[AliITSgeomTGeo::kNLayers]; // probability of sharing
 
-inline 
-void AliITStrackV2::GetExternalParameters(Double_t& xr, Double_t x[5]) const {
-  //---------------------------------------------------------------------
-  // This function return external ITS track representation
-  //---------------------------------------------------------------------
-     xr=fX;          
-     x[0]=GetY(); x[1]=GetZ(); x[2]=GetSnp(); x[3]=GetTgl(); x[4]=Get1Pt();
-}
+  AliESDtrack *fESDtrack;    //! pointer to the connected ESD track
 
-inline
-void AliITStrackV2::SetSampledEdx(Float_t q, Int_t i) {
+private:
+  AliITStrackV2 &operator=(const AliITStrackV2 &tr);
+  ClassDef(AliITStrackV2,9)  //ITS reconstructed track
+};
+
+inline void AliITStrackV2::SetSampledEdx(Float_t q, Int_t i) {
   //----------------------------------------------------------------------
   // This function stores dEdx sample corrected for the track segment length 
   // Origin: Boris Batyunya, JINR, Boris.Batiounia@cern.ch
@@ -129,16 +129,130 @@ void AliITStrackV2::SetSampledEdx(Float_t q, Int_t i) {
   Double_t s=GetSnp(), t=GetTgl();
   q *= TMath::Sqrt((1-s*s)/(1+t*t));
   fdEdxSample[i]=q;
+  return;
+}
+
+inline void  AliITStrackV2::SetModuleIndexInfo(Int_t ilayer,Int_t idet,Int_t status,
+                                              Float_t xloc,Float_t zloc) {
+  //----------------------------------------------------------------------
+  // This function encodes in the module number also the status of cluster association
+  // "status" can have the following values: 
+  // 1 "found" (cluster is associated), 
+  // 2 "dead" (module is dead from OCDB), 
+  // 3 "skipped" (module or layer forced to be skipped),
+  // 4 "outinz" (track out of z acceptance), 
+  // 5 "nocls" (no clusters in the road), 
+  // 6 "norefit" (cluster rejected during refit) 
+  // 7 "deadzspd" (holes in z in SPD)
+  // WARNING: THIS METHOD HAS TO BE SYNCHRONIZED WITH AliESDtrack::GetITSModuleIndexInfo()!
+  //----------------------------------------------------------------------
+
+  if(idet<0) {
+    idet=0;
+  } else {
+    // same detector numbering as in AliITSCalib classes
+    if(ilayer==1) idet+=AliITSgeomTGeo::GetNLadders(1)*AliITSgeomTGeo::GetNDetectors(1);
+    if(ilayer==3) idet+=AliITSgeomTGeo::GetNLadders(3)*AliITSgeomTGeo::GetNDetectors(3);
+    if(ilayer==5) idet+=AliITSgeomTGeo::GetNLadders(5)*AliITSgeomTGeo::GetNDetectors(5);
+  }
+
+  Int_t xInt = Int_t(xloc*10.);
+  Int_t zInt = Int_t(zloc*10.);
+
+  if(TMath::Abs(xloc*10.-(Float_t)xInt)>0.5){
+    if(zloc>0) { 
+      xInt++; 
+    } 
+    else { 
+      xInt--; 
+    }
+  }
+  if(TMath::Abs(zloc*10.-(Float_t)zInt)>0.5){
+    if(zloc>0) { 
+      zInt++; 
+    } 
+    else { 
+      zInt--; 
+    }
+  }
+  Int_t signs=0;
+  if(xInt>=0 && zInt>=0) signs=10000;
+  if(xInt>=0 && zInt<0)  signs=20000;
+  if(xInt<0 && zInt>=0)  signs=30000;
+  if(xInt<0 && zInt<0)   signs=40000;
+
+  Int_t modindex = signs;
+  
+  modindex += TMath::Abs(zInt);
+  modindex += TMath::Abs(xInt)*100;
+
+  modindex += status*100000;
+
+  modindex += idet*1000000;
+
+  SetModuleIndex(ilayer,modindex);
+  return;
 }
 
-inline void AliITStrackV2::GetXYZ(Float_t r[3]) const {
-  //---------------------------------------------------------------------
-  // Returns the position of the track in the global coord. system 
-  //---------------------------------------------------------------------
-  Double_t cs=TMath::Cos(fAlpha), sn=TMath::Sin(fAlpha);
-  r[0]=fX*cs - fP0*sn; r[1]=fX*sn + fP0*cs; r[2]=fP1;
+inline Bool_t AliITStrackV2::GetModuleIndexInfo(Int_t ilayer,Int_t &idet,Int_t &status,
+                                              Float_t &xloc,Float_t &zloc) const {
+  //----------------------------------------------------------------------
+  // This function encodes in the module number also the status of cluster association
+  // "status" can have the following values: 
+  // 1 "found" (cluster is associated), 
+  // 2 "dead" (module is dead from OCDB), 
+  // 3 "skipped" (module or layer forced to be skipped),
+  // 4 "outinz" (track out of z acceptance), 
+  // 5 "nocls" (no clusters in the road), 
+  // 6 "norefit" (cluster rejected during refit), 
+  // 7 "deadzspd" (holes in z in SPD)
+  // Also given are the coordinates of the crossing point of track and module
+  // (in the local module ref. system)
+  // WARNING: THIS METHOD HAS TO BE SYNCHRONIZED WITH AliESDtrack::GetITSModuleIndexInfo()!
+  //----------------------------------------------------------------------
+
+
+  if(fModule[ilayer]==-1) {
+    AliError("fModule was not set !");
+    idet = -1;
+    status=0;
+    xloc=-99.; zloc=-99.;
+    return kFALSE;
+  }
+
+  Int_t module = fModule[ilayer];
+
+  idet = Int_t(module/1000000);
+
+  module -= idet*1000000;
+
+  status = Int_t(module/100000);
+
+  module -= status*100000;
+
+  Int_t signs = Int_t(module/10000);
+
+  module-=signs*10000;
+
+  Int_t xInt = Int_t(module/100);
+  module -= xInt*100;
+
+  Int_t zInt = module;
+
+  if(signs==1) { xInt*=1; zInt*=1; }
+  if(signs==2) { xInt*=1; zInt*=-1; }
+  if(signs==3) { xInt*=-1; zInt*=1; }
+  if(signs==4) { xInt*=-1; zInt*=-1; }
+
+  xloc = 0.1*(Float_t)xInt;
+  zloc = 0.1*(Float_t)zInt;
+
+  if(status==4) idet = -1;
+
+  return kTRUE;
 }
 
+
 #endif