CMS 3D CMS Logo

List of all members | Public Member Functions | Private Member Functions | Private Attributes
DistortedPFCandProducer Class Reference
Inheritance diagram for DistortedPFCandProducer:
edm::EDProducer edm::ProducerBase edm::EDConsumerBase edm::ProductRegistryHelper

Public Member Functions

 DistortedPFCandProducer (const edm::ParameterSet &)
 
 ~DistortedPFCandProducer () override
 
- Public Member Functions inherited from edm::EDProducer
 EDProducer ()
 
SerialTaskQueueglobalLuminosityBlocksQueue ()
 
SerialTaskQueueglobalRunsQueue ()
 
ModuleDescription const & moduleDescription () const
 
 ~EDProducer () override
 
- Public Member Functions inherited from edm::ProducerBase
void callWhenNewProductsRegistered (std::function< void(BranchDescription const &)> const &func)
 
std::vector< edm::ProductResolverIndex > const & indiciesForPutProducts (BranchType iBranchType) const
 
 ProducerBase ()
 
std::vector< edm::ProductResolverIndex > const & putTokenIndexToProductResolverIndex () const
 
std::vector< bool > const & recordProvenanceList () const
 
void registerProducts (ProducerBase *, ProductRegistry *, ModuleDescription const &)
 
std::function< void(BranchDescription const &)> registrationCallback () const
 used by the fwk to register list of products More...
 
void resolvePutIndicies (BranchType iBranchType, ModuleToResolverIndicies const &iIndicies, std::string const &moduleLabel)
 
TypeLabelList const & typeLabelList () const
 used by the fwk to register the list of products of this module More...
 
 ~ProducerBase () noexcept(false) 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 &&)=default
 
 EDConsumerBase (EDConsumerBase const &)=delete
 
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
 
EDConsumerBaseoperator= (EDConsumerBase &&)=default
 
EDConsumerBase const & operator= (EDConsumerBase const &)=delete
 
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 beginJob () override
 
void endJob () override
 
void produce (edm::Event &, const edm::EventSetup &) override
 

Private Attributes

std::vector< double > efficiencyRatioOverMC_
 
std::vector< double > etaBinEdges_
 
edm::EDGetTokenT< reco::GenParticleMatchgenMatchMapToken_
 
edm::EDGetTokenT< edm::View< reco::Muon > > muonToken_
 
edm::EDGetTokenT< edm::View< reco::PFCandidate > > pfToken_
 
std::vector< double > relativeShiftOnPt_
 
std::vector< double > relativeUncertaintyOnPt_
 
std::vector< double > shiftOnOneOverPt_
 
std::vector< double > uncertaintyOnOneOverPt_
 

Additional Inherited Members

- Public Types inherited from edm::EDProducer
typedef EDProducer ModuleType
 
- Public Types inherited from edm::ProducerBase
using ModuleToResolverIndicies = std::unordered_multimap< std::string, std::tuple< edm::TypeID const *, const char *, edm::ProductResolverIndex > >
 
typedef ProductRegistryHelper::TypeLabelList TypeLabelList
 
- Public Types inherited from edm::EDConsumerBase
typedef ProductLabels Labels
 
- Static Public Member Functions inherited from edm::EDProducer
static const std::string & baseType ()
 
static void fillDescriptions (ConfigurationDescriptions &descriptions)
 
static void prevalidate (ConfigurationDescriptions &descriptions)
 
static bool wantsGlobalLuminosityBlocks ()
 
static bool wantsGlobalRuns ()
 
static bool wantsStreamLuminosityBlocks ()
 
static bool wantsStreamRuns ()
 
- Protected Member Functions inherited from edm::ProducerBase
template<class ProductType >
BranchAliasSetterT< ProductType > produces ()
 declare what type of product will make and with which optional label More...
 
template<typename ProductType , BranchType B>
BranchAliasSetterT< ProductType > produces ()
 
template<typename ProductType , Transition B>
BranchAliasSetterT< ProductType > produces ()
 
BranchAliasSetter produces (const TypeID &id, std::string instanceName=std::string(), bool recordProvenance=true)
 
template<BranchType B>
BranchAliasSetter produces (const TypeID &id, std::string instanceName=std::string(), bool recordProvenance=true)
 
template<Transition B>
BranchAliasSetter produces (const TypeID &id, std::string instanceName=std::string(), bool recordProvenance=true)
 
template<typename ProductType , Transition B>
BranchAliasSetterT< ProductType > produces (std::string instanceName)
 
template<class ProductType >
BranchAliasSetterT< ProductType > produces (std::string instanceName)
 
template<typename ProductType , BranchType B>
BranchAliasSetterT< ProductType > produces (std::string instanceName)
 
ProducesCollector producesCollector ()
 
- Protected Member Functions inherited from edm::EDConsumerBase
EDGetToken consumes (const TypeToGet &id, edm::InputTag const &tag)
 
template<typename ProductType , BranchType B = InEvent>
EDGetTokenT< ProductType > consumes (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)
 
EDGetToken mayConsume (const TypeToGet &id, edm::InputTag const &tag)
 
template<BranchType B>
EDGetToken mayConsume (const TypeToGet &id, edm::InputTag const &tag)
 
template<typename ProductType , BranchType B = InEvent>
EDGetTokenT< ProductType > mayConsume (edm::InputTag const &tag)
 

Detailed Description

Definition at line 17 of file DistortedPFCandProducer.cc.

Constructor & Destructor Documentation

◆ DistortedPFCandProducer()

DistortedPFCandProducer::DistortedPFCandProducer ( const edm::ParameterSet pset)
explicit

Definition at line 51 of file DistortedPFCandProducer.cc.

51  {
52  // What is being produced
53  produces<std::vector<reco::PFCandidate> >();
54 
55  // Input products
56  muonToken_ =
57  consumes<edm::View<reco::Muon> >(pset.getUntrackedParameter<edm::InputTag>("MuonTag", edm::InputTag("muons")));
58  genMatchMapToken_ = consumes<reco::GenParticleMatch>(
59  pset.getUntrackedParameter<edm::InputTag>("GenMatchMapTag", edm::InputTag("genMatchMap")));
60  pfToken_ = consumes<edm::View<reco::PFCandidate> >(
61  pset.getUntrackedParameter<edm::InputTag>("PFTag", edm::InputTag("particleFlow")));
62 
63  // Eta edges
64  std::vector<double> defEtaEdges;
65  defEtaEdges.push_back(-999999.);
66  defEtaEdges.push_back(999999.);
67  etaBinEdges_ = pset.getUntrackedParameter<std::vector<double> >("EtaBinEdges", defEtaEdges);
68  unsigned int ninputs_expected = etaBinEdges_.size() - 1;
69 
70  // Distortions in muon momentum
71  std::vector<double> defDistortion;
72  defDistortion.push_back(0.);
73 
75  pset.getUntrackedParameter<std::vector<double> >("ShiftOnOneOverPt", defDistortion); // in [1/GeV]
76  if (shiftOnOneOverPt_.size() == 1 && ninputs_expected > 1) {
77  for (unsigned int i = 1; i < ninputs_expected; i++) {
79  }
80  }
81 
82  relativeShiftOnPt_ = pset.getUntrackedParameter<std::vector<double> >("RelativeShiftOnPt", defDistortion);
83  if (relativeShiftOnPt_.size() == 1 && ninputs_expected > 1) {
84  for (unsigned int i = 1; i < ninputs_expected; i++) {
86  }
87  }
88 
90  pset.getUntrackedParameter<std::vector<double> >("UncertaintyOnOneOverPt", defDistortion); // in [1/GeV]
91  if (uncertaintyOnOneOverPt_.size() == 1 && ninputs_expected > 1) {
92  for (unsigned int i = 1; i < ninputs_expected; i++) {
94  }
95  }
96 
97  relativeUncertaintyOnPt_ = pset.getUntrackedParameter<std::vector<double> >("RelativeUncertaintyOnPt", defDistortion);
98  if (relativeUncertaintyOnPt_.size() == 1 && ninputs_expected > 1) {
99  for (unsigned int i = 1; i < ninputs_expected; i++) {
101  }
102  }
103 
104  // Data/MC efficiency ratios
105  std::vector<double> defEfficiencyRatio;
106  defEfficiencyRatio.push_back(1.);
108  pset.getUntrackedParameter<std::vector<double> >("EfficiencyRatioOverMC", defEfficiencyRatio);
109  if (efficiencyRatioOverMC_.size() == 1 && ninputs_expected > 1) {
110  for (unsigned int i = 1; i < ninputs_expected; i++) {
112  }
113  }
114 
115  // Send a warning if there are inconsistencies in vector sizes !!
116  bool effWrong = efficiencyRatioOverMC_.size() != ninputs_expected;
117  bool momWrong = shiftOnOneOverPt_.size() != ninputs_expected || relativeShiftOnPt_.size() != ninputs_expected ||
118  uncertaintyOnOneOverPt_.size() != ninputs_expected ||
119  relativeUncertaintyOnPt_.size() != ninputs_expected;
120  if (effWrong and momWrong) {
121  edm::LogError("")
122  << "WARNING: DistortedPFCandProducer : Size of some parameters do not match the EtaBinEdges vector!!";
123  }
124 }

References efficiencyRatioOverMC_, etaBinEdges_, genMatchMapToken_, mps_fire::i, HLT_2018_cff::InputTag, muonToken_, pfToken_, muonDTDigis_cfi::pset, relativeShiftOnPt_, relativeUncertaintyOnPt_, shiftOnOneOverPt_, and uncertaintyOnOneOverPt_.

◆ ~DistortedPFCandProducer()

DistortedPFCandProducer::~DistortedPFCandProducer ( )
override

Definition at line 127 of file DistortedPFCandProducer.cc.

127 {}

Member Function Documentation

◆ beginJob()

void DistortedPFCandProducer::beginJob ( void  )
overrideprivatevirtual

Reimplemented from edm::EDProducer.

Definition at line 130 of file DistortedPFCandProducer.cc.

130 {}

◆ endJob()

void DistortedPFCandProducer::endJob ( void  )
overrideprivatevirtual

Reimplemented from edm::EDProducer.

Definition at line 133 of file DistortedPFCandProducer.cc.

133 {}

◆ produce()

void DistortedPFCandProducer::produce ( edm::Event ev,
const edm::EventSetup iSetup 
)
overrideprivatevirtual

Implements edm::EDProducer.

Definition at line 136 of file DistortedPFCandProducer.cc.

136  {
137  if (ev.isRealData())
138  return;
139 
140  // Muon collection
142  if (!ev.getByToken(muonToken_, muonCollection)) {
143  edm::LogError("") << ">>> Muon collection does not exist !!!";
144  return;
145  }
146 
148  if (!ev.getByToken(genMatchMapToken_, genMatchMap)) {
149  edm::LogError("") << ">>> Muon-GenParticle match map does not exist !!!";
150  return;
151  }
152 
153  // Get PFCandidate collection
155  if (!ev.getByToken(pfToken_, pfCollection)) {
156  edm::LogError("") << ">>> PFCandidate collection does not exist !!!";
157  return;
158  }
159 
160  unsigned int muonCollectionSize = muonCollection->size();
161  unsigned int pfCollectionSize = pfCollection->size();
162 
163  if (pfCollectionSize < 1)
164  return;
165 
166  // Ask for PfMuon consistency
167  bool pfMuonFound = false;
168 
169  std::unique_ptr<reco::PFCandidateCollection> newmuons(new reco::PFCandidateCollection);
170 
171  // Loop on all PF candidates
172  for (unsigned int j = 0; j < pfCollectionSize; j++) {
173  edm::RefToBase<reco::PFCandidate> pf = pfCollection->refAt(j);
174 
175  // New PF muon
176  double ptmu = pf->pt();
177 
178  for (unsigned int i = 0; i < muonCollectionSize; i++) {
180 
181  // Check the muon is in the PF collection
182  if (pf->particleId() == reco::PFCandidate::mu) {
183  reco::MuonRef muref = pf->muonRef();
184  if (muref.isNonnull()) {
185  if (muref.key() == mu.key()) {
186  if (mu->isStandAloneMuon() && ptmu == muref->standAloneMuon()->pt() &&
187  ((!mu->isGlobalMuon() || (mu->isGlobalMuon() && ptmu != muref->combinedMuon()->pt())) &&
188  (!mu->isTrackerMuon() || (mu->isTrackerMuon() && ptmu != mu->track()->pt())))) {
189  pfMuonFound = false;
190  } else if (!mu->isTrackerMuon()) {
191  pfMuonFound = false;
192  } else {
193  pfMuonFound = true;
194  }
195  } else {
196  pfMuonFound = false;
197  }
198  }
199  }
200 
201  // do nothing if StandAlone muon
202  //const reco::Track& track = *trackRef;
203 
204  if (!pfMuonFound)
205  continue;
206 
207  double ptgen = pf->pt();
208  double etagen = pf->eta();
209 
210  reco::GenParticleRef gen = (*genMatchMap)[mu];
211  if (!gen.isNull()) {
212  ptgen = gen->pt();
213  etagen = gen->eta();
214  LogTrace("") << ">>> Muon-GenParticle match found; ptmu= " << pf->pt() << ", ptgen= " << ptgen;
215  } else {
216  LogTrace("") << ">>> MUON-GENPARTICLE MATCH NOT FOUND!!!";
217  }
218 
219  // Initialize parameters
220  double effRatio = 0.;
221  double shift1 = 0.;
222  double shift2 = 0.;
223  double sigma1 = 0.;
224  double sigma2 = 0.;
225 
226  // Find out which eta bin should be used
227  unsigned int nbins = etaBinEdges_.size() - 1;
228  unsigned int etaBin = nbins;
229  if (etagen > etaBinEdges_[0] && etagen < etaBinEdges_[nbins]) {
230  for (unsigned int j = 1; j <= nbins; ++j) {
231  if (etagen > etaBinEdges_[j])
232  continue;
233  etaBin = j - 1;
234  break;
235  }
236  }
237  if (etaBin < nbins) {
238  LogTrace("") << ">>> etaBin: " << etaBin << ", for etagen =" << etagen;
239  } else {
240  // Muon is rejected if outside the considered eta range
241  LogTrace("") << ">>> Muon outside eta range: reject it; etagen = " << etagen;
242  pfMuonFound = false;
243  continue;
244  }
245 
246  if (!pfMuonFound)
247  continue;
248 
249  // Set shifts
250  shift1 = shiftOnOneOverPt_[etaBin];
251  shift2 = relativeShiftOnPt_[etaBin];
252  LogTrace("") << "\tshiftOnOneOverPt= " << shift1 * 100 << " [%]";
253  LogTrace("") << "\trelativeShiftOnPt= " << shift2 * 100 << " [%]";
254 
255  // Set resolutions
258  LogTrace("") << "\tuncertaintyOnOneOverPt= " << sigma1 << " [1/GeV]";
259  LogTrace("") << "\trelativeUncertaintyOnPt= " << sigma2 * 100 << " [%]";
260 
261  // Set efficiency ratio
262  effRatio = efficiencyRatioOverMC_[etaBin];
263  LogTrace("") << "\tefficiencyRatioOverMC= " << effRatio;
264 
265  // Reject muons according to efficiency ratio
266  double rndf = CLHEP::RandFlat::shoot();
267  if (rndf > effRatio)
268  continue;
269 
270  // Gaussian Random numbers for smearing
271  double rndg1 = CLHEP::RandGauss::shoot();
272  double rndg2 = CLHEP::RandGauss::shoot();
273 
274  // change here the pt of the candidate, if it is a muon
275 
276  ptmu += ptgen * (shift1 * ptgen + shift2 + sigma1 * rndg1 * ptgen + sigma2 * rndg2);
277  pfMuonFound = false;
278  }
279 
280  reco::PFCandidate* newmu = pf->clone();
281  newmu->setP4(reco::Particle::PolarLorentzVector(ptmu, pf->eta(), pf->phi(), pf->mass()));
282 
283  newmuons->push_back(*newmu);
284  }
285 
286  ev.put(std::move(newmuons));
287 }

References efficiencyRatioOverMC_, etaBin(), etaBinEdges_, ev, genMatchMapToken_, mps_fire::i, edm::Ref< C, T, F >::isNonnull(), dqmiolumiharvest::j, edm::Ref< C, T, F >::key(), LogTrace, eostools::move(), amptDefaultParameters_cff::mu, reco::PFCandidate::mu, pdwgLeptonRecoSkim_cfi::muonCollection, muonToken_, LaserClient_cfi::nbins, MuonAlignmentFromReference_cff::newmuons, packedPFCandidateRefMixer_cfi::pf, pfToken_, relativeShiftOnPt_, relativeUncertaintyOnPt_, reco::LeafCandidate::setP4(), shiftOnOneOverPt_, and uncertaintyOnOneOverPt_.

Member Data Documentation

◆ efficiencyRatioOverMC_

std::vector<double> DistortedPFCandProducer::efficiencyRatioOverMC_
private

Definition at line 37 of file DistortedPFCandProducer.cc.

Referenced by DistortedPFCandProducer(), and produce().

◆ etaBinEdges_

std::vector<double> DistortedPFCandProducer::etaBinEdges_
private

Definition at line 30 of file DistortedPFCandProducer.cc.

Referenced by DistortedPFCandProducer(), and produce().

◆ genMatchMapToken_

edm::EDGetTokenT<reco::GenParticleMatch> DistortedPFCandProducer::genMatchMapToken_
private

Definition at line 28 of file DistortedPFCandProducer.cc.

Referenced by DistortedPFCandProducer(), and produce().

◆ muonToken_

edm::EDGetTokenT<edm::View<reco::Muon> > DistortedPFCandProducer::muonToken_
private

Definition at line 27 of file DistortedPFCandProducer.cc.

Referenced by DistortedPFCandProducer(), and produce().

◆ pfToken_

edm::EDGetTokenT<edm::View<reco::PFCandidate> > DistortedPFCandProducer::pfToken_
private

Definition at line 29 of file DistortedPFCandProducer.cc.

Referenced by DistortedPFCandProducer(), and produce().

◆ relativeShiftOnPt_

std::vector<double> DistortedPFCandProducer::relativeShiftOnPt_
private

Definition at line 33 of file DistortedPFCandProducer.cc.

Referenced by DistortedPFCandProducer(), and produce().

◆ relativeUncertaintyOnPt_

std::vector<double> DistortedPFCandProducer::relativeUncertaintyOnPt_
private

Definition at line 35 of file DistortedPFCandProducer.cc.

Referenced by DistortedPFCandProducer(), and produce().

◆ shiftOnOneOverPt_

std::vector<double> DistortedPFCandProducer::shiftOnOneOverPt_
private

Definition at line 32 of file DistortedPFCandProducer.cc.

Referenced by DistortedPFCandProducer(), and produce().

◆ uncertaintyOnOneOverPt_

std::vector<double> DistortedPFCandProducer::uncertaintyOnOneOverPt_
private

Definition at line 34 of file DistortedPFCandProducer.cc.

Referenced by DistortedPFCandProducer(), and produce().

MuonAlignmentFromReference_cff.newmuons
newmuons
Definition: MuonAlignmentFromReference_cff.py:26
mps_fire.i
i
Definition: mps_fire.py:355
etaBin
int etaBin(const l1t::HGCalMulticluster *cl)
Definition: L1EGammaEEProducer.cc:19
amptDefaultParameters_cff.mu
mu
Definition: amptDefaultParameters_cff.py:16
DistortedPFCandProducer::pfToken_
edm::EDGetTokenT< edm::View< reco::PFCandidate > > pfToken_
Definition: DistortedPFCandProducer.cc:29
edm::Handle
Definition: AssociativeIterator.h:50
edm::Ref< MuonCollection >
reco::PFCandidate::mu
Definition: PFCandidate.h:47
LaserClient_cfi.nbins
nbins
Definition: LaserClient_cfi.py:51
reco::Particle::PolarLorentzVector
math::PtEtaPhiMLorentzVector PolarLorentzVector
Lorentz vector.
Definition: Particle.h:23
gen
Definition: PythiaDecays.h:13
DistortedPFCandProducer::uncertaintyOnOneOverPt_
std::vector< double > uncertaintyOnOneOverPt_
Definition: DistortedPFCandProducer.cc:34
HLT_2018_cff.InputTag
InputTag
Definition: HLT_2018_cff.py:79016
edm::LogError
Definition: MessageLogger.h:183
DistortedPFCandProducer::genMatchMapToken_
edm::EDGetTokenT< reco::GenParticleMatch > genMatchMapToken_
Definition: DistortedPFCandProducer.cc:28
edm::Ref::isNonnull
bool isNonnull() const
Checks for non-null.
Definition: Ref.h:238
DistortedPFCandProducer::efficiencyRatioOverMC_
std::vector< double > efficiencyRatioOverMC_
Definition: DistortedPFCandProducer.cc:37
pdwgLeptonRecoSkim_cfi.muonCollection
muonCollection
Definition: pdwgLeptonRecoSkim_cfi.py:7
reco::LeafCandidate::setP4
void setP4(const LorentzVector &p4) final
set 4-momentum
Definition: LeafCandidate.h:158
eostools.move
def move(src, dest)
Definition: eostools.py:511
DistortedPFCandProducer::shiftOnOneOverPt_
std::vector< double > shiftOnOneOverPt_
Definition: DistortedPFCandProducer.cc:32
packedPFCandidateRefMixer_cfi.pf
pf
Definition: packedPFCandidateRefMixer_cfi.py:4
ev
bool ev
Definition: Hydjet2Hadronizer.cc:95
DistortedPFCandProducer::muonToken_
edm::EDGetTokenT< edm::View< reco::Muon > > muonToken_
Definition: DistortedPFCandProducer.cc:27
reco::PFCandidateCollection
std::vector< reco::PFCandidate > PFCandidateCollection
collection of PFCandidates
Definition: PFCandidateFwd.h:12
DistortedPFCandProducer::etaBinEdges_
std::vector< double > etaBinEdges_
Definition: DistortedPFCandProducer.cc:30
edm::RefToBase
Definition: AssociativeIterator.h:54
DistortedPFCandProducer::relativeShiftOnPt_
std::vector< double > relativeShiftOnPt_
Definition: DistortedPFCandProducer.cc:33
reco::PFCandidate
Particle reconstructed by the particle flow algorithm.
Definition: PFCandidate.h:40
edm::Ref::key
key_type key() const
Accessor for product key.
Definition: Ref.h:250
LogTrace
#define LogTrace(id)
Definition: MessageLogger.h:671
dqmiolumiharvest.j
j
Definition: dqmiolumiharvest.py:66
edm::InputTag
Definition: InputTag.h:15
DistortedPFCandProducer::relativeUncertaintyOnPt_
std::vector< double > relativeUncertaintyOnPt_
Definition: DistortedPFCandProducer.cc:35
muonDTDigis_cfi.pset
pset
Definition: muonDTDigis_cfi.py:27