]> git.uio.no Git - u/mrichter/AliRoot.git/blobdiff - PWGJE/EMCALJetTasks/UserTasks/AliAnalysisTaskJetV2.h
Merge branch 'feature-movesplit'
[u/mrichter/AliRoot.git] / PWGJE / EMCALJetTasks / UserTasks / AliAnalysisTaskJetV2.h
index 8e486afd202056df9eb59b2c3aa73f5724fef96e..e024488c5c6c1cb5968c387f336bc2aa1c436628 100644 (file)
@@ -5,6 +5,9 @@
 #ifndef AliAnalysisTaskJetV2_H
 #define AliAnalysisTaskJetV2_H
 
+// uncomment to compile with debug information
+//#define DEBUGTASK
+
 #include <AliAnalysisTaskEmcalJet.h>
 #include <AliEmcalJet.h>
 #include <AliVEvent.h>
 #include <AliJetContainer.h>
 #include <AliParticleContainer.h>
 
+class TFile;
 class TF1;
-class THF1;
-class THF2;
+class TH1F;
+class TH2F;
+class TH3F;
 class TProfile;
 class AliLocalRhoParameter;
 class AliClusterContainer;
@@ -30,11 +35,11 @@ class AliAnalysisTaskJetV2 : public AliAnalysisTaskEmcalJet {
          // enumerators
         enum fitModulationType  { kNoFit, kV2, kV3, kCombined, kFourierSeries, kIntegratedFlow, kQC2, kQC4 }; // fit type
         enum fitGoodnessTest    { kChi2ROOT, kChi2Poisson, kKolmogorov, kKolmogorovTOY, kLinearFit };
-        enum collisionType      { kPbPb, kPythia };                     // collision type
+        enum collisionType      { kPbPb, kPythia, kPbPb10h, kPbPb11h, kJetFlowMC }; // collision type, kPbPb = 11h, kept for backward compatibilitiy
         enum qcRecovery         { kFixedRho, kNegativeVn, kTryFit };    // how to deal with negative cn value for qcn value
         enum runModeType        { kLocal, kGrid };                      // run mode type
-        enum dataType           { kESD, kAOD, kESDMC, kAODMC };         // data type
-        enum detectorType       { kTPC, kVZEROA, kVZEROC, kVZEROComb};  // detector that was used
+        enum dataType           { kESD, kAOD, kESDMC, kAODMC};          // data type
+        enum detectorType       { kTPC, kVZEROA, kVZEROC, kVZEROComb, kFixedEP};  // detector that was used for event plane
         enum analysisType       { kCharged, kFull };                    // analysis type
         // constructors, destructor
                                 AliAnalysisTaskJetV2();
@@ -42,16 +47,19 @@ class AliAnalysisTaskJetV2 : public AliAnalysisTaskEmcalJet {
         virtual                 ~AliAnalysisTaskJetV2();
         // setting up the task and technical aspects
         void                    ExecOnce();
+        virtual Bool_t          Notify();
         Bool_t                  InitializeAnalysis();
         virtual void            UserCreateOutputObjects();
+        virtual void            Exec(Option_t *);
         virtual Bool_t          Run();
         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);
         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);
-        /* inline */    Double_t PhaseShift(Double_t x) const {  
+        TH3F*                   BookTH3F(const char* name, const char* x, const char* y, const char* z, Int_t binsx, Double_t minx, Double_t maxx, Int_t binsy, Double_t miny, Double_t maxy, Int_t binsz, Double_t minz, Double_t maxz, Int_t c = -1, Bool_t append = kTRUE);
+        /* inline */    static Double_t PhaseShift(Double_t x) {  
             while (x>=TMath::TwoPi())x-=TMath::TwoPi();
             while (x<0.)x+=TMath::TwoPi();
             return x; }
-        /* inline */    Double_t PhaseShift(Double_t x, Double_t n) const {
+        /* inline */    static Double_t PhaseShift(Double_t x, Double_t n) {
             x = PhaseShift(x);
             if(TMath::Nint(n)==2) while (x>TMath::Pi()) x-=TMath::Pi();
             if(TMath::Nint(n)==3) {
@@ -59,13 +67,15 @@ class AliAnalysisTaskJetV2 : public AliAnalysisTaskEmcalJet {
                 if(x>TMath::TwoPi()/n) x = TMath::TwoPi()-(x+TMath::TwoPi()/n);
             }
             return x; }
-        /* inline */    Double_t ChiSquarePDF(Int_t ndf, Double_t x) const {
+        /* inline */    static Bool_t   IsInPlane(Double_t dPhi) {
+            return (dPhi < -1.*TMath::Pi()/4. || dPhi > TMath::Pi()/4.); }
+        /* inline */    static Double_t ChiSquarePDF(Int_t ndf, Double_t x) {
             Double_t n(ndf/2.), denom(TMath::Power(2, n)*TMath::Gamma(n));
             if (denom!=0)  return ((1./denom)*TMath::Power(x, n-1)*TMath::Exp(-x/2.)); 
             return -999; }
         // note that the cdf of the chisquare distribution is the normalized lower incomplete gamma function
-        /* inline */    Double_t ChiSquareCDF(Int_t ndf, Double_t x) const { return TMath::Gamma(ndf/2., x/2.); }
-        /* inline */    Double_t ChiSquare(TH1& histo, TF1* func) const {
+        /* inline */    static Double_t ChiSquareCDF(Int_t ndf, Double_t x) { return TMath::Gamma(ndf/2., x/2.); }
+        /* inline */    static Double_t ChiSquare(TH1& histo, TF1* func) {
             // evaluate the chi2 using a poissonian error estimate on bins
             Double_t chi2(0.);
             for(Int_t i(0); i < histo.GetXaxis()->GetNbins(); i++) {
@@ -74,16 +84,19 @@ class AliAnalysisTaskJetV2 : public AliAnalysisTaskEmcalJet {
             }
            return chi2;
         }
-        /* inline*/ Double_t KolmogorovTest(TH1F& histo, TF1* func) const {
+        /* inline */ Double_t KolmogorovTest(TH1F& histo, TF1* func) const {
             // return the probability from a Kolmogorov test
+            return .5;
+            /* this test is disabeled as it eats a lot of resources but kept as a dummty to 
+             * ensure compatibility of the output with offline macros
             TH1F test(histo);       // stack copy of test statistic
             for(Int_t i(0); i < test.GetXaxis()->GetNbins(); i++) test.SetBinContent(i+1, func->Eval(test.GetXaxis()->GetBinCenter(1+i)));
             if(fFitGoodnessTest == kKolmogorovTOY) return histo.TH1::KolmogorovTest((&test), "X");
             return histo.TH1::KolmogorovTest((&test));
+            */
         }
+
         // setters - analysis setup
-        void                    SetDebugMode(Int_t d)                           {fDebug = d;}
         void                    SetRunToyMC(Bool_t t)                           {fRunToyMC = t; }
         void                    SetAttachToEvent(Bool_t b)                      {fAttachToEvent = b;}
         void                    SetFillHistograms(Bool_t b)                     {fFillHistograms = b;}
@@ -98,6 +111,8 @@ class AliAnalysisTaskJetV2 : public AliAnalysisTaskEmcalJet {
                                                                                  fUserSuppliedV3 = j; }
         void                    SetOnTheFlyResCorrection(TH1F* r2, TH1F* r3)    {fUserSuppliedR2 = r2;
                                                                                  fUserSuppliedR3 = r3; }
+        void                    SetEventPlaneWeights(TH1F* ep)                  {fEventPlaneWeights = ep; }
+        void                    SetAcceptanceWeights(Bool_t w)                  {fAcceptanceWeights = w; }
         void                    SetNameRhoSmall(TString name)                   {fNameSmallRho = name; }
         void                    SetRandomSeed(TRandom3* r)                      {if (fRandom) delete fRandom; fRandom = r; }
         void                    SetModulationFit(TF1* fit);
@@ -121,9 +136,23 @@ class AliAnalysisTaskJetV2 : public AliAnalysisTaskEmcalJet {
         void                    SetExcludeLeadingJetsFromFit(Float_t n)         {fExcludeLeadingJetsFromFit = n; }
         void                    SetRebinSwapHistoOnTheFly(Bool_t r)             {fRebinSwapHistoOnTheFly = r; }
         void                    SetSaveThisPercentageOfFits(Float_t p)          {fPercentageOfFits = p; }
-        void                    SetUseV0EventPlaneFromHeader(Bool_t h)          {fUseV0EventPlaneFromHeader = h;}
-        void                    SetExplicitOutlierCutForYear(Int_t y)           {fExplicitOutlierCut = y;}
-        // getters - these are used as well by AliAnalyisTaskJetFlow, so be careful when changing them
+        // setters specific to the vzero calibration for 10h data        
+        void                    SetVZEROApol(Int_t ring, Float_t f)             {fVZEROApol[ring]=f;}
+        void                    SetVZEROCpol(Int_t ring, Float_t f)             {fVZEROCpol[ring]=f;}
+        void                    SetVZEROgainEqualizationPerRing(Bool_t s)       {fVZEROgainEqualizationPerRing = s;}
+        void                    SetUseVZERORing(Int_t i, Bool_t u) {
+            // exclude vzero rings: 0 through 7 can be excluded by calling this setter multiple times
+            // 0 corresponds to segment ID 0 through 7, etc
+            fUseVZERORing[i] = u;
+            fVZEROgainEqualizationPerRing = kTRUE;       // must be true for this option
+        }
+
+        void                    SetChi2VZEROA(TArrayD* a)                       { fChi2A = a;}
+        void                    SetChi2VZEROC(TArrayD* a)                       { fChi2C = a;}
+        void                    SetChi3VZEROA(TArrayD* a)                       { fChi3A = a;}
+        void                    SetChi3VZEROC(TArrayD* a)                       { fChi3C = a;}
+
+        // getters 
         TString                 GetJetsName() const                             {return GetJetContainer()->GetArrayName(); }
         TString                 GetTracksName() const                           {return GetParticleContainer()->GetArrayName(); }
         TString                 GetLocalRhoName() const                         {return fLocalRhoName; }
@@ -132,34 +161,26 @@ class AliAnalysisTaskJetV2 : public AliAnalysisTaskEmcalJet {
         TList*                  GetOutputList() const                           {return fOutputList;}
         AliLocalRhoParameter*   GetLocalRhoParameter() const                    {return fLocalRho;}
         Double_t                GetJetRadius() const                            {return GetJetContainer()->GetJetRadius();}
-        /* inline */    AliEmcalJet* GetLeadingJet() {
-            // return pointer to the highest pt jet (before background subtraction) within acceptance
-            // only rudimentary cuts are applied on this level, hence the implementation outside of
-            // the framework
-            Int_t iJets(fJets->GetEntriesFast());
-            Double_t pt(0);
-            AliEmcalJet* leadingJet(0x0);
-            for(Int_t i(0); i < iJets; i++) {
-                AliEmcalJet* jet = static_cast<AliEmcalJet*>(fJets->At(i));
-                if(!PassesSimpleCuts(jet)) continue;
-                if(jet->Pt() > pt) {
-                   leadingJet = jet;
-                   pt = leadingJet->Pt();
-                }
-            }
-            return leadingJet;
-        }
-        void                    ExecMe()                                {ExecOnce();}
-        AliAnalysisTaskJetV2* ReturnMe()                                {return this;}
+        AliEmcalJet*            GetLeadingJet(AliLocalRhoParameter* localRho = 0x0);
+        static TH1F*            GetEventPlaneWeights(TH1F* hist);
+        static void             PrintTriggerSummary(UInt_t trigger);
+        void                    ExecMe()                                        {ExecOnce();}
+        AliAnalysisTaskJetV2*   ReturnMe()                                      {return this;}
         // local cuts
         void                    SetSoftTrackMinMaxPt(Float_t min, Float_t max)          {fSoftTrackMinPt = min; fSoftTrackMaxPt = max;}
         void                    SetSemiGoodJetMinMaxPhi(Double_t a, Double_t b)         {fSemiGoodJetMinPhi = a; fSemiGoodJetMaxPhi = b;}
         void                    SetSemiGoodTrackMinMaxPhi(Double_t a, Double_t b)       {fSemiGoodTrackMinPhi = a; fSemiGoodTrackMaxPhi = b;}
         // numerical evaluations
+        static void             NumericalOverlap(Double_t x1, Double_t x2, Double_t psi2, Double_t &percIn, Double_t &percOut, Double_t &percLost);
+        static Int_t            OverlapsWithPlane(Double_t x1, Double_t x2, 
+                Double_t a, Double_t b, Double_t c, Double_t d, Double_t e, Double_t phi);
+        static Double_t         CalculateEventPlaneChi(Double_t res);
         void                    CalculateEventPlaneVZERO(Double_t vzero[2][2]) const;
-        void                    CalculateEventPlaneTPC(Double_t* tpc);
         void                    CalculateEventPlaneCombinedVZERO(Double_t* comb) const;
+        void                    CalculateEventPlaneTPC(Double_t* tpc);
         void                    CalculateEventPlaneResolution(Double_t vzero[2][2], Double_t* vzeroComb, Double_t* tpc);
+        void                    CalculateQvectorVZERO(Double_t Qa2[2], Double_t Qc2[2], Double_t Qa3[2], Double_t Qc3[2]) const;
+        void                    CalculateQvectorCombinedVZERO(Double_t Q2[2], Double_t Q3[2]) const;
         void                    CalculateRandomCone(
                 Float_t &pt, 
                 Float_t &eta, 
@@ -170,7 +191,7 @@ class AliAnalysisTaskJetV2 : public AliAnalysisTaskEmcalJet {
                 ) const;
         Double_t                CalculateQC2(Int_t harm);
         Double_t                CalculateQC4(Int_t harm);
-        // helper calculations for the q-cumulant analysis, also used by AliAnalyisTaskJetFlow
+        // helper calculations for the q-cumulant analysis
         void                    QCnQnk(Int_t n, Int_t k, Double_t &reQ, Double_t &imQ);
         void                    QCnDiffentialFlowVectors(
             TClonesArray* pois, TArrayD* ptBins, Bool_t vpart, Double_t* repn, Double_t* impn, 
@@ -182,28 +203,30 @@ class AliAnalysisTaskJetV2 : public AliAnalysisTaskEmcalJet {
         Bool_t                  QCnRecovery(Double_t psi2, Double_t psi3);
         // analysis details
         Bool_t                  CorrectRho(Double_t psi2, Double_t psi3);
-        // event and track selection, also used by AliAnalyisTaskJetFlow
+        // event and track selection
         /* inline */    Bool_t PassesCuts(AliVParticle* track) const    { return AcceptTrack(track, 0); }
         /* inline */    Bool_t PassesCuts(AliEmcalJet* jet)             { return AcceptJet(jet, 0); }
         /* inline */    Bool_t PassesCuts(AliVCluster* clus) const      { return AcceptCluster(clus, 0); }
         /* inline */    Bool_t PassesSimpleCuts(AliEmcalJet* jet)       {
             Float_t minPhi(GetJetContainer()->GetJetPhiMin()), maxPhi(GetJetContainer()->GetJetPhiMax());
             Float_t minEta(GetJetContainer()->GetJetEtaMin()), maxEta(GetJetContainer()->GetJetEtaMax());
-            return (jet && jet->Pt() > 1. && jet->Eta() > minEta && jet->Eta() < maxEta && jet->Phi() > minPhi && jet->Phi() < maxPhi && jet->Area() > .557*GetJetRadius()*GetJetRadius()*TMath::Pi());
+            return (jet/* && jet->Pt() > 1.*/ && jet->Eta() > minEta && jet->Eta() < maxEta && jet->Phi() > minPhi && jet->Phi() < maxPhi && jet->Area() > .557*GetJetRadius()*GetJetRadius()*TMath::Pi());
         }
         Bool_t                  PassesCuts(AliVEvent* event);
-        Bool_t                  PassesCuts(Int_t year);
         Bool_t                  PassesCuts(const AliVCluster* track) const;
         // filling histograms
         void                    FillHistogramsAfterSubtraction(Double_t psi2, Double_t vzero[2][2], Double_t* vzeroComb, Double_t* tpc);
-        void                    FillTrackHistograms() const;
-        void                    FillClusterHistograms() const;
-        void                    FillEventPlaneHistograms(Double_t vzero[2][2], Double_t* vzeroComb, Double_t* tpc) const;
-        void                    FillRhoHistograms();
-        void                    FillDeltaPtHistograms(Double_t psi2) const; 
-        void                    FillJetHistograms(Double_t psi2);
         void                    FillQAHistograms(AliVTrack* vtrack) const;
         void                    FillQAHistograms(AliVEvent* vevent);
+        void                    FillWeightedTrackHistograms() const;
+        void                    FillWeightedClusterHistograms() const;
+        void                    FillWeightedEventPlaneHistograms(Double_t vzero[2][2], Double_t* vzeroComb, Double_t* tpc) const;
+        void                    FillWeightedRhoHistograms();
+        void                    FillWeightedDeltaPtHistograms(Double_t psi2) const; 
+        void                    FillWeightedJetHistograms(Double_t psi2);
+        void                    FillWeightedQAHistograms(AliVTrack* vtrack) const;
+        void                    FillWeightedQAHistograms(AliVEvent* vevent);
+        void                    FillWeightedTriggerQA(Double_t dPhi, Double_t pt, UInt_t trigger);
         void                    FillAnalysisSummaryHistogram() const;
         virtual void            Terminate(Option_t* option);
         // interface methods for the output file
@@ -212,9 +235,10 @@ class AliAnalysisTaskJetV2 : public AliAnalysisTaskEmcalJet {
         TH1F*                   CorrectForResolutionDiff(TH1F* v, detectorType detector, TArrayD* cen, Int_t c, Int_t h = 2);
         TH1F*                   CorrectForResolutionInt(TH1F* v, detectorType detector, TArrayD* cen, Int_t h = 2);
         TH1F*                   GetDifferentialQC(TProfile* refCumulants, TProfile* diffCumlants, TArrayD* ptBins, Int_t h);
+        void                    ReadVZEROCalibration2010h();
+        Int_t                   GetVZEROCentralityBin() const;
     private:
         // analysis flags and settings
-        Int_t                   fDebug;                 // debug level (0 none, 1 fcn calls, 2 verbose)
         Bool_t                  fRunToyMC;              // run toy mc for fit routine
         Bool_t                  fLocalInit;             //! is the analysis initialized?
         Bool_t                  fAttachToEvent;         // attach local rho to the event
@@ -230,10 +254,14 @@ class AliAnalysisTaskJetV2 : public AliAnalysisTaskEmcalJet {
         TH1F*                   fUserSuppliedV3;        // histo with integrated v3
         TH1F*                   fUserSuppliedR2;        // correct the extracted v2 with this r
         TH1F*                   fUserSuppliedR3;        // correct the extracted v3 with this r
+        TH1F*                   fEventPlaneWeights;     // weight histo for the event plane
+        Bool_t                  fAcceptanceWeights;     // store centrality dependent acceptance weights
+        Float_t                 fEventPlaneWeight;      //! the actual weight of an event
         AliParticleContainer*   fTracksCont;            //! tracks
         AliClusterContainer*    fClusterCont;           //! cluster container
         AliJetContainer*        fJetsCont;              //! jets
         AliEmcalJet*            fLeadingJet;            //! leading jet
+        AliEmcalJet*            fLeadingJetAfterSub;    //! leading jet after background subtraction
         // members
         Int_t                   fNAcceptedTracks;       //! number of accepted tracks
         Int_t                   fNAcceptedTracksQCn;    //! accepted tracks for QCn
@@ -269,6 +297,9 @@ class AliAnalysisTaskJetV2 : public AliAnalysisTaskEmcalJet {
         Float_t                 fAbsVertexZ;            // cut on zvertex
         // general qa histograms
         TH1F*                   fHistCentrality;        //! accepted centrality
+        TProfile*               fHistCentralityPercIn;  //! centrality versus perc in
+        TProfile*               fHistCentralityPercOut; //! centrality versus perc out
+        TProfile*               fHistCentralityPercLost;//! centrality versus perc lost
         TH1F*                   fHistVertexz;           //! accepted verte
         TH2F*                   fHistRunnumbersPhi;     //! run numbers averaged phi
         TH2F*                   fHistRunnumbersEta;     //! run numbers averaged eta
@@ -291,8 +322,6 @@ class AliAnalysisTaskJetV2 : public AliAnalysisTaskEmcalJet {
         Float_t                 fExcludeLeadingJetsFromFit;    // exclude n leading jets from fit
         Bool_t                  fRebinSwapHistoOnTheFly;       // rebin swap histo on the fly
         Float_t                 fPercentageOfFits;      // save this percentage of fits
-        Bool_t                  fUseV0EventPlaneFromHeader;    // use the vzero event plane from the header
-        Int_t                   fExplicitOutlierCut;    // cut on correlation of tpc and global multiplicity
         // transient object pointers
         TList*                  fOutputList;            //! output list
         TList*                  fOutputListGood;        //! output list for local analysis
@@ -315,6 +344,9 @@ class AliAnalysisTaskJetV2 : public AliAnalysisTaskEmcalJet {
         TH1F*                   fHistClusterPt[10];     //! pt emcal clusters
         TH2F*                   fHistClusterEtaPhi[10]; //! eta phi emcal clusters
         TH2F*                   fHistClusterEtaPhiWeighted[10]; //! eta phi emcal clusters, pt weighted
+        // qa histograms for triggers
+        TH2F*                   fHistTriggerQAIn[10];   //! trigger qa in plane
+        TH2F*                   fHistTriggerQAOut[10];  //! trigger qa out of plane
         // qa event planes
         TProfile*               fHistPsiControl;        //! event plane control histogram
         TProfile*               fHistPsiSpread;         //! event plane spread histogram
@@ -325,11 +357,17 @@ class AliAnalysisTaskJetV2 : public AliAnalysisTaskEmcalJet {
         TH2F*                   fHistPsiVZEROAV0M;      //! psi 2 from vzero a
         TH2F*                   fHistPsiVZEROCV0M;      //! psi 2 from vzero c
         TH2F*                   fHistPsiVZEROVV0M;      //! psi 2 from combined vzero
-        TH2F*                   fHistPsiTPCiV0M;        //! psi 2 from tpc
+        TH2F*                   fHistPsiTPCV0M;         //! psi 2 from tpc
         TH2F*                   fHistPsiVZEROATRK;      //! psi 2 from vzero a
         TH2F*                   fHistPsiVZEROCTRK;      //! psi 2 from vzero c
         TH2F*                   fHistPsiVZEROTRK;       //! psi 2 from combined vzero
         TH2F*                   fHistPsiTPCTRK;         //! psi 2 from tpc
+        TH3F*                   fHistPsiTPCLeadingJet[10];      //! correlation tpc EP, LJ pt
+        TH3F*                   fHistPsiVZEROALeadingJet[10];   //! correlation vzeroa EP, LJ pt
+        TH3F*                   fHistPsiVZEROCLeadingJet[10];   //! correlation vzeroc EP, LJ pt
+        TH3F*                   fHistPsiVZEROCombLeadingJet[10];//! correlation vzerocomb EP, LJ pt
+        TH3F*                   fHistPsi2Correlation[10];       //! correlation of event planes
+        TH2F*                   fHistLeadingJetBackground[10];  //! geometric correlation of leading jet w/wo bkg subtraction
         // background
         TH1F*                   fHistRhoPackage[10];    //! rho as estimated by emcal jet package
         TH1F*                   fHistRho[10];           //! background
@@ -359,11 +397,27 @@ class AliAnalysisTaskJetV2 : public AliAnalysisTaskEmcalJet {
         // in plane, out of plane jet spectra
         TH2F*                   fHistJetPsi2Pt[10];             //! event plane dependence of jet pt
         TH2F*                   fHistJetPsi2PtRho0[10];         //! event plane dependence of jet pt vs rho_0
+        // vzero event plane calibration cache for 10h data
+        Float_t                 fMeanQ[9][2][2];                //! recentering
+        Float_t                 fWidthQ[9][2][2];               //! recentering
+        Float_t                 fMeanQv3[9][2][2];              //! recentering
+        Float_t                 fWidthQv3[9][2][2];             //! recentering
+        TH1*                    fVZEROgainEqualization;         //! equalization histo
+        Bool_t                  fVZEROgainEqualizationPerRing;  // per ring vzero gain calibration
+        Float_t                 fVZEROApol[4];                  //! calibration info per ring
+        Float_t                 fVZEROCpol[4];                  //! calibration info per ring
+        Bool_t                  fUseVZERORing[8];               // kTRUE means the ring is included
+        TArrayD*                fChi2A;                         // chi vs cent for vzero A ep_2
+        TArrayD*                fChi2C;                         // chi vs cent for vzero C ep_2
+        TArrayD*                fChi3A;                         // chi vs cent for vzero A ep_3
+        TArrayD*                fChi3C;                         // chi vs cent for vzero C ep_3
+        TFile*                  fOADB;                          //! fOADB
+
 
         AliAnalysisTaskJetV2(const AliAnalysisTaskJetV2&);                  // not implemented
         AliAnalysisTaskJetV2& operator=(const AliAnalysisTaskJetV2&);       // not implemented
 
-        ClassDef(AliAnalysisTaskJetV2, 1);
+        ClassDef(AliAnalysisTaskJetV2, 4);
 };
 
 #endif