]> git.uio.no Git - u/mrichter/AliRoot.git/blame - PWGJE/EMCALJetTasks/UserTasks/AliAnalysisTaskJetV2.h
try to fix compilation problem in call to destructor, move some specific AOD methods...
[u/mrichter/AliRoot.git] / PWGJE / EMCALJetTasks / UserTasks / AliAnalysisTaskJetV2.h
CommitLineData
eae37c5c 1/* Copyright(c) 1998-1999, ALICE Experiment at CERN, All rights reserved. */
2/* See cxx source for full Copyright notice */
3/* $Id$ */
4
5#ifndef AliAnalysisTaskJetV2_H
6#define AliAnalysisTaskJetV2_H
7
8#include <AliAnalysisTaskEmcalJet.h>
9#include <AliEmcalJet.h>
10#include <AliVEvent.h>
11#include <AliVParticle.h>
12#include <AliVCluster.h>
13#include <TClonesArray.h>
14#include <TMath.h>
15#include <TArrayD.h>
16#include <TRandom3.h>
17#include <AliJetContainer.h>
18#include <AliParticleContainer.h>
19
20class TF1;
21class THF1;
22class THF2;
23class TProfile;
24class AliLocalRhoParameter;
25class AliClusterContainer;
26class AliVTrack;
27
28class AliAnalysisTaskJetV2 : public AliAnalysisTaskEmcalJet {
29 public:
30 // enumerators
31 enum fitModulationType { kNoFit, kV2, kV3, kCombined, kFourierSeries, kIntegratedFlow, kQC2, kQC4 }; // fit type
32 enum fitGoodnessTest { kChi2ROOT, kChi2Poisson, kKolmogorov, kKolmogorovTOY, kLinearFit };
6c3fa11d 33 enum collisionType { kPbPb, kPythia, kPbPb10h, kPbPb11h }; // collision type, kPbPb = 11h, kept for backward compatibilitiy
eae37c5c 34 enum qcRecovery { kFixedRho, kNegativeVn, kTryFit }; // how to deal with negative cn value for qcn value
35 enum runModeType { kLocal, kGrid }; // run mode type
36 enum dataType { kESD, kAOD, kESDMC, kAODMC }; // data type
6c3fa11d 37 enum detectorType { kTPC, kVZEROA, kVZEROC, kVZEROComb}; // detector that was used for event plane
eae37c5c 38 enum analysisType { kCharged, kFull }; // analysis type
39 // constructors, destructor
40 AliAnalysisTaskJetV2();
41 AliAnalysisTaskJetV2(const char *name, runModeType type);
42 virtual ~AliAnalysisTaskJetV2();
43 // setting up the task and technical aspects
44 void ExecOnce();
f41baaab 45 virtual Bool_t Notify();
eae37c5c 46 Bool_t InitializeAnalysis();
47 virtual void UserCreateOutputObjects();
48 virtual Bool_t Run();
49 TH1F* BookTH1F(const char* name, const char* x, Int_t bins, Double_t min, Double_t max, Int_t c = -1, Bool_t append = kTRUE);
50 TH2F* BookTH2F(const char* name, const char* x, const char* y, Int_t binsx, Double_t minx, Double_t maxx, Int_t binsy, Double_t miny, Double_t maxy, Int_t c = -1, Bool_t append = kTRUE);
51 /* inline */ Double_t PhaseShift(Double_t x) const {
52 while (x>=TMath::TwoPi())x-=TMath::TwoPi();
53 while (x<0.)x+=TMath::TwoPi();
54 return x; }
55 /* inline */ Double_t PhaseShift(Double_t x, Double_t n) const {
56 x = PhaseShift(x);
57 if(TMath::Nint(n)==2) while (x>TMath::Pi()) x-=TMath::Pi();
58 if(TMath::Nint(n)==3) {
59 if(x>2.*TMath::TwoPi()/n) x = TMath::TwoPi() - x;
60 if(x>TMath::TwoPi()/n) x = TMath::TwoPi()-(x+TMath::TwoPi()/n);
61 }
62 return x; }
63 /* inline */ Double_t ChiSquarePDF(Int_t ndf, Double_t x) const {
64 Double_t n(ndf/2.), denom(TMath::Power(2, n)*TMath::Gamma(n));
65 if (denom!=0) return ((1./denom)*TMath::Power(x, n-1)*TMath::Exp(-x/2.));
66 return -999; }
67 // note that the cdf of the chisquare distribution is the normalized lower incomplete gamma function
68 /* inline */ Double_t ChiSquareCDF(Int_t ndf, Double_t x) const { return TMath::Gamma(ndf/2., x/2.); }
69 /* inline */ Double_t ChiSquare(TH1& histo, TF1* func) const {
70 // evaluate the chi2 using a poissonian error estimate on bins
71 Double_t chi2(0.);
72 for(Int_t i(0); i < histo.GetXaxis()->GetNbins(); i++) {
73 if(histo.GetBinContent(i+1) <= 0.) continue;
74 chi2 += TMath::Power((histo.GetBinContent(i+1)-func->Eval(histo.GetXaxis()->GetBinCenter(1+i))), 2)/histo.GetBinContent(i+1);
75 }
76 return chi2;
77 }
78 /* inline*/ Double_t KolmogorovTest(TH1F& histo, TF1* func) const {
79 // return the probability from a Kolmogorov test
6c3fa11d 80 return .5;
eae37c5c 81 TH1F test(histo); // stack copy of test statistic
82 for(Int_t i(0); i < test.GetXaxis()->GetNbins(); i++) test.SetBinContent(i+1, func->Eval(test.GetXaxis()->GetBinCenter(1+i)));
83 if(fFitGoodnessTest == kKolmogorovTOY) return histo.TH1::KolmogorovTest((&test), "X");
84 return histo.TH1::KolmogorovTest((&test));
85 }
86
87 // setters - analysis setup
88 void SetDebugMode(Int_t d) {fDebug = d;}
89 void SetRunToyMC(Bool_t t) {fRunToyMC = t; }
90 void SetAttachToEvent(Bool_t b) {fAttachToEvent = b;}
91 void SetFillHistograms(Bool_t b) {fFillHistograms = b;}
92 void SetFillQAHistograms(Bool_t qa) {fFillQAHistograms = qa;}
93 void SetReduceBinsXYByFactor(Float_t x, Float_t y) {fReduceBinsXByFactor = x;
94 fReduceBinsYByFactor = y;}
95 void SetNoEventWeightsForQC(Bool_t e) {fNoEventWeightsForQC = e;}
96 void SetCentralityClasses(TArrayD* c) {fCentralityClasses = c;}
97 void SetExpectedRuns(TArrayI* r) {fExpectedRuns = r;}
98 void SetExpectedSemiGoodRuns(TArrayI* r) {fExpectedSemiGoodRuns = r;}
99 void SetIntegratedFlow(TH1F* i, TH1F* j) {fUserSuppliedV2 = i;
100 fUserSuppliedV3 = j; }
101 void SetOnTheFlyResCorrection(TH1F* r2, TH1F* r3) {fUserSuppliedR2 = r2;
102 fUserSuppliedR3 = r3; }
103 void SetNameRhoSmall(TString name) {fNameSmallRho = name; }
104 void SetRandomSeed(TRandom3* r) {if (fRandom) delete fRandom; fRandom = r; }
105 void SetModulationFit(TF1* fit);
106 void SetUseControlFit(Bool_t c);
107 void SetModulationFitMinMaxP(Float_t m, Float_t n) {fMinPvalue = m; fMaxPvalue = n; }
108 void SetModulationFitType(fitModulationType type) {fFitModulationType = type; }
109 void SetGoodnessTest(fitGoodnessTest test) {fFitGoodnessTest = test; }
110 void SetQCnRecoveryType(qcRecovery type) {fQCRecovery = type; }
111 void SetModulationFitOptions(TString opt) {fFitModulationOptions = opt; }
112 void SetReferenceDetector(detectorType type) {fDetectorType = type; }
113 void SetAnalysisType(analysisType type) {fAnalysisType = type; }
114 void SetCollisionType(collisionType type) {fCollisionType = type; }
115 void SetUsePtWeight(Bool_t w) {
116 fUsePtWeight = w;
117 if(!fUsePtWeight) fUsePtWeightErrorPropagation = kFALSE; }
118 void SetUsePtWeightErrorPropagation(Bool_t w) {fUsePtWeightErrorPropagation = w; }
119 void SetRunModeType(runModeType type) {fRunModeType = type; }
120 void SetAbsVertexZ(Float_t v) {fAbsVertexZ = v; }
121 void SetMinDistanceRctoLJ(Float_t m) {fMinDisanceRCtoLJ = m; }
122 void SetMaxNoRandomCones(Int_t m) {fMaxCones = m; }
123 void SetExcludeLeadingJetsFromFit(Float_t n) {fExcludeLeadingJetsFromFit = n; }
124 void SetRebinSwapHistoOnTheFly(Bool_t r) {fRebinSwapHistoOnTheFly = r; }
125 void SetSaveThisPercentageOfFits(Float_t p) {fPercentageOfFits = p; }
126 void SetUseV0EventPlaneFromHeader(Bool_t h) {fUseV0EventPlaneFromHeader = h;}
a008f846 127// void SetExplicitOutlierCutForYear(Int_t y) {fExplicitOutlierCut = y;}
eae37c5c 128 // getters - these are used as well by AliAnalyisTaskJetFlow, so be careful when changing them
129 TString GetJetsName() const {return GetJetContainer()->GetArrayName(); }
130 TString GetTracksName() const {return GetParticleContainer()->GetArrayName(); }
131 TString GetLocalRhoName() const {return fLocalRhoName; }
132 TArrayD* GetCentralityClasses() const {return fCentralityClasses;}
133 TProfile* GetResolutionParameters(Int_t h, Int_t c) const {return (h==2) ? fProfV2Resolution[c] : fProfV3Resolution[c];}
134 TList* GetOutputList() const {return fOutputList;}
135 AliLocalRhoParameter* GetLocalRhoParameter() const {return fLocalRho;}
136 Double_t GetJetRadius() const {return GetJetContainer()->GetJetRadius();}
137 /* inline */ AliEmcalJet* GetLeadingJet() {
138 // return pointer to the highest pt jet (before background subtraction) within acceptance
139 // only rudimentary cuts are applied on this level, hence the implementation outside of
140 // the framework
141 Int_t iJets(fJets->GetEntriesFast());
142 Double_t pt(0);
143 AliEmcalJet* leadingJet(0x0);
144 for(Int_t i(0); i < iJets; i++) {
145 AliEmcalJet* jet = static_cast<AliEmcalJet*>(fJets->At(i));
146 if(!PassesSimpleCuts(jet)) continue;
147 if(jet->Pt() > pt) {
148 leadingJet = jet;
149 pt = leadingJet->Pt();
150 }
151 }
152 return leadingJet;
153 }
154 void ExecMe() {ExecOnce();}
155 AliAnalysisTaskJetV2* ReturnMe() {return this;}
156 // local cuts
157 void SetSoftTrackMinMaxPt(Float_t min, Float_t max) {fSoftTrackMinPt = min; fSoftTrackMaxPt = max;}
158 void SetSemiGoodJetMinMaxPhi(Double_t a, Double_t b) {fSemiGoodJetMinPhi = a; fSemiGoodJetMaxPhi = b;}
159 void SetSemiGoodTrackMinMaxPhi(Double_t a, Double_t b) {fSemiGoodTrackMinPhi = a; fSemiGoodTrackMaxPhi = b;}
160 // numerical evaluations
161 void CalculateEventPlaneVZERO(Double_t vzero[2][2]) const;
162 void CalculateEventPlaneTPC(Double_t* tpc);
163 void CalculateEventPlaneCombinedVZERO(Double_t* comb) const;
164 void CalculateEventPlaneResolution(Double_t vzero[2][2], Double_t* vzeroComb, Double_t* tpc);
165 void CalculateRandomCone(
166 Float_t &pt,
167 Float_t &eta,
168 Float_t &phi,
169 AliParticleContainer* tracksCont,
170 AliClusterContainer* clusterCont = 0x0,
171 AliEmcalJet* jet = 0x0
172 ) const;
173 Double_t CalculateQC2(Int_t harm);
174 Double_t CalculateQC4(Int_t harm);
175 // helper calculations for the q-cumulant analysis, also used by AliAnalyisTaskJetFlow
176 void QCnQnk(Int_t n, Int_t k, Double_t &reQ, Double_t &imQ);
177 void QCnDiffentialFlowVectors(
178 TClonesArray* pois, TArrayD* ptBins, Bool_t vpart, Double_t* repn, Double_t* impn,
179 Double_t *mp, Double_t *reqn, Double_t *imqn, Double_t* mq, Int_t n);
180 Double_t QCnS(Int_t i, Int_t j);
181 Double_t QCnM();
182 Double_t QCnM11();
183 Double_t QCnM1111();
184 Bool_t QCnRecovery(Double_t psi2, Double_t psi3);
185 // analysis details
186 Bool_t CorrectRho(Double_t psi2, Double_t psi3);
187 // event and track selection, also used by AliAnalyisTaskJetFlow
188 /* inline */ Bool_t PassesCuts(AliVParticle* track) const { return AcceptTrack(track, 0); }
189 /* inline */ Bool_t PassesCuts(AliEmcalJet* jet) { return AcceptJet(jet, 0); }
190 /* inline */ Bool_t PassesCuts(AliVCluster* clus) const { return AcceptCluster(clus, 0); }
191 /* inline */ Bool_t PassesSimpleCuts(AliEmcalJet* jet) {
192 Float_t minPhi(GetJetContainer()->GetJetPhiMin()), maxPhi(GetJetContainer()->GetJetPhiMax());
193 Float_t minEta(GetJetContainer()->GetJetEtaMin()), maxEta(GetJetContainer()->GetJetEtaMax());
194 return (jet && jet->Pt() > 1. && jet->Eta() > minEta && jet->Eta() < maxEta && jet->Phi() > minPhi && jet->Phi() < maxPhi && jet->Area() > .557*GetJetRadius()*GetJetRadius()*TMath::Pi());
195 }
196 Bool_t PassesCuts(AliVEvent* event);
a008f846 197 /*Bool_t PassesCuts(Int_t year);*/
eae37c5c 198 Bool_t PassesCuts(const AliVCluster* track) const;
199 // filling histograms
200 void FillHistogramsAfterSubtraction(Double_t psi2, Double_t vzero[2][2], Double_t* vzeroComb, Double_t* tpc);
201 void FillTrackHistograms() const;
202 void FillClusterHistograms() const;
203 void FillEventPlaneHistograms(Double_t vzero[2][2], Double_t* vzeroComb, Double_t* tpc) const;
204 void FillRhoHistograms();
205 void FillDeltaPtHistograms(Double_t psi2) const;
206 void FillJetHistograms(Double_t psi2);
207 void FillQAHistograms(AliVTrack* vtrack) const;
208 void FillQAHistograms(AliVEvent* vevent);
209 void FillAnalysisSummaryHistogram() const;
210 virtual void Terminate(Option_t* option);
211 // interface methods for the output file
212 void SetOutputList(TList* l) {fOutputList = l;}
213 TH1F* GetResolutionFromOuptutFile(detectorType detector, Int_t h = 2, TArrayD* c = 0x0);
214 TH1F* CorrectForResolutionDiff(TH1F* v, detectorType detector, TArrayD* cen, Int_t c, Int_t h = 2);
215 TH1F* CorrectForResolutionInt(TH1F* v, detectorType detector, TArrayD* cen, Int_t h = 2);
216 TH1F* GetDifferentialQC(TProfile* refCumulants, TProfile* diffCumlants, TArrayD* ptBins, Int_t h);
217 private:
218 // analysis flags and settings
219 Int_t fDebug; // debug level (0 none, 1 fcn calls, 2 verbose)
220 Bool_t fRunToyMC; // run toy mc for fit routine
221 Bool_t fLocalInit; //! is the analysis initialized?
222 Bool_t fAttachToEvent; // attach local rho to the event
223 Bool_t fFillHistograms; // fill histograms
224 Bool_t fFillQAHistograms; // fill qa histograms
225 Float_t fReduceBinsXByFactor; // reduce the bins on x-axis of histo's by this much
226 Float_t fReduceBinsYByFactor; // reduce the bins on y-axis of histo's by this much
227 Bool_t fNoEventWeightsForQC; // don't store event weights for qc analysis
228 TArrayD* fCentralityClasses; //-> centrality classes (maximum 10)
229 TArrayI* fExpectedRuns; //-> array of expected run numbers, used for QA
230 TArrayI* fExpectedSemiGoodRuns; //-> array of expected semi-good runs, used for cuts and QA
231 TH1F* fUserSuppliedV2; // histo with integrated v2
232 TH1F* fUserSuppliedV3; // histo with integrated v3
233 TH1F* fUserSuppliedR2; // correct the extracted v2 with this r
234 TH1F* fUserSuppliedR3; // correct the extracted v3 with this r
235 AliParticleContainer* fTracksCont; //! tracks
236 AliClusterContainer* fClusterCont; //! cluster container
237 AliJetContainer* fJetsCont; //! jets
238 AliEmcalJet* fLeadingJet; //! leading jet
239 // members
240 Int_t fNAcceptedTracks; //! number of accepted tracks
241 Int_t fNAcceptedTracksQCn; //! accepted tracks for QCn
242 fitModulationType fFitModulationType; // fit modulation type
243 fitGoodnessTest fFitGoodnessTest; // fit goodness test type
244 qcRecovery fQCRecovery; // recovery type for e-by-e qc method
245 Bool_t fUsePtWeight; // use dptdphi instead of dndphi
246 Bool_t fUsePtWeightErrorPropagation; // recalculate the bin errors in case of pt weighting
247 detectorType fDetectorType; // type of detector used for modulation fit
248 analysisType fAnalysisType; // analysis type (full or charged jets)
249 TString fFitModulationOptions; // fit options for modulation fit
250 runModeType fRunModeType; // run mode type
251 dataType fDataType; // datatype
252 collisionType fCollisionType; // collision type
253 TRandom3* fRandom; //-> dont use gRandom to not interfere with other tasks
254 Int_t fRunNumber; //! current runnumber (for QA and jet, track selection)
255 Int_t fMappedRunNumber; //! mapped runnumer (for QA)
256 Int_t fInCentralitySelection; //! centrality bin
257 TF1* fFitModulation; //-> modulation fit for rho
258 TF1* fFitControl; //-> control fit
259 Float_t fMinPvalue; // minimum value of p
260 Float_t fMaxPvalue; // maximum value of p
261 TString fNameSmallRho; // name of small rho
262 AliRhoParameter* fCachedRho; //! temp cache for rho pointer
263 // additional jet cuts (most are inherited)
264 Float_t fSoftTrackMinPt; // min pt for soft tracks
265 Float_t fSoftTrackMaxPt; // max pt for soft tracks
266 Double_t fSemiGoodJetMinPhi; // min phi for semi good tpc runs
267 Double_t fSemiGoodJetMaxPhi; // max phi for semi good tpc runs
268 Double_t fSemiGoodTrackMinPhi; // min phi for semi good tpc runs
269 Double_t fSemiGoodTrackMaxPhi; // max phi for semi good tpc runs
270 // event cuts
271 Float_t fAbsVertexZ; // cut on zvertex
272 // general qa histograms
273 TH1F* fHistCentrality; //! accepted centrality
274 TH1F* fHistVertexz; //! accepted verte
275 TH2F* fHistRunnumbersPhi; //! run numbers averaged phi
276 TH2F* fHistRunnumbersEta; //! run numbers averaged eta
277 TH1F* fHistPvalueCDFROOT; //! pdf value of chisquare p
278 TH2F* fHistPvalueCDFROOTCent; //! p value versus centrlaity from root
279 TH2F* fHistChi2ROOTCent; //! reduced chi2 from ROOT, centrality correlation
280 TH2F* fHistPChi2Root; //! correlation p value and reduced chi2
281 TH1F* fHistPvalueCDF; //! cdf value of chisquare p
282 TH2F* fHistPvalueCDFCent; //! p value vs centrality
283 TH2F* fHistChi2Cent; //! reduced chi2, centrlaity correlation
284 TH2F* fHistPChi2; //! correlation p value and reduced chi2
285 TH1F* fHistKolmogorovTest; //! KolmogorovTest value
286 TH2F* fHistKolmogorovTestCent;//! KolmogorovTest value, centrality correlation
287 TH2F* fHistPKolmogorov; //! p value vs kolmogorov value
288 TH2F* fHistRhoStatusCent; //! status of rho as function of centrality
289 TH1F* fHistUndeterminedRunQA; //! undetermined run QA
290 // general settings
291 Float_t fMinDisanceRCtoLJ; // min distance between rc and leading jet
292 Int_t fMaxCones; // max number of random cones
293 Float_t fExcludeLeadingJetsFromFit; // exclude n leading jets from fit
294 Bool_t fRebinSwapHistoOnTheFly; // rebin swap histo on the fly
295 Float_t fPercentageOfFits; // save this percentage of fits
296 Bool_t fUseV0EventPlaneFromHeader; // use the vzero event plane from the header
a008f846 297// Int_t fExplicitOutlierCut; // cut on correlation of tpc and global multiplicity
eae37c5c 298 // transient object pointers
299 TList* fOutputList; //! output list
300 TList* fOutputListGood; //! output list for local analysis
301 TList* fOutputListBad; //! output list for local analysis
302 TH1F* fHistAnalysisSummary; //! analysis summary
303 TH1F* fHistSwap; //! swap histogram
304 TProfile* fProfV2; //! extracted v2
305 TProfile* fProfV2Cumulant; //! v2 cumulant
306 TProfile* fProfV2Resolution[10]; //! resolution parameters for v2
307 TProfile* fProfV3; //! extracted v3
308 TProfile* fProfV3Cumulant; //! v3 cumulant
309 TProfile* fProfV3Resolution[10]; //! resolution parameters for v3
310 // qa histograms for accepted pico tracks
311 TH1F* fHistPicoTrackPt[10]; //! pt of all charged tracks
312 TH1F* fHistPicoTrackMult[10]; //! multiplicity of accepted pico tracks
313 TH2F* fHistPicoCat1[10]; //! pico tracks spd hit and refit
314 TH2F* fHistPicoCat2[10]; //! pico tracks wo spd hit w refit, constrained
315 TH2F* fHistPicoCat3[10]; //! pico tracks wo spd hit wo refit, constrained
316 // qa histograms for accepted emcal clusters
317 TH1F* fHistClusterPt[10]; //! pt emcal clusters
318 TH2F* fHistClusterEtaPhi[10]; //! eta phi emcal clusters
319 TH2F* fHistClusterEtaPhiWeighted[10]; //! eta phi emcal clusters, pt weighted
320 // qa event planes
321 TProfile* fHistPsiControl; //! event plane control histogram
322 TProfile* fHistPsiSpread; //! event plane spread histogram
323 TH1F* fHistPsiVZEROA; //! psi 2 from vzero a
324 TH1F* fHistPsiVZEROC; //! psi 2 from vzero c
325 TH1F* fHistPsiVZERO; //! psi 2 from combined vzero
326 TH1F* fHistPsiTPC; //! psi 2 from tpc
327 TH2F* fHistPsiVZEROAV0M; //! psi 2 from vzero a
328 TH2F* fHistPsiVZEROCV0M; //! psi 2 from vzero c
329 TH2F* fHistPsiVZEROVV0M; //! psi 2 from combined vzero
330 TH2F* fHistPsiTPCiV0M; //! psi 2 from tpc
331 TH2F* fHistPsiVZEROATRK; //! psi 2 from vzero a
332 TH2F* fHistPsiVZEROCTRK; //! psi 2 from vzero c
333 TH2F* fHistPsiVZEROTRK; //! psi 2 from combined vzero
334 TH2F* fHistPsiTPCTRK; //! psi 2 from tpc
335 // background
336 TH1F* fHistRhoPackage[10]; //! rho as estimated by emcal jet package
337 TH1F* fHistRho[10]; //! background
338 TH2F* fHistRhoVsMult; //! rho versus multiplicity
339 TH2F* fHistRhoVsCent; //! rho veruss centrality
340 TH2F* fHistRhoAVsMult; //! rho * A vs multiplicity for all jets
341 TH2F* fHistRhoAVsCent; //! rho * A vs centrality for all jets
342 // delta pt distributions
343 TH2F* fHistRCPhiEta[10]; //! random cone eta and phi
344 TH2F* fHistRhoVsRCPt[10]; //! rho * A vs rcpt
345 TH1F* fHistRCPt[10]; //! rcpt
346 TH2F* fHistDeltaPtDeltaPhi2[10]; //! dpt vs dphi (psi2 - phi)
347 TH2F* fHistDeltaPtDeltaPhi2Rho0[10]; //! dpt vs dphi, rho_0
348 TH2F* fHistRCPhiEtaExLJ[10]; //! random cone eta and phi, excl leading jet
349 TH2F* fHistRhoVsRCPtExLJ[10]; //! rho * A vs rcpt, excl leading jet
350 TH1F* fHistRCPtExLJ[10]; //! rcpt, excl leading jet
351 TH2F* fHistDeltaPtDeltaPhi2ExLJ[10]; //! dpt vs dphi, excl leading jet
352 TH2F* fHistDeltaPtDeltaPhi2ExLJRho0[10]; //! dpt vs dphi, excl leading jet, rho_0
353 // jet histograms (after kinematic cuts)
354 TH1F* fHistJetPtRaw[10]; //! jet pt - no background subtraction
355 TH1F* fHistJetPt[10]; //! pt of found jets (background subtracted)
356 TH2F* fHistJetEtaPhi[10]; //! eta and phi correlation
357 TH2F* fHistJetPtArea[10]; //! jet pt versus area
358 TH2F* fHistJetPtEta[10]; //! jet pt versus eta (temp control)
359 TH2F* fHistJetPtConstituents[10]; //! jet pt versus number of constituents
360 TH2F* fHistJetEtaRho[10]; //! jet eta versus rho
361 // in plane, out of plane jet spectra
362 TH2F* fHistJetPsi2Pt[10]; //! event plane dependence of jet pt
363 TH2F* fHistJetPsi2PtRho0[10]; //! event plane dependence of jet pt vs rho_0
364
365 AliAnalysisTaskJetV2(const AliAnalysisTaskJetV2&); // not implemented
366 AliAnalysisTaskJetV2& operator=(const AliAnalysisTaskJetV2&); // not implemented
367
a008f846 368 ClassDef(AliAnalysisTaskJetV2, 2);
eae37c5c 369};
370
371#endif