X-Git-Url: http://git.uio.no/git/?p=u%2Fmrichter%2FAliRoot.git;a=blobdiff_plain;f=TOF%2FAliTOFtrackerMI.cxx;h=f25c925e9d522c49be5837d7e4638f3edbb37a8c;hp=698429dfa47840fe45ecc77cb27eb6a1ebe60fb2;hb=07bbc13c498c86c1ca3b79969814aabea9c844ba;hpb=6c94f3308e8e21efdd662a43a6a60db688334d59 diff --git a/TOF/AliTOFtrackerMI.cxx b/TOF/AliTOFtrackerMI.cxx index 698429dfa47..f25c925e9d5 100644 --- a/TOF/AliTOFtrackerMI.cxx +++ b/TOF/AliTOFtrackerMI.cxx @@ -24,61 +24,31 @@ #include #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 "AliTOFcalib.h" +#include "AliTOFRecoParam.h" +#include "AliTOFReconstructor.h" #include "AliTOFcluster.h" #include "AliTOFGeometry.h" #include "AliTOFtrackerMI.h" #include "AliTOFtrack.h" +#include "AliTOFpidESD.h" + +class TGeoManager; extern TGeoManager *gGeoManager; ClassImp(AliTOFtrackerMI) //_____________________________________________________________________________ -AliTOFtrackerMI::AliTOFtrackerMI(AliTOFGeometry * geom, Double_t parPID[2]): - fGeom(geom), - fTOFpid(new AliTOFpidESD(parPID)), - fHoles(kFALSE), - fN(0), - fNseeds(0), - fNseedsTOF(0), - fngoodmatch(0), - fnbadmatch(0), - fnunmatch(0), - fnmatch(0), - fR(378.), - fTOFHeigth(15.3), - fdCut(3.), - fDx(1.5), - fDy(0), - fDz(0), - fTracks(0x0), - fSeeds(0x0), - fDebugStreamer(0x0) - { - //AliTOFtrackerMI main Ctor - - //fHoles=true; - fDy=AliTOFGeometry::XPad(); - fDz=AliTOFGeometry::ZPad(); - fDebugStreamer = new TTreeSRedirector("TOFdebug.root"); - //Init(); // temporary solution to know about Holes/no Holes - fHoles=geom->GetHoles(); -} -//_____________________________________________________________________________ -AliTOFtrackerMI::AliTOFtrackerMI(const AliTOFtrackerMI &t): - AliTracker(), +AliTOFtrackerMI::AliTOFtrackerMI(): + fRecoParam(0x0), fGeom(0x0), - fTOFpid(0x0), - fHoles(kFALSE), + fPid(0x0), fN(0), fNseeds(0), fNseedsTOF(0), @@ -86,63 +56,21 @@ 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 - - fHoles=t.fHoles; - fNseeds=t.fNseeds; - fNseedsTOF=t.fNseedsTOF; - fngoodmatch=t.fngoodmatch; - fnbadmatch=t.fnbadmatch; - fnunmatch=t.fnunmatch; - fnmatch=t.fnmatch; - fGeom = t.fGeom; - fTOFpid = t.fTOFpid; - fR=t.fR; - fTOFHeigth=t.fTOFHeigth; - fdCut=t.fdCut; - fDy=t.fDy; - fDz=t.fDz; - fDx=1.5; - fSeeds=t.fSeeds; - fTracks=t.fTracks; - fN=t.fN; -} - -//_________________________________________________________________________________ -AliTOFtrackerMI& AliTOFtrackerMI::operator=(const AliTOFtrackerMI &t) -{ - //AliTOFtrackerMI assignment operator - - this->fHoles=t.fHoles; - this->fNseeds=t.fNseeds; - this->fNseedsTOF=t.fNseedsTOF; - this->fngoodmatch=t.fngoodmatch; - this->fnbadmatch=t.fnbadmatch; - this->fnunmatch=t.fnunmatch; - this->fnmatch=t.fnmatch; - this->fGeom = t.fGeom; - this->fTOFpid = t.fTOFpid; - this->fR=t.fR; - this->fTOFHeigth=t.fTOFHeigth; - this->fdCut=t.fdCut; - this->fDy=t.fDy; - this->fDz=t.fDz; - this->fDx=t.fDx; - this->fSeeds=t.fSeeds; - this->fTracks=t.fTracks; - this->fN=t.fN; - return *this; + //AliTOFtrackerMI main Ctor + fDy=AliTOFGeometry::XPad(); + fDz=AliTOFGeometry::ZPad(); + fDebugStreamer = new TTreeSRedirector("TOFdebug.root"); } //_____________________________________________________________________________ @@ -154,33 +82,44 @@ AliTOFtrackerMI::~AliTOFtrackerMI(){ //fDebugStreamer->Close(); delete fDebugStreamer; } - delete fTOFpid; + delete fRecoParam; + delete fGeom; + delete fPid; + if (fTracks){ + fTracks->Delete(); + delete fTracks; + fTracks=0x0; + } + if (fSeeds){ + fSeeds->Delete(); + delete fSeeds; + fSeeds=0x0; + } } //_____________________________________________________________________________ -/* -void AliTOFtrackerMI::Init() { +Int_t AliTOFtrackerMI::PropagateBack(AliESDEvent* event) { + // + // Gets seeds from ESD event and Match with TOF Clusters + // + + // initialize RecoParam for current event -// temporary solution to know about Holes/no Holes, will be implemented as -// an AliTOFGeometry getter + AliInfo("Initializing params for TOF... "); - AliModule* frame=gAlice->GetModule("FRAME"); + fRecoParam = AliTOFReconstructor::GetRecoParam(); // instantiate reco param from STEER... - if(!frame) { - AliError("Could Not load FRAME! Assume Frame with Holes "); - fHoles=true; - } else{ - if(frame->IsVersion()==1) {fHoles=false;} - else {fHoles=true;} + if (fRecoParam == 0x0) { + AliFatal("No Reco Param found for TOF!!!"); } -} -*/ -//_____________________________________________________________________________ -Int_t AliTOFtrackerMI::PropagateBack(AliESD* event) { - // - // Gets seeds from ESD event and Match with TOF Clusters - // + //fRecoParam->Dump(); + //if(fRecoParam->GetApplyPbPbCuts())fRecoParam=fRecoParam->GetPbPbparam(); + //fRecoParam->PrintParameters(); + Double_t parPID[2]; + parPID[0]=fRecoParam->GetTimeResolution(); + parPID[1]=fRecoParam->GetTimeNSigma(); + fPid=new AliTOFpidESD(parPID); //Initialise some counters @@ -193,7 +132,6 @@ Int_t AliTOFtrackerMI::PropagateBack(AliESD* event) { Int_t ntrk=event->GetNumberOfTracks(); fNseeds = ntrk; - fSeeds= new TClonesArray("AliESDtrack"); TClonesArray &aESDTrack = *fSeeds; @@ -248,18 +186,10 @@ Int_t AliTOFtrackerMI::PropagateBack(AliESD* event) { //Make TOF PID - fTOFpid->MakePID(event); + 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; } @@ -267,7 +197,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; @@ -276,13 +205,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); @@ -294,8 +223,7 @@ void AliTOFtrackerMI::CollectESD() { // Propagate the rest of TPCbp else { - if(track->PropagateToInnerTOF(fHoles)){ // temporary solution - // if(track->PropagateToInnerTOF(fGeom->GetHoles())){ + if(track->PropagateToInnerTOF()){ // temporary solution track->SetSeedIndex(i); t->UpdateTrackParams(track,AliESDtrack::kTOFout); new(aTOFTrack[fNseedsTOF]) AliTOFtrack(*track); @@ -332,10 +260,10 @@ void AliTOFtrackerMI::MatchTracks( Bool_t /*mLastStep*/){ void AliTOFtrackerMI::MatchTracksMI(Bool_t mLastStep){ //Match ESD tracks to clusters in TOF - const Float_t kTofOffset = 26; // time offset - const Float_t kMinQuality = -6.; // minimal quality - const Float_t kMaxQualityD = 1.; // max delta quality if cluster used - const Float_t kForbiddenR = 0.1; // minimal PID according TPC + const Float_t kTofOffset = 26; // time offset + const Float_t kMinQuality = -6.; // minimal quality + const Float_t kMaxQualityD = 1.; // max delta quality if cluster used + const Float_t kForbiddenR = 0.1; // minimal PID according TPC static const Double_t kMasses[]={ 0.000511, 0.105658, 0.139570, 0.493677, 0.938272, 1.875613 @@ -343,24 +271,24 @@ void AliTOFtrackerMI::MatchTracksMI(Bool_t mLastStep){ Int_t nSteps=(Int_t)(fTOFHeigth/0.1); - AliTOFcalib *calib = new AliTOFcalib(fGeom); + //AliTOFcalib *calib = new AliTOFcalib(); // AdC //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; iGetYat(xs,skip); if (skip){ - xs = 372.; + xs = 373.; ymax=xs*TMath::Tan(0.5*AliTOFGeometry::GetAlpha()); ysect=trackTOFin->GetYat(xs,skip); } @@ -421,10 +349,10 @@ void AliTOFtrackerMI::MatchTracksMI(Bool_t mLastStep){ Float_t scalefact=3.; Double_t dphi= scalefact* - ((5*TMath::Sqrt(cov[0]) + 3.*fDy +10.*TMath::Abs(par[2]))/fR); + ((5*TMath::Sqrt(cov[0]) + 3.*fDy + 10.*TMath::Abs(par[2]))/fR); Double_t dz= scalefact* - (5*TMath::Sqrt(cov[2]) + 3.*fDz +10.*TMath::Abs(par[3])); + (5*TMath::Sqrt(cov[2]) + 3.*fDz + 10.*TMath::Abs(par[3])); Double_t phi=TMath::ATan2(par[0],x) + trackTOFin->GetAlpha(); if (phi<-TMath::Pi())phi+=2*TMath::Pi(); @@ -443,13 +371,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++; } @@ -461,9 +384,9 @@ void AliTOFtrackerMI::MatchTracksMI(Bool_t mLastStep){ for (Int_t icl=0; icl=1000) break; - index[nfound]=clind[5][icl]; - AliTOFcluster *cluster = fClusters[clind[5][icl]]; - GetLinearDistances(trackTOFin,cluster, distances); + index[nfound]=clind[icl]; + AliTOFcluster *cluster = fClusters[clind[icl]]; + GetLinearDistances(trackTOFin, cluster, distances); dist3D[nfound][0] = distances[4]; dist3D[nfound][1] = distances[1]; dist3D[nfound][2] = distances[2]; @@ -478,7 +401,7 @@ void AliTOFtrackerMI::MatchTracksMI(Bool_t mLastStep){ // clusters[nfound] = cluster; // - //length and TOF updates + //length and TOF updates trackTOFin->GetIntegratedTimes(times[nfound]); length[nfound] = trackTOFin->GetIntegratedLength(); length[nfound]+=distances[4]; @@ -512,8 +435,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; @@ -587,14 +511,26 @@ 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()); + + AliDebug(2, Form("%7i %7i %10i %10i %10i %10i %7i", + i, + fnmatch-1, + TMath::Abs(trackTOFin->GetLabel()), + tlab[0], tlab[1], tlab[2], + igold)); // AdC + AliTOFtrack *trackTOFout = new AliTOFtrack(*t); - trackTOFout->PropagateTo(378.); + trackTOFout->PropagateTo(379.); + + // Fill the track residual histograms. + FillResiduals(trackTOFout,cgold,kFALSE); + t->UpdateTrackParams(trackTOFout,AliESDtrack::kTOFout); t->SetIntegratedLength(length[igold]); t->SetIntegratedTimes(times[igold]); @@ -608,66 +544,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 calib; + delete [] clind; + //delete calib; // AdC } - - - - -// //_________________________________________________________________________ -// 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; iUncheckedAt(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; iSetAddress(&clusters); cTree->GetEvent(0); @@ -688,23 +571,7 @@ Int_t AliTOFtrackerMI::LoadClusters(TTree *cTree) { for (Int_t i=0; iUncheckedAt(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))); @@ -781,7 +648,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 @@ -920,3 +787,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; iAdd(fClusters[i]); + +}