X-Git-Url: http://git.uio.no/git/?a=blobdiff_plain;f=ITS%2FAliITSVertexerZ.cxx;h=21c86d1a86e1141362a0a79384956831a6ba5986;hb=a9d2ffa786657bd507a244516bcbb32ba2e7a63b;hp=d97b164113a79eef6fbec70f7ae3c844e2fae132;hpb=8b40a6b84b6d4ab20a20287bf6d755ac01e27392;p=u%2Fmrichter%2FAliRoot.git diff --git a/ITS/AliITSVertexerZ.cxx b/ITS/AliITSVertexerZ.cxx index d97b164113a..21c86d1a86e 100644 --- a/ITS/AliITSVertexerZ.cxx +++ b/ITS/AliITSVertexerZ.cxx @@ -15,17 +15,14 @@ #include "AliITSVertexerZ.h" #include #include -#include #include #include #include -#include "AliITSLoader.h" -#include "AliITSgeom.h" -#include "AliITSDetTypeRec.h" +#include "AliESDVertex.h" +#include "AliITSgeomTGeo.h" #include "AliITSRecPoint.h" +#include "AliITSRecPointContainer.h" #include "AliITSZPoint.h" -#include "AliHeader.h" -#include "AliGenEventHeader.h" ///////////////////////////////////////////////////////////////// // this class implements a fast method to determine @@ -46,8 +43,6 @@ fLastL1(0), fFirstL2(0), fLastL2(0), fDiffPhiMax(0), -fX0(0.), -fY0(0.), fZFound(0), fZsig(0.), fZCombc(0), @@ -71,14 +66,12 @@ fWindowWidth(0) { } //______________________________________________________________________ -AliITSVertexerZ::AliITSVertexerZ(TString fn, Float_t x0, Float_t y0):AliITSVertexer(fn), +AliITSVertexerZ::AliITSVertexerZ(Float_t x0, Float_t y0):AliITSVertexer(), fFirstL1(0), fLastL1(0), fFirstL2(0), fLastL2(0), fDiffPhiMax(0), -fX0(x0), -fY0(y0), fZFound(0), fZsig(0.), fZCombc(0), @@ -99,40 +92,10 @@ fWindowWidth(0) { SetPPsetting(); ConfigIterations(); SetWindowWidth(); + SetVtxStart((Double_t)x0,(Double_t)y0,0.); } -//______________________________________________________________________ -AliITSVertexerZ::AliITSVertexerZ(const AliITSVertexerZ &vtxr) : AliITSVertexer(vtxr), -fFirstL1(vtxr.fFirstL1), -fLastL1(vtxr.fLastL1), -fFirstL2(vtxr.fFirstL2), -fLastL2(vtxr.fLastL2), -fDiffPhiMax(vtxr.fDiffPhiMax), -fX0(vtxr.fX0), -fY0(vtxr.fY0), -fZFound(vtxr.fZFound), -fZsig(vtxr.fZsig), -fZCombc(vtxr.fZCombc), -fLowLim(vtxr.fLowLim), -fHighLim(vtxr.fHighLim), -fStepCoarse(vtxr.fStepCoarse), -fTolerance(vtxr.fTolerance), -fMaxIter(vtxr.fMaxIter), -fWindowWidth(vtxr.fWindowWidth){ - // Copy constructor - -} - -//______________________________________________________________________ -AliITSVertexerZ& AliITSVertexerZ::operator=(const AliITSVertexerZ& vtxr ){ - // Assignment operator - - this->~AliITSVertexerZ(); - new(this) AliITSVertexerZ(vtxr); - return *this; -} - //______________________________________________________________________ AliITSVertexerZ::~AliITSVertexerZ() { // Destructor @@ -143,7 +106,7 @@ AliITSVertexerZ::~AliITSVertexerZ() { void AliITSVertexerZ::ConfigIterations(Int_t noiter,Float_t *ptr){ // configure the iterative procedure to gain efficiency for // pp events with very low multiplicity - Float_t defaults[5]={0.05,0.1,0.2,0.3,0.5}; + Float_t defaults[5]={0.02,0.05,0.1,0.2,0.3}; fMaxIter=noiter; if(noiter>5){ Error("ConfigIterations","Maximum number of iterations is 5\n"); @@ -154,7 +117,7 @@ void AliITSVertexerZ::ConfigIterations(Int_t noiter,Float_t *ptr){ } //______________________________________________________________________ -Int_t AliITSVertexerZ::GetPeakRegion(TH1F*h, Int_t &binmin, Int_t &binmax) const { +Int_t AliITSVertexerZ::GetPeakRegion(TH1F*h, Int_t &binmin, Int_t &binmax){ // Finds a region around a peak in the Z histogram // Case of 2 peaks is treated Int_t imax=h->GetNbinsX(); @@ -204,91 +167,56 @@ Int_t AliITSVertexerZ::GetPeakRegion(TH1F*h, Int_t &binmin, Int_t &binmax) const return npeaks; } //______________________________________________________________________ -AliESDVertex* AliITSVertexerZ::FindVertexForCurrentEvent(Int_t evnumber){ +AliESDVertex* AliITSVertexerZ::FindVertexForCurrentEvent(TTree *itsClusterTree){ // Defines the AliESDVertex for the current event - VertexZFinder(evnumber); + VertexZFinder(itsClusterTree); Int_t ntrackl=0; for(Int_t iteraz=0;iterazGetNContributors(); if(!fCurrentVertex || ntrackl==0 || ntrackl==-1){ Float_t diffPhiMaxOrig=fDiffPhiMax; fDiffPhiMax=GetPhiMaxIter(iteraz); - VertexZFinder(evnumber); + VertexZFinder(itsClusterTree); fDiffPhiMax=diffPhiMaxOrig; } } - FindMultiplicity(evnumber); + if(fComputeMultiplicity) FindMultiplicity(itsClusterTree); return fCurrentVertex; } - - - //______________________________________________________________________ -void AliITSVertexerZ::VertexZFinder(Int_t evnumber){ +void AliITSVertexerZ::VertexZFinder(TTree *itsClusterTree){ // Defines the AliESDVertex for the current event fCurrentVertex = 0; - AliRunLoader *rl =AliRunLoader::GetRunLoader(); - AliITSLoader* itsLoader = (AliITSLoader*)rl->GetLoader("ITSLoader"); - AliITSgeom* geom = itsLoader->GetITSgeom(); - itsLoader->LoadRecPoints(); - rl->GetEvent(evnumber); - - AliITSDetTypeRec detTypeRec; - - TTree *tR = itsLoader->TreeR(); - detTypeRec.SetTreeAddressR(tR); + Double_t startPos[3]={GetNominalPos()[0],GetNominalPos()[1],GetNominalPos()[2]}; + Double_t startCov[6]={GetNominalCov()[0],GetNominalCov()[1],GetNominalCov()[2], + GetNominalCov()[3],GetNominalCov()[4],GetNominalCov()[5]}; + ResetVertex(); TClonesArray *itsRec = 0; - // lc and gc are local and global coordinates for layer 1 - Float_t lc[3]; for(Int_t ii=0; ii<3; ii++) lc[ii]=0.; - Float_t gc[3]; for(Int_t ii=0; ii<3; ii++) gc[ii]=0.; + // lc1 and gc1 are local and global coordinates for layer 1 + Float_t gc1[3]={0.,0.,0.}; // ; for(Int_t ii=0; ii<3; ii++) gc1[ii]=0.; // lc2 and gc2 are local and global coordinates for layer 2 - Float_t lc2[3]; for(Int_t ii=0; ii<3; ii++) lc2[ii]=0.; - Float_t gc2[3]; for(Int_t ii=0; ii<3; ii++) gc2[ii]=0.; - - itsRec = detTypeRec.RecPoints(); - TBranch *branch; - branch = tR->GetBranch("ITSRecPoints"); + Float_t gc2[3]={0.,0.,0.}; //; for(Int_t ii=0; ii<3; ii++) gc2[ii]=0.; + AliITSRecPointContainer* rpcont=AliITSRecPointContainer::Instance(); + itsRec=rpcont->FetchClusters(0,itsClusterTree); + if(!rpcont->IsSPDActive()){ + AliWarning("Null pointer for RecPoints branch, vertex not calculated"); + ResetHistograms(); + fCurrentVertex = new AliESDVertex(startPos,startCov,99999.,-2); + return; + } Int_t nrpL1 = 0; Int_t nrpL2 = 0; - // By default fFirstL1=0 and fLastL1=79 - // This loop counts the number of recpoints on layer1 (central modules) - for(Int_t module= fFirstL1; module<=fLastL1;module++){ - // Keep only central modules - // if(module%4==0 || module%4==3)continue; - // cout<<"Procesing module "<GetEvent(module); - // cout<<"Number of clusters "<GetEntries()<GetEntries(); - detTypeRec.ResetRecPoints(); - } - //By default fFirstL2=80 and fLastL2=239 - //This loop counts the number of RP on layer 2 - for(Int_t module= fFirstL2; module<=fLastL2;module++){ - branch->GetEvent(module); - nrpL2+= itsRec->GetEntries(); - detTypeRec.ResetRecPoints(); - } + nrpL1=rpcont->GetNClustersInLayerFast(1); + nrpL2=rpcont->GetNClustersInLayerFast(2); + if(nrpL1 == 0 || nrpL2 == 0){ + AliDebug(1,Form("No RecPoints in at least one SPD layer (%d %d)",nrpL1,nrpL2)); ResetHistograms(); - itsLoader->UnloadRecPoints(); - fCurrentVertex = new AliESDVertex(0.,5.3,-2); + fCurrentVertex = new AliESDVertex(startPos,startCov,99999.,-2); return; } - // The vertex finding is attempted only if the number of RP is !=0 on - // both layers - Float_t *xc1 = new Float_t [nrpL1]; // coordinates of the L1 Recpoints - Float_t *yc1 = new Float_t [nrpL1]; - Float_t *zc1 = new Float_t [nrpL1]; - Float_t *phi1 = new Float_t [nrpL1]; - Float_t *err1 = new Float_t [nrpL1]; - Float_t *xc2 = new Float_t [nrpL2]; // coordinates of the L1 Recpoints - Float_t *yc2 = new Float_t [nrpL2]; - Float_t *zc2 = new Float_t [nrpL2]; - Float_t *phi2 = new Float_t [nrpL2]; - Float_t *err2 = new Float_t [nrpL2]; - Int_t ind = 0;// running index for RP // Force a coarse bin size of 200 microns if the number of clusters on layer 2 // is low if(nrpL2GetEvent(module); - Int_t nrecp1 = itsRec->GetEntries(); - for(Int_t j=0;jAt(j); - // Local coordinates of this recpoint - lc[0]=recp->GetDetLocalX(); - lc[2]=recp->GetDetLocalZ(); - geom->LtoG(module,lc,gc); - // Global coordinates of this recpoints - gc[0]-=fX0; // Possible beam offset in the bending plane - gc[1]-=fY0; // " " - xc1[ind]=gc[0]; - yc1[ind]=gc[1]; - zc1[ind]=gc[2]; - // azimuthal angle is computed in the interval 0 --> 2*pi - phi1[ind] = TMath::ATan2(gc[1],gc[0]); - if(phi1[ind]<0)phi1[ind]=2*TMath::Pi()+phi1[ind]; - err1[ind]=recp->GetSigmaZ2(); - ind++; - } - detTypeRec.ResetRecPoints(); - } - ind = 0; // the running index is reset for Layer 2 - for(Int_t module= fFirstL2; module<=fLastL2;module++){ - branch->GetEvent(module); - Int_t nrecp2 = itsRec->GetEntries(); - for(Int_t j=0;jAt(j); - lc[0]=recp->GetDetLocalX(); - lc[2]=recp->GetDetLocalZ(); - geom->LtoG(module,lc,gc); - gc[0]-=fX0; - gc[1]-=fY0; - xc2[ind]=gc[0]; - yc2[ind]=gc[1]; - zc2[ind]=gc[2]; - phi2[ind] = TMath::ATan2(gc[1],gc[0]); - if(phi2[ind]<0)phi2[ind]=2*TMath::Pi()+phi2[ind]; - err2[ind]=recp->GetSigmaZ2(); - ind++; - } - detTypeRec.ResetRecPoints(); - } - -/* Test the ffect of mutiple scatternig on error. Negligible + /* Test the ffect of mutiple scatternig on error. Negligible // Multiple scattering Float_t beta=1.,pmed=0.875; //pmed=875 MeV (for tracks with dphi<0.01 rad) Float_t beta2=beta*beta; @@ -356,62 +236,98 @@ void AliITSVertexerZ::VertexZFinder(Int_t evnumber){ Float_t theta2BP=14.1*14.1/(beta2*p2*1e6)*TMath::Abs(dBP); Float_t theta2L1=14.1*14.1/(beta2*p2*1e6)*TMath::Abs(dL1); */ - TClonesArray *points = new TClonesArray("AliITSZPoint",nrpL1*nrpL2); - TClonesArray &pts = *points; + Int_t nEntriesMod[kNSPDMod]; + TClonesArray* recpArr[kNSPDMod]; + for(Int_t modul=0; modulUncheckedGetClusters(modul); + nEntriesMod[modul]=recpArr[modul]->GetEntriesFast(); + } + } + + Int_t maxdim=TMath::Min(nrpL1*nrpL2,50000); // temporary; to limit the size in PbPb + static TClonesArray points("AliITSZPoint",maxdim); Int_t nopoints =0; - for(Int_t i=0;iTMath::Pi())diff=2.*TMath::Pi()-diff; //diffFill(zr0); + for(Int_t modul1= fFirstL1; modul1<=fLastL1;modul1++){ // Loop on modules of layer 1 + if(!fUseModule[modul1]) continue; + UShort_t ladder=int(modul1/4)+1; // ladders are numbered starting from 1 + TClonesArray *prpl1=recpArr[modul1]; //rpcont->UncheckedGetClusters(modul1); + Int_t nrecp1 = nEntriesMod[modul1]; //prpl1->GetEntries(); + for(Int_t j1=0;j1At(j1); + recp1->GetGlobalXYZ(gc1); + gc1[0]-=GetNominalPos()[0]; // Possible beam offset in the bending plane + gc1[1]-=GetNominalPos()[1]; // " " + Float_t phi1 = TMath::ATan2(gc1[1],gc1[0]); + if(phi1<0)phi1+=TMath::TwoPi(); + for(Int_t ladl2=0 ; ladl2AliITSgeomTGeo::GetNLadders(2)) ladmod=ladmod-AliITSgeomTGeo::GetNLadders(2); + Int_t modul2=AliITSgeomTGeo::GetModuleIndex(2,ladmod,k+1); + if(!fUseModule[modul2]) continue; + itsRec=recpArr[modul2]; // rpcont->UncheckedGetClusters(modul2); + Int_t nrecp2 = nEntriesMod[modul2]; // itsRec->GetEntries(); + for(Int_t j2=0;j2At(j2); + recp2->GetGlobalXYZ(gc2); + gc2[0]-=GetNominalPos()[0]; + gc2[1]-=GetNominalPos()[1]; + Float_t phi2 = TMath::ATan2(gc2[1],gc2[0]); + if(phi2<0)phi2+=TMath::TwoPi(); + + Float_t diff = TMath::Abs(phi2-phi1); + if(diff>TMath::Pi())diff=TMath::TwoPi()-diff; + if(diffGetSigmaZ2(); + Float_t r2=TMath::Sqrt(gc2[0]*gc2[0]+gc2[1]*gc2[1]); + Float_t zc2=gc2[2]; + Float_t erz2=recp2->GetSigmaZ2(); + // Float_t tgth=(zc2[j]-zc1[i])/(r2-r1); // slope (used for multiple scattering) + Float_t zr0=(r2*zc1-r1*zc2)/(r2-r1); //Z @ null radius + Float_t ezr0q=(r2*r2*erz1+r1*r1*erz2)/((r2-r1)*(r2-r1)); //error on Z @ null radius + /* + // Multiple scattering + ezr0q+=r1*r1*(1+tgth*tgth)*theta2L1/2; // multiple scattering in layer 1 + ezr0q+=rBP*rBP*(1+tgth*tgth)*theta2BP/2; // multiple scattering in beam pipe + */ + if(nopointsFill(zr0); + } + } + } } } } - delete [] xc1; - delete [] yc1; - delete [] zc1; - delete [] phi1; - delete [] err1; - delete [] xc2; - delete [] yc2; - delete [] zc2; - delete [] phi2; - delete [] err2; - points->Sort(); + points.Sort(); Double_t contents = fZCombc->GetEntries()- fZCombc->GetBinContent(0)-fZCombc->GetBinContent(nbincoarse+1); if(contents<1.){ // Warning("FindVertexForCurrentEvent","Insufficient number of rec. points\n"); ResetHistograms(); - itsLoader->UnloadRecPoints(); - fCurrentVertex = new AliESDVertex(0.,5.3,-1); + fCurrentVertex = new AliESDVertex(startPos,startCov,99999.,-1); + points.Clear(); return; } TH1F *hc = fZCombc; - if(hc->GetBinContent(hc->GetMaximumBin())<3)hc->Rebin(3); + if(hc->GetBinContent(hc->GetMaximumBin())<3)hc->Rebin(4); Int_t binmin,binmax; Int_t nPeaks=GetPeakRegion(hc,binmin,binmax); - if(nPeaks==2)AliWarning("2 peaks found"); + if(nPeaks==2)AliDebug(2,"2 peaks found"); Float_t zm =0.; Float_t ezm =0.; Float_t lim1 = hc->GetBinLowEdge(binmin); Float_t lim2 = hc->GetBinLowEdge(binmax)+hc->GetBinWidth(binmax); + Float_t widthSR=lim2-lim1; if(nPeaks ==1 && (lim2-lim1)GetEntriesFast(); i++){ - AliITSZPoint* p=(AliITSZPoint*)points->UncheckedAt(i); + for(Int_t i =0; iGetZ()>lim1 && p->GetZ()GetErrZ(); zm+=p->GetZ()/deno; @@ -439,17 +355,58 @@ void AliITSVertexerZ::VertexZFinder(Int_t evnumber){ ncontr++; } } - zm/=ezm; - ezm=TMath::Sqrt(1./ezm); + if(ezm>0) { + zm/=ezm; + ezm=TMath::Sqrt(1./ezm); + } niter++; } while(niter<10 && TMath::Abs((zm-lim1)-(lim2-zm))>fTolerance); - fCurrentVertex = new AliESDVertex(zm,ezm,ncontr); - fCurrentVertex->SetTitle("vertexer: B"); + if(nPeaks==2) ezm=widthSR; + Double_t position[3]={GetNominalPos()[0],GetNominalPos()[1],zm}; + Double_t covmatrix[6]={GetNominalCov()[0],0.,GetNominalCov()[2],0.,0.,ezm}; + fCurrentVertex = new AliESDVertex(position,covmatrix,99999.,ncontr); + fCurrentVertex->SetTitle("vertexer: Z"); + fCurrentVertex->SetDispersion(fDiffPhiMax); + fNoVertices=1; + points.Clear(); + if(ncontr>fMinTrackletsForPilup){ + Float_t secPeakPos; + Int_t ncontr2=FindSecondPeak(fZCombc,binmin,binmax,secPeakPos); + if(ncontr2>=fMinTrackletsForPilup){ + fIsPileup=kTRUE; + fNoVertices=2; + fZpuv=secPeakPos; + fNTrpuv=ncontr2; + AliESDVertex secondVert(secPeakPos,0.1,ncontr2); + fVertArray = new AliESDVertex[2]; + fVertArray[0]=(*fCurrentVertex); + fVertArray[1]=secondVert; + } + } + if(fNoVertices==1){ + fVertArray = new AliESDVertex[1]; + fVertArray[0]=(*fCurrentVertex); + } + ResetHistograms(); - itsLoader->UnloadRecPoints(); return; } +//_____________________________________________________________________ +Int_t AliITSVertexerZ::FindSecondPeak(TH1F* h, Int_t binmin,Int_t binmax, Float_t& secPeakPos){ + for(Int_t i=binmin-1;i<=binmax+1;i++){ + h->SetBinContent(i,0.); + } + Int_t secPeakBin=h->GetMaximumBin(); + secPeakPos=h->GetBinCenter(secPeakBin); + Int_t secPeakCont=(Int_t)h->GetBinContent(secPeakBin); + secPeakCont+=(Int_t)h->GetBinContent(secPeakBin-1); + secPeakCont+=(Int_t)h->GetBinContent(secPeakBin+1); + secPeakCont+=(Int_t)h->GetBinContent(secPeakBin-2); + secPeakCont+=(Int_t)h->GetBinContent(secPeakBin+2); + return secPeakCont; +} + //_____________________________________________________________________ void AliITSVertexerZ::ResetHistograms(){ // delete TH1 data members @@ -457,22 +414,6 @@ void AliITSVertexerZ::ResetHistograms(){ fZCombc = 0; } -//______________________________________________________________________ -void AliITSVertexerZ::FindVertices(){ - // computes the vertices of the events in the range FirstEvent - LastEvent - AliRunLoader *rl = AliRunLoader::GetRunLoader(); - AliITSLoader* itsLoader = (AliITSLoader*) rl->GetLoader("ITSLoader"); - itsLoader->ReloadRecPoints(); - for(Int_t i=fFirstEvent;i<=fLastEvent;i++){ - // cout<<"Processing event "<GetEvent(i); - FindVertexForCurrentEvent(i); - if(fCurrentVertex){ - WriteCurrentVertex(); - } - } -} - //________________________________________________________ void AliITSVertexerZ::PrintStatus() const { // Print current status @@ -485,9 +426,6 @@ void AliITSVertexerZ::PrintStatus() const { cout <<"Limits for Z histograms: "<