CMS 3D CMS Logo

List of all members | Public Member Functions | Private Member Functions | Private Attributes
zPdfUnc Class Reference
Inheritance diagram for zPdfUnc:
edm::EDAnalyzer edm::EDConsumerBase

Public Member Functions

 zPdfUnc (const edm::ParameterSet &pset)
 
- Public Member Functions inherited from edm::EDAnalyzer
void callWhenNewProductsRegistered (std::function< void(BranchDescription const &)> const &func)
 
 EDAnalyzer ()
 
SerialTaskQueueglobalLuminosityBlocksQueue ()
 
SerialTaskQueueglobalRunsQueue ()
 
ModuleDescription const & moduleDescription () const
 
std::string workerType () const
 
 ~EDAnalyzer () override
 
- Public Member Functions inherited from edm::EDConsumerBase
std::vector< ConsumesInfoconsumesInfo () const
 
void convertCurrentProcessAlias (std::string const &processName)
 Convert "@currentProcess" in InputTag process names to the actual current process name. More...
 
 EDConsumerBase ()
 
 EDConsumerBase (EDConsumerBase const &)=delete
 
 EDConsumerBase (EDConsumerBase &&)=default
 
ESProxyIndex const * esGetTokenIndices (edm::Transition iTrans) const
 
ProductResolverIndexAndSkipBit indexFrom (EDGetToken, BranchType, TypeID const &) const
 
void itemsMayGet (BranchType, std::vector< ProductResolverIndexAndSkipBit > &) const
 
void itemsToGet (BranchType, std::vector< ProductResolverIndexAndSkipBit > &) const
 
std::vector< ProductResolverIndexAndSkipBit > const & itemsToGetFrom (BranchType iType) const
 
void labelsForToken (EDGetToken iToken, Labels &oLabels) const
 
void modulesWhoseProductsAreConsumed (std::vector< ModuleDescription const * > &modules, ProductRegistry const &preg, std::map< std::string, ModuleDescription const * > const &labelsToDesc, std::string const &processName) const
 
EDConsumerBase const & operator= (EDConsumerBase const &)=delete
 
EDConsumerBaseoperator= (EDConsumerBase &&)=default
 
bool registeredToConsume (ProductResolverIndex, bool, BranchType) const
 
bool registeredToConsumeMany (TypeID const &, BranchType) const
 
ProductResolverIndexAndSkipBit uncheckedIndexFrom (EDGetToken) const
 
void updateLookup (BranchType iBranchType, ProductResolverIndexHelper const &, bool iPrefetchMayGet)
 
void updateLookup (eventsetup::ESRecordsToProxyIndices const &)
 
virtual ~EDConsumerBase () noexcept(false)
 

Private Member Functions

void analyze (const edm::Event &event, const edm::EventSetup &setup) override
 
void endJob () override
 

Private Attributes

double accEtaMax_
 
double accEtaMin_
 
double accMassMax_
 
double accMassMin_
 
double accMassMinDenominator_
 
double accPtMin_
 
double angMax_
 
std::string filename_
 
edm::EDGetTokenT< reco::GenParticleCollectiongenToken_
 
TH1F * h_etaZMC_
 
TH1F * h_mZMC_
 
TH1F * h_nZ_
 
TH1F * h_phiZMC_
 
TH1F * h_ptZMC_
 
TH1F * h_rapidityZMC_
 
TH1F * h_thetaZMC_
 
TH1F * h_weight_histo
 
TH1F * hardeta
 
TH1F * hardpt
 
bool isMCatNLO_
 
double massMax_
 
double nAcc_
 
double nAccReW_
 
unsigned int nbinsAng_
 
unsigned int nbinsMass_
 
unsigned int nbinsPt_
 
double nBothMuHasZHasGrandMa_
 
unsigned int pdfmember_
 
edm::EDGetTokenT< std::vector< double > > pdfweightsToken_
 
double ptMax_
 
TH1F * softeta
 
TH1F * softpt
 

Additional Inherited Members

- Public Types inherited from edm::EDAnalyzer
typedef EDAnalyzer ModuleType
 
- Public Types inherited from edm::EDConsumerBase
typedef ProductLabels Labels
 
- Static Public Member Functions inherited from edm::EDAnalyzer
static const std::string & baseType ()
 
static void fillDescriptions (ConfigurationDescriptions &descriptions)
 
static void prevalidate (ConfigurationDescriptions &)
 
static bool wantsGlobalLuminosityBlocks ()
 
static bool wantsGlobalRuns ()
 
static bool wantsStreamLuminosityBlocks ()
 
static bool wantsStreamRuns ()
 
- Protected Member Functions inherited from edm::EDConsumerBase
template<typename ProductType , BranchType B = InEvent>
EDGetTokenT< ProductType > consumes (edm::InputTag const &tag)
 
EDGetToken consumes (const TypeToGet &id, edm::InputTag const &tag)
 
template<BranchType B>
EDGetToken consumes (TypeToGet const &id, edm::InputTag const &tag)
 
ConsumesCollector consumesCollector ()
 Use a ConsumesCollector to gather consumes information from helper functions. More...
 
template<typename ProductType , BranchType B = InEvent>
void consumesMany ()
 
void consumesMany (const TypeToGet &id)
 
template<BranchType B>
void consumesMany (const TypeToGet &id)
 
template<typename ESProduct , typename ESRecord , Transition Tr = Transition::Event>
auto esConsumes ()
 
template<typename ESProduct , typename ESRecord , Transition Tr = Transition::Event>
auto esConsumes (ESInputTag const &tag)
 
template<typename ProductType , BranchType B = InEvent>
EDGetTokenT< ProductType > mayConsume (edm::InputTag const &tag)
 
EDGetToken mayConsume (const TypeToGet &id, edm::InputTag const &tag)
 
template<BranchType B>
EDGetToken mayConsume (const TypeToGet &id, edm::InputTag const &tag)
 

Detailed Description

Definition at line 7 of file zPdfUnc.cc.

Constructor & Destructor Documentation

zPdfUnc::zPdfUnc ( const edm::ParameterSet pset)

Definition at line 49 of file zPdfUnc.cc.

References angMax_, gather_cfg::cout, h_etaZMC_, h_mZMC_, h_nZ_, h_phiZMC_, h_ptZMC_, h_rapidityZMC_, h_thetaZMC_, h_weight_histo, hardeta, hardpt, TFileDirectory::make(), massMax_, TFileService::mkdir(), nAcc_, nAccReW_, nbinsAng_, nbinsMass_, nbinsPt_, nBothMuHasZHasGrandMa_, ptMax_, softeta, and softpt.

50  : genToken_(consumes<GenParticleCollection>(pset.getParameter<InputTag>("genParticles"))),
51  pdfweightsToken_(consumes<std::vector<double> >(pset.getParameter<InputTag>("pdfweights"))),
52  pdfmember_(pset.getUntrackedParameter<unsigned int>("pdfmember")),
53  nbinsMass_(pset.getUntrackedParameter<unsigned int>("nbinsMass")),
54  nbinsPt_(pset.getUntrackedParameter<unsigned int>("nbinsPt")),
55  nbinsAng_(pset.getUntrackedParameter<unsigned int>("nbinsAng")),
56  massMax_(pset.getUntrackedParameter<double>("massMax")),
57  ptMax_(pset.getUntrackedParameter<double>("ptMax")),
58  angMax_(pset.getUntrackedParameter<double>("angMax")),
59  accPtMin_(pset.getUntrackedParameter<double>("accPtMin")),
60  accMassMin_(pset.getUntrackedParameter<double>("accMassMin")),
61  accMassMax_(pset.getUntrackedParameter<double>("accMassMax")),
62  accEtaMin_(pset.getUntrackedParameter<double>("accEtaMin")),
63  accEtaMax_(pset.getUntrackedParameter<double>("accEtaMax")),
64  accMassMinDenominator_(pset.getUntrackedParameter<double>("accMassMinDenominator")),
65  isMCatNLO_(pset.getUntrackedParameter<bool>("isMCatNLO")),
66  filename_(pset.getUntrackedParameter<std::string>("outfilename")) {
67  cout << ">>> Z Histogrammer constructor" << endl;
69 
70  TFileDirectory ZMCHisto = fs->mkdir("ZMCHisto");
71  h_nZ_ = ZMCHisto.make<TH1F>("ZNumber", "number of Z particles", 11, -0.5, 10.5);
72  h_weight_histo = ZMCHisto.make<TH1F>("weight_histo", "weight_histo", 20, -10, 10);
73 
74  h_mZMC_ = ZMCHisto.make<TH1F>("ZMCMass", "Z MC mass (GeV/c^{2})", nbinsMass_, 0, massMax_);
75  h_ptZMC_ = ZMCHisto.make<TH1F>("ZMCPt", "Z MC p_{t} (GeV/c)", nbinsPt_, 0, ptMax_);
76  hardpt = ZMCHisto.make<TH1F>("hardpt", "hard muon p_{t} (GeV/c)", nbinsPt_, 0, ptMax_);
77  softpt = ZMCHisto.make<TH1F>("softpt", "soft muon p_{t} (GeV/c)", nbinsPt_, 0, ptMax_);
78 
79  h_phiZMC_ = ZMCHisto.make<TH1F>("ZMCPhi", "Z MC #phi", nbinsAng_, -angMax_, angMax_);
80  h_thetaZMC_ = ZMCHisto.make<TH1F>("ZMCTheta", "Z MC #theta", nbinsAng_, 0, angMax_);
81  h_etaZMC_ = ZMCHisto.make<TH1F>("ZMCEta", "Z MC #eta", nbinsAng_, -angMax_, angMax_);
82  h_rapidityZMC_ = ZMCHisto.make<TH1F>("ZMCRapidity", "Z MC y", nbinsAng_, -angMax_, angMax_);
83 
84  hardeta = ZMCHisto.make<TH1F>("hard muon eta", "hard muon #eta", nbinsAng_, -angMax_, angMax_);
85  softeta = ZMCHisto.make<TH1F>("soft muon eta", "soft muon #eta", nbinsAng_, -angMax_, angMax_);
86  nAcc_ = 0.;
87  nAccReW_ = 0;
89 }
T getParameter(std::string const &) const
T getUntrackedParameter(std::string const &, T const &) const
double ptMax_
Definition: zPdfUnc.cc:17
TH1F * h_weight_histo
Definition: zPdfUnc.cc:22
double nBothMuHasZHasGrandMa_
Definition: zPdfUnc.cc:24
TH1F * h_ptZMC_
Definition: zPdfUnc.cc:20
double accMassMinDenominator_
Definition: zPdfUnc.cc:18
double accEtaMax_
Definition: zPdfUnc.cc:18
TH1F * h_nZ_
Definition: zPdfUnc.cc:19
double accPtMin_
Definition: zPdfUnc.cc:18
double nAccReW_
Definition: zPdfUnc.cc:24
TH1F * softeta
Definition: zPdfUnc.cc:21
unsigned int nbinsAng_
Definition: zPdfUnc.cc:16
EDGetTokenT< ProductType > consumes(edm::InputTag const &tag)
edm::EDGetTokenT< std::vector< double > > pdfweightsToken_
Definition: zPdfUnc.cc:15
double angMax_
Definition: zPdfUnc.cc:17
TH1F * h_etaZMC_
Definition: zPdfUnc.cc:20
bool isMCatNLO_
Definition: zPdfUnc.cc:23
T * make(const Args &...args) const
make new ROOT object
double accMassMax_
Definition: zPdfUnc.cc:18
edm::EDGetTokenT< reco::GenParticleCollection > genToken_
Definition: zPdfUnc.cc:14
TH1F * hardeta
Definition: zPdfUnc.cc:21
unsigned int nbinsPt_
Definition: zPdfUnc.cc:16
TH1F * h_phiZMC_
Definition: zPdfUnc.cc:20
std::string filename_
Definition: zPdfUnc.cc:25
TFileDirectory mkdir(const std::string &dir, const std::string &descr="")
create a new subdirectory
Definition: TFileService.h:69
TH1F * h_mZMC_
Definition: zPdfUnc.cc:20
double nAcc_
Definition: zPdfUnc.cc:24
TH1F * h_thetaZMC_
Definition: zPdfUnc.cc:20
double accEtaMin_
Definition: zPdfUnc.cc:18
TH1F * softpt
Definition: zPdfUnc.cc:21
TH1F * hardpt
Definition: zPdfUnc.cc:21
unsigned int nbinsMass_
Definition: zPdfUnc.cc:16
TH1F * h_rapidityZMC_
Definition: zPdfUnc.cc:20
double massMax_
Definition: zPdfUnc.cc:17
double accMassMin_
Definition: zPdfUnc.cc:18
unsigned int pdfmember_
Definition: zPdfUnc.cc:16

Member Function Documentation

void zPdfUnc::analyze ( const edm::Event event,
const edm::EventSetup setup 
)
overrideprivate

Definition at line 91 of file zPdfUnc.cc.

References funct::abs(), accEtaMax_, accEtaMin_, accMassMax_, accMassMin_, accMassMinDenominator_, accPtMin_, gather_cfg::cout, HLT_2018_cff::eta1, HLT_2018_cff::eta2, relval_steps::gen(), genToken_, h_etaZMC_, h_mZMC_, h_phiZMC_, h_ptZMC_, h_rapidityZMC_, h_thetaZMC_, h_weight_histo, hardeta, hardpt, mps_fire::i, reco::CompositeRefCandidateT< D >::mother(), reco::Candidate::mother(), PDWG_BPHSkim_cff::muons, nAcc_, nAccReW_, nBothMuHasZHasGrandMa_, reco::CompositeRefCandidateT< D >::numberOfMothers(), reco::Candidate::numberOfMothers(), p4, pdfmember_, pdfweightsToken_, reco::Candidate::pdgId(), reco::LeafCandidate::pdgId(), HLT_2018_cff::pt1, HLT_2018_cff::pt2, softeta, softpt, mathSSE::sqrt(), reco::LeafCandidate::status(), mps_merge::weight, and HGCalRecHit_cfi::weights.

91  {
92  cout << ">>> Z Histogrammer analyze" << endl;
93 
95  Handle<vector<double> > pdfweights;
96 
97  event.getByToken(genToken_, gen);
98  event.getByToken(pdfweightsToken_, pdfweights);
99 
100  // get weight and fill it to histogram
101  std::vector<double> weights = (*pdfweights);
102 
103  unsigned int nmembers = weights.size();
104 
105  double weight = weights[pdfmember_];
106 
107  h_weight_histo->Fill(weight);
108 
109  cout << "found nmember: " << nmembers << endl;
110  cout << "taken the member n " << pdfmember_ << " weight= " << weight << endl;
111 
112  std::vector<GenParticle> muons;
113 
114  for (unsigned int i = 0; i < gen->size(); ++i) {
115  const GenParticle& muMC = (*gen)[i];
116  // filling only muons coming form Z
117  if (abs(muMC.pdgId()) == 13 && muMC.status() == 1 && muMC.numberOfMothers() > 0) {
118  if (muMC.mother()->numberOfMothers() > 0) {
119  cout << "I'm getting a muon \n"
120  << "with "
121  << "muMC.numberOfMothers() " << muMC.numberOfMothers() << "\n the first mother has pdgId "
122  << muMC.mother()->pdgId() << "with "
123  << "muMC.mother()->numberOfMothers() " << muMC.mother()->numberOfMothers()
124  << "\n the first grandma has pdgId " << muMC.mother()->mother()->pdgId() << endl;
125  if (muMC.mother()->mother()->pdgId() == 23)
126  muons.push_back(muMC);
127  }
128  }
129  }
130 
131  cout << "finally I selected " << muons.size() << " muons" << endl;
132 
133  // if there are at least two muons,
134  // calculate invarant mass of first two and fill it into histogram
135 
136  double inv_mass = 0.0;
137  double Zpt_ = 0.0;
138  double Zeta_ = 0.0;
139  double Ztheta_ = 0.0;
140  double Zphi_ = 0.0;
141  double Zrapidity_ = 0.0;
142 
143  if (muons.size() > 1) {
144  if (muons[0].mother()->mother()->pdgId() == 23 && muons[1].mother()->mother()->pdgId() == 23)
146  math::XYZTLorentzVector tot_momentum(muons[0].p4());
147  math::XYZTLorentzVector mom2(muons[1].p4());
148  tot_momentum += mom2;
149  inv_mass = sqrt(tot_momentum.mass2());
150 
151  Zpt_ = tot_momentum.pt();
152  Zeta_ = tot_momentum.eta();
153  Ztheta_ = tot_momentum.theta();
154  Zphi_ = tot_momentum.phi();
155  Zrapidity_ = tot_momentum.Rapidity();
156 
157  // IMPORTANT: use the weight of the event ...
158 
159  double weight_sign = weight;
160  //double weight_sign = 1. ;
161  // fill the denominator numbers only if mass>accMassMinDenominator and go on in that case
162  if (inv_mass > accMassMinDenominator_) {
163  h_mZMC_->Fill(inv_mass, weight_sign);
164  h_ptZMC_->Fill(Zpt_, weight_sign);
165  h_etaZMC_->Fill(Zeta_, weight_sign);
166  h_thetaZMC_->Fill(Ztheta_, weight_sign);
167  h_phiZMC_->Fill(Zphi_, weight_sign);
168  h_rapidityZMC_->Fill(Zrapidity_, weight_sign);
169 
170  double pt1 = muons[0].pt();
171  double pt2 = muons[1].pt();
172  double eta1 = muons[0].eta();
173  double eta2 = muons[1].eta();
174  if (pt1 > pt2) {
175  hardpt->Fill(pt1, weight_sign);
176  softpt->Fill(pt2, weight_sign);
177  hardeta->Fill(eta1, weight_sign);
178  softeta->Fill(eta2, weight_sign);
179  } else {
180  hardpt->Fill(pt2, weight_sign);
181  softpt->Fill(pt1, weight_sign);
182  hardeta->Fill(eta2, weight_sign);
183  softeta->Fill(eta1, weight_sign);
184  }
185 
186  //evaluating the geometric acceptance
187  if (pt1 >= accPtMin_ && pt2 >= accPtMin_ && fabs(eta1) >= accEtaMin_ && fabs(eta2) >= accEtaMin_ &&
188  fabs(eta1) <= accEtaMax_ && fabs(eta2) <= accEtaMax_ && inv_mass >= accMassMin_ && inv_mass <= accMassMax_) {
189  nAcc_++;
190  nAccReW_ += weight;
191  }
192  }
193  }
194 }
int pdgId() const final
PDG identifier.
TH1F * h_weight_histo
Definition: zPdfUnc.cc:22
double nBothMuHasZHasGrandMa_
Definition: zPdfUnc.cc:24
TH1F * h_ptZMC_
Definition: zPdfUnc.cc:20
double accMassMinDenominator_
Definition: zPdfUnc.cc:18
double accEtaMax_
Definition: zPdfUnc.cc:18
size_t numberOfMothers() const override
number of mothers
Definition: weight.py:1
virtual const Candidate * mother(size_type i=0) const =0
return pointer to mother
double accPtMin_
Definition: zPdfUnc.cc:18
double nAccReW_
Definition: zPdfUnc.cc:24
TH1F * softeta
Definition: zPdfUnc.cc:21
XYZTLorentzVectorD XYZTLorentzVector
Lorentz vector with cylindrical internal representation using pseudorapidity.
Definition: LorentzVector.h:29
edm::EDGetTokenT< std::vector< double > > pdfweightsToken_
Definition: zPdfUnc.cc:15
virtual int pdgId() const =0
PDG identifier.
T sqrt(T t)
Definition: SSEVec.h:19
double p4[4]
Definition: TauolaWrapper.h:92
virtual size_type numberOfMothers() const =0
number of mothers (zero or one in most of but not all the cases)
TH1F * h_etaZMC_
Definition: zPdfUnc.cc:20
Abs< T >::type abs(const T &t)
Definition: Abs.h:22
double accMassMax_
Definition: zPdfUnc.cc:18
def gen(fragment, howMuch)
Production test section ####.
edm::EDGetTokenT< reco::GenParticleCollection > genToken_
Definition: zPdfUnc.cc:14
TH1F * hardeta
Definition: zPdfUnc.cc:21
TH1F * h_phiZMC_
Definition: zPdfUnc.cc:20
TH1F * h_mZMC_
Definition: zPdfUnc.cc:20
double nAcc_
Definition: zPdfUnc.cc:24
TH1F * h_thetaZMC_
Definition: zPdfUnc.cc:20
double accEtaMin_
Definition: zPdfUnc.cc:18
int status() const final
status word
TH1F * softpt
Definition: zPdfUnc.cc:21
TH1F * hardpt
Definition: zPdfUnc.cc:21
TH1F * h_rapidityZMC_
Definition: zPdfUnc.cc:20
const Candidate * mother(size_type=0) const override
return mother at a given position, i = 0, ... numberOfMothers() - 1 (read only mode) ...
double accMassMin_
Definition: zPdfUnc.cc:18
unsigned int pdfmember_
Definition: zPdfUnc.cc:16
void zPdfUnc::endJob ( void  )
overrideprivatevirtual

Reimplemented from edm::EDAnalyzer.

Definition at line 196 of file zPdfUnc.cc.

References gather_cfg::cout, DEFINE_FWK_MODULE, runTheMatrix::err, filename_, h_mZMC_, nAcc_, nAccReW_, nbinsMass_, nBothMuHasZHasGrandMa_, and mathSSE::sqrt().

196  {
197  cout << " number of events accepted :" << nAcc_ << endl;
198  cout << " number of events accepted reweigthed :" << nAccReW_ << endl;
199  double nev = h_mZMC_->GetEntries();
200  double nev_weigthed = h_mZMC_->Integral();
201  cout << " number of total events :" << nev << endl;
202  cout << " number of total weighted events :" << nev_weigthed << endl;
203  cout << " number of cases in which BothMuHasZHasGrandMa :" << nBothMuHasZHasGrandMa_ << endl;
204  double eff = (double)nAcc_ / (double)h_mZMC_->GetEntries();
205  double eff_rew = (double)nAccReW_ / (double)h_mZMC_->Integral(0, nbinsMass_ + 1);
206  double err = sqrt(eff * (1. - eff) / (double)h_mZMC_->GetEntries());
207  double err_rew = sqrt(eff_rew * (1. - eff_rew) / (double)h_mZMC_->Integral(0, nbinsMass_ + 1));
208  cout << " geometric acceptance: " << eff << "+/-" << err << endl;
209  cout << " geometric acceptance reweighted: " << eff_rew << "+/-" << err_rew << endl;
210 
211  ofstream myfile;
212  myfile.open(filename_.c_str(), std::ios::app);
213  myfile << eff << " " << eff_rew << " " << nev << " " << nev_weigthed << endl;
214  myfile.close();
215 }
double nBothMuHasZHasGrandMa_
Definition: zPdfUnc.cc:24
double nAccReW_
Definition: zPdfUnc.cc:24
T sqrt(T t)
Definition: SSEVec.h:19
std::string filename_
Definition: zPdfUnc.cc:25
TH1F * h_mZMC_
Definition: zPdfUnc.cc:20
double nAcc_
Definition: zPdfUnc.cc:24
unsigned int nbinsMass_
Definition: zPdfUnc.cc:16

Member Data Documentation

double zPdfUnc::accEtaMax_
private

Definition at line 18 of file zPdfUnc.cc.

Referenced by analyze().

double zPdfUnc::accEtaMin_
private

Definition at line 18 of file zPdfUnc.cc.

Referenced by analyze().

double zPdfUnc::accMassMax_
private

Definition at line 18 of file zPdfUnc.cc.

Referenced by analyze().

double zPdfUnc::accMassMin_
private

Definition at line 18 of file zPdfUnc.cc.

Referenced by analyze().

double zPdfUnc::accMassMinDenominator_
private

Definition at line 18 of file zPdfUnc.cc.

Referenced by analyze().

double zPdfUnc::accPtMin_
private

Definition at line 18 of file zPdfUnc.cc.

Referenced by analyze().

double zPdfUnc::angMax_
private

Definition at line 17 of file zPdfUnc.cc.

Referenced by zPdfUnc().

std::string zPdfUnc::filename_
private

Definition at line 25 of file zPdfUnc.cc.

Referenced by endJob().

edm::EDGetTokenT<reco::GenParticleCollection> zPdfUnc::genToken_
private

Definition at line 14 of file zPdfUnc.cc.

Referenced by analyze().

TH1F * zPdfUnc::h_etaZMC_
private

Definition at line 20 of file zPdfUnc.cc.

Referenced by analyze(), and zPdfUnc().

TH1F* zPdfUnc::h_mZMC_
private

Definition at line 20 of file zPdfUnc.cc.

Referenced by analyze(), endJob(), and zPdfUnc().

TH1F* zPdfUnc::h_nZ_
private

Definition at line 19 of file zPdfUnc.cc.

Referenced by zPdfUnc().

TH1F * zPdfUnc::h_phiZMC_
private

Definition at line 20 of file zPdfUnc.cc.

Referenced by analyze(), and zPdfUnc().

TH1F * zPdfUnc::h_ptZMC_
private

Definition at line 20 of file zPdfUnc.cc.

Referenced by analyze(), and zPdfUnc().

TH1F * zPdfUnc::h_rapidityZMC_
private

Definition at line 20 of file zPdfUnc.cc.

Referenced by analyze(), and zPdfUnc().

TH1F * zPdfUnc::h_thetaZMC_
private

Definition at line 20 of file zPdfUnc.cc.

Referenced by analyze(), and zPdfUnc().

TH1F* zPdfUnc::h_weight_histo
private

Definition at line 22 of file zPdfUnc.cc.

Referenced by analyze(), and zPdfUnc().

TH1F * zPdfUnc::hardeta
private

Definition at line 21 of file zPdfUnc.cc.

Referenced by analyze(), and zPdfUnc().

TH1F* zPdfUnc::hardpt
private

Definition at line 21 of file zPdfUnc.cc.

Referenced by analyze(), and zPdfUnc().

bool zPdfUnc::isMCatNLO_
private

Definition at line 23 of file zPdfUnc.cc.

double zPdfUnc::massMax_
private

Definition at line 17 of file zPdfUnc.cc.

Referenced by zPdfUnc().

double zPdfUnc::nAcc_
private

Definition at line 24 of file zPdfUnc.cc.

Referenced by analyze(), endJob(), and zPdfUnc().

double zPdfUnc::nAccReW_
private

Definition at line 24 of file zPdfUnc.cc.

Referenced by analyze(), endJob(), and zPdfUnc().

unsigned int zPdfUnc::nbinsAng_
private

Definition at line 16 of file zPdfUnc.cc.

Referenced by zPdfUnc().

unsigned int zPdfUnc::nbinsMass_
private

Definition at line 16 of file zPdfUnc.cc.

Referenced by endJob(), and zPdfUnc().

unsigned int zPdfUnc::nbinsPt_
private

Definition at line 16 of file zPdfUnc.cc.

Referenced by zPdfUnc().

double zPdfUnc::nBothMuHasZHasGrandMa_
private

Definition at line 24 of file zPdfUnc.cc.

Referenced by analyze(), endJob(), and zPdfUnc().

unsigned int zPdfUnc::pdfmember_
private

Definition at line 16 of file zPdfUnc.cc.

Referenced by analyze().

edm::EDGetTokenT<std::vector<double> > zPdfUnc::pdfweightsToken_
private

Definition at line 15 of file zPdfUnc.cc.

Referenced by analyze().

double zPdfUnc::ptMax_
private

Definition at line 17 of file zPdfUnc.cc.

Referenced by zPdfUnc().

TH1F * zPdfUnc::softeta
private

Definition at line 21 of file zPdfUnc.cc.

Referenced by analyze(), and zPdfUnc().

TH1F * zPdfUnc::softpt
private

Definition at line 21 of file zPdfUnc.cc.

Referenced by analyze(), and zPdfUnc().