From d686d0622251c070038e9f3af26b91df64a31338 Mon Sep 17 00:00:00 2001 From: arcelli Date: Wed, 3 Oct 2007 10:45:41 +0000 Subject: [PATCH] new TOF tracking schema --- TOF/AliTOFtrackerV1.cxx | 800 ++++++++++++++++++++++++++++++++++++++++ TOF/AliTOFtrackerV1.h | 97 +++++ 2 files changed, 897 insertions(+) create mode 100644 TOF/AliTOFtrackerV1.cxx create mode 100644 TOF/AliTOFtrackerV1.h diff --git a/TOF/AliTOFtrackerV1.cxx b/TOF/AliTOFtrackerV1.cxx new file mode 100644 index 00000000000..daa16a8abec --- /dev/null +++ b/TOF/AliTOFtrackerV1.cxx @@ -0,0 +1,800 @@ +/************************************************************************** + * Copyright(c) 1998-1999, ALICE Experiment at CERN, All rights reserved. * + * * + * Author: The ALICE Off-line Project. * + * Contributors are mentioned in the code where appropriate. * + * * + * Permission to use, copy, modify and distribute this software and its * + * documentation strictly for non-commercial purposes is hereby granted * + * without fee, provided that the above copyright notice appears in all * + * copies and that both the copyright notice and this permission notice * + * appear in the supporting documentation. The authors make no claims * + * about the suitability of this software for any purpose. It is * + * provided "as is" without express or implied warranty. * +**************************************************************************/ + +//--------------------------------------------------------------------// +// // +// AliTOFtrackerV1 Class // +// Task: Perform association of the ESD tracks to TOF Clusters // +// and Update ESD track with associated TOF Cluster parameters // +// // +// -- Authors : S. Arcelli, C. Zampolli (Bologna University and INFN) // +// -- Contacts: Annalisa.De.Caro@cern.ch // +// -- : Chiara.Zampolli@bo.infn.it // +// -- : Silvia.Arcelli@bo.infn.it // +// // +//--------------------------------------------------------------------// + +#include +#include + +#include +#include +#include +#include +#include + +#include "AliAlignObj.h" +#include "AliESDtrack.h" +#include "AliESDEvent.h" +#include "AliLog.h" +#include "AliTrackPointArray.h" + +#include "AliTOFcalib.h" +#include "AliTOFRecoParam.h" +#include "AliTOFcluster.h" +#include "AliTOFGeometryV5.h" +#include "AliTOFtrackerV1.h" +#include "AliTOFtrack.h" + +extern TROOT *gROOT; + +ClassImp(AliTOFtrackerV1) + +//_____________________________________________________________________________ +AliTOFtrackerV1::AliTOFtrackerV1(): + fRecoParam(0x0), + fGeom(0x0), + fPid(0x0), + fN(0), + fNseeds(0), + fNseedsTOF(0), + fngoodmatch(0), + fnbadmatch(0), + fnunmatch(0), + fnmatch(0), + fTracks(0x0), + fSeeds(0x0), + fHDigClusMap(0x0), + fHDigNClus(0x0), + fHDigClusTime(0x0), + fHDigClusToT(0x0), + fHRecNClus(0x0), + fHRecChi2(0x0), + fHRecDistZ(0x0), + fHRecSigYVsP(0x0), + fHRecSigZVsP(0x0), + fHRecSigYVsPWin(0x0), + fHRecSigZVsPWin(0x0) + { + //AliTOFtrackerV1 main Ctor + + // Getting the geometry + fGeom=new AliTOFGeometryV5(); + // Read the reconstruction parameters from the OCDB + AliTOFcalib *calib = new AliTOFcalib(fGeom); + fRecoParam = (AliTOFRecoParam*)calib->ReadRecParFromCDB("TOF/Calib",-1); + if(fRecoParam->GetApplyPbPbCuts())fRecoParam=fRecoParam->GetPbPbparam(); + delete calib; + Double_t parPID[2]; + parPID[0]=fRecoParam->GetTimeResolution(); + parPID[1]=fRecoParam->GetTimeNSigma(); + fPid=new AliTOFpidESD(parPID); + InitCheckHists(); + +} +//_____________________________________________________________________________ +AliTOFtrackerV1::AliTOFtrackerV1(const AliTOFtrackerV1 &t): + AliTracker(), + fRecoParam(0x0), + fGeom(0x0), + fPid(0x0), + fN(0), + fNseeds(0), + fNseedsTOF(0), + fngoodmatch(0), + fnbadmatch(0), + fnunmatch(0), + fnmatch(0), + fTracks(0x0), + fSeeds(0x0), + fHDigClusMap(0x0), + fHDigNClus(0x0), + fHDigClusTime(0x0), + fHDigClusToT(0x0), + fHRecNClus(0x0), + fHRecChi2(0x0), + fHRecDistZ(0x0), + fHRecSigYVsP(0x0), + fHRecSigZVsP(0x0), + fHRecSigYVsPWin(0x0), + fHRecSigZVsPWin(0x0) + { + //AliTOFtrackerV1 copy Ctor + + fNseeds=t.fNseeds; + fNseeds=t.fNseeds; + fNseedsTOF=t.fNseedsTOF; + fngoodmatch=t.fngoodmatch; + fnbadmatch=t.fnbadmatch; + fnunmatch=t.fnunmatch; + fnmatch=t.fnmatch; + fRecoParam=t.fRecoParam; + fGeom=t.fGeom; + fPid=t.fPid; + fSeeds=t.fSeeds; + fTracks=t.fTracks; + fN=t.fN; +} + +//_____________________________________________________________________________ +AliTOFtrackerV1& AliTOFtrackerV1::operator=(const AliTOFtrackerV1 &t) +{ + //AliTOFtrackerV1 assignment operator + + 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->fRecoParam = t.fRecoParam; + this->fGeom = t.fGeom; + this->fPid = t.fPid; + this->fSeeds=t.fSeeds; + this->fTracks=t.fTracks; + this->fN=t.fN; + return *this; + +} +//_____________________________________________________________________________ +AliTOFtrackerV1::~AliTOFtrackerV1() { + // + // Dtor + // + + SaveCheckHists(); + + delete fRecoParam; + delete fGeom; + delete fPid; + delete fHDigClusMap; + delete fHDigNClus; + delete fHDigClusTime; + delete fHDigClusToT; + delete fHRecNClus; + delete fHRecChi2; + delete fHRecDistZ; + delete fHRecSigYVsP; + delete fHRecSigZVsP; + delete fHRecSigYVsPWin; + delete fHRecSigZVsPWin; +} +//_____________________________________________________________________________ +Int_t AliTOFtrackerV1::PropagateBack(AliESDEvent* event) { + // + // Gets seeds from ESD event and Match with TOF Clusters + // + + + //Initialise some counters + + fNseeds=0; + fNseedsTOF=0; + fngoodmatch=0; + fnbadmatch=0; + fnunmatch=0; + fnmatch=0; + + Int_t ntrk=event->GetNumberOfTracks(); + fNseeds = ntrk; + fSeeds= new TClonesArray("AliESDtrack",ntrk); + 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); + } + + //Prepare ESD tracks candidates for TOF Matching + CollectESD(); + + //Matching Step + MatchTracks(); + + AliInfo(Form("Number of matched tracks: %d",fnmatch)); + AliInfo(Form("Number of good matched tracks: %d",fngoodmatch)); + AliInfo(Form("Number of bad matched tracks: %d",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()); + t->SetTOFsignalToT(seed->GetTOFsignalToT()); + t->SetTOFsignalRaw(seed->GetTOFsignalRaw()); + t->SetTOFsignalDz(seed->GetTOFsignalDz()); + t->SetTOFCalChannel(seed->GetTOFCalChannel()); + Int_t tlab[3]; seed->GetTOFLabel(tlab); + t->SetTOFLabel(tlab); + AliTOFtrack *track = new AliTOFtrack(*seed); + t->UpdateTrackParams(track,AliESDtrack::kTOFout); + delete track; + } + } + + //Handle Time Zero information + + Double_t timeZero=0.; + Double_t timeZeroMax=99999.; + Bool_t usetimeZero = fRecoParam->UseTimeZero(); + Bool_t timeZeroFromT0 = fRecoParam->GetTimeZerofromT0(); + Bool_t timeZeroFromTOF = fRecoParam->GetTimeZerofromTOF(); + + AliDebug(1,Form("Use Time Zero?: %d",usetimeZero)); + AliDebug(1,Form("Time Zero from T0? : %d",timeZeroFromT0)); + AliDebug(1,Form("Time Zero From TOF? : %d",timeZeroFromTOF)); + + if(usetimeZero){ + if(timeZeroFromT0){ + timeZero=GetTimeZerofromT0(event); + } + if(timeZeroFromTOF && (timeZero>timeZeroMax || !timeZeroFromT0)){ + timeZero=GetTimeZerofromTOF(event); + } + } + AliDebug(2,Form("time Zero used in PID: %f",timeZero)); + //Make TOF PID + fPid->MakePID(event,timeZero); + + if (fSeeds) { + fSeeds->Delete(); + delete fSeeds; + fSeeds = 0x0; + } + if (fTracks) { + fTracks->Delete(); + delete fTracks; + fTracks = 0x0; + } + return 0; + +} +//_________________________________________________________________________ +void AliTOFtrackerV1::CollectESD() { + //prepare the set of ESD tracks to be matched to clusters in TOF + + Int_t seedsTOF1=0; + Int_t seedsTOF2=0; + + fTracks= new TClonesArray("AliTOFtrack"); + TClonesArray &aTOFTrack = *fTracks; + for (Int_t i=0; iUncheckedAt(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++; + seedsTOF1++; + delete track; + } + + // Propagate the rest of TPCbp + + else { + if(track->PropagateToInnerTOF()){ + track->SetSeedIndex(i); + t->UpdateTrackParams(track,AliESDtrack::kTOFout); + new(aTOFTrack[fNseedsTOF]) AliTOFtrack(*track); + fNseedsTOF++; + seedsTOF2++; + } + delete track; + } + } + + AliInfo(Form("Number of TOF seeds %i",fNseedsTOF)); + AliInfo(Form("Number of TOF seeds Type 1 %i",seedsTOF1)); + AliInfo(Form("Number of TOF seeds Type 2 %i",seedsTOF2)); + + // Sort according uncertainties on track position + fTracks->Sort(); + +} +//_________________________________________________________________________ +void AliTOFtrackerV1::MatchTracks( ){ + // + //Match ESD tracks to clusters in TOF + // + + + // Parameters regulating the reconstruction + Float_t dY=fGeom->XPad(); + Float_t dZ=fGeom->ZPad(); + + const Int_t ncmax = 100; + Float_t sensRadius = fRecoParam->GetSensRadius(); + Float_t scaleFact = fRecoParam->GetWindowScaleFact(); + Float_t dyMax=fRecoParam->GetWindowSizeMaxY(); + Float_t dzMax=fRecoParam->GetWindowSizeMaxZ(); + Double_t maxChi2=fRecoParam->GetMaxChi2(); + Bool_t timeWalkCorr = fRecoParam->GetTimeWalkCorr(); + AliDebug(1,"++++++++++++++TOF Reconstruction Parameters:++++++++++++ \n"); + AliDebug(1,Form("TOF sens radius: %f",sensRadius)); + AliDebug(1,Form("TOF Window scale factor: %f",scaleFact)); + AliDebug(1,Form("TOF Window max dy: %f",dyMax)); + AliDebug(1,Form("TOF Window max dz: %f",dzMax)); + AliDebug(1,Form("TOF Max Chi2: %f",maxChi2)); + AliDebug(1,Form("Time Walk Correction? : %d",timeWalkCorr)); + + + //The matching loop + + AliTOFcalib *calib = new AliTOFcalib(fGeom); + + for (Int_t iseed=0; iseedUncheckedAt(iseed); + AliESDtrack *t =(AliESDtrack*)fSeeds->UncheckedAt(track->GetSeedIndex()); + if(t->GetTOFsignal()>0. ) continue; + AliTOFtrack *trackTOFin =new AliTOFtrack(*track); + + // Determine a window around the track + Double_t x,par[5]; trackTOFin->GetExternalParameters(x,par); + Double_t cov[15]; trackTOFin->GetExternalCovariance(cov); + + Double_t z = par[1]; + Double_t dz = scaleFact*3.*TMath::Sqrt(cov[2]+dZ*dZ/12); + Double_t dphi = scaleFact*3.*TMath::Sqrt(cov[0]+dY*dY/12.)/sensRadius; + + Double_t phi=TMath::ATan2(par[0],x) + trackTOFin->GetAlpha(); + if (phi<-TMath::Pi())phi+=2*TMath::Pi(); + if (phi>=TMath::Pi())phi-=2*TMath::Pi(); + + //upper limit on window's size. + if(dz> dzMax) dz=dzMax; + if(dphi*sensRadius> dyMax) dphi=dyMax/sensRadius; + + + // find the clusters inside the selected window + Int_t nc=0; + AliTOFcluster *clusters[ncmax]; // pointers to the clusters in the window + Int_t index[ncmax];//to keep track of the cluster index + for (Int_t k=FindClusterIndex(z-dz); kncmax)break; + if(c->GetZ() > z+dz) break; + if(c->IsUsed()) continue; + if(!c->GetStatus()) continue; // skip bad channels as declared in OCDB + Float_t xyz[3]; c->GetGlobalXYZ(xyz); + Double_t clPhi=TMath::ATan2(xyz[1],xyz[0]); + Double_t dph=TMath::Abs(clPhi-phi); + if (dph>TMath::Pi()) dph-=2.*TMath::Pi(); + if (TMath::Abs(dph)>dphi) continue; + clusters[nc]=c; + index[nc] = k; + nc++; + } + + //start propagation: go to the average TOF pad middle plane at ~378.5 cm + + Float_t xTOF = sensRadius; + Double_t ymax = xTOF*TMath::Tan(0.5*fGeom->GetAlpha()); + Bool_t skip = kFALSE; + Double_t ysect = trackTOFin->GetYat(xTOF,skip); + if (skip) break; + if (ysect > ymax) { + if (!trackTOFin->Rotate(fGeom->GetAlpha())) { + break; + } + } else if (ysect <-ymax) { + if (!trackTOFin->Rotate(fGeom->GetAlpha())) { + break; + } + } + if(!trackTOFin->PropagateTo(xTOF)) { + break; + } + + + AliTOFcluster *bestCluster=0; + Double_t bestChi2=maxChi2; + Int_t idclus=-1; + for (Int_t i=0; iGetPredictedChi2((AliCluster3D*)c); + if (chi2 >= bestChi2) continue; + bestChi2=chi2; + bestCluster=c; + idclus=index[i]; + } + + if (!bestCluster) { // no matching , go to the next track + fnunmatch++; + delete trackTOFin; + continue; + } + + fnmatch++; + bestCluster->Use(); + if ( + (bestCluster->GetLabel(0)==TMath::Abs(trackTOFin->GetLabel())) + || + (bestCluster->GetLabel(1)==TMath::Abs(trackTOFin->GetLabel())) + || + (bestCluster->GetLabel(2)==TMath::Abs(trackTOFin->GetLabel())) + ) { + fngoodmatch++; + AliDebug(2,Form(" track label good %5i",trackTOFin->GetLabel())); + + } + else{ + fnbadmatch++; + AliDebug(2,Form(" track label bad %5i",trackTOFin->GetLabel())); + } + + //Propagate the track to the best matched cluster + trackTOFin->PropagateTo(bestCluster); + + + //now take the local distance in Z from the pad center for time walk correction + Float_t tiltangle = fGeom->GetAngles(bestCluster->GetDetInd(1),bestCluster->GetDetInd(2))*TMath::DegToRad(); + Double_t dzTW=trackTOFin->GetZ()-bestCluster->GetZ(); // in cm + dzTW/=TMath::Cos(tiltangle); + + //update the ESD track and delete the TOFtrack + t->UpdateTrackParams(trackTOFin,AliESDtrack::kTOFout); + delete trackTOFin; + + // Store quantities to be used in the TOF Calibration + Float_t tToT=fGeom->ToTBinWidth()*bestCluster->GetToT()*1E-3; // in ns + t->SetTOFsignalToT(tToT); + Float_t rawTime=fGeom->TdcBinWidth()*bestCluster->GetTDCRAW()+32; // RAW time,in ps + t->SetTOFsignalRaw(rawTime); + t->SetTOFsignalDz(dzTW); + AliDebug(2,Form(" Setting TOF raw time: %f z distance: %f time: %f = ",rawTime,dzTW)); + Int_t ind[5]; + ind[0]=bestCluster->GetDetInd(0); + ind[1]=bestCluster->GetDetInd(1); + ind[2]=bestCluster->GetDetInd(2); + ind[3]=bestCluster->GetDetInd(3); + ind[4]=bestCluster->GetDetInd(4); + Int_t calindex = calib->GetIndex(ind); + t->SetTOFCalChannel(calindex); + + // keep track of the track labels in the matched cluster + Int_t tlab[3]; + tlab[0]=bestCluster->GetLabel(0); + tlab[1]=bestCluster->GetLabel(1); + tlab[2]=bestCluster->GetLabel(2); + AliDebug(2,Form(" tdc time of the matched track %i = ",bestCluster->GetTDC())); + Double_t tof=fGeom->TdcBinWidth()*bestCluster->GetTDC()+32; // in ps + AliDebug(2,Form(" tof time of the matched track: %f = ",tof)); + Double_t tofcorr=tof; + if(timeWalkCorr)tofcorr=CorrectTimeWalk(dzTW,tof); + AliDebug(2,Form(" tof time of the matched track, after TW corr: %f = ",tofcorr)); + //Set TOF time signal and pointer to the matched cluster + t->SetTOFsignal(tofcorr); + t->SetTOFcluster(idclus); // pointing to the recPoints tree + t->SetTOFLabel(tlab); + + Double_t mom=t->GetP(); + // Fill Reco-QA histos for Reconstruction + fHRecNClus->Fill(nc); + fHRecChi2->Fill(bestChi2); + fHRecDistZ->Fill(dzTW); + fHRecSigYVsP->Fill(mom,TMath::Sqrt(cov[0])); + fHRecSigZVsP->Fill(mom,TMath::Sqrt(cov[2])); + fHRecSigYVsPWin->Fill(mom,dphi*sensRadius); + fHRecSigZVsPWin->Fill(mom,dz); + + // Fill Tree for on-the-fly offline Calibration + // no longer there - all info is in the ESDs now + + } + delete calib; + +} +//_________________________________________________________________________ +Int_t AliTOFtrackerV1::LoadClusters(TTree *cTree) { + //-------------------------------------------------------------------- + //This function loads the TOF clusters + //-------------------------------------------------------------------- + + Int_t npadX = fGeom->NpadX(); + Int_t npadZ = fGeom->NpadZ(); + Int_t nStripA = fGeom->NStripA(); + Int_t nStripB = fGeom->NStripB(); + Int_t nStripC = fGeom->NStripC(); + + TBranch *branch=cTree->GetBranch("TOF"); + if (!branch) { + AliError("can't get the branch with the TOF clusters !"); + return 1; + } + + TClonesArray dummy("AliTOFcluster",10000), *clusters=&dummy; + branch->SetAddress(&clusters); + + cTree->GetEvent(0); + Int_t nc=clusters->GetEntriesFast(); + fHDigNClus->Fill(nc); + + for (Int_t i=0; iUncheckedAt(i); + fClusters[i]=new AliTOFcluster(*c); fN++; + + // Fill Digits QA histos + + Int_t isector = c->GetDetInd(0); + Int_t iplate = c->GetDetInd(1); + Int_t istrip = c->GetDetInd(2); + Int_t ipadX = c->GetDetInd(4); + Int_t ipadZ = c->GetDetInd(3); + + Float_t time =(fGeom->TdcBinWidth()*c->GetTDC())*1E-3; // in ns + Float_t tot = (fGeom->TdcBinWidth()*c->GetToT())*1E-3;//in ns + + Int_t stripOffset = 0; + switch (iplate) { + case 0: + stripOffset = 0; + break; + case 1: + stripOffset = nStripC; + break; + case 2: + stripOffset = nStripC+nStripB; + break; + case 3: + stripOffset = nStripC+nStripB+nStripA; + break; + case 4: + stripOffset = nStripC+nStripB+nStripA+nStripB; + break; + default: + AliError(Form("Wrong plate number in TOF (%d) !",iplate)); + break; + }; + Int_t zindex=npadZ*(istrip+stripOffset)+(ipadZ+1); + Int_t phiindex=npadX*isector+ipadX+1; + fHDigClusMap->Fill(zindex,phiindex); + fHDigClusTime->Fill(time); + fHDigClusToT->Fill(tot); + } + + + return 0; +} +//_________________________________________________________________________ +void AliTOFtrackerV1::UnloadClusters() { + //-------------------------------------------------------------------- + //This function unloads TOF clusters + //-------------------------------------------------------------------- + for (Int_t i=0; iGetZ()) return 0; + if (z > fClusters[fN-1]->GetZ()) return fN; + Int_t b=0, e=fN-1, m=(b+e)/2; + for (; b fClusters[m]->GetZ()) b=m+1; + else e=m; + } + return m; +} + +//_________________________________________________________________________ +Bool_t AliTOFtrackerV1::GetTrackPoint(Int_t index, AliTrackPoint& p) const +{ + // Get track space point with index i + // Coordinates are in the global system + AliTOFcluster *cl = fClusters[index]; + Float_t xyz[3]; + cl->GetGlobalXYZ(xyz); + Float_t phi=TMath::ATan2(xyz[1],xyz[0]); + Float_t phiangle = (Int_t(phi*TMath::RadToDeg()/20.)+0.5)*20.*TMath::DegToRad(); + Float_t sinphi = TMath::Sin(phiangle), cosphi = TMath::Cos(phiangle); + Float_t tiltangle = fGeom->GetAngles(cl->GetDetInd(1),cl->GetDetInd(2))*TMath::DegToRad(); + Float_t sinth = TMath::Sin(tiltangle), costh = TMath::Cos(tiltangle); + Float_t sigmay2 = fGeom->XPad()*fGeom->XPad()/12.; + Float_t sigmaz2 = fGeom->ZPad()*fGeom->ZPad()/12.; + Float_t cov[6]; + cov[0] = sinphi*sinphi*sigmay2 + cosphi*cosphi*sinth*sinth*sigmaz2; + cov[1] = -sinphi*cosphi*sigmay2 + sinphi*cosphi*sinth*sinth*sigmaz2; + cov[2] = -cosphi*sinth*costh*sigmaz2; + cov[3] = cosphi*cosphi*sigmay2 + sinphi*sinphi*sinth*sinth*sigmaz2; + cov[4] = -sinphi*sinth*costh*sigmaz2; + cov[5] = costh*costh*sigmaz2; + p.SetXYZ(xyz[0],xyz[1],xyz[2],cov); + + // Detector numbering scheme + Int_t nSector = fGeom->NSectors(); + Int_t nPlate = fGeom->NPlates(); + Int_t nStripA = fGeom->NStripA(); + Int_t nStripB = fGeom->NStripB(); + Int_t nStripC = fGeom->NStripC(); + + Int_t isector = cl->GetDetInd(0); + if (isector >= nSector) + AliError(Form("Wrong sector number in TOF (%d) !",isector)); + Int_t iplate = cl->GetDetInd(1); + if (iplate >= nPlate) + AliError(Form("Wrong plate number in TOF (%d) !",iplate)); + Int_t istrip = cl->GetDetInd(2); + + Int_t stripOffset = 0; + switch (iplate) { + case 0: + stripOffset = 0; + break; + case 1: + stripOffset = nStripC; + break; + case 2: + stripOffset = nStripC+nStripB; + break; + case 3: + stripOffset = nStripC+nStripB+nStripA; + break; + case 4: + stripOffset = nStripC+nStripB+nStripA+nStripB; + break; + default: + AliError(Form("Wrong plate number in TOF (%d) !",iplate)); + break; + }; + + Int_t idet = (2*(nStripC+nStripB)+nStripA)*isector + + stripOffset + + istrip; + UShort_t volid = AliGeomManager::LayerToVolUID(AliGeomManager::kTOF,idet); + p.SetVolumeID((UShort_t)volid); + return kTRUE; +} +//_________________________________________________________________________ +void AliTOFtrackerV1::InitCheckHists() { + + //Init histos for Digits/Reco QA and Calibration + + //Digits "QA" + fHDigClusMap = new TH2F("TOFDig_ClusMap", "",182,0.5,182.5,864, 0.5,864.5); + fHDigNClus = new TH1F("TOFDig_NClus", "",200,0.5,200.5); + fHDigClusTime = new TH1F("TOFDig_ClusTime", "",2000,0.,200.); + fHDigClusToT = new TH1F("TOFDig_ClusToT", "",500,0.,100); + + //Reco "QA" + fHRecNClus =new TH1F("TOFRec_NClusW", "",50,0.5,50.5); + fHRecDistZ=new TH1F("TOFRec_DistZ", "",50,0.5,10.5); + fHRecChi2=new TH1F("TOFRec_Chi2", "",100,0.,10.); + fHRecSigYVsP=new TH2F("TOFDig_SigYVsP", "",40,0.,4.,100, 0.,5.); + fHRecSigZVsP=new TH2F("TOFDig_SigZVsP", "",40,0.,4.,100, 0.,5.); + fHRecSigYVsPWin=new TH2F("TOFDig_SigYVsPWin", "",40,0.,4.,100, 0.,50.); + fHRecSigZVsPWin=new TH2F("TOFDig_SigZVsPWin", "",40,0.,4.,100, 0.,50.); +} + +//_________________________________________________________________________ +void AliTOFtrackerV1::SaveCheckHists() { + + //write histos for Digits/Reco QA and Calibration + + TDirectory *dir = gDirectory; + TFile *logFile = 0; + TFile *logFileTOF = 0; + + TSeqCollection *list = gROOT->GetListOfFiles(); + int n = list->GetEntries(); + for(int i=0; iAt(i); + if (strstr(logFile->GetName(), "AliESDs.root")) break; + } + + Bool_t isThere=kFALSE; + for(int i=0; iAt(i); + if (strstr(logFileTOF->GetName(), "TOFQA.root")){ + isThere=kTRUE; + break; + } + } + + logFile->cd(); + fHDigClusMap->Write(fHDigClusMap->GetName(), TObject::kOverwrite); + fHDigNClus->Write(fHDigNClus->GetName(), TObject::kOverwrite); + fHDigClusTime->Write(fHDigClusTime->GetName(), TObject::kOverwrite); + fHDigClusToT->Write(fHDigClusToT->GetName(), TObject::kOverwrite); + fHRecNClus->Write(fHRecNClus->GetName(), TObject::kOverwrite); + fHRecChi2->Write(fHRecChi2->GetName(), TObject::kOverwrite); + fHRecDistZ->Write(fHRecDistZ->GetName(), TObject::kOverwrite); + fHRecSigYVsP->Write(fHRecSigYVsP->GetName(), TObject::kOverwrite); + fHRecSigZVsP->Write(fHRecSigZVsP->GetName(), TObject::kOverwrite); + fHRecSigYVsPWin->Write(fHRecSigYVsPWin->GetName(), TObject::kOverwrite); + fHRecSigZVsPWin->Write(fHRecSigZVsPWin->GetName(), TObject::kOverwrite); + logFile->Flush(); + + if(!isThere)logFileTOF = new TFile( "TOFQA.root","RECREATE"); + logFileTOF->cd(); + fHDigClusMap->Write(fHDigClusMap->GetName(), TObject::kOverwrite); + fHDigNClus->Write(fHDigNClus->GetName(), TObject::kOverwrite); + fHDigClusTime->Write(fHDigClusTime->GetName(), TObject::kOverwrite); + fHDigClusToT->Write(fHDigClusToT->GetName(), TObject::kOverwrite); + fHRecNClus->Write(fHRecNClus->GetName(), TObject::kOverwrite); + fHRecChi2->Write(fHRecChi2->GetName(), TObject::kOverwrite); + fHRecDistZ->Write(fHRecDistZ->GetName(), TObject::kOverwrite); + fHRecSigYVsP->Write(fHRecSigYVsP->GetName(), TObject::kOverwrite); + fHRecSigZVsP->Write(fHRecSigZVsP->GetName(), TObject::kOverwrite); + fHRecSigYVsPWin->Write(fHRecSigYVsPWin->GetName(), TObject::kOverwrite); + fHRecSigZVsPWin->Write(fHRecSigZVsPWin->GetName(), TObject::kOverwrite); + logFileTOF->Flush(); + + dir->cd(); + } +//_________________________________________________________________________ +Float_t AliTOFtrackerV1::CorrectTimeWalk( Float_t dist, Float_t tof) { + + //dummy, for the moment + Float_t tofcorr=0.; + if(distZPad()*0.5){ + tofcorr=tof; + //place here the actual correction + }else{ + tofcorr=tof; + } + return tofcorr; +} +//_________________________________________________________________________ +Float_t AliTOFtrackerV1::GetTimeZerofromT0(AliESDEvent *event) const { + + //Returns TimeZero as measured by T0 detector + + return event->GetT0(); +} +//_________________________________________________________________________ +Float_t AliTOFtrackerV1::GetTimeZerofromTOF(AliESDEvent * /*event*/) const { + + //dummy, for the moment. T0 algorithm using tracks on TOF + { + //place T0 algo here... + } + return 0.; +} diff --git a/TOF/AliTOFtrackerV1.h b/TOF/AliTOFtrackerV1.h new file mode 100644 index 00000000000..e10c6836454 --- /dev/null +++ b/TOF/AliTOFtrackerV1.h @@ -0,0 +1,97 @@ +#ifndef ALITOFTRACKERV1_H +#define ALITOFTRACKERV1_H + +/* Copyright(c) 1998-1999, ALICE Experiment at CERN, All rights reserved. * + * See cxx source for full Copyright notice */ + +/* $Id$ */ + +//----------------------------------------------------------------------// +// // +// AliTOFtrackerV1 Class // +// Task: Perform association of the ESD tracks to TOF Clusters // +// and Update ESD track with associated TOF Cluster parameters // +// // +// -- Authors : S. Arcelli, C. Zampolli (Bologna University and INFN) // +// -- Contacts: Annalisa.De.Caro@cern.ch // +// -- : Chiara.Zampolli@bo.infn.it // +// -- : Silvia.Arcelli@bo.infn.it // +// // +//----------------------------------------------------------------------// + +#include "AliTracker.h" +#include "AliTOFpidESD.h" + +class TClonesArray; + +class AliESDEvent; + +class AliTOFcluster; +class AliTOFRecoParam; +class AliTOFGeometry; +class TH1F; +class TH2F; + +class AliTOFtrackerV1 : public AliTracker { + +enum {kMaxCluster=77777}; //maximal number of the TOF clusters + +public: + + AliTOFtrackerV1(); + AliTOFtrackerV1(const AliTOFtrackerV1 &t); //Copy Ctor + AliTOFtrackerV1& operator=(const AliTOFtrackerV1 &source); // ass. op. + + virtual ~AliTOFtrackerV1(); + virtual Int_t Clusters2Tracks(AliESDEvent* /*event*/) {return -1;}; + virtual Int_t PropagateBack(AliESDEvent* event); + virtual Int_t RefitInward(AliESDEvent* /*event*/) {return -1;}; + virtual Int_t LoadClusters(TTree * cTree); // Load Clusters + virtual void UnloadClusters();// UnLoad Clusters + virtual AliCluster *GetCluster(Int_t /*index*/) const {return NULL;}; + Bool_t GetTrackPoint(Int_t index, AliTrackPoint& p) const; + void InitCheckHists(); + void SaveCheckHists(); + +private: + + Int_t FindClusterIndex(Double_t z) const; // Returns cluster index + void MatchTracks(); // Matching Algorithm + void CollectESD(); // Select starting Set for Matching + Float_t GetTimeZerofromTOF(AliESDEvent* /*event*/) const; // T0 from TOF + Float_t GetTimeZerofromT0(AliESDEvent* event) const; // T0 from T0 + Float_t CorrectTimeWalk(Float_t dist,Float_t tof); // Time Walk correction + + AliTOFRecoParam* fRecoParam; // Pointer to TOF Recon. Pars + AliTOFGeometry* fGeom; // Pointer to TOF geometry + AliTOFpidESD* fPid; // Pointer to TOF PID + AliTOFcluster *fClusters[kMaxCluster]; // pointers to the TOF clusters + + Int_t fN; // Number of Clusters + Int_t fNseeds; // Number of track seeds + Int_t fNseedsTOF; // TPC BP tracks + Int_t fngoodmatch; // Correctly matched tracks + Int_t fnbadmatch; // Wrongly matched tracks + Int_t fnunmatch; // Unmatched tracks + Int_t fnmatch; // Total matched tracks + + TClonesArray* fTracks; //! pointer to the TClonesArray with TOF tracks + TClonesArray* fSeeds; //! pointer to the TClonesArray with ESD tracks + //Digits/Reco QA histos + + TH2F * fHDigClusMap; //Digits QA, Cluster Map + TH1F * fHDigNClus; //Digits QA, # of clusters on TOF/event + TH1F * fHDigClusTime;//Digits QA, Cluster Time (ns) + TH1F * fHDigClusToT; //Digits QA, Cluster ToT (ns) + TH1F * fHRecNClus; //Reco QA, cluster occupancy in search window + TH1F * fHRecChi2;//Reco QA, track-best TOF cluster chi2 + TH1F * fHRecDistZ;//Reco QA, track-TOF cluster closest distance (cm) + TH2F * fHRecSigYVsP;//Reco QA, track error in Y at TOF inner surface (cm) + TH2F * fHRecSigZVsP; //Reco QA, track error in Z at TOF inner surface (cm) + TH2F * fHRecSigYVsPWin;//Reco QA, search window size in Y (cm) + TH2F * fHRecSigZVsPWin;//Reco QA, search window size in X (cm) + + ClassDef(AliTOFtrackerV1, 1) // TOF tracker +}; + +#endif -- 2.39.3