#include <TClonesArray.h>
#include <TH1F.h>
#include <TH2F.h>
#include <TTree.h>
#include <TBits.h>
#include <TArrayI.h>
#include "AliTrackletAlg.h"
#include "../ITS/AliITSReconstructor.h"
#include "../ITS/AliITSsegmentationSPD.h"
#include "../ITS/AliITSRecPoint.h"
#include "../ITS/AliITSRecPointContainer.h"
#include "../ITS/AliITSgeom.h"
#include "../ITS/AliITSgeomTGeo.h"
#include "../ITS/AliITSDetTypeRec.h"
#include "AliESDEvent.h"
#include "AliESDVertex.h"
#include "AliESDtrack.h"
#include "AliMultiplicity.h"
#include "AliLog.h"
#include "TGeoGlobalMagField.h"
#include "AliMagF.h"
#include "AliESDv0.h"
#include "AliV0.h"
#include "AliKFParticle.h"
#include "AliKFVertex.h"
ClassImp(AliTrackletAlg)
AliTrackletAlg::AliTrackletAlg():
fDetTypeRec(0),fESDEvent(0),fTreeRP(0),fUsedClusLay1(0),fUsedClusLay2(0),
fClustersLay1(0),
fClustersLay2(0),
fDetectorIndexClustersLay1(0),
fDetectorIndexClustersLay2(0),
fOverlapFlagClustersLay1(0),
fOverlapFlagClustersLay2(0),
fTracklets(0),
fSClusters(0),
fNClustersLay1(0),
fNClustersLay2(0),
fNTracklets(0),
fNSingleCluster(0),
fPhiWindow(0),
fThetaWindow(0),
fPhiShift(0),
fRemoveClustersFromOverlaps(0),
fPhiOverlapCut(0),
fZetaOverlapCut(0),
fPhiRotationAngle(0),
fCutPxDrSPDin(0.1),
fCutPxDrSPDout(0.15),
fCutPxDz(0.2),
fCutDCArz(0.5),
fCutMinElectronProbTPC(0.5),
fCutMinElectronProbESD(0.1),
fCutMinP(0.05),
fCutMinRGamma(2.),
fCutMinRK0(1.),
fCutMinPointAngle(0.98),
fCutMaxDCADauther(0.5),
fCutMassGamma(0.03),
fCutMassGammaNSigma(5.),
fCutMassK0(0.03),
fCutMassK0NSigma(5.),
fCutChi2cGamma(2.),
fCutChi2cK0(2.),
fCutGammaSFromDecay(-10.),
fCutK0SFromDecay(-10.),
fCutMaxDCA(1.),
fHistOn(0),
fhClustersDPhiAcc(0),
fhClustersDThetaAcc(0),
fhClustersDPhiAll(0),
fhClustersDThetaAll(0),
fhDPhiVsDThetaAll(0),
fhDPhiVsDThetaAcc(0),
fhetaTracklets(0),
fhphiTracklets(0),
fhetaClustersLay1(0),
fhphiClustersLay1(0){
fNFiredChips[0] = 0;
fNFiredChips[1] = 0;
SetHistOn();
if(AliITSReconstructor::GetRecoParam()) {
SetPhiWindow(AliITSReconstructor::GetRecoParam()->GetTrackleterPhiWindow());
SetThetaWindow(AliITSReconstructor::GetRecoParam()->GetTrackleterThetaWindow());
SetPhiShift(AliITSReconstructor::GetRecoParam()->GetTrackleterPhiShift());
SetRemoveClustersFromOverlaps(AliITSReconstructor::GetRecoParam()->GetTrackleterRemoveClustersFromOverlaps());
SetPhiOverlapCut(AliITSReconstructor::GetRecoParam()->GetTrackleterPhiOverlapCut());
SetZetaOverlapCut(AliITSReconstructor::GetRecoParam()->GetTrackleterZetaOverlapCut());
SetPhiRotationAngle(AliITSReconstructor::GetRecoParam()->GetTrackleterPhiRotationAngle());
SetCutPxDrSPDin(AliITSReconstructor::GetRecoParam()->GetMultCutPxDrSPDin());
SetCutPxDrSPDout(AliITSReconstructor::GetRecoParam()->GetMultCutPxDrSPDout());
SetCutPxDz(AliITSReconstructor::GetRecoParam()->GetMultCutPxDz());
SetCutDCArz(AliITSReconstructor::GetRecoParam()->GetMultCutDCArz());
SetCutMinElectronProbTPC(AliITSReconstructor::GetRecoParam()->GetMultCutMinElectronProbTPC());
SetCutMinElectronProbESD(AliITSReconstructor::GetRecoParam()->GetMultCutMinElectronProbESD());
SetCutMinP(AliITSReconstructor::GetRecoParam()->GetMultCutMinP());
SetCutMinRGamma(AliITSReconstructor::GetRecoParam()->GetMultCutMinRGamma());
SetCutMinRK0(AliITSReconstructor::GetRecoParam()->GetMultCutMinRK0());
SetCutMinPointAngle(AliITSReconstructor::GetRecoParam()->GetMultCutMinPointAngle());
SetCutMaxDCADauther(AliITSReconstructor::GetRecoParam()->GetMultCutMaxDCADauther());
SetCutMassGamma(AliITSReconstructor::GetRecoParam()->GetMultCutMassGamma());
SetCutMassGammaNSigma(AliITSReconstructor::GetRecoParam()->GetMultCutMassGammaNSigma());
SetCutMassK0(AliITSReconstructor::GetRecoParam()->GetMultCutMassK0());
SetCutMassK0NSigma(AliITSReconstructor::GetRecoParam()->GetMultCutMassK0NSigma());
SetCutChi2cGamma(AliITSReconstructor::GetRecoParam()->GetMultCutChi2cGamma());
SetCutChi2cK0(AliITSReconstructor::GetRecoParam()->GetMultCutChi2cK0());
SetCutGammaSFromDecay(AliITSReconstructor::GetRecoParam()->GetMultCutGammaSFromDecay());
SetCutK0SFromDecay(AliITSReconstructor::GetRecoParam()->GetMultCutK0SFromDecay());
SetCutMaxDCA(AliITSReconstructor::GetRecoParam()->GetMultCutMaxDCA());
} else {
SetPhiWindow();
SetThetaWindow();
SetPhiShift();
SetRemoveClustersFromOverlaps();
SetPhiOverlapCut();
SetZetaOverlapCut();
SetPhiRotationAngle();
SetCutPxDrSPDin();
SetCutPxDrSPDout();
SetCutPxDz();
SetCutDCArz();
SetCutMinElectronProbTPC();
SetCutMinElectronProbESD();
SetCutMinP();
SetCutMinRGamma();
SetCutMinRK0();
SetCutMinPointAngle();
SetCutMaxDCADauther();
SetCutMassGamma();
SetCutMassGammaNSigma();
SetCutMassK0();
SetCutMassK0NSigma();
SetCutChi2cGamma();
SetCutChi2cK0();
SetCutGammaSFromDecay();
SetCutK0SFromDecay();
SetCutMaxDCA();
}
fClustersLay1 = 0;
fClustersLay2 = 0;
fDetectorIndexClustersLay1 = 0;
fDetectorIndexClustersLay2 = 0;
fOverlapFlagClustersLay1 = 0;
fOverlapFlagClustersLay2 = 0;
fTracklets = 0;
fSClusters = 0;
Bool_t oldStatus = TH1::AddDirectoryStatus();
TH1::AddDirectory(kFALSE);
fhClustersDPhiAcc = new TH1F("dphiacc", "dphi", 100,-0.1,0.1);
fhClustersDThetaAcc = new TH1F("dthetaacc","dtheta",100,-0.1,0.1);
fhDPhiVsDThetaAcc = new TH2F("dphiVsDthetaAcc","",100,-0.1,0.1,100,-0.1,0.1);
fhClustersDPhiAll = new TH1F("dphiall", "dphi", 100,0.0,0.5);
fhClustersDThetaAll = new TH1F("dthetaall","dtheta",100,0.0,0.5);
fhDPhiVsDThetaAll = new TH2F("dphiVsDthetaAll","",100,0.,0.5,100,0.,0.5);
fhetaTracklets = new TH1F("etaTracklets", "eta", 100,-2.,2.);
fhphiTracklets = new TH1F("phiTracklets", "phi", 100, 0., 2*TMath::Pi());
fhetaClustersLay1 = new TH1F("etaClustersLay1", "etaCl1", 100,-2.,2.);
fhphiClustersLay1 = new TH1F("phiClustersLay1", "phiCl1", 100, 0., 2*TMath::Pi());
TH1::AddDirectory(oldStatus);
}
AliTrackletAlg::AliTrackletAlg(const AliTrackletAlg &mr) :
AliTrackleter(mr),
fDetTypeRec(0),fESDEvent(0),fTreeRP(0),fUsedClusLay1(0),fUsedClusLay2(0),
fClustersLay1(0),
fClustersLay2(0),
fDetectorIndexClustersLay1(0),
fDetectorIndexClustersLay2(0),
fOverlapFlagClustersLay1(0),
fOverlapFlagClustersLay2(0),
fTracklets(0),
fSClusters(0),
fNClustersLay1(0),
fNClustersLay2(0),
fNTracklets(0),
fNSingleCluster(0),
fPhiWindow(0),
fThetaWindow(0),
fPhiShift(0),
fRemoveClustersFromOverlaps(0),
fPhiOverlapCut(0),
fZetaOverlapCut(0),
fPhiRotationAngle(0),
fCutPxDrSPDin(0.1),
fCutPxDrSPDout(0.15),
fCutPxDz(0.2),
fCutDCArz(0.5),
fCutMinElectronProbTPC(0.5),
fCutMinElectronProbESD(0.1),
fCutMinP(0.05),
fCutMinRGamma(2.),
fCutMinRK0(1.),
fCutMinPointAngle(0.98),
fCutMaxDCADauther(0.5),
fCutMassGamma(0.03),
fCutMassGammaNSigma(5.),
fCutMassK0(0.03),
fCutMassK0NSigma(5.),
fCutChi2cGamma(2.),
fCutChi2cK0(2.),
fCutGammaSFromDecay(-10.),
fCutK0SFromDecay(-10.),
fCutMaxDCA(1.),
fHistOn(0),
fhClustersDPhiAcc(0),
fhClustersDThetaAcc(0),
fhClustersDPhiAll(0),
fhClustersDThetaAll(0),
fhDPhiVsDThetaAll(0),
fhDPhiVsDThetaAcc(0),
fhetaTracklets(0),
fhphiTracklets(0),
fhetaClustersLay1(0),
fhphiClustersLay1(0)
{
AliError("May not use");
}
AliTrackletAlg& AliTrackletAlg::operator=(const AliTrackletAlg& mr){
if (this != &mr) {
this->~AliTrackletAlg();
new(this) AliTrackletAlg(mr);
}
return *this;
}
AliTrackletAlg::~AliTrackletAlg(){
delete fhClustersDPhiAcc;
delete fhClustersDThetaAcc;
delete fhClustersDPhiAll;
delete fhClustersDThetaAll;
delete fhDPhiVsDThetaAll;
delete fhDPhiVsDThetaAcc;
delete fhetaTracklets;
delete fhphiTracklets;
delete fhetaClustersLay1;
delete fhphiClustersLay1;
delete[] fUsedClusLay1;
delete[] fUsedClusLay2;
for(Int_t i=0; i<fNTracklets; i++)
delete [] fTracklets[i];
for(Int_t i=0; i<fNSingleCluster; i++)
delete [] fSClusters[i];
delete [] fClustersLay1;
delete [] fClustersLay2;
delete [] fDetectorIndexClustersLay1;
delete [] fDetectorIndexClustersLay2;
delete [] fOverlapFlagClustersLay1;
delete [] fOverlapFlagClustersLay2;
delete [] fTracklets;
delete [] fSClusters;
}
void AliTrackletAlg::Reconstruct(AliESDEvent* esd, TTree* treeRP)
{
if (!treeRP) { AliError(" Invalid ITS cluster tree !\n"); return; }
if (!esd) {AliError("ESDEvent is not available, use old reconstructor"); return;}
if (fMult) delete fMult; fMult = 0;
fNClustersLay1 = 0;
fNClustersLay2 = 0;
fNTracklets = 0;
fNSingleCluster = 0;
fESDEvent = esd;
fTreeRP = treeRP;
Bool_t isVtxOK=kTRUE, isCosmics=kFALSE;
AliESDVertex* vtx = (AliESDVertex*)fESDEvent->GetPrimaryVertexSPD();
if (!vtx || vtx->GetNContributors()<1) isVtxOK = kFALSE;
if (vtx && strstr(vtx->GetTitle(),"cosmics")) {
isVtxOK = kFALSE;
isCosmics = kTRUE;
}
if (!isVtxOK) {
if (!isCosmics) {
AliDebug(1,"Tracklets multiplicity not determined because the primary vertex was not found");
AliDebug(1,"Just counting the number of cluster-fired chips on the SPD layers");
}
vtx = 0;
}
if(vtx){
float vtxf[3] = {static_cast<float>(vtx->GetX()),static_cast<float>(vtx->GetY()),static_cast<float>(vtx->GetZ())};
FindTracklets(vtxf);
}
else {
FindTracklets(0);
}
CreateMultiplicityObject();
}
void AliTrackletAlg::Reconstruct(TTree* clusterTree, Float_t* vtx, Float_t* ) {
if (fMult) delete fMult; fMult = 0;
fNClustersLay1 = 0;
fNClustersLay2 = 0;
fNTracklets = 0;
fNSingleCluster = 0;
if (!clusterTree) { AliError(" Invalid ITS cluster tree !\n"); return; }
fESDEvent = 0;
fTreeRP = clusterTree;
FindTracklets(vtx);
}
void AliTrackletAlg::FindTracklets(const Float_t *vtx)
{
LoadClusterArrays(fTreeRP);
if (fESDEvent) ProcessESDTracks();
if (!vtx) return;
const Double_t pi = TMath::Pi();
Printf("pi %f",pi);
Float_t bz = 0;
AliMagF* field = 0;
if (TGeoGlobalMagField::Instance()) field = dynamic_cast<AliMagF*>(TGeoGlobalMagField::Instance()->GetField());
if (!field)
{
AliError("Could not retrieve magnetic field. Assuming no field. Delta Phi shift will be deactivated in AliTrackletAlg.");
}
else
bz = TMath::Abs(field->SolenoidField());
const Double_t dPhiShift = fPhiShift / 5 * bz;
AliDebug(1, Form("Using phi shift of %f", dPhiShift));
const Double_t dPhiWindow2 = fPhiWindow * fPhiWindow;
const Double_t dThetaWindow2 = fThetaWindow * fThetaWindow;
Int_t* partners = new Int_t[fNClustersLay2];
Float_t* minDists = new Float_t[fNClustersLay2];
Int_t* associatedLay1 = new Int_t[fNClustersLay1];
TArrayI** blacklist = new TArrayI*[fNClustersLay1];
for (Int_t i=0; i<fNClustersLay2; i++) {
partners[i] = -1;
minDists[i] = 2;
}
for (Int_t i=0; i<fNClustersLay1; i++)
associatedLay1[i] = 0;
for (Int_t i=0; i<fNClustersLay1; i++)
blacklist[i] = 0;
AliDebug(1,"Looking for tracklets... ");
for (Int_t iC1=0; iC1<fNClustersLay1; iC1++) {
float *clPar = GetClusterLayer1(iC1);
Float_t x = clPar[kClTh] - vtx[0];
Float_t y = clPar[kClPh] - vtx[1];
Float_t z = clPar[kClZ] - vtx[2];
Float_t r = TMath::Sqrt(x*x + y*y + z*z);
clPar[kClTh] = TMath::ACos(z/r);
clPar[kClPh] = TMath::Pi() + TMath::ATan2(-y,-x);
clPar[kClPh] = clPar[kClPh] + fPhiRotationAngle;
if (fHistOn) {
Float_t eta = clPar[kClTh];
eta= TMath::Tan(eta/2.);
eta=-TMath::Log(eta);
fhetaClustersLay1->Fill(eta);
fhphiClustersLay1->Fill(clPar[kClPh]);
}
}
for (Int_t iC2=0; iC2<fNClustersLay2; iC2++) {
float *clPar = GetClusterLayer2(iC2);
Float_t x = clPar[kClTh] - vtx[0];
Float_t y = clPar[kClPh] - vtx[1];
Float_t z = clPar[kClZ] - vtx[2];
Float_t r = TMath::Sqrt(x*x + y*y + z*z);
clPar[kClTh] = TMath::ACos(z/r);
clPar[kClPh] = TMath::Pi() + TMath::ATan2(-y,-x);
}
Int_t found = 1;
while (found > 0) {
Printf("Found something...");
Printf("cl1...%d",fNClustersLay1);
Printf("cl2...%d",fNClustersLay2);
found = 0;
for (Int_t iC1=0; iC1<fNClustersLay1; iC1++) {
if (associatedLay1[iC1] != 0) continue;
found++;
Int_t iC2WithBestDist = -1;
Double_t minDist = 2;
float* clPar1 = GetClusterLayer1(iC1);
for (Int_t iC2=0; iC2<fNClustersLay2; iC2++) {
float* clPar2 = GetClusterLayer2(iC2);
if (blacklist[iC1]) {
Bool_t blacklisted = kFALSE;
for (Int_t i=blacklist[iC1]->GetSize(); i--;) {
if (blacklist[iC1]->At(i) == iC2) {
blacklisted = kTRUE;
break;
}
}
if (blacklisted) continue;
}
Double_t dTheta = TMath::Abs(clPar2[kClTh] - clPar1[kClTh]);
Double_t dPhi = TMath::Abs(clPar2[kClPh] - clPar1[kClPh]);
if (dPhi>pi) dPhi=2.*pi-dPhi;
if (fHistOn) {
fhClustersDPhiAll->Fill(dPhi);
fhClustersDThetaAll->Fill(dTheta);
fhDPhiVsDThetaAll->Fill(dTheta, dPhi);
}
dPhi -= dPhiShift;
Float_t d = dPhi*dPhi/dPhiWindow2 + dTheta*dTheta/dThetaWindow2;
if (d<1 && d<minDist) {
minDist=d;
iC2WithBestDist = iC2;
}
}
if (minDist<1) {
if (minDists[iC2WithBestDist] > minDist) {
Int_t oldPartner = partners[iC2WithBestDist];
partners[iC2WithBestDist] = iC1;
minDists[iC2WithBestDist] = minDist;
associatedLay1[iC1] = 1;
if (oldPartner != -1) {
if (blacklist[oldPartner] == 0) {
blacklist[oldPartner] = new TArrayI(1);
} else blacklist[oldPartner]->Set(blacklist[oldPartner]->GetSize()+1);
blacklist[oldPartner]->AddAt(iC2WithBestDist, blacklist[oldPartner]->GetSize()-1);
associatedLay1[oldPartner] = 0;
}
} else {
if (blacklist[iC1] == 0) {
blacklist[iC1] = new TArrayI(1);
}
else
blacklist[iC1]->Set(blacklist[iC1]->GetSize()+1);
blacklist[iC1]->AddAt(iC2WithBestDist, blacklist[iC1]->GetSize()-1);
}
} else
associatedLay1[iC1] = 2;
}
}
for (Int_t iC2=0; iC2<fNClustersLay2; iC2++) {
if (partners[iC2] == -1) continue;
if (fRemoveClustersFromOverlaps) FlagClustersInOverlapRegions (partners[iC2],iC2);
Printf("saving tracklets");
if (fOverlapFlagClustersLay1[partners[iC2]] || fOverlapFlagClustersLay2[iC2]) continue;
float* clPar2 = GetClusterLayer2(iC2);
float* clPar1 = GetClusterLayer1(partners[iC2]);
Float_t* tracklet = fTracklets[fNTracklets] = new Float_t[kTrNPar];
tracklet[kTrTheta] = clPar1[kClTh];
tracklet[kTrPhi] = clPar1[kClPh];
tracklet[kTrDPhi] = clPar1[kClPh] - clPar2[kClPh];
if (tracklet[kTrDPhi] > TMath::Pi()) tracklet[kTrDPhi] = tracklet[kTrDPhi]-2.*TMath::Pi();
if (tracklet[kTrDPhi] < -TMath::Pi()) tracklet[kTrDPhi] = tracklet[kTrDPhi]+2.*TMath::Pi();
tracklet[kTrDTheta] = clPar1[kClTh] - clPar2[kClTh];
if (fHistOn) {
fhClustersDPhiAcc->Fill(tracklet[kTrDPhi]);
fhClustersDThetaAcc->Fill(tracklet[kTrDTheta]);
fhDPhiVsDThetaAcc->Fill(tracklet[kTrDTheta],tracklet[kTrDPhi]);
}
Int_t label1 = 0;
Int_t label2 = 0;
while (label2 < 3) {
if ((Int_t) clPar1[kClMC0+label1] != -2 && (Int_t) clPar1[kClMC0+label1] == (Int_t) clPar2[kClMC0+label2])
break;
label1++;
if (label1 == 3) {
label1 = 0;
label2++;
}
}
if (label2 < 3) {
AliDebug(AliLog::kDebug, Form("Found label %d == %d for tracklet candidate %d\n", (Int_t) clPar1[kClMC0+label1], (Int_t) clPar1[kClMC0+label2], fNTracklets));
tracklet[kTrLab1] = clPar1[kClMC0+label1];
tracklet[kTrLab2] = clPar2[kClMC0+label2];
} else {
AliDebug(AliLog::kDebug, Form("Did not find label %d %d %d %d %d %d for tracklet candidate %d\n", (Int_t) clPar1[kClMC0], (Int_t) clPar1[kClMC1], (Int_t) clPar1[kClMC2], (Int_t) clPar2[kClMC0], (Int_t) clPar2[kClMC1], (Int_t) clPar2[kClMC2], fNTracklets));
tracklet[kTrLab1] = clPar1[kClMC0];
tracklet[kTrLab2] = clPar2[kClMC0];
}
if (fHistOn) {
Float_t eta = tracklet[kTrTheta];
eta= TMath::Tan(eta/2.);
eta=-TMath::Log(eta);
fhetaTracklets->Fill(eta);
fhphiTracklets->Fill(tracklet[kTrPhi]);
}
tracklet[kClID1] = partners[iC2];
tracklet[kClID2] = iC2;
AliDebug(1,Form(" Adding tracklet candidate %d ", fNTracklets));
AliDebug(1,Form(" Cl. %d of Layer 1 and %d of Layer 2", partners[iC2], iC2));
fNTracklets++;
associatedLay1[partners[iC2]] = 1;
}
for (Int_t iC1=0; iC1<fNClustersLay1; iC1++) {
float* clPar1 = GetClusterLayer1(iC1);
if (associatedLay1[iC1]==2||associatedLay1[iC1]==0) {
fSClusters[fNSingleCluster] = new Float_t[kClNPar];
fSClusters[fNSingleCluster][kSCTh] = clPar1[kClTh];
fSClusters[fNSingleCluster][kSCPh] = clPar1[kClPh];
fSClusters[fNSingleCluster][kSCLab] = clPar1[kClMC0];
fSClusters[fNSingleCluster][kSCID] = iC1;
AliDebug(1,Form(" Adding a single cluster %d (cluster %d of layer 1)",
fNSingleCluster, iC1));
fNSingleCluster++;
}
}
delete[] partners;
delete[] minDists;
delete[] associatedLay1;
for (Int_t i=0; i<fNClustersLay1; i++)
if (blacklist[i])
delete blacklist[i];
delete[] blacklist;
AliDebug(1,Form("%d tracklets found", fNTracklets));
}
void AliTrackletAlg::CreateMultiplicityObject()
{
TBits fastOrFiredMap,firedChipMap;
if (fDetTypeRec) {
fastOrFiredMap = fDetTypeRec->GetFastOrFiredMap();
firedChipMap = fDetTypeRec->GetFiredChipMap(fTreeRP);
}
fMult = new AliMultiplicity(fNTracklets,fNSingleCluster,fNFiredChips[0],fNFiredChips[1],fastOrFiredMap);
fMult->SetFiredChipMap(firedChipMap);
AliITSRecPointContainer* rcont = AliITSRecPointContainer::Instance();
fMult->SetITSClusters(0,rcont->GetNClustersInLayer(1,fTreeRP));
for(Int_t kk=2;kk<=6;kk++) fMult->SetITSClusters(kk-1,rcont->GetNClustersInLayerFast(kk));
for (int i=fNTracklets;i--;) {
float* tlInfo = fTracklets[i];
fMult->SetTrackletData(i,tlInfo, fUsedClusLay1[int(tlInfo[kClID1])],fUsedClusLay2[int(tlInfo[kClID2])]);
}
for (int i=fNSingleCluster;i--;) {
float* clInfo = fSClusters[i];
fMult->SetSingleClusterData(i,clInfo,fUsedClusLay1[int(clInfo[kSCID])]);
}
fMult->CompactBits();
}
void AliTrackletAlg::LoadClusterArrays(TTree* itsClusterTree)
{
AliDebug(1,"Loading clusters and cluster-fired chips ...");
fNClustersLay1 = 0;
fNClustersLay2 = 0;
fNFiredChips[0] = 0;
fNFiredChips[1] = 0;
AliITSsegmentationSPD seg;
TClonesArray statITSrec("AliITSRecPoint");
TClonesArray* itsClusters= &statITSrec;
TBranch* branch=itsClusterTree->GetBranch("ITSRecPoints");
if(!branch) {
printf("NO itsClusterTree branch available. Skipping...\n");
return;
}
branch->SetAddress(&itsClusters);
static TClonesArray clArr("AliITSRecPoint",100);
for (int il=0;il<2;il++) {
int nclLayer = 0;
int detMin = AliITSgeomTGeo::GetModuleIndex(il+1,1,1);
int detMax = AliITSgeomTGeo::GetModuleIndex(il+2,1,1);
for (int idt=detMin;idt<detMax;idt++) {
branch->GetEvent(idt);
int nClusters = itsClusters->GetEntriesFast();
if (!nClusters) continue;
Int_t nClustersInChip[5] = {0,0,0,0,0};
while(nClusters--) {
AliITSRecPoint* cluster = (AliITSRecPoint*)itsClusters->UncheckedAt(nClusters);
if (!cluster) continue;
new (clArr[nclLayer++]) AliITSRecPoint(*cluster);
Float_t locz = cluster->GetDetLocalZ();
Int_t iChip = seg.GetChipFromLocal(0,locz);
if (iChip>=0)
nClustersInChip[iChip]++;
}
for(Int_t ifChip=5;ifChip--;) if (nClustersInChip[ifChip]) fNFiredChips[il]++;
}
Float_t *z = new Float_t[nclLayer];
Int_t * index = new Int_t[nclLayer];
for (int ic=0;ic<nclLayer;ic++) z[ic] = ((AliITSRecPoint*)clArr[ic])->GetZ();
TMath::Sort(nclLayer,z,index,kFALSE);
Float_t* clustersLay = new Float_t[nclLayer*kClNPar];
Int_t* detectorIndexClustersLay = new Int_t[nclLayer];
Bool_t* overlapFlagClustersLay = new Bool_t[nclLayer];
UInt_t* usedClusLay = new UInt_t[nclLayer];
for (int ic=0;ic<nclLayer;ic++) {
AliITSRecPoint* cluster = (AliITSRecPoint*)clArr[index[ic]];
float* clPar = &clustersLay[ic*kClNPar];
cluster->GetGlobalXYZ( clPar );
detectorIndexClustersLay[ic] = cluster->GetDetectorIndex();
overlapFlagClustersLay[ic] = kFALSE;
usedClusLay[ic] = 0;
for (Int_t i=3;i--;) clPar[kClMC0+i] = cluster->GetLabel(i);
}
clArr.Clear();
delete[] z;
delete[] index;
if (il==0) {
fClustersLay1 = clustersLay;
fOverlapFlagClustersLay1 = overlapFlagClustersLay;
fDetectorIndexClustersLay1 = detectorIndexClustersLay;
fUsedClusLay1 = usedClusLay;
fNClustersLay1 = nclLayer;
}
else {
fClustersLay2 = clustersLay;
fOverlapFlagClustersLay2 = overlapFlagClustersLay;
fDetectorIndexClustersLay2 = detectorIndexClustersLay;
fUsedClusLay2 = usedClusLay;
fNClustersLay2 = nclLayer;
}
}
Printf("LoadClusterArr: N cl1 %d",fNClustersLay1);
Printf("LoadClusterArrN: N cl2 %d",fNClustersLay2);
int nmaxT = TMath::Min(fNClustersLay1, fNClustersLay2);
fTracklets = new Float_t*[nmaxT];
fSClusters = new Float_t*[fNClustersLay1];
for (Int_t i=nmaxT;i--;) fTracklets[i] = 0;
AliDebug(1,Form("(clusters in layer 1 : %d, layer 2: %d)",fNClustersLay1,fNClustersLay2));
AliDebug(1,Form("(cluster-fired chips in layer 1 : %d, layer 2: %d)",fNFiredChips[0],fNFiredChips[1]));
}
void
AliTrackletAlg::LoadClusterFiredChips(TTree* itsClusterTree) {
AliDebug(1,"Loading cluster-fired chips ...");
fNFiredChips[0] = 0;
fNFiredChips[1] = 0;
AliITSsegmentationSPD seg;
AliITSRecPointContainer* rpcont=AliITSRecPointContainer::Instance();
TClonesArray* itsClusters=NULL;
rpcont->FetchClusters(0,itsClusterTree);
if(!rpcont->IsSPDActive()){
AliWarning("No SPD rec points found, multiplicity not calculated");
return;
}
Int_t nSPDmodules=AliITSgeomTGeo::GetModuleIndex(3,1,1);
for (Int_t iIts=0; iIts < nSPDmodules; iIts++) {
itsClusters=rpcont->UncheckedGetClusters(iIts);
Int_t nClusters = itsClusters->GetEntriesFast();
Int_t nClustersInChip[5] = {0,0,0,0,0};
Int_t layer = 0;
while(nClusters--) {
AliITSRecPoint* cluster = (AliITSRecPoint*)itsClusters->UncheckedAt(nClusters);
layer = cluster->GetLayer();
if (layer>1) break;
Float_t locz = cluster->GetDetLocalZ();
Int_t iChip = seg.GetChipFromLocal(0,locz);
if (iChip>=0)
nClustersInChip[iChip]++;
}
if (layer>1) continue;
for(Int_t ifChip=0; ifChip<5; ifChip++) {
if(nClustersInChip[ifChip] >= 1) fNFiredChips[layer]++;
}
}
AliDebug(1,Form("(cluster-fired chips in layer 1 : %d, layer 2: %d)",fNFiredChips[0],fNFiredChips[1]));
}
void
AliTrackletAlg::SaveHists() {
if (!fHistOn)
return;
fhClustersDPhiAll->Write();
fhClustersDThetaAll->Write();
fhDPhiVsDThetaAll->Write();
fhClustersDPhiAcc->Write();
fhClustersDThetaAcc->Write();
fhDPhiVsDThetaAcc->Write();
fhetaTracklets->Write();
fhphiTracklets->Write();
fhetaClustersLay1->Write();
fhphiClustersLay1->Write();
}
void
AliTrackletAlg::FlagClustersInOverlapRegions (Int_t iC1, Int_t iC2WithBestDist) {
Float_t distClSameMod=0.;
Float_t distClSameModMin=0.;
Int_t iClOverlap =0;
Float_t meanRadiusLay1 = 3.99335;
Float_t meanRadiusLay2 = 7.37935;
Float_t zproj1=0.;
Float_t zproj2=0.;
Float_t deZproj=0.;
Float_t* clPar1 = GetClusterLayer1(iC1);
Float_t* clPar2B = GetClusterLayer2(iC2WithBestDist);
for (Int_t iiC1=0; iiC1<fNClustersLay1; iiC1++) {
if (!fOverlapFlagClustersLay1[iiC1]) {
if ((TMath::Abs(fDetectorIndexClustersLay1[iC1]-fDetectorIndexClustersLay1[iiC1])==4)||
(TMath::Abs(fDetectorIndexClustersLay1[iC1]-fDetectorIndexClustersLay1[iiC1])==76)) {
Float_t *clPar11 = GetClusterLayer1(iiC1);
Float_t dePhi=TMath::Abs(clPar11[kClPh]-clPar1[kClPh]);
if (dePhi>TMath::Pi()) dePhi=2.*TMath::Pi()-dePhi;
zproj1=meanRadiusLay1/TMath::Tan(clPar1[kClTh]);
zproj2=meanRadiusLay1/TMath::Tan(clPar11[kClTh]);
deZproj=TMath::Abs(zproj1-zproj2);
distClSameMod = TMath::Sqrt(TMath::Power(deZproj/fZetaOverlapCut,2)+TMath::Power(dePhi/fPhiOverlapCut,2));
if (distClSameMod<=1.) fOverlapFlagClustersLay1[iiC1]=kTRUE;
}
}
}
distClSameMod=0.;
distClSameModMin=0.;
iClOverlap =0;
for (Int_t iiC2=0; iiC2<fNClustersLay2; iiC2++) {
if (!fOverlapFlagClustersLay2[iiC2]) {
Float_t *clPar2 = GetClusterLayer2(iiC2);
if ((TMath::Abs(fDetectorIndexClustersLay2[iC2WithBestDist]-fDetectorIndexClustersLay2[iiC2])==4) ||
(TMath::Abs(fDetectorIndexClustersLay2[iC2WithBestDist]-fDetectorIndexClustersLay2[iiC2])==156)) {
Float_t dePhi=TMath::Abs(clPar2[kClPh]-clPar2B[kClPh]);
if (dePhi>TMath::Pi()) dePhi=2.*TMath::Pi()-dePhi;
zproj1=meanRadiusLay2/TMath::Tan(clPar2B[kClTh]);
zproj2=meanRadiusLay2/TMath::Tan(clPar2[kClTh]);
deZproj=TMath::Abs(zproj1-zproj2);
distClSameMod = TMath::Sqrt(TMath::Power(deZproj/fZetaOverlapCut,2)+TMath::Power(dePhi/fPhiOverlapCut,2));
if (distClSameMod<=1.) fOverlapFlagClustersLay2[iiC2]=kTRUE;
}
}
}
}
void AliTrackletAlg::ProcessESDTracks()
{
if (!fESDEvent) return;
AliESDVertex* vtx = (AliESDVertex*)fESDEvent->GetPrimaryVertexTracks();
if (!vtx || vtx->GetNContributors()<1) vtx = (AliESDVertex*)fESDEvent->GetPrimaryVertexSPD();
if (!vtx || vtx->GetNContributors()<1) {
AliDebug(1,"No primary vertex: cannot flag primary tracks");
return;
}
Int_t ntracks = fESDEvent->GetNumberOfTracks();
for(Int_t itr=0; itr<ntracks; itr++) {
AliESDtrack* track = fESDEvent->GetTrack(itr);
if (!track->IsOn(AliESDtrack::kITSin)) continue;
FlagTrackClusters(itr);
FlagIfSecondary(track,vtx);
}
FlagV0s(vtx);
}
void AliTrackletAlg::FlagTrackClusters(Int_t id)
{
const UInt_t kMaskL = 0x0000ffff;
const UInt_t kMaskH = 0xffff0000;
const UInt_t kMaxTrID = kMaskL - 1;
if (UInt_t(id)>kMaxTrID) return;
const AliESDtrack* track = fESDEvent->GetTrack(id);
Int_t idx[12];
if ( track->GetITSclusters(idx)<3 ) return;
UInt_t *uClus[2] = {fUsedClusLay1,fUsedClusLay2};
UInt_t mark = id+1;
if (track->IsOn(AliESDtrack::kITSpureSA)) mark <<= 16;
for (int i=AliESDfriendTrack::kMaxITScluster;i--;) {
if (idx[i]<0) continue;
int layID= (idx[i] & 0xf0000000) >> 28;
if (layID>1) continue;
int clID = (idx[i] & 0x0fffffff);
if ( track->IsOn(AliESDtrack::kITSpureSA) ) {
if (uClus[layID][clID]&kMaskH) {
AliWarning(Form("Tracks %5d and %5d share cluster %6d of lr%d",id,int(uClus[layID][clID]>>16)-1,clID,layID));
uClus[layID][clID] &= kMaskL;
}
}
else if (uClus[layID][clID]&kMaskL) {
AliWarning(Form("Tracks %5d and %5d share cluster %6d of lr%d",id,int(uClus[layID][clID]&kMaskL)-1,clID,layID));
uClus[layID][clID] &= kMaskH;
}
uClus[layID][clID] |= mark;
}
}
void AliTrackletAlg::FlagIfSecondary(AliESDtrack* track, const AliVertex* vtx)
{
double cut = (track->HasPointOnITSLayer(0)||track->HasPointOnITSLayer(1)) ? fCutPxDrSPDin:fCutPxDrSPDout;
float xz[2];
track->GetDZ(vtx->GetX(),vtx->GetY(),vtx->GetZ(), fESDEvent->GetMagneticField(), xz);
if (TMath::Abs(xz[0]*track->P())>cut || TMath::Abs(xz[1]*track->P())>fCutPxDz ||
TMath::Abs(xz[0])>fCutDCArz || TMath::Abs(xz[1])>fCutDCArz)
track->SetStatus(AliESDtrack::kMultSec);
else track->ResetStatus(AliESDtrack::kMultSec);
}
void AliTrackletAlg::FlagV0s(const AliESDVertex *vtx)
{
const double kK0Mass = 0.4976;
AliV0 pvertex;
AliKFVertex vertexKF;
AliKFParticle epKF0,epKF1,pipmKF0,piKF0,piKF1,gammaKF,k0KF;
Double_t mass,massErr,chi2c;
enum {kKFIni=BIT(14)};
double recVtx[3];
float recVtxF[3];
vtx->GetXYZ(recVtx);
for (int i=3;i--;) recVtxF[i] = recVtx[i];
int ntracks = fESDEvent->GetNumberOfTracks();
if (ntracks<2) return;
vertexKF.X() = recVtx[0];
vertexKF.Y() = recVtx[1];
vertexKF.Z() = recVtx[2];
vertexKF.Covariance(0,0) = vtx->GetXRes()*vtx->GetXRes();
vertexKF.Covariance(1,2) = vtx->GetYRes()*vtx->GetYRes();
vertexKF.Covariance(2,2) = vtx->GetZRes()*vtx->GetZRes();
AliESDtrack *trc0,*trc1;
for (int it0=0;it0<ntracks;it0++) {
trc0 = fESDEvent->GetTrack(it0);
if (trc0->IsOn(AliESDtrack::kMultInV0)) continue;
if (!trc0->IsOn(AliESDtrack::kITSin)) continue;
Bool_t isSAP = trc0->IsPureITSStandalone();
Int_t q0 = trc0->Charge();
Bool_t testGamma = CanBeElectron(trc0);
epKF0.ResetBit(kKFIni);
piKF0.ResetBit(kKFIni);
double bestChi2=1e16;
int bestID = -1;
for (int it1=it0+1;it1<ntracks;it1++) {
trc1 = fESDEvent->GetTrack(it1);
if (trc1->IsOn(AliESDtrack::kMultInV0)) continue;
if (!trc1->IsOn(AliESDtrack::kITSin)) continue;
if (trc1->IsPureITSStandalone() != isSAP) continue;
if ( (q0+trc1->Charge())!=0 ) continue;
pvertex.SetParamN(q0<0 ? *trc0:*trc1);
pvertex.SetParamP(q0>0 ? *trc0:*trc1);
pvertex.Update(recVtxF);
if (pvertex.P()<fCutMinP) continue;
if (pvertex.GetV0CosineOfPointingAngle()<fCutMinPointAngle) continue;
if (pvertex.GetDcaV0Daughters()>fCutMaxDCADauther) continue;
double d = pvertex.GetD(recVtx[0],recVtx[1],recVtx[2]);
if (d>fCutMaxDCA) continue;
double dx=recVtx[0]-pvertex.Xv(), dy=recVtx[1]-pvertex.Yv();
double rv = TMath::Sqrt(dx*dx+dy*dy);
Bool_t gammaOK = kFALSE;
while (testGamma && CanBeElectron(trc1)) {
if (rv<fCutMinRGamma) break;
if (!epKF0.TestBit(kKFIni)) {
new(&epKF0) AliKFParticle(*trc0,q0>0 ? kPositron:kElectron);
epKF0.SetBit(kKFIni);
}
new(&epKF1) AliKFParticle(*trc1,q0<0 ? kPositron:kElectron);
gammaKF.Initialize();
gammaKF += epKF0;
gammaKF += epKF1;
gammaKF.SetProductionVertex(vertexKF);
gammaKF.GetMass(mass,massErr);
if (mass>fCutMassGamma || (massErr>0&&(mass>massErr*fCutMassGammaNSigma))) break;
if (gammaKF.GetS()<fCutGammaSFromDecay) break;
gammaKF.SetMassConstraint(0.,0.001);
chi2c = (gammaKF.GetNDF()!=0) ? gammaKF.GetChi2()/gammaKF.GetNDF() : 1000;
if (chi2c>fCutChi2cGamma) break;
gammaOK = kTRUE;
if (chi2c>bestChi2) break;
bestChi2 = chi2c;
bestID = it1;
break;
}
if (gammaOK) continue;
while (1) {
if (rv<fCutMinRK0) break;
if (!piKF0.TestBit(kKFIni)) {
new(&piKF0) AliKFParticle(*trc0,q0>0 ? kPiPlus:kPiMinus);
piKF0.SetBit(kKFIni);
}
new(&piKF1) AliKFParticle(*trc1,q0<0 ? kPiPlus:kPiMinus);
k0KF.Initialize();
k0KF += piKF0;
k0KF += piKF1;
k0KF.SetProductionVertex(vertexKF);
k0KF.GetMass(mass,massErr);
mass -= kK0Mass;
if (TMath::Abs(mass)>fCutMassK0 || (massErr>0&&(abs(mass)>massErr*fCutMassK0NSigma))) break;
if (k0KF.GetS()<fCutK0SFromDecay) break;
k0KF.SetMassConstraint(kK0Mass,0.001);
chi2c = (k0KF.GetNDF()!=0) ? k0KF.GetChi2()/k0KF.GetNDF() : 1000;
if (chi2c>fCutChi2cK0) break;
if (chi2c>bestChi2) break;
bestChi2 = chi2c;
bestID = it1;
break;
}
}
if (bestID>=0) {
trc0->SetStatus(AliESDtrack::kMultInV0);
fESDEvent->GetTrack(bestID)->SetStatus(AliESDtrack::kMultInV0);
}
}
}
Bool_t AliTrackletAlg::CanBeElectron(const AliESDtrack* trc) const
{
Double_t pid[AliPID::kSPECIES];
if (!trc->IsOn(AliESDtrack::kESDpid)) return kTRUE;
trc->GetESDpid(pid);
return (trc->IsOn(AliESDtrack::kTPCpid)) ?
pid[AliPID::kElectron]>fCutMinElectronProbTPC :
pid[AliPID::kElectron]>fCutMinElectronProbESD;
}