]> git.uio.no Git - u/mrichter/AliRoot.git/blobdiff - TOF/AliTOFtrackerMI.cxx
Added the method FillClusterArray for the TOF cluster visualization and removed some...
[u/mrichter/AliRoot.git] / TOF / AliTOFtrackerMI.cxx
index cb9000543c5ffa9f54cfb3887d146fb284877c97..70460ddf0758c4355783b3a7862a553bbfb47ae2 100644 (file)
 #include <Rtypes.h>
 
 #include "TClonesArray.h"
-#include "TGeoManager.h"
 #include "TTree.h"
 #include "TTreeStream.h"
 
-#include "AliRun.h"
-#include "AliESD.h"
+#include "AliESDEvent.h"
 #include "AliESDtrack.h"
 
 #include "AliTOFRecoParam.h"
 #include "AliTOFcalib.h"
 #include "AliTOFcluster.h"
-#include "AliTOFGeometryV5.h"
+#include "AliTOFGeometry.h"
 #include "AliTOFtrackerMI.h"
 #include "AliTOFtrack.h"
+#include "AliTOFpidESD.h"
+
+class TGeoManager;
 
 extern TGeoManager *gGeoManager;
 
@@ -55,26 +56,26 @@ AliTOFtrackerMI::AliTOFtrackerMI():
   fnbadmatch(0),
   fnunmatch(0),
   fnmatch(0),
-  fR(378.), 
+  fR(379.), 
   fTOFHeigth(15.3),  
   fdCut(3.), 
   fDx(1.5), 
   fDy(0), 
   fDz(0), 
-  fTracks(0x0),
-  fSeeds(0x0),
+  fTracks(new TClonesArray("AliTOFtrack")),
+  fSeeds(new TClonesArray("AliESDtrack")),
   fDebugStreamer(0x0)
  { 
   //AliTOFtrackerMI main Ctor
 
    fRecoParam=new AliTOFRecoParam();
-   fGeom=new AliTOFGeometryV5();
+   fGeom=new AliTOFGeometry();
    Double_t parPID[2];   
    parPID[0]=fRecoParam->GetTimeResolution();
    parPID[1]=fRecoParam->GetTimeNSigma();
    fPid=new AliTOFpidESD(parPID);
-   fDy=fGeom->XPad(); 
-   fDz=fGeom->ZPad(); 
+   fDy=AliTOFGeometry::XPad(); 
+   fDz=AliTOFGeometry::ZPad(); 
    fDebugStreamer = new TTreeSRedirector("TOFdebug.root");   
 }
 //_____________________________________________________________________________
@@ -90,14 +91,14 @@ AliTOFtrackerMI::AliTOFtrackerMI(const AliTOFtrackerMI &t):
   fnbadmatch(0),
   fnunmatch(0),
   fnmatch(0),
-  fR(378.), 
+  fR(379.), 
   fTOFHeigth(15.3),  
   fdCut(3.), 
   fDx(1.5), 
   fDy(0), 
   fDz(0), 
-  fTracks(0x0),
-  fSeeds(0x0),
+  fTracks(new TClonesArray("AliTOFtrack")),
+  fSeeds(new TClonesArray("AliESDtrack")),
   fDebugStreamer(0x0)
  { 
   //AliTOFtrackerMI copy Ctor
@@ -109,7 +110,7 @@ AliTOFtrackerMI::AliTOFtrackerMI(const AliTOFtrackerMI &t):
   fnunmatch=t.fnunmatch;
   fnmatch=t.fnmatch;
   fRecoParam = t.fRecoParam;
-  fGeom = t.fGeom;
+  fGeom=t.fGeom;
   fPid = t.fPid;
   fR=t.fR; 
   fTOFHeigth=t.fTOFHeigth;  
@@ -161,10 +162,20 @@ AliTOFtrackerMI::~AliTOFtrackerMI(){
   delete fRecoParam;
   delete fGeom;
   delete fPid;
+  if (fTracks){
+    fTracks->Delete();
+    delete fTracks;
+    fTracks=0x0;
+  }
+  if (fSeeds){
+    fSeeds->Delete();
+    delete fSeeds;
+    fSeeds=0x0;
+  }
 }
 
 //_____________________________________________________________________________
-Int_t AliTOFtrackerMI::PropagateBack(AliESD* event) {
+Int_t AliTOFtrackerMI::PropagateBack(AliESDEvent* event) {
   //
   // Gets seeds from ESD event and Match with TOF Clusters
   //
@@ -181,7 +192,6 @@ Int_t AliTOFtrackerMI::PropagateBack(AliESD* event) {
 
   Int_t ntrk=event->GetNumberOfTracks();
   fNseeds = ntrk;
-  fSeeds= new TClonesArray("AliESDtrack");
   TClonesArray &aESDTrack = *fSeeds;
 
 
@@ -238,16 +248,8 @@ Int_t AliTOFtrackerMI::PropagateBack(AliESD* event) {
   //Make TOF PID
   fPid->MakePID(event);
 
-  if (fSeeds) {
-    fSeeds->Delete();
-    delete fSeeds;
-    fSeeds = 0x0;
-  }
-  if (fTracks) {
-    fTracks->Delete();
-    delete fTracks;
-    fTracks = 0x0;
-  }
+  fSeeds->Clear();
+  fTracks->Clear();
   return 0;
   
 }
@@ -255,7 +257,6 @@ Int_t AliTOFtrackerMI::PropagateBack(AliESD* event) {
 void AliTOFtrackerMI::CollectESD() {
    //prepare the set of ESD tracks to be matched to clusters in TOF
  
-  fTracks= new TClonesArray("AliTOFtrack");
   TClonesArray &aTOFTrack = *fTracks;
   Int_t c0=0;
   Int_t c1=0;
@@ -264,13 +265,13 @@ void AliTOFtrackerMI::CollectESD() {
     AliESDtrack *t =(AliESDtrack*)fSeeds->UncheckedAt(i);
     if ((t->GetStatus()&AliESDtrack::kTPCout)==0)continue;
 
-    // TRD good tracks, already propagated at 371 cm
+    // TRD good tracks, already propagated at 372 cm
 
     AliTOFtrack *track = new AliTOFtrack(*t); // New
     Double_t x = track->GetX(); //New
 
     if (((t->GetStatus()&AliESDtrack::kTRDout)!=0 ) && 
-        ( x >= fGeom->RinTOF()) ){
+        ( x >= AliTOFGeometry::RinTOF()) ){
       track->SetSeedIndex(i);
       t->UpdateTrackParams(track,AliESDtrack::kTOFout);    
       new(aTOFTrack[fNseedsTOF]) AliTOFtrack(*track);
@@ -330,24 +331,24 @@ void AliTOFtrackerMI::MatchTracksMI(Bool_t mLastStep){
   
   Int_t nSteps=(Int_t)(fTOFHeigth/0.1);
 
-  AliTOFcalib *calib = new AliTOFcalib(fGeom);
+  AliTOFcalib *calib = new AliTOFcalib();
 
   //PH Arrays (moved outside of the loop)
   Float_t * trackPos[4];
   for (Int_t ii=0; ii<4; ii++) trackPos[ii] = new Float_t[nSteps];
-  Int_t * clind[6];
-  for (Int_t ii=0;ii<6;ii++) clind[ii] = new Int_t[fN];
+  Int_t * clind = new Int_t[fN];
 
   // Some init 
   
   Int_t         index[1000];
+  Float_t       quality[1000];
   Float_t       dist3D[1000][6];
   Double_t      times[1000][6];
   Float_t       mintimedist[1000];
   Float_t       likelihood[1000];
   Float_t       length[1000];
   AliTOFcluster *clusters[1000];
-  Double_t       tpcpid[5];
+  Double_t      tpcpid[5];
   dist3D[0][0]=1;
   
   for (Int_t i=0; i<fNseedsTOF; i++) {
@@ -377,21 +378,21 @@ void AliTOFtrackerMI::MatchTracksMI(Bool_t mLastStep){
     //
     //propagat track to the middle of TOF
     //
-    Float_t xs = 378.2;  // should be defined in the TOF geometry
-    Double_t ymax=xs*TMath::Tan(0.5*fGeom->GetAlpha());  
+    Float_t xs = 379.2;  // should be defined in the TOF geometry
+    Double_t ymax=xs*TMath::Tan(0.5*AliTOFGeometry::GetAlpha());  
     Bool_t skip=kFALSE;
     Double_t ysect=trackTOFin->GetYat(xs,skip);
     if (skip){
-      xs = 372.;
-      ymax=xs*TMath::Tan(0.5*fGeom->GetAlpha());
+      xs = 373.;
+      ymax=xs*TMath::Tan(0.5*AliTOFGeometry::GetAlpha());
       ysect=trackTOFin->GetYat(xs,skip);
     }
     if (ysect > ymax) {
-      if (!trackTOFin->Rotate(fGeom->GetAlpha())) {
+      if (!trackTOFin->Rotate(AliTOFGeometry::GetAlpha())) {
        continue;
       }
     } else if (ysect <-ymax) {
-      if (!trackTOFin->Rotate(-fGeom->GetAlpha())) {
+      if (!trackTOFin->Rotate(-AliTOFGeometry::GetAlpha())) {
        continue;
       }
     }    
@@ -430,13 +431,8 @@ void AliTOFtrackerMI::MatchTracksMI(Bool_t mLastStep){
       Double_t dph=TMath::Abs(c->GetPhi()-phi);
       if (dph>TMath::Pi()) dph-=2.*TMath::Pi();
       if (TMath::Abs(dph)>dphi) continue;
-    
-      clind[0][nc] = c->GetDetInd(0);
-      clind[1][nc] = c->GetDetInd(1);
-      clind[2][nc] = c->GetDetInd(2);
-      clind[3][nc] = c->GetDetInd(3);
-      clind[4][nc] = c->GetDetInd(4);
-      clind[5][nc] = k;      
+
+      clind[nc] = k;
       nc++;
     }
 
@@ -448,8 +444,8 @@ void AliTOFtrackerMI::MatchTracksMI(Bool_t mLastStep){
     for (Int_t icl=0; icl<nc; icl++){
       Float_t distances[5];
       if (nfound>=1000) break;
-      index[nfound]=clind[5][icl];
-      AliTOFcluster *cluster = fClusters[clind[5][icl]];
+      index[nfound]=clind[icl];
+      AliTOFcluster *cluster = fClusters[clind[icl]];
       GetLinearDistances(trackTOFin,cluster, distances);
       dist3D[nfound][0] = distances[4];
       dist3D[nfound][1] = distances[1];
@@ -470,7 +466,7 @@ void AliTOFtrackerMI::MatchTracksMI(Bool_t mLastStep){
       length[nfound] = trackTOFin->GetIntegratedLength();
       length[nfound]+=distances[4];
       mintimedist[nfound]=1000; 
-      Double_t tof2=fGeom->TdcBinWidth()*cluster->GetTDC()+kTofOffset; // in ps
+      Double_t tof2=AliTOFGeometry::TdcBinWidth()*cluster->GetTDC()+kTofOffset; // in ps
       // Float_t tgamma = TMath::Sqrt(cluster->GetR()*cluster->GetR()+cluster->GetZ()*cluster->GetZ())/0.03;  //time for "primary" gamma
       //if (trackTOFin->GetPt()<0.7 && TMath::Abs(tgamma-tof2)<350) continue;  // gamma conversion candidate - TEMPORARY
       for(Int_t j=0;j<=5;j++){
@@ -499,8 +495,9 @@ void AliTOFtrackerMI::MatchTracksMI(Bool_t mLastStep){
     //
     //choose the best cluster
     //
-    Float_t quality[1000];
-    Int_t   index[1000];
+    //Float_t quality[1000];
+    //Int_t   index[1000];
+    for (Int_t kk=0; kk<1000; kk++) quality[kk]=0;
     //
     AliTOFcluster * cgold=0;
     Int_t igold =-1;
@@ -555,7 +552,7 @@ void AliTOFtrackerMI::MatchTracksMI(Bool_t mLastStep){
     tlab[1]=cgold->GetLabel(1);
     tlab[2]=cgold->GetLabel(2);
     //    Double_t tof2=25.*cgold->GetTDC()-350; // in ps
-    Double_t tof2=fGeom->TdcBinWidth()*cgold->GetTDC()+kTofOffset; // in ps
+    Double_t tof2=AliTOFGeometry::TdcBinWidth()*cgold->GetTDC()+kTofOffset; // in ps
     Float_t tgamma = TMath::Sqrt(cgold->GetR()*cgold->GetR()+cgold->GetZ()*cgold->GetZ())/0.03;
     Float_t info[11]={dist3D[igold][0],dist3D[igold][1],dist3D[igold][2],dist3D[igold][3],dist3D[igold][4],mintimedist[igold],
                      -1,tgamma, qualityGold,cgold->GetQuality(),0};
@@ -574,14 +571,14 @@ void AliTOFtrackerMI::MatchTracksMI(Bool_t mLastStep){
     ind[2]=cgold->GetDetInd(2);
     ind[3]=cgold->GetDetInd(3);
     ind[4]=cgold->GetDetInd(4);
-    Int_t calindex = calib->GetIndex(ind);
+    Int_t calindex = AliTOFGeometry::GetIndex(ind);
     t->SetTOFCalChannel(calindex);
 
     t->SetTOFInfo(info);
     t->SetTOFsignal(tof2);
     t->SetTOFcluster(cgold->GetIndex());  
     AliTOFtrack *trackTOFout = new AliTOFtrack(*t); 
-    trackTOFout->PropagateTo(378.);
+    trackTOFout->PropagateTo(379.);
     t->UpdateTrackParams(trackTOFout,AliESDtrack::kTOFout);    
     t->SetIntegratedLength(length[igold]);
     t->SetIntegratedTimes(times[igold]);
@@ -595,66 +592,11 @@ void AliTOFtrackerMI::MatchTracksMI(Bool_t mLastStep){
   //
   //
   for (Int_t ii=0; ii<4; ii++) delete [] trackPos[ii];
-  for (Int_t ii=0;ii<6;ii++) delete [] clind[ii];
+  delete [] clind;
   delete calib;
 }
-
-
-
-
-// //_________________________________________________________________________
-// Int_t AliTOFtrackerMI::LoadClusters(TTree *dTree) {
-//   //--------------------------------------------------------------------
-//   //This function loads the TOF clusters
-//   //--------------------------------------------------------------------
-
-//   TBranch *branch=dTree->GetBranch("TOF");
-//   if (!branch) { 
-//     AliError(" can't get the branch with the TOF digits !");
-//     return 1;
-//   }
-
-//   TClonesArray dummy("AliTOFdigit",10000), *digits=&dummy;
-//   branch->SetAddress(&digits);
-
-//   dTree->GetEvent(0);
-//   Int_t nd=digits->GetEntriesFast();
-//   Info("LoadClusters","number of digits: %d",nd);
-
-//   for (Int_t i=0; i<nd; i++) {
-//     AliTOFdigit *d=(AliTOFdigit*)digits->UncheckedAt(i);
-//     Int_t dig[5]; Float_t g[3];
-//     dig[0]=d->GetSector();
-//     dig[1]=d->GetPlate();
-//     dig[2]=d->GetStrip();
-//     dig[3]=d->GetPadz();
-//     dig[4]=d->GetPadx();
-
-//     fGeom->GetPos(dig,g);
-
-//     Double_t h[5];
-//     h[0]=TMath::Sqrt(g[0]*g[0]+g[1]*g[1]);
-//     h[1]=TMath::ATan2(g[1],g[0]); h[2]=g[2]; 
-//     h[3]=d->GetTdc(); h[4]=d->GetAdc();
-
-//     AliTOFcluster *cl=new AliTOFcluster(h,d->GetTracks(),dig,i);
-//     InsertCluster(cl);
-//   }  
-
-//   return 0;
-// }
-// //_________________________________________________________________________
-// void AliTOFtrackerMI::UnloadClusters() {
-//   //--------------------------------------------------------------------
-//   //This function unloads TOF clusters
-//   //--------------------------------------------------------------------
-//   for (Int_t i=0; i<fN; i++) delete fClusters[i];
-//   fN=0;
-// }
-
-
-
 //_________________________________________________________________________
+
 Int_t AliTOFtrackerMI::LoadClusters(TTree *cTree) {
   //--------------------------------------------------------------------
   //This function loads the TOF clusters
@@ -666,7 +608,9 @@ Int_t AliTOFtrackerMI::LoadClusters(TTree *cTree) {
     return 1;
   }
 
-  TClonesArray dummy("AliTOFcluster",10000), *clusters=&dummy;
+  static TClonesArray dummy("AliTOFcluster",10000);
+  dummy.Clear();
+  TClonesArray *clusters=&dummy;
   branch->SetAddress(&clusters);
 
   cTree->GetEvent(0);
@@ -675,23 +619,7 @@ Int_t AliTOFtrackerMI::LoadClusters(TTree *cTree) {
 
   for (Int_t i=0; i<nc; i++) {
     AliTOFcluster *c=(AliTOFcluster*)clusters->UncheckedAt(i);
-    /*
-    for (Int_t jj=0; jj<5; jj++) dig[jj]=c->GetDetInd(jj);
-
-    Double_t h[5];
-    h[0]=c->GetR();
-    h[1]=c->GetPhi();
-    h[2]=c->GetZ();
-    h[3]=c->GetTDC();
-    h[4]=c->GetADC();
 
-    Int_t indexDig[3];
-    for (Int_t jj=0; jj<3; jj++) indexDig[jj] = c->GetLabel(jj);
-
-    AliTOFcluster *cl=new AliTOFcluster(h,c->GetTracks(),dig,i);
-    */
-
-    //    fClusters[i]=c; fN++;
     fClusters[i]=new AliTOFcluster(*c); fN++;
 
     //AliInfo(Form("%4i %4i  %f %f %f  %f %f   %2i %1i %2i %1i %2i",i, fClusters[i]->GetIndex(),fClusters[i]->GetZ(),fClusters[i]->GetR(),fClusters[i]->GetPhi(), fClusters[i]->GetTDC(),fClusters[i]->GetADC(),fClusters[i]->GetDetInd(0),fClusters[i]->GetDetInd(1),fClusters[i]->GetDetInd(2),fClusters[i]->GetDetInd(3),fClusters[i]->GetDetInd(4)));
@@ -768,7 +696,7 @@ Float_t AliTOFtrackerMI::GetLinearDistances(AliTOFtrack * track, AliTOFcluster *
   cind[2]= cluster->GetDetInd(2);
   cind[3]= cluster->GetDetInd(3);
   cind[4]= cluster->GetDetInd(4);
-  Float_t tiltangle  = fGeom->GetAngles(cluster->GetDetInd(1),cluster->GetDetInd(2))/kRaddeg;  //tiltangle  
+  Float_t tiltangle  = AliTOFGeometry::GetAngles(cluster->GetDetInd(1),cluster->GetDetInd(2))/kRaddeg;  //tiltangle  
 
   Float_t cpos[3];  //cluster position
   Float_t cpos0[3];  //cluster position
@@ -907,3 +835,17 @@ void    AliTOFtrackerMI::GetLikelihood(Float_t dy, Float_t dz, const Double_t *c
   p1 = 0.5*(1+TMath::Erf(normd+normwidth*0.5));  
   pz+= 0.25*(p1-p0);
 }
+//_________________________________________________________________________
+
+void AliTOFtrackerMI::FillClusterArray(TObjArray* arr) const
+{
+  //
+  // Returns the TOF cluster array
+  //
+
+  if (fN==0)
+    arr = 0x0;
+  else
+    for (Int_t i=0; i<fN; ++i) arr->Add(fClusters[i]);
+
+}