X-Git-Url: http://git.uio.no/git/?a=blobdiff_plain;f=TOF%2FAliTOFtrackerMI.cxx;h=7cdd1cd33af535ca9c3658edc6700293e0da98f3;hb=8bec71285df8614da58260f69f125721f633f6cb;hp=f965f9dfc7ceb169a1a3ddfb6cb96be7df483a22;hpb=58d8d9a3338ac0897ebde8b3bbec0ed4ab7b1670;p=u%2Fmrichter%2FAliRoot.git diff --git a/TOF/AliTOFtrackerMI.cxx b/TOF/AliTOFtrackerMI.cxx index f965f9dfc7c..7cdd1cd33af 100644 --- a/TOF/AliTOFtrackerMI.cxx +++ b/TOF/AliTOFtrackerMI.cxx @@ -24,61 +24,33 @@ #include #include "TClonesArray.h" -#include "TGeoManager.h" +#include "TObjArray.h" #include "TTree.h" #include "TTreeStream.h" -#include "AliRun.h" -#include "AliESD.h" +#include "AliESDEvent.h" #include "AliESDtrack.h" +#include "AliESDpid.h" -#include "AliTOFcalib.h" +#include "AliTOFRecoParam.h" +#include "AliTOFReconstructor.h" #include "AliTOFcluster.h" #include "AliTOFGeometry.h" #include "AliTOFtrackerMI.h" #include "AliTOFtrack.h" +#include "AliMathBase.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(): + fkRecoParam(0x0), fGeom(0x0), - fTOFpid(0x0), - fHoles(kFALSE), fN(0), fNseeds(0), fNseedsTOF(0), @@ -86,101 +58,79 @@ 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 TObjArray(100)), 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 main Ctor -//_________________________________________________________________________________ -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; + for (Int_t ii=0; iiClose(); delete fDebugStreamer; } - delete fTOFpid; -} - -//_____________________________________________________________________________ -/* -void AliTOFtrackerMI::Init() { - -// temporary solution to know about Holes/no Holes, will be implemented as -// an AliTOFGeometry getter + delete fkRecoParam; + delete fGeom; + if (fTracks){ + fTracks->Delete(); + delete fTracks; + fTracks=0x0; + } + if (fSeeds){ + fSeeds->Delete(); + delete fSeeds; + fSeeds=0x0; + } - AliModule* frame=gAlice->GetModule("FRAME"); + for (Int_t ii=0; iiDelete(); - if(!frame) { - AliError("Could Not load FRAME! Assume Frame with Holes "); - fHoles=true; - } else{ - if(frame->IsVersion()==1) {fHoles=false;} - else {fHoles=true;} - } } -*/ //_____________________________________________________________________________ -Int_t AliTOFtrackerMI::PropagateBack(AliESD* event) { +void AliTOFtrackerMI::GetPidSettings(AliESDpid *esdPID) { + // + // Sets TOF resolution from RecoParams + // + if (fkRecoParam) + esdPID->GetTOFResponse().SetTimeResolution(fkRecoParam->GetTimeResolution()); + else + AliWarning("fkRecoParam not yet set; cannot set PID settings"); +} + +//_____________________________________________________________________________ +Int_t AliTOFtrackerMI::PropagateBack(AliESDEvent * const event) { // // Gets seeds from ESD event and Match with TOF Clusters // + // initialize RecoParam for current event + AliDebug(1,"Initializing params for TOF"); + + fkRecoParam = AliTOFReconstructor::GetRecoParam(); // instantiate reco param from STEER... + + if (fkRecoParam == 0x0) { + AliFatal("No Reco Param found for TOF!!!"); + } + //fkRecoParam->Dump(); + //if(fkRecoParam->GetApplyPbPbCuts())fkRecoParam=fkRecoParam->GetPbPbparam(); + //fkRecoParam->PrintParameters(); //Initialise some counters @@ -193,16 +143,10 @@ Int_t AliTOFtrackerMI::PropagateBack(AliESD* event) { Int_t ntrk=event->GetNumberOfTracks(); fNseeds = ntrk; - fSeeds= new TClonesArray("AliESDtrack"); - TClonesArray &aESDTrack = *fSeeds; - //Load ESD tracks into a local Array of ESD Seeds - - for (Int_t i=0; iGetTrack(i); - new(aESDTrack[i]) AliESDtrack(*t); - } + for (Int_t i=0; iAddLast(event->GetTrack(i)); //Prepare ESD tracks candidates for TOF Matching CollectESD(); @@ -215,51 +159,62 @@ Int_t AliTOFtrackerMI::PropagateBack(AliESD* event) { MatchTracksMI(kFALSE); // assign track to clusters MatchTracksMI(kTRUE); // assign clusters to esd - Info("PropagateBack","Number of matched tracks: %d",fnmatch); - Info("PropagateBack","Number of good matched tracks: %d",fngoodmatch); - Info("PropagateBack","Number of bad matched tracks: %d",fnbadmatch); + AliInfo(Form("Number of matched tracks = %d (good = %d, bad = %d)",fnmatch,fngoodmatch,fnbadmatch)); //Update the matched ESD tracks for (Int_t i=0; iGetTrack(i); - AliESDtrack *seed =(AliESDtrack*)fSeeds->UncheckedAt(i); - if(seed->GetTOFsignal()>0){ - t->SetTOFsignal(seed->GetTOFsignal()); - t->SetTOFcluster(seed->GetTOFcluster()); - Int_t tlab[3]; - seed->GetTOFLabel(tlab); - t->SetTOFLabel(tlab); - AliTOFtrack *track = new AliTOFtrack(*seed); - Float_t info[10]; - Double_t times[10]; - seed->GetTOFInfo(info); - seed->GetIntegratedTimes(times); - t->UpdateTrackParams(track,AliESDtrack::kTOFout); - t->SetIntegratedLength(seed->GetIntegratedLength()); - t->SetIntegratedTimes(times); - t->SetTOFsignalToT(seed->GetTOFsignalToT()); - t->SetTOFCalChannel(seed->GetTOFCalChannel()); - // - t->SetTOFInfo(info); - delete track; + AliESDtrack *seed =(AliESDtrack*)fSeeds->At(i); + + if ( (seed->GetStatus()&AliESDtrack::kTOFin)!=0 ) { + t->SetStatus(AliESDtrack::kTOFin); + //if(seed->GetTOFsignal()>0){ + if ( (seed->GetStatus()&AliESDtrack::kTOFout)!=0 ) { + t->SetStatus(AliESDtrack::kTOFout); + t->SetTOFsignal(seed->GetTOFsignal()); + t->SetTOFcluster(seed->GetTOFcluster()); + Int_t tlab[3]; seed->GetTOFLabel(tlab); + t->SetTOFLabel(tlab); + + // Check done: + // by calling the AliESDtrack::UpdateTrackParams, + // the current track parameters are changed + // and it could cause refit problems. + // We need to update only the following track parameters: + // the track length and expected times. + // Removed AliESDtrack::UpdateTrackParams call + // Called AliESDtrack::SetIntegratedTimes(...) and + // AliESDtrack::SetIntegratedLength() routines. + /* + AliTOFtrack *track = new AliTOFtrack(*seed); + t->UpdateTrackParams(track,AliESDtrack::kTOFout); + delete track; + */ + + Double_t times[10]; seed->GetIntegratedTimes(times); + t->SetIntegratedTimes(times); + t->SetIntegratedLength(seed->GetIntegratedLength()); + t->SetTOFsignalToT(seed->GetTOFsignalToT()); + t->SetTOFCalChannel(seed->GetTOFCalChannel()); + t->SetTOFDeltaBC(seed->GetTOFDeltaBC()); + t->SetTOFL0L1(seed->GetTOFL0L1()); + // + // Make attention, please: + // AliESDtrack::fTOFInfo array does not be stored in the AliESDs.root file + // it is there only for a check during the reconstruction step. + Float_t info[10]; + seed->GetTOFInfo(info); + t->SetTOFInfo(info); + } } } //Make TOF PID - fTOFpid->MakePID(event); - if (fSeeds) { - fSeeds->Delete(); - delete fSeeds; - fSeeds = 0x0; - } - if (fTracks) { - fTracks->Delete(); - delete fTracks; - fTracks = 0x0; - } + fSeeds->Clear(); + fTracks->Delete(); return 0; } @@ -267,37 +222,35 @@ 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; for (Int_t i=0; iUncheckedAt(i); + AliESDtrack *t =(AliESDtrack*)fSeeds->At(i); if ((t->GetStatus()&AliESDtrack::kTPCout)==0)continue; - // TRD good tracks, already propagated at 371 cm - AliTOFtrack *track = new AliTOFtrack(*t); // New - Double_t x = track->GetX(); //New - - if (((t->GetStatus()&AliESDtrack::kTRDout)!=0 ) && - ( x >= fGeom->RinTOF()) ){ - track->SetSeedIndex(i); - t->UpdateTrackParams(track,AliESDtrack::kTOFout); - new(aTOFTrack[fNseedsTOF]) AliTOFtrack(*track); - fNseedsTOF++; - c0++; - delete track; - } + Float_t x = (Float_t)track->GetX(); //New - // Propagate the rest of TPCbp + // TRD good tracks, already propagated at 371 cm + if ( ( (t->GetStatus()&AliESDtrack::kTRDout)!=0 ) && + ( x >= AliTOFGeometry::Rmin() ) ) { + if ( track->PropagateToInnerTOF() ) { + track->SetSeedIndex(i); + t->UpdateTrackParams(track,AliESDtrack::kTOFin); + new(aTOFTrack[fNseedsTOF]) AliTOFtrack(*track); + fNseedsTOF++; + c0++; + delete track; + } + } + // 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); + t->UpdateTrackParams(track,AliESDtrack::kTOFin); new(aTOFTrack[fNseedsTOF]) AliTOFtrack(*track); fNseedsTOF++; c1++; @@ -314,16 +267,8 @@ void AliTOFtrackerMI::CollectESD() { } - - - - - - -// -// //_________________________________________________________________________ -void AliTOFtrackerMI::MatchTracks( Bool_t /*mLastStep*/){ +void AliTOFtrackerMI::MatchTracks( Bool_t /*mLastStep*/) const { return; } // @@ -332,41 +277,39 @@ 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 = 0; // 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[]={ + static const Double_t kMasses[AliPID::kSPECIES+1]={ 0.000511, 0.105658, 0.139570, 0.493677, 0.938272, 1.875613 }; Int_t nSteps=(Int_t)(fTOFHeigth/0.1); - AliTOFcalib *calib = new AliTOFcalib(fGeom); - //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 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]; + const Int_t kNclusterMax = 1000; // related to fN value + AliTOFcluster *clusters[kNclusterMax]; + Int_t index[kNclusterMax]; + Float_t quality[kNclusterMax]; + Float_t dist3D[kNclusterMax][6]; + Double_t times[kNclusterMax][6]; + Float_t mintimedist[kNclusterMax]; + Float_t likelihood[kNclusterMax]; + Float_t length[kNclusterMax]; + Double_t tpcpid[AliPID::kSPECIES+1]; // overrun_static - coverity warning dist3D[0][0]=1; for (Int_t i=0; iUncheckedAt(i); - AliESDtrack *t =(AliESDtrack*)fSeeds->UncheckedAt(track->GetSeedIndex()); + AliESDtrack *t =(AliESDtrack*)fSeeds->At(track->GetSeedIndex()); Bool_t hasTime = ( (t->GetStatus()& AliESDtrack::kTIME)>0) ? kTRUE:kFALSE; // did we integrate time Float_t trdquality = t->GetTRDQuality(); // @@ -374,10 +317,10 @@ void AliTOFtrackerMI::MatchTracksMI(Bool_t mLastStep){ // t->GetTPCpid(tpcpid); Double_t sumpid=0; - for (Int_t ipid=0;ipid<5;ipid++){ + for (Int_t ipid=0;ipid0) tpcpid[ipid]/=sumpid; else{ tpcpid[ipid]=0.2; @@ -390,12 +333,12 @@ 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 + 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.; + xs = 373.; ymax=xs*TMath::Tan(0.5*AliTOFGeometry::GetAlpha()); ysect=trackTOFin->GetYat(xs,skip); } @@ -418,13 +361,20 @@ void AliTOFtrackerMI::MatchTracksMI(Bool_t mLastStep){ trackTOFin->GetExternalParameters(x,par); Double_t cov[15]; trackTOFin->GetExternalCovariance(cov); + + if (cov[0]<0. || cov[2]<0.) { + AliWarning(Form("Very strange track (%d)! At least one of its covariance matrix diagonal elements is negative!",i)); + //delete trackTOFin; + //continue; + } + Float_t scalefact=3.; Double_t dphi= scalefact* - ((5*TMath::Sqrt(cov[0]) + 3.*fDy +10.*TMath::Abs(par[2]))/fR); + ((5*TMath::Sqrt(TMath::Abs(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(TMath::Abs(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(); @@ -436,6 +386,12 @@ void AliTOFtrackerMI::MatchTracksMI(Bool_t mLastStep){ // find the clusters in the window of the track for (Int_t k=FindClusterIndex(z-dz); k=kNclusterMax) { + AliWarning("No more matchable clusters can be stored! Please, increase the corresponding vectors size."); + break; + } + AliTOFcluster *c=fClusters[k]; if (c->GetZ() > z+dz) break; // if (c->IsUsed()) continue; @@ -443,16 +399,13 @@ 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++; } + AliDebug(1,Form(" Number of matchable TOF clusters for the track number %d: %d",i,nc)); + // // select close clusters // @@ -460,10 +413,10 @@ void AliTOFtrackerMI::MatchTracksMI(Bool_t mLastStep){ // Bool_t dump = kTRUE; 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 +431,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]; @@ -486,7 +439,8 @@ void AliTOFtrackerMI::MatchTracksMI(Bool_t mLastStep){ 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++){ + for(Int_t j=0;jkForbiddenR){ @@ -503,7 +457,10 @@ void AliTOFtrackerMI::MatchTracksMI(Bool_t mLastStep){ } // nfound++; - } + } + + AliDebug(1,Form(" Number of track points for the track number %d: %d",i,nfound)); + if (nfound == 0 ) { fnunmatch++; delete trackTOFin; @@ -512,8 +469,9 @@ void AliTOFtrackerMI::MatchTracksMI(Bool_t mLastStep){ // //choose the best cluster // - Float_t quality[1000]; - Int_t index[1000]; + //Float_t quality[kNclusterMax]; + //Int_t index[kNclusterMax]; + for (Int_t kk=0; kkGetTDC()-350; // 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}; + Float_t info[10]={dist3D[igold][0], + dist3D[igold][1], + dist3D[igold][2], + dist3D[igold][3], + dist3D[igold][4], + mintimedist[igold], + -1, + tgamma, + qualityGold, + static_cast(cgold->GetQuality())}; // GetLinearDistances(trackTOFin,cgold,&info[6]); if (inonfake>=0){ info[6] = inonfake; @@ -587,14 +553,28 @@ 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()); + t->SetTOFDeltaBC(cgold->GetDeltaBC()); + t->SetTOFL0L1(cgold->GetL0L1Latency()); + + 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 +588,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,24 +615,9 @@ 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++; +//PH fClusters[i]=new AliTOFcluster(*c); fN++; + fClusters[i]=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))); //AliInfo(Form("%i %f",i, fClusters[i]->GetZ())); @@ -721,7 +633,7 @@ void AliTOFtrackerMI::UnloadClusters() { //This function unloads TOF clusters //-------------------------------------------------------------------- for (Int_t i=0; iGetAngles(cluster->fdetIndex[1],cluster->fdetIndex[2])/kRaddeg; //tiltangle Int_t cind[5]; @@ -781,7 +693,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 @@ -794,12 +706,12 @@ Float_t AliTOFtrackerMI::GetLinearDistances(AliTOFtrack * track, AliTOFcluster * Float_t phi = TMath::ATan2(cpos[1],cpos[0]); if(phi<0) phi=2.*TMath::Pi()+phi; // Get the local angle in the sector philoc - Float_t phiangle = (Int_t (phi*kRaddeg/20.) + 0.5)*20./kRaddeg; + Float_t phiangle = (Int_t (phi*kRaddeg/20.) + 0.5)*20./kRaddeg; // Double_t v0[3]; Double_t dir[3]; - track->GetGlobalXYZ(v0[0],v0[1],v0[2]); - track->GetPxPyPz(dir[0],dir[1],dir[2]); + track->GetXYZ(v0); + track->GetPxPyPz(dir); dir[0]/=track->GetP(); dir[1]/=track->GetP(); dir[2]/=track->GetP(); @@ -815,27 +727,27 @@ Float_t AliTOFtrackerMI::GetLinearDistances(AliTOFtrack * track, AliTOFcluster * temp = cpos[0]*cosphi+cpos[1]*sinphi; cpos[1] = -cpos[0]*sinphi+cpos[1]*cosphi; cpos[0] = temp; - temp = v0[0]*cosphi+v0[1]*sinphi; + temp = v0[0]*cosphi+v0[1]*sinphi; v0[1] = -v0[0]*sinphi+v0[1]*cosphi; v0[0] = temp; // temp = cpos[0]*costh+cpos[2]*sinth; cpos[2] = -cpos[0]*sinth+cpos[2]*costh; cpos[0] = temp; - temp = v0[0]*costh+v0[2]*sinth; - v0[2] = -v0[0]*sinth+v0[2]*costh; - v0[0] = temp; + temp = v0[0]*costh+v0[2]*sinth; + v0[2] = -v0[0]*sinth+v0[2]*costh; + v0[0] = temp; // // //rotate direction vector // - temp = dir[0]*cosphi+dir[1]*sinphi; + temp = dir[0]*cosphi+dir[1]*sinphi; dir[1] = -dir[0]*sinphi+dir[1]*cosphi; dir[0] = temp; // - temp = dir[0]*costh+dir[2]*sinth; - dir[2] = -dir[0]*sinth+dir[2]*costh; - dir[0] = temp; + temp = dir[0]*costh+dir[2]*sinth; + dir[2] = -dir[0]*sinth+dir[2]*costh; + dir[0] = temp; // Float_t v3[3]; Float_t k = (cpos[0]-v0[0])/dir[0]; @@ -852,7 +764,9 @@ Float_t AliTOFtrackerMI::GetLinearDistances(AliTOFtrack * track, AliTOFcluster * // // Debuging part of the matching // - if (track->GetLabel()==cluster->GetLabel(0) ||track->GetLabel()==cluster->GetLabel(1) ){ + if (track->GetLabel()==cluster->GetLabel(0) || + track->GetLabel()==cluster->GetLabel(1) || + track->GetLabel()==cluster->GetLabel(2) ){ TTreeSRedirector& cstream = *fDebugStreamer; Float_t tdc = cluster->GetTDC(); cstream<<"Tracks"<< @@ -870,9 +784,8 @@ Float_t AliTOFtrackerMI::GetLinearDistances(AliTOFtrack * track, AliTOFcluster * return distances[3]; } - - -void AliTOFtrackerMI::GetLikelihood(Float_t dy, Float_t dz, const Double_t *cov, AliTOFtrack * /*track*/, Float_t & py, Float_t &pz) +//_________________________________________________________________________ +void AliTOFtrackerMI::GetLikelihood(Float_t dy, Float_t dz, const Double_t *cov, AliTOFtrack * /*track*/, Float_t & py, Float_t &pz) const { // // get likelihood - track covariance taken @@ -886,8 +799,8 @@ void AliTOFtrackerMI::GetLikelihood(Float_t dy, Float_t dz, const Double_t *c Float_t normwidth, normd, p0,p1; - Float_t sigmay = TMath::Max(TMath::Sqrt(cov[0]+kMeanSigmaY*kMeanSigmaY),kMaxSigmaY); - Float_t sigmaz = TMath::Max(TMath::Sqrt(cov[2]+kMeanSigmaZ*kMeanSigmaZ),kMaxSigmaZ); + Float_t sigmay = TMath::Max(TMath::Sqrt(TMath::Abs(cov[0])+kMeanSigmaY*kMeanSigmaY),kMaxSigmaY); + Float_t sigmaz = TMath::Max(TMath::Sqrt(TMath::Abs(cov[2])+kMeanSigmaZ*kMeanSigmaZ),kMaxSigmaZ); py=0; pz=0; @@ -896,27 +809,41 @@ void AliTOFtrackerMI::GetLikelihood(Float_t dy, Float_t dz, const Double_t *c // normwidth = fDy/sigmay; normd = dy/sigmay; - p0 = 0.5*(1+TMath::Erf(normd-normwidth*0.5)); - p1 = 0.5*(1+TMath::Erf(normd+normwidth*0.5)); + p0 = 0.5*(1+AliMathBase::ErfFast(normd-normwidth*0.5)); + p1 = 0.5*(1+AliMathBase::ErfFast(normd+normwidth*0.5)); py+= 0.75*(p1-p0); // normwidth = fDy/(3.*sigmay); normd = dy/(3.*sigmay); - p0 = 0.5*(1+TMath::Erf(normd-normwidth*0.5)); - p1 = 0.5*(1+TMath::Erf(normd+normwidth*0.5)); + p0 = 0.5*(1+AliMathBase::ErfFast(normd-normwidth*0.5)); + p1 = 0.5*(1+AliMathBase::ErfFast(normd+normwidth*0.5)); py+= 0.25*(p1-p0); // // pz calculation - 75% admixture of original sigma - 25% tails // normwidth = fDz/sigmaz; normd = dz/sigmaz; - p0 = 0.5*(1+TMath::Erf(normd-normwidth*0.5)); - p1 = 0.5*(1+TMath::Erf(normd+normwidth*0.5)); + p0 = 0.5*(1+AliMathBase::ErfFast(normd-normwidth*0.5)); + p1 = 0.5*(1+AliMathBase::ErfFast(normd+normwidth*0.5)); pz+= 0.75*(p1-p0); // normwidth = fDz/(3.*sigmaz); normd = dz/(3.*sigmaz); - p0 = 0.5*(1+TMath::Erf(normd-normwidth*0.5)); - p1 = 0.5*(1+TMath::Erf(normd+normwidth*0.5)); + p0 = 0.5*(1+AliMathBase::ErfFast(normd-normwidth*0.5)); + p1 = 0.5*(1+AliMathBase::ErfFast(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]); + +}