ROOT logo
#ifndef ALITRDSEEDV1_H
#define ALITRDSEEDV1_H
/* Copyright(c) 1998-1999, ALICE Experiment at CERN, All rights reserved. *
* See cxx source for full Copyright notice                               */

/* $Id: AliTRDseedV1.h 60233 2013-01-10 09:04:08Z abercuci $ */

////////////////////////////////////////////////////////////////////////////
//                                                                        //
// \class AliTRDseedV1
// \brief The TRD offline tracklet
// \author Alexandru Bercuci
//                                                                        //
////////////////////////////////////////////////////////////////////////////

#ifndef ALITRDTRACKLETBASE_H
#include "AliTRDtrackletBase.h"
#endif

#ifndef ROOT_TMath
#include "TMath.h"
#endif

#ifndef ALITRDGEOMETRY_H
#include "AliTRDgeometry.h"
#endif

#ifndef ALIPID_H
#include "AliPID.h"
#endif


#ifndef ALITRDCLUSTER_H 
#include "AliTRDcluster.h"
#endif


class TTreeSRedirector;
class TLinearFitter;
class TGeoHMatrix;
class AliRieman;

class AliTRDReconstructor;
class AliTRDtrackingChamber;
class AliTRDtrackV1;
class AliTRDpadPlane;
class AliTRDseedV1 : public AliTRDtrackletBase
{
  friend class AliHLTTRDTracklet; // wrapper for HLT

public:
  enum ETRDtrackletBuffers {    
    kNbits     = 6      // bits to store number of clusters
   ,kMask      = 0x3f   // bit mask
   ,kNtb       = 31     // max clusters/pad row
   ,kNclusters = 2*kNtb // max number of clusters/tracklet
   ,kNdEdxSlices= 8     // dEdx slices allocated in reconstruction
  };

  // bits from 0-13 are reserved by ROOT (see TObject.h)
  enum ETRDtrackletStatus {
    kOwner      = BIT(14) // owner of its clusters
   ,kRowCross   = BIT(15) // pad row cross tracklet
   ,kChmbGood   = BIT(16) // status of the detector from calibration view point
   ,kCalib      = BIT(17) // calibrated tracklet
   ,kKink       = BIT(18) // kink prolongation tracklet
   ,kStandAlone = BIT(19) // tracklet build during stand alone track finding
   ,kPrimary    = BIT(20) // tracklet from a primary track candidate
  };

  enum ETRDtrackletError { // up to 8 bits
    kAttachClFound = 0  // not enough clusters found
    ,kAttachRowGap  = 1  // found gap attached rows
    ,kAttachRow     = 2  // found 3 rows
    ,kAttachMultipleCl= 3// multiple clusters attached to time bin
    ,kAttachClAttach= 4  // not enough clusters attached
    ,kFitCl         = 5  // not enough clusters for fit
    ,kFitFailedY    = 6  // fit failed in XY plane failed
    ,kFitFailedZ    = 7  // fit in the QZ plane failed
  };

  AliTRDseedV1(Int_t det = -1);
  ~AliTRDseedV1();
  AliTRDseedV1(const AliTRDseedV1 &ref);
  AliTRDseedV1& operator=(const AliTRDseedV1 &ref);

  Bool_t    AttachClusters(AliTRDtrackingChamber *const chamber, Bool_t tilt = kFALSE, Bool_t ChgPlus=kTRUE, Int_t ev=-1);
  void      Bootstrap(const AliTRDReconstructor *rec);
  void      Calibrate();
  void      CookdEdx(Int_t nslices);
  void      CookLabels();
  Bool_t    CookPID();
  Bool_t    Fit(UChar_t opt=0); // OBSOLETE
  Bool_t    FitRobust(AliTRDpadPlane *pp, TGeoHMatrix *mdet, Float_t bz, Int_t chg, Int_t opt=0);
  Double_t  EstimatedCrossPoint(AliTRDpadPlane *pp, Float_t bz);
  Bool_t    Init(const AliTRDtrackV1 *track);
  void      Init(const AliRieman *fit);
  Bool_t    IsEqual(const TObject *inTracklet) const;
  Bool_t    IsCalibrated() const     { return TestBit(kCalib);}
  Bool_t    IsChmbGood() const       { return TestBit(kChmbGood);}
  Bool_t    IsOwner() const          { return TestBit(kOwner);}
  Bool_t    IsKink() const           { return TestBit(kKink);}
  Bool_t    IsPrimary() const        { return TestBit(kPrimary);}
  Bool_t    HasError(ETRDtrackletError err) const
                                     { return TESTBIT(fErrorMsg, err);}
  Bool_t    IsOK() const             { return GetN() > 4 && GetNUsed() < 4;}
  Bool_t    IsRowCross() const       { return TestBit(kRowCross);}
  Bool_t    IsUsable(Int_t i) const  { return fClusters[i] && !fClusters[i]->IsUsed();}
  Bool_t    IsStandAlone() const     { return TestBit(kStandAlone);}

  Float_t   GetAnodeWireOffset(Float_t zt);
  Float_t   GetC(Int_t typ=0) const    { return fC[typ]; }
  Float_t   GetCharge(Bool_t useOutliers=kFALSE) const;
  Float_t   GetChi2() const          { return fChi2; }
  inline Float_t   GetChi2Z() const;
  inline Float_t   GetChi2Y() const;
  inline Float_t   GetChi2Phi() const;
  void      GetCovAt(Double_t x, Double_t *cov) const;
  void      GetCovXY(Double_t *cov) const { memcpy(cov, &fCov[0], 3*sizeof(Double_t));}
  void      GetCovRef(Double_t *cov) const { memcpy(cov, &fRefCov, 7*sizeof(Double_t));}
  static Int_t GetCovSqrt(const Double_t * const c, Double_t *d);
  static Double_t GetCovInv(const Double_t * const c, Double_t *d);
  UChar_t   GetErrorMsg() const      { return fErrorMsg;}
  Float_t   GetdX() const            { return fdX;}
  const Float_t*  GetdEdx() const    { return &fdEdx[0];}
  Float_t   GetQperTB(Int_t tb) const;
  Float_t   GetdQdl() const;
  Float_t   GetdQdl(Int_t ic, Float_t *dx=NULL) const;
  Float_t   GetdYdX() const          { return fYfit[1];}
  Float_t   GetdZdX() const          { return fZfit[1];}
  Int_t     GetdY() const            { return Int_t(GetY()/0.014);}
  Int_t     GetDetector() const      { return fDet;}
  Int_t     GetChargeGaps(Float_t sz[kNtb], Float_t pos[kNtb], Int_t ntb[kNtb]) const;
  void      GetCalibParam(Float_t &exb, Float_t &vd, Float_t &t0, Float_t &s2, Float_t &dl, Float_t &dt) const    { 
              exb = fExB; vd = fVD; t0 = fT0; s2 = fS2PRF; dl = fDiffL; dt = fDiffT;}
  AliTRDcluster*  GetClusters(Int_t i) const               { return i<0 || i>=kNclusters ? NULL: fClusters[i];}
  Int_t     GetIndexes(Int_t i) const{ return i<0 || i>=kNclusters ? -1 : fIndexes[i];}
  Int_t     GetLabels(Int_t i) const { return fLabels[i];}  
  Float_t   GetLocalZ() const        { return fZfit[0] - fZfit[1] * fX;}
  Float_t   GetLocalY() const        { return fYfit[0] - fYfit[1] * fX;}
  Float_t   GetMomentum(Float_t *err = NULL) const;
  Int_t     GetN() const             { return (Int_t)fN&kMask;}
  Int_t     GetN2() const            { return GetN();}
  Int_t     GetNUsed() const         { return Int_t((fN>>kNbits)&kMask);}
  Int_t     GetNShared() const       { return Int_t(((fN>>kNbits)>>kNbits)&kMask);}
  Int_t     GetTBoccupancy() const;
  Int_t     GetTBcross() const;
  Float_t   GetQuality(Bool_t kZcorr) const;
  Float_t   GetPadLength() const     { return fPad[0];}
  Float_t   GetPadWidth() const      { return fPad[1];}
  Int_t     GetPlane() const         { return AliTRDgeometry::GetLayer(fDet);    }

  Float_t*  GetProbability(Bool_t force=kFALSE);
  Float_t   GetPt() const            { return fPt; }
  inline Double_t  GetPID(Int_t is=-1) const;
  Float_t   GetS2Y() const           { return fCov[0];}
  Float_t   GetS2Z() const           { return fS2Z;}
  Double_t  GetS2DYDX(Float_t) const { return fCov[2];}
  inline Double_t  GetS2DZDX(Float_t) const;
  inline Double_t  GetS2XcrossDZDX(Double_t absdzdx) const;
  Float_t   GetSigmaY() const        { return fS2Y > 0. ? TMath::Sqrt(fS2Y) : 0.2;}
  Float_t   GetSnp() const           { return fYref[1]/TMath::Sqrt(1+fYref[1]*fYref[1]);}
  Float_t   GetTgl() const           { return fZref[1]/TMath::Sqrt(1+fYref[1]*fYref[1]);}
  Float_t   GetTilt() const          { return fPad[2];}
  UInt_t    GetTrackletWord() const  { return 0;}
  UShort_t  GetVolumeId() const;
  Float_t   GetX0() const            { return fX0;}
  Float_t   GetX() const             { return fX0 - fX;}
  Float_t   GetXcross() const        { return fS2Y;}
  Float_t   GetY() const             { return TMath::Abs(fY)<1.e-15?GetLocalY():fY;/*fYfit[0] - fYfit[1] * fX;*/}
  Double_t  GetYat(Double_t x) const { return fY/*fit[0]*/ - fYfit[1] * (fX0-x);}
  Float_t   GetYfit(Int_t id) const  { return fYfit[id];}
  Float_t   GetYref(Int_t id) const  { return fYref[id];}
  Float_t   GetYref() const          { return fYref[0] - fYref[1] *fX;}
  Float_t   GetZ() const             { return TMath::Abs(fZ)<1.e-15?GetLocalZ():fZ;/*fZfit[0] - fZfit[1] * fX;*/}
  Double_t  GetZat(Double_t x) const { return fZ/*fit[0]*/ - fZfit[1] * (fX0-x);}
  Float_t   GetZfit(Int_t id) const  { return fZfit[id];}
  Float_t   GetZref(Int_t id) const  { return fZref[id];}
  Float_t   GetZref() const          { return fZref[0] - fZref[1] *fX;}
  Int_t     GetYbin() const          { return Int_t(GetY()/0.016);}
  Int_t     GetZbin() const          { return Int_t(GetZ()/fPad[0]);}

  inline AliTRDcluster* NextCluster();
  inline AliTRDcluster* PrevCluster();
  void      Print(Option_t *o = "") const;
  inline void ResetClusterIter(Bool_t forward = kTRUE);
  void      Reset(Option_t *opt="");

  void      SetC(Float_t c, Int_t typ=0) { fC[typ] = c;}
  void      SetChmbGood(Bool_t k = kTRUE){ SetBit(kChmbGood, k);}
  void      SetChi2(Float_t chi2)    { fChi2 = chi2;}
  inline void SetCovRef(const Double_t *cov);
  void      SetErrorMsg(ETRDtrackletError err)  { SETBIT(fErrorMsg, err);}
  void      SetIndexes(Int_t i, Int_t idx) { fIndexes[i]  = idx; }
  void      SetLabels(Int_t *lbls)   { memcpy(fLabels, lbls, 3*sizeof(Int_t)); }
  void      SetKink(Bool_t k = kTRUE){ SetBit(kKink, k);}
  void      SetPrimary(Bool_t k = kTRUE){ SetBit(kPrimary, k);}  
  void      SetStandAlone(Bool_t st) { SetBit(kStandAlone, st); }
  void      SetPt(Double_t pt)       { fPt = pt;}
  void      SetOwner();
  void      SetPadPlane(AliTRDpadPlane * const p);
  void      SetPadLength(Float_t l)  { fPad[0] = l;}
  void      SetPadWidth(Float_t w)   { fPad[1] = w;}
  void      SetTilt(Float_t tilt)    { fPad[2] = tilt; }
  void      SetDetector(Int_t d)     { fDet = d;  }
  void      SetDX(Float_t inDX)      { fdX = inDX;}
  void      SetReconstructor(const AliTRDReconstructor *rec) {fkReconstructor = rec;}
  void      SetX0(Float_t x0)        { fX0 = x0; }
  void      SetXYZ(TGeoHMatrix *mDet);
  void      SetYref(Int_t i, Float_t y) { if(i==0||i==1) fYref[i]     = y;}
  void      SetZref(Int_t i, Float_t z) { if(i==0||i==1) fZref[i]     = z;}
//   void      SetUsabilityMap(Long_t um)  { fUsable = um; }
  void      Update(const AliTRDtrackV1* trk);
  void      UpdateUsed();
  void      UseClusters();

protected:
  void      Copy(TObject &ref) const;
  void      UnbiasDZDX(Bool_t rc, Float_t bz);
  Double_t  UnbiasY(Bool_t rc, Float_t bz);

private:
  inline void SetN(Int_t n);
  inline void SetNUsed(Int_t n);
  inline void SetNShared(Int_t n);
  inline void Swap(Int_t &n1, Int_t &n2) const;
  inline void Swap(Double_t &d1, Double_t &d2) const;

  const AliTRDReconstructor *fkReconstructor;//! local reconstructor
  AliTRDcluster  **fClusterIter;            //! clusters iterator
  Int_t            fIndexes[kNclusters];    //! Indexes
  Float_t          fExB;                    // tg(a_L) @ tracklet location
  Float_t          fVD;                     // drift velocity @ tracklet location
  Float_t          fT0;                     // time 0 @ tracklet location
  Float_t          fS2PRF;                  // sigma^2 PRF for xd->0 and phi=a_L 
  Float_t          fDiffL;                  // longitudinal diffusion coefficient
  Float_t          fDiffT;                  // transversal diffusion coefficient
  Char_t           fClusterIdx;             //! clusters iterator
  UChar_t          fErrorMsg;               // processing error
  UInt_t           fN;                      // number of clusters attached/used/shared
  Short_t          fDet;                    // TRD detector
  AliTRDcluster   *fClusters[kNclusters];   // Clusters
  Float_t          fPad[4];                 // local pad definition : length/width/tilt/anode wire offset 
  Float_t          fYref[2];                //  Reference y, dydx
  Float_t          fZref[2];                //  Reference z, dz/dx
  Float_t          fYfit[2];                //  Fit :: chamber local y, dy/dx
  Float_t          fZfit[2];                //  Fit :: chamber local z, dz/dx
  Float_t          fPt;                     //  Pt estimate @ tracklet [GeV/c]
  Float_t          fdX;                     // length of time bin
  Float_t          fX0;                     // anode wire position in TrackingCoordinates (alignment included)
  Float_t          fX;                      // local radial offset from anode wire where tracklet position is estimated
  Float_t          fY;                      // r-phi position of the tracklet  in TrackingCoordinates (alignment included)
  Float_t          fZ;                      // z position of the tracklet in TrackingCoordinates (alignment included)
  Float_t          fS2Y;                    // estimated radial cross point (chmb. coord.) in case of RC tracklets 
  Float_t          fS2Z;                    // estimated resolution in the z direction 
  Float_t          fC[2];                   // Curvature for standalone [0] rieman [1] vertex constrained 
  Float_t          fChi2;                   // Global chi2  
  Float_t          fdEdx[kNdEdxSlices];     // dE/dx measurements for tracklet
  Float_t          fProb[AliPID::kSPECIES]; // PID probabilities
  Int_t            fLabels[3];              // most frequent MC labels and total number of different labels
  Double_t         fRefCov[7];              // covariance matrix of the track in the yz plane + the rest of the diagonal elements
  Double_t         fCov[3];                 // covariance matrix of the tracklet in the xy plane

  ClassDef(AliTRDseedV1, 13)                 // The offline TRD tracklet 
};

//____________________________________________________________
inline Float_t AliTRDseedV1::GetChi2Z() const
{
  Double_t dz = fZref[0]-fZfit[0]; dz*=dz;
  Double_t cov[3]; GetCovAt(fX, cov);
  Double_t s2 = fRefCov[2]+cov[2];
  return s2 > 0. ? dz/s2 : 0.; 
}

//____________________________________________________________
inline Float_t AliTRDseedV1::GetChi2Y() const
{
  Double_t dy = fYref[0]-fYfit[0]; dy*=dy;
  Double_t cov[3]; GetCovAt(fX, cov);
  Double_t s2 = fRefCov[0]+cov[0];
  return s2 > 0. ? dy/s2 : 0.; 
}

//____________________________________________________________
inline Float_t AliTRDseedV1::GetChi2Phi() const
{
  Double_t dphi = fYref[1]-fYfit[1]; dphi*=dphi;
  Double_t cov[3]; GetCovAt(fX, cov);
  Double_t s2 = fRefCov[2]+cov[2];
  return s2 > 0. ? dphi/s2 : 0.; 
}



//____________________________________________________________
inline Double_t AliTRDseedV1::GetPID(Int_t is) const
{
  if(is<0) return fProb[AliPID::kElectron];
  if(is<AliPID::kSPECIES) return fProb[is];
  return 0.;
}

//____________________________________________________________
Double_t AliTRDseedV1::GetS2XcrossDZDX(Double_t absdzdx) const
{
  // correct sigma(x_cross) for the width of the crossing area
  if(absdzdx>0.05) return TMath::Exp(-1.58839-absdzdx*3.24116);
  else return 0.957043-absdzdx*12.4597;
}

//____________________________________________________________
Double_t AliTRDseedV1::GetS2DZDX(Float_t dzdx) const
{
  // Error parametrization for dzdx.
  // TODO Should be layer dependent 
  
  Double_t p0[] = {0.02835, 0.03925},
           p1[] = {0.04746, 0.06316};
           
  Double_t s2(p0[IsRowCross()]+p1[IsRowCross()]*dzdx*dzdx);
  s2*=s2;
  return s2;
}

  //____________________________________________________________
inline AliTRDcluster* AliTRDseedV1::NextCluster()
{
// Mimic the usage of STL iterators.
// Forward iterator

  fClusterIdx++; fClusterIter++;
  while(fClusterIdx < kNclusters){
    if(!(*fClusterIter)){ 
      fClusterIdx++; 
      fClusterIter++;
      continue;
    }
    return *fClusterIter;
  }
  return NULL;
}

//____________________________________________________________
inline AliTRDcluster* AliTRDseedV1::PrevCluster()
{
// Mimic the usage of STL iterators.
// Backward iterator

  fClusterIdx--; fClusterIter--;
  while(fClusterIdx >= 0){
    if(!(*fClusterIter)){ 
      fClusterIdx--; 
      fClusterIter--;
      continue;
    }
    return *fClusterIter;
  }
  return NULL;
}

//____________________________________________________________
inline void AliTRDseedV1::ResetClusterIter(Bool_t forward) 
{
// Mimic the usage of STL iterators.
// Facilitate the usage of NextCluster for forward like 
// iterator (kTRUE) and PrevCluster for backward like iterator (kFALSE)

  if(forward){
    fClusterIter = &fClusters[0]; fClusterIter--; 
    fClusterIdx=-1;
  } else {
    fClusterIter = &fClusters[kNclusters-1]; fClusterIter++; 
    fClusterIdx=kNclusters;
  }
}

//____________________________________________________________
inline void AliTRDseedV1::SetCovRef(const Double_t *cov)
{ 
// Copy some "important" covariance matrix elements
//  var(y)
// cov(y,z)  var(z)
//                  var(snp)
//                           var(tgl)
//                        cov(tgl, 1/pt)  var(1/pt)

  memcpy(&fRefCov[0], cov, 3*sizeof(Double_t)); // yz full covariance
  fRefCov[3] = cov[ 5];  // snp variance 
  fRefCov[4] = cov[ 9];  // tgl variance
  fRefCov[5] = cov[13];  // cov(tgl, 1/pt)
  fRefCov[6] = cov[14];  // 1/pt variance
}


//____________________________________________________________
inline void AliTRDseedV1::SetN(Int_t n)
{
  if(n<0 || n>kNclusters) return; 
  fN &= ~kMask; 
  fN |= (n&kMask);
}

//____________________________________________________________
inline void AliTRDseedV1::SetNUsed(Int_t n)
{
  if(n<0 || n>kNclusters) return; 
  UInt_t mask(kMask<<kNbits); 
  fN &= ~mask;
  n=n<<kNbits; fN |= (n&mask);
}

//____________________________________________________________
inline void AliTRDseedV1::SetNShared(Int_t n)
{
  if(n<0 || n>kNclusters) return; 
  UInt_t mask((kMask<<kNbits)<<kNbits); 
  fN &= ~mask;
  n = (n<<kNbits)<<kNbits; fN|=(n&mask);
}

//____________________________________________________________
inline void AliTRDseedV1::Swap(Int_t &n1, Int_t &n2) const
{
// swap values of n1 with n2
  Int_t tmp(n1);
  n1=n2; n2=tmp;
}

//____________________________________________________________
inline void AliTRDseedV1::Swap(Double_t &d1, Double_t &d2) const
{
// swap values of d1 with d2
  Double_t tmp(d1);
  d1=d2; d2=tmp;
}


#endif



 AliTRDseedV1.h:1
 AliTRDseedV1.h:2
 AliTRDseedV1.h:3
 AliTRDseedV1.h:4
 AliTRDseedV1.h:5
 AliTRDseedV1.h:6
 AliTRDseedV1.h:7
 AliTRDseedV1.h:8
 AliTRDseedV1.h:9
 AliTRDseedV1.h:10
 AliTRDseedV1.h:11
 AliTRDseedV1.h:12
 AliTRDseedV1.h:13
 AliTRDseedV1.h:14
 AliTRDseedV1.h:15
 AliTRDseedV1.h:16
 AliTRDseedV1.h:17
 AliTRDseedV1.h:18
 AliTRDseedV1.h:19
 AliTRDseedV1.h:20
 AliTRDseedV1.h:21
 AliTRDseedV1.h:22
 AliTRDseedV1.h:23
 AliTRDseedV1.h:24
 AliTRDseedV1.h:25
 AliTRDseedV1.h:26
 AliTRDseedV1.h:27
 AliTRDseedV1.h:28
 AliTRDseedV1.h:29
 AliTRDseedV1.h:30
 AliTRDseedV1.h:31
 AliTRDseedV1.h:32
 AliTRDseedV1.h:33
 AliTRDseedV1.h:34
 AliTRDseedV1.h:35
 AliTRDseedV1.h:36
 AliTRDseedV1.h:37
 AliTRDseedV1.h:38
 AliTRDseedV1.h:39
 AliTRDseedV1.h:40
 AliTRDseedV1.h:41
 AliTRDseedV1.h:42
 AliTRDseedV1.h:43
 AliTRDseedV1.h:44
 AliTRDseedV1.h:45
 AliTRDseedV1.h:46
 AliTRDseedV1.h:47
 AliTRDseedV1.h:48
 AliTRDseedV1.h:49
 AliTRDseedV1.h:50
 AliTRDseedV1.h:51
 AliTRDseedV1.h:52
 AliTRDseedV1.h:53
 AliTRDseedV1.h:54
 AliTRDseedV1.h:55
 AliTRDseedV1.h:56
 AliTRDseedV1.h:57
 AliTRDseedV1.h:58
 AliTRDseedV1.h:59
 AliTRDseedV1.h:60
 AliTRDseedV1.h:61
 AliTRDseedV1.h:62
 AliTRDseedV1.h:63
 AliTRDseedV1.h:64
 AliTRDseedV1.h:65
 AliTRDseedV1.h:66
 AliTRDseedV1.h:67
 AliTRDseedV1.h:68
 AliTRDseedV1.h:69
 AliTRDseedV1.h:70
 AliTRDseedV1.h:71
 AliTRDseedV1.h:72
 AliTRDseedV1.h:73
 AliTRDseedV1.h:74
 AliTRDseedV1.h:75
 AliTRDseedV1.h:76
 AliTRDseedV1.h:77
 AliTRDseedV1.h:78
 AliTRDseedV1.h:79
 AliTRDseedV1.h:80
 AliTRDseedV1.h:81
 AliTRDseedV1.h:82
 AliTRDseedV1.h:83
 AliTRDseedV1.h:84
 AliTRDseedV1.h:85
 AliTRDseedV1.h:86
 AliTRDseedV1.h:87
 AliTRDseedV1.h:88
 AliTRDseedV1.h:89
 AliTRDseedV1.h:90
 AliTRDseedV1.h:91
 AliTRDseedV1.h:92
 AliTRDseedV1.h:93
 AliTRDseedV1.h:94
 AliTRDseedV1.h:95
 AliTRDseedV1.h:96
 AliTRDseedV1.h:97
 AliTRDseedV1.h:98
 AliTRDseedV1.h:99
 AliTRDseedV1.h:100
 AliTRDseedV1.h:101
 AliTRDseedV1.h:102
 AliTRDseedV1.h:103
 AliTRDseedV1.h:104
 AliTRDseedV1.h:105
 AliTRDseedV1.h:106
 AliTRDseedV1.h:107
 AliTRDseedV1.h:108
 AliTRDseedV1.h:109
 AliTRDseedV1.h:110
 AliTRDseedV1.h:111
 AliTRDseedV1.h:112
 AliTRDseedV1.h:113
 AliTRDseedV1.h:114
 AliTRDseedV1.h:115
 AliTRDseedV1.h:116
 AliTRDseedV1.h:117
 AliTRDseedV1.h:118
 AliTRDseedV1.h:119
 AliTRDseedV1.h:120
 AliTRDseedV1.h:121
 AliTRDseedV1.h:122
 AliTRDseedV1.h:123
 AliTRDseedV1.h:124
 AliTRDseedV1.h:125
 AliTRDseedV1.h:126
 AliTRDseedV1.h:127
 AliTRDseedV1.h:128
 AliTRDseedV1.h:129
 AliTRDseedV1.h:130
 AliTRDseedV1.h:131
 AliTRDseedV1.h:132
 AliTRDseedV1.h:133
 AliTRDseedV1.h:134
 AliTRDseedV1.h:135
 AliTRDseedV1.h:136
 AliTRDseedV1.h:137
 AliTRDseedV1.h:138
 AliTRDseedV1.h:139
 AliTRDseedV1.h:140
 AliTRDseedV1.h:141
 AliTRDseedV1.h:142
 AliTRDseedV1.h:143
 AliTRDseedV1.h:144
 AliTRDseedV1.h:145
 AliTRDseedV1.h:146
 AliTRDseedV1.h:147
 AliTRDseedV1.h:148
 AliTRDseedV1.h:149
 AliTRDseedV1.h:150
 AliTRDseedV1.h:151
 AliTRDseedV1.h:152
 AliTRDseedV1.h:153
 AliTRDseedV1.h:154
 AliTRDseedV1.h:155
 AliTRDseedV1.h:156
 AliTRDseedV1.h:157
 AliTRDseedV1.h:158
 AliTRDseedV1.h:159
 AliTRDseedV1.h:160
 AliTRDseedV1.h:161
 AliTRDseedV1.h:162
 AliTRDseedV1.h:163
 AliTRDseedV1.h:164
 AliTRDseedV1.h:165
 AliTRDseedV1.h:166
 AliTRDseedV1.h:167
 AliTRDseedV1.h:168
 AliTRDseedV1.h:169
 AliTRDseedV1.h:170
 AliTRDseedV1.h:171
 AliTRDseedV1.h:172
 AliTRDseedV1.h:173
 AliTRDseedV1.h:174
 AliTRDseedV1.h:175
 AliTRDseedV1.h:176
 AliTRDseedV1.h:177
 AliTRDseedV1.h:178
 AliTRDseedV1.h:179
 AliTRDseedV1.h:180
 AliTRDseedV1.h:181
 AliTRDseedV1.h:182
 AliTRDseedV1.h:183
 AliTRDseedV1.h:184
 AliTRDseedV1.h:185
 AliTRDseedV1.h:186
 AliTRDseedV1.h:187
 AliTRDseedV1.h:188
 AliTRDseedV1.h:189
 AliTRDseedV1.h:190
 AliTRDseedV1.h:191
 AliTRDseedV1.h:192
 AliTRDseedV1.h:193
 AliTRDseedV1.h:194
 AliTRDseedV1.h:195
 AliTRDseedV1.h:196
 AliTRDseedV1.h:197
 AliTRDseedV1.h:198
 AliTRDseedV1.h:199
 AliTRDseedV1.h:200
 AliTRDseedV1.h:201
 AliTRDseedV1.h:202
 AliTRDseedV1.h:203
 AliTRDseedV1.h:204
 AliTRDseedV1.h:205
 AliTRDseedV1.h:206
 AliTRDseedV1.h:207
 AliTRDseedV1.h:208
 AliTRDseedV1.h:209
 AliTRDseedV1.h:210
 AliTRDseedV1.h:211
 AliTRDseedV1.h:212
 AliTRDseedV1.h:213
 AliTRDseedV1.h:214
 AliTRDseedV1.h:215
 AliTRDseedV1.h:216
 AliTRDseedV1.h:217
 AliTRDseedV1.h:218
 AliTRDseedV1.h:219
 AliTRDseedV1.h:220
 AliTRDseedV1.h:221
 AliTRDseedV1.h:222
 AliTRDseedV1.h:223
 AliTRDseedV1.h:224
 AliTRDseedV1.h:225
 AliTRDseedV1.h:226
 AliTRDseedV1.h:227
 AliTRDseedV1.h:228
 AliTRDseedV1.h:229
 AliTRDseedV1.h:230
 AliTRDseedV1.h:231
 AliTRDseedV1.h:232
 AliTRDseedV1.h:233
 AliTRDseedV1.h:234
 AliTRDseedV1.h:235
 AliTRDseedV1.h:236
 AliTRDseedV1.h:237
 AliTRDseedV1.h:238
 AliTRDseedV1.h:239
 AliTRDseedV1.h:240
 AliTRDseedV1.h:241
 AliTRDseedV1.h:242
 AliTRDseedV1.h:243
 AliTRDseedV1.h:244
 AliTRDseedV1.h:245
 AliTRDseedV1.h:246
 AliTRDseedV1.h:247
 AliTRDseedV1.h:248
 AliTRDseedV1.h:249
 AliTRDseedV1.h:250
 AliTRDseedV1.h:251
 AliTRDseedV1.h:252
 AliTRDseedV1.h:253
 AliTRDseedV1.h:254
 AliTRDseedV1.h:255
 AliTRDseedV1.h:256
 AliTRDseedV1.h:257
 AliTRDseedV1.h:258
 AliTRDseedV1.h:259
 AliTRDseedV1.h:260
 AliTRDseedV1.h:261
 AliTRDseedV1.h:262
 AliTRDseedV1.h:263
 AliTRDseedV1.h:264
 AliTRDseedV1.h:265
 AliTRDseedV1.h:266
 AliTRDseedV1.h:267
 AliTRDseedV1.h:268
 AliTRDseedV1.h:269
 AliTRDseedV1.h:270
 AliTRDseedV1.h:271
 AliTRDseedV1.h:272
 AliTRDseedV1.h:273
 AliTRDseedV1.h:274
 AliTRDseedV1.h:275
 AliTRDseedV1.h:276
 AliTRDseedV1.h:277
 AliTRDseedV1.h:278
 AliTRDseedV1.h:279
 AliTRDseedV1.h:280
 AliTRDseedV1.h:281
 AliTRDseedV1.h:282
 AliTRDseedV1.h:283
 AliTRDseedV1.h:284
 AliTRDseedV1.h:285
 AliTRDseedV1.h:286
 AliTRDseedV1.h:287
 AliTRDseedV1.h:288
 AliTRDseedV1.h:289
 AliTRDseedV1.h:290
 AliTRDseedV1.h:291
 AliTRDseedV1.h:292
 AliTRDseedV1.h:293
 AliTRDseedV1.h:294
 AliTRDseedV1.h:295
 AliTRDseedV1.h:296
 AliTRDseedV1.h:297
 AliTRDseedV1.h:298
 AliTRDseedV1.h:299
 AliTRDseedV1.h:300
 AliTRDseedV1.h:301
 AliTRDseedV1.h:302
 AliTRDseedV1.h:303
 AliTRDseedV1.h:304
 AliTRDseedV1.h:305
 AliTRDseedV1.h:306
 AliTRDseedV1.h:307
 AliTRDseedV1.h:308
 AliTRDseedV1.h:309
 AliTRDseedV1.h:310
 AliTRDseedV1.h:311
 AliTRDseedV1.h:312
 AliTRDseedV1.h:313
 AliTRDseedV1.h:314
 AliTRDseedV1.h:315
 AliTRDseedV1.h:316
 AliTRDseedV1.h:317
 AliTRDseedV1.h:318
 AliTRDseedV1.h:319
 AliTRDseedV1.h:320
 AliTRDseedV1.h:321
 AliTRDseedV1.h:322
 AliTRDseedV1.h:323
 AliTRDseedV1.h:324
 AliTRDseedV1.h:325
 AliTRDseedV1.h:326
 AliTRDseedV1.h:327
 AliTRDseedV1.h:328
 AliTRDseedV1.h:329
 AliTRDseedV1.h:330
 AliTRDseedV1.h:331
 AliTRDseedV1.h:332
 AliTRDseedV1.h:333
 AliTRDseedV1.h:334
 AliTRDseedV1.h:335
 AliTRDseedV1.h:336
 AliTRDseedV1.h:337
 AliTRDseedV1.h:338
 AliTRDseedV1.h:339
 AliTRDseedV1.h:340
 AliTRDseedV1.h:341
 AliTRDseedV1.h:342
 AliTRDseedV1.h:343
 AliTRDseedV1.h:344
 AliTRDseedV1.h:345
 AliTRDseedV1.h:346
 AliTRDseedV1.h:347
 AliTRDseedV1.h:348
 AliTRDseedV1.h:349
 AliTRDseedV1.h:350
 AliTRDseedV1.h:351
 AliTRDseedV1.h:352
 AliTRDseedV1.h:353
 AliTRDseedV1.h:354
 AliTRDseedV1.h:355
 AliTRDseedV1.h:356
 AliTRDseedV1.h:357
 AliTRDseedV1.h:358
 AliTRDseedV1.h:359
 AliTRDseedV1.h:360
 AliTRDseedV1.h:361
 AliTRDseedV1.h:362
 AliTRDseedV1.h:363
 AliTRDseedV1.h:364
 AliTRDseedV1.h:365
 AliTRDseedV1.h:366
 AliTRDseedV1.h:367
 AliTRDseedV1.h:368
 AliTRDseedV1.h:369
 AliTRDseedV1.h:370
 AliTRDseedV1.h:371
 AliTRDseedV1.h:372
 AliTRDseedV1.h:373
 AliTRDseedV1.h:374
 AliTRDseedV1.h:375
 AliTRDseedV1.h:376
 AliTRDseedV1.h:377
 AliTRDseedV1.h:378
 AliTRDseedV1.h:379
 AliTRDseedV1.h:380
 AliTRDseedV1.h:381
 AliTRDseedV1.h:382
 AliTRDseedV1.h:383
 AliTRDseedV1.h:384
 AliTRDseedV1.h:385
 AliTRDseedV1.h:386
 AliTRDseedV1.h:387
 AliTRDseedV1.h:388
 AliTRDseedV1.h:389
 AliTRDseedV1.h:390
 AliTRDseedV1.h:391
 AliTRDseedV1.h:392
 AliTRDseedV1.h:393
 AliTRDseedV1.h:394
 AliTRDseedV1.h:395
 AliTRDseedV1.h:396
 AliTRDseedV1.h:397
 AliTRDseedV1.h:398
 AliTRDseedV1.h:399
 AliTRDseedV1.h:400
 AliTRDseedV1.h:401
 AliTRDseedV1.h:402
 AliTRDseedV1.h:403
 AliTRDseedV1.h:404
 AliTRDseedV1.h:405
 AliTRDseedV1.h:406
 AliTRDseedV1.h:407
 AliTRDseedV1.h:408
 AliTRDseedV1.h:409
 AliTRDseedV1.h:410
 AliTRDseedV1.h:411
 AliTRDseedV1.h:412
 AliTRDseedV1.h:413
 AliTRDseedV1.h:414
 AliTRDseedV1.h:415
 AliTRDseedV1.h:416
 AliTRDseedV1.h:417
 AliTRDseedV1.h:418
 AliTRDseedV1.h:419
 AliTRDseedV1.h:420
 AliTRDseedV1.h:421
 AliTRDseedV1.h:422
 AliTRDseedV1.h:423
 AliTRDseedV1.h:424
 AliTRDseedV1.h:425
 AliTRDseedV1.h:426
 AliTRDseedV1.h:427
 AliTRDseedV1.h:428
 AliTRDseedV1.h:429
 AliTRDseedV1.h:430
 AliTRDseedV1.h:431
 AliTRDseedV1.h:432
 AliTRDseedV1.h:433
 AliTRDseedV1.h:434
 AliTRDseedV1.h:435
 AliTRDseedV1.h:436
 AliTRDseedV1.h:437
 AliTRDseedV1.h:438
 AliTRDseedV1.h:439
 AliTRDseedV1.h:440
 AliTRDseedV1.h:441
 AliTRDseedV1.h:442