Skip to content

Commit

Permalink
Merge pull request #5526 from arizzi/miniAODportsOf_4914_4833_4862_50…
Browse files Browse the repository at this point in the history
…37_5230_From720pre6Plus5425

Same as #5525 (#4914 #4833 #4862 #5037 #5230 plus #5425 and other fixes) MiniAOD related
  • Loading branch information
davidlange6 committed Sep 26, 2014
2 parents fd09fc8 + 0246744 commit 9c8306e
Show file tree
Hide file tree
Showing 41 changed files with 137 additions and 54 deletions.
2 changes: 1 addition & 1 deletion DataFormats/PatCandidates/interface/MET.h
Expand Up @@ -168,7 +168,7 @@ namespace pat {
enum METUncertainty {
JetEnUp=0, JetEnDown=1, JetResUp=2, JetResDown=3,
MuonEnUp=4, MuonEnDown=5, ElectronEnUp=6, ElectronEnDown=7, TauEnUp=8,TauEnDown=9,
UnclusteredEnUp=10,UnclusteredEnDown=11, METUncertaintySize=12
UnclusteredEnUp=10,UnclusteredEnDown=11, NoShift=12, METUncertaintySize=13
};
enum METUncertaintyLevel {
Raw=0, Type1=1, Type1p2=2
Expand Down
3 changes: 3 additions & 0 deletions DataFormats/PatCandidates/interface/PackedGenParticle.h
Expand Up @@ -56,6 +56,9 @@ namespace pat {
virtual size_t numberOfMothers() const;
/// return mother at a given position (throws an exception)
virtual const reco::Candidate * mother( size_type ) const;
/// direct access to the mother reference (may be null)
const reco::GenParticleRef & motherRef() const { return mother_; }

/// return daughter at a given position (throws an exception)
virtual reco::Candidate * daughter( size_type );
/// return daughter with a specified role name
Expand Down
2 changes: 1 addition & 1 deletion DataFormats/PatCandidates/src/Electron.cc
Expand Up @@ -395,7 +395,7 @@ reco::CandidatePtr Electron::sourceCandidatePtr( size_type i ) const {
if (i >= associatedPackedFCandidateIndices_.size()) {
return reco::CandidatePtr();
} else {
return reco::CandidatePtr(edm::refToPtr(edm::Ref<pat::PackedCandidateCollection>(packedPFCandidates_, i)));
return reco::CandidatePtr(edm::refToPtr(edm::Ref<pat::PackedCandidateCollection>(packedPFCandidates_, associatedPackedFCandidateIndices_[i])));
}
}

Expand Down
3 changes: 2 additions & 1 deletion DataFormats/PatCandidates/src/PackedGenParticle.cc
Expand Up @@ -79,7 +79,8 @@ size_t pat::PackedGenParticle::numberOfDaughters() const {
}

size_t pat::PackedGenParticle::numberOfMothers() const {
return 0;
if(mother_.isNonnull()) return 1;
return 0;
}

bool pat::PackedGenParticle::overlap( const reco::Candidate & o ) const {
Expand Down
2 changes: 1 addition & 1 deletion DataFormats/PatCandidates/src/Photon.cc
Expand Up @@ -335,7 +335,7 @@ reco::CandidatePtr Photon::sourceCandidatePtr( size_type i ) const {
if (i >= associatedPackedFCandidateIndices_.size()) {
return reco::CandidatePtr();
} else {
return reco::CandidatePtr(edm::refToPtr(edm::Ref<pat::PackedCandidateCollection>(packedPFCandidates_, i)));
return reco::CandidatePtr(edm::refToPtr(edm::Ref<pat::PackedCandidateCollection>(packedPFCandidates_, associatedPackedFCandidateIndices_[i])));
}
}

4 changes: 4 additions & 0 deletions DataFormats/PatCandidates/src/classes_def_objects.xml
Expand Up @@ -354,6 +354,10 @@
<class name="edm::Association<pat::PackedCandidateCollection>" />
<class name="edm::Wrapper<edm::Association<pat::PackedCandidateCollection> >" />

<class name="edm::RefProd<std::vector<pat::PackedGenParticle> >" />
<class name="edm::Association<std::vector<pat::PackedGenParticle> >" />
<class name="edm::Wrapper<edm::Association<std::vector<pat::PackedGenParticle> > >"/>

</selection>
<exclusion>
</exclusion>
Expand Down
2 changes: 2 additions & 0 deletions DataFormats/PatCandidates/src/classes_objects.h
Expand Up @@ -167,6 +167,8 @@ namespace DataFormats_PatCandidates {

edm::Wrapper<edm::Association<pat::PackedCandidateCollection > > w_asso_pc;
edm::Wrapper<edm::Association<reco::PFCandidateCollection > > w_asso_pfc;
edm::Wrapper<edm::Association<std::vector<pat::PackedGenParticle> > > asso_pgp;


};

Expand Down
4 changes: 3 additions & 1 deletion JetMETCorrections/Type1MET/plugins/CorrectedPFMETProducer.cc
Expand Up @@ -28,10 +28,12 @@ namespace CorrectedMETProducer_namespace

reco::PFMET operator()(const reco::PFMET& rawMEt, const CorrMETData& correction) const
{
return reco::PFMET(rawMEt.getSpecific(),
reco::PFMET ret(rawMEt.getSpecific(),
correctedSumEt(rawMEt, correction),
correctedP4(rawMEt, correction),
rawMEt.vertex());
ret.setSignificanceMatrix(rawMEt.getSignificanceMatrix());
return ret;
}
};
}
Expand Down
31 changes: 30 additions & 1 deletion PhysicsTools/PatAlgos/plugins/PATGenJetSlimmer.cc
Expand Up @@ -15,7 +15,9 @@
#include "FWCore/Framework/interface/Event.h"
#include "FWCore/ParameterSet/interface/ParameterSet.h"
#include "CommonTools/Utils/interface/StringCutObjectSelector.h"

#include "DataFormats/Common/interface/Association.h"
#include "DataFormats/Common/interface/RefToPtr.h"
#include "DataFormats/PatCandidates/interface/PackedGenParticle.h"
#include "DataFormats/JetReco/interface/GenJet.h"

namespace pat {
Expand All @@ -29,6 +31,8 @@ namespace pat {

private:
edm::EDGetTokenT<edm::View<reco::GenJet> > src_;
edm::EDGetTokenT<edm::Association<std::vector<pat::PackedGenParticle> > > gp2pgp_;

StringCutObjectSelector<reco::GenJet> cut_;

/// reset daughters to an empty vector
Expand All @@ -41,6 +45,7 @@ namespace pat {

pat::PATGenJetSlimmer::PATGenJetSlimmer(const edm::ParameterSet & iConfig) :
src_(consumes<edm::View<reco::GenJet> >(iConfig.getParameter<edm::InputTag>("src"))),
gp2pgp_(consumes<edm::Association<std::vector<pat::PackedGenParticle> > >(iConfig.getParameter<edm::InputTag>("packedGenParticles"))),
cut_(iConfig.getParameter<std::string>("cut")),
clearDaughters_(iConfig.getParameter<bool>("clearDaughters")),
dropSpecific_(iConfig.getParameter<bool>("dropSpecific"))
Expand All @@ -59,6 +64,10 @@ pat::PATGenJetSlimmer::produce(edm::Event & iEvent, const edm::EventSetup & iSet
auto_ptr<vector<reco::GenJet> > out(new vector<reco::GenJet>());
out->reserve(src->size());

Handle<edm::Association<std::vector<pat::PackedGenParticle> > > gp2pgp;
iEvent.getByToken(gp2pgp_,gp2pgp);


for (View<reco::GenJet>::const_iterator it = src->begin(), ed = src->end(); it != ed; ++it) {
if (!cut_(*it)) continue;

Expand All @@ -68,6 +77,26 @@ pat::PATGenJetSlimmer::produce(edm::Event & iEvent, const edm::EventSetup & iSet
if (clearDaughters_) {
jet.clearDaughters();
}
else // rekey
{
//copy old
reco::CompositePtrCandidate::daughters old = jet.daughterPtrVector();
jet.clearDaughters();
std::map<unsigned int,reco::CandidatePtr> ptrs;
for(unsigned int i=0;i<old.size();i++)
{
// if(! ((*gp2pgp)[old[i]]).isNonnull()) {
// std::cout << "Missing ref for key" << old[i].key() << " pdgid " << old[i]->pdgId() << " st "<< old[i]->status() << " pt " << old[i]->pt() << " eta " << old[i]->eta() << std::endl;
// }
ptrs[((*gp2pgp)[old[i]]).key()]=refToPtr((*gp2pgp)[old[i]]);
}
for(std::map<unsigned int,reco::CandidatePtr>::iterator itp=ptrs.begin();itp!=ptrs.end();itp++) //iterate on sorted items
{
jet.addDaughter(itp->second);
}


}
if (dropSpecific_) {
jet.setSpecific( reco::GenJet::Specific() );
}
Expand Down
2 changes: 2 additions & 0 deletions PhysicsTools/PatAlgos/plugins/PATMETSlimmer.cc
Expand Up @@ -54,6 +54,7 @@ void pat::PATMETSlimmer::maybeReadShifts(const edm::ParameterSet &basePSet, cons
throw cms::Exception("Unsupported", "Reading PSets not supported, for now just use input tag");
} else if (basePSet.existsAs<edm::InputTag>(name)) {
const edm::InputTag & baseTag = basePSet.getParameter<edm::InputTag>(name);
shifts_.push_back(OneMETShift(pat::MET::NoShift, level, baseTag, consumesCollector()));
shifts_.push_back(OneMETShift(pat::MET::JetEnUp, level, baseTag, consumesCollector()));
shifts_.push_back(OneMETShift(pat::MET::JetEnDown, level, baseTag, consumesCollector()));
shifts_.push_back(OneMETShift(pat::MET::JetResUp, level, baseTag, consumesCollector()));
Expand All @@ -75,6 +76,7 @@ pat::PATMETSlimmer::OneMETShift::OneMETShift(pat::MET::METUncertainty shift_, pa
std::string baseTagStr = baseTag.encode();
char buff[1024];
switch (shift) {
case pat::MET::NoShift : snprintf(buff, 1023, baseTagStr.c_str(), "OriginalReserved"); break;
case pat::MET::JetEnUp : snprintf(buff, 1023, baseTagStr.c_str(), "JetEnUp"); break;
case pat::MET::JetEnDown: snprintf(buff, 1023, baseTagStr.c_str(), "JetEnDown"); break;
case pat::MET::JetResUp : snprintf(buff, 1023, baseTagStr.c_str(), "JetResUp"); break;
Expand Down
39 changes: 36 additions & 3 deletions PhysicsTools/PatAlgos/plugins/PATPackedGenParticleProducer.cc
Expand Up @@ -46,19 +46,25 @@ namespace pat {

private:
edm::EDGetTokenT<reco::GenParticleCollection> Cands_;
edm::EDGetTokenT<reco::GenParticleCollection> GenOrigs_;
edm::EDGetTokenT<edm::Association<reco::GenParticleCollection> > Asso_;
edm::EDGetTokenT<edm::Association<reco::GenParticleCollection> > AssoOriginal_;
edm::EDGetTokenT<reco::VertexCollection> PVs_;
double maxEta_;
};
}

pat::PATPackedGenParticleProducer::PATPackedGenParticleProducer(const edm::ParameterSet& iConfig) :
Cands_(consumes<reco::GenParticleCollection>(iConfig.getParameter<edm::InputTag>("inputCollection"))),
GenOrigs_(consumes<reco::GenParticleCollection>(iConfig.getParameter<edm::InputTag>("inputOriginal"))),
Asso_(consumes<edm::Association<reco::GenParticleCollection> >(iConfig.getParameter<edm::InputTag>("map"))),
AssoOriginal_(consumes<edm::Association<reco::GenParticleCollection> >(iConfig.getParameter<edm::InputTag>("inputCollection"))),
PVs_(consumes<reco::VertexCollection>(iConfig.getParameter<edm::InputTag>("inputVertices"))),
maxEta_(iConfig.getParameter<double>("maxEta"))
{
produces< std::vector<pat::PackedGenParticle> > ();
produces< edm::Association< std::vector<pat::PackedGenParticle> > >();

}

pat::PATPackedGenParticleProducer::~PATPackedGenParticleProducer() {}
Expand All @@ -73,6 +79,13 @@ void pat::PATPackedGenParticleProducer::produce(edm::Event& iEvent, const edm::E
edm::Handle<edm::Association<reco::GenParticleCollection> > asso;
iEvent.getByToken( Asso_, asso );

edm::Handle<edm::Association<reco::GenParticleCollection> > assoOriginal;
iEvent.getByToken( AssoOriginal_, assoOriginal);

edm::Handle<reco::GenParticleCollection> genOrigs;
iEvent.getByToken( GenOrigs_, genOrigs);
std::vector<int> mapping(genOrigs->size(), -1);


edm::Handle<reco::VertexCollection> PVs;
iEvent.getByToken( PVs_, PVs );
Expand All @@ -83,13 +96,27 @@ void pat::PATPackedGenParticleProducer::produce(edm::Event& iEvent, const edm::E
PVpos = PV->position();
}

std::auto_ptr< std::vector<pat::PackedGenParticle> > outPtrP( new std::vector<pat::PackedGenParticle> );
//invert the value map from Orig2New to New2Orig
std::map< edm::Ref<reco::GenParticleCollection> , edm::Ref<reco::GenParticleCollection> > reverseMap;
for(unsigned int ic=0, nc = genOrigs->size(); ic < nc; ++ic)
{
edm::Ref<reco::GenParticleCollection> originalRef = edm::Ref<reco::GenParticleCollection>(genOrigs,ic);
edm::Ref<reco::GenParticleCollection> newRef = (*assoOriginal)[originalRef];
reverseMap.insert(std::pair<edm::Ref<reco::GenParticleCollection>,edm::Ref<reco::GenParticleCollection>>(newRef,originalRef));
}

std::auto_ptr< std::vector<pat::PackedGenParticle> > outPtrP( new std::vector<pat::PackedGenParticle> );

unsigned int packed=0;
for(unsigned int ic=0, nc = cands->size(); ic < nc; ++ic) {
const reco::GenParticle &cand=(*cands)[ic];
if(cand.status() ==1 && std::abs(cand.eta() < maxEta_))
if(cand.status() ==1 && std::abs(cand.eta()) < maxEta_)
{
// Obtain original gen particle collection reference from input reference and map
edm::Ref<reco::GenParticleCollection> inputRef = edm::Ref<reco::GenParticleCollection>(cands,ic);
edm::Ref<reco::GenParticleCollection> originalRef=reverseMap[inputRef];
mapping[originalRef.key()]=packed;
packed++;
if(cand.numberOfMothers() > 0) {
edm::Ref<reco::GenParticleCollection> newRef=(*asso)[cand.motherRef(0)];
outPtrP->push_back( pat::PackedGenParticle(cand,newRef));
Expand All @@ -102,8 +129,14 @@ void pat::PATPackedGenParticleProducer::produce(edm::Event& iEvent, const edm::E
}


iEvent.put( outPtrP );
edm::OrphanHandle<std::vector<pat::PackedGenParticle> > oh= iEvent.put( outPtrP );

std::auto_ptr<edm::Association< std::vector<pat::PackedGenParticle> > > gp2pgp(new edm::Association< std::vector<pat::PackedGenParticle> > (oh ));
edm::Association< std::vector<pat::PackedGenParticle> >::Filler gp2pgpFiller(*gp2pgp);
gp2pgpFiller.insert(genOrigs, mapping.begin(), mapping.end());
gp2pgpFiller.fill();
iEvent.put(gp2pgp);


}

Expand Down
2 changes: 1 addition & 1 deletion PhysicsTools/PatAlgos/python/patTemplate_cfg.py
Expand Up @@ -19,7 +19,7 @@
process.load("Configuration.Geometry.GeometryIdeal_cff")
process.load("Configuration.StandardSequences.FrontierConditions_GlobalTag_cff")
from Configuration.AlCa.GlobalTag import GlobalTag
process.GlobalTag = GlobalTag(process.GlobalTag, 'auto:startup')
process.GlobalTag = GlobalTag(process.GlobalTag, 'auto:run2_mc')
process.load("Configuration.StandardSequences.MagneticField_cff")

## Output Module Configuration (expects a path 'p')
Expand Down
Expand Up @@ -7,7 +7,7 @@
## input collection of jets
src = cms.InputTag("ak4PFJetsCHS"),
## payload postfix for testing
payload = cms.string('AK5PFchs'),
payload = cms.string('AK4PFchs'),
## correction levels
levels = cms.vstring(
## tags for the individual jet corrections; when
Expand Down
4 changes: 3 additions & 1 deletion PhysicsTools/PatAlgos/python/slimming/genParticles_cff.py
Expand Up @@ -6,5 +6,7 @@
prunedGenParticlesWithStatusOne.select.append( "keep status == 1")

prunedGenParticles.src = cms.InputTag("prunedGenParticlesWithStatusOne")

packedGenParticles.inputCollection = cms.InputTag("prunedGenParticlesWithStatusOne")
packedGenParticles.map = cms.InputTag("prunedGenParticles")
packedGenParticles.map = cms.InputTag("prunedGenParticles") # map with rekey association from prunedGenParticlesWithStatusOne to prunedGenParticles, used to relink our refs to prunedGen
packedGenParticles.inputOriginal = cms.InputTag("genParticles")
18 changes: 8 additions & 10 deletions PhysicsTools/PatAlgos/python/slimming/miniAOD_tools.py
Expand Up @@ -66,15 +66,6 @@ def miniAOD_customizeCommon(process):
process.selectedPatElectrons.cut = cms.string("")
process.selectedPatTaus.cut = cms.string("pt > 18. && tauID('decayModeFinding')> 0.5")
process.selectedPatPhotons.cut = cms.string("")
#
from PhysicsTools.PatAlgos.tools.jetTools import switchJetCollection
#switch to AK4 (though it should soon be unnecessary as ak4 should become the 71X default)
#FIXME: still using AK5PFchs for jet energy corrections, while waiting for a new globalTag
switchJetCollection(process, jetSource = cms.InputTag('ak4PFJetsCHS'),
jetCorrections = ('AK4PFchs', cms.vstring(['L1FastJet', 'L2Relative', 'L3Absolute']), ''),
btagDiscriminators = ['jetBProbabilityBJetTags', 'jetProbabilityBJetTags', 'trackCountingHighPurBJetTags', 'trackCountingHighEffBJetTags', 'simpleSecondaryVertexHighEffBJetTags',
'simpleSecondaryVertexHighPurBJetTags', 'combinedSecondaryVertexBJetTags' , 'combinedInclusiveSecondaryVertexBJetTags' ],
)

# add CMS top tagger
from RecoJets.JetProducers.caTopTaggers_cff import caTopTagInfos as toptag
Expand Down Expand Up @@ -148,8 +139,14 @@ def miniAOD_customizeCommon(process):
'?(tagInfoSecondaryVertex().nVertices()>0)?(tagInfoSecondaryVertex().secondaryVertex(0).nTracks):(0)',
'?(tagInfoSecondaryVertex().nVertices()>0)?(tagInfoSecondaryVertex().flightDistance(0).value):(0)',
'?(tagInfoSecondaryVertex().nVertices()>0)?(tagInfoSecondaryVertex().flightDistance(0).significance):(0)',
'?(tagInfoSecondaryVertex().nVertices()>0)?(tagInfoSecondaryVertex().secondaryVertex(0).p4.x):(0)',
'?(tagInfoSecondaryVertex().nVertices()>0)?(tagInfoSecondaryVertex().secondaryVertex(0).p4.y):(0)',
'?(tagInfoSecondaryVertex().nVertices()>0)?(tagInfoSecondaryVertex().secondaryVertex(0).p4.z):(0)',
'?(tagInfoSecondaryVertex().nVertices()>0)?(tagInfoSecondaryVertex().secondaryVertex(0).position.x):(0)',
'?(tagInfoSecondaryVertex().nVertices()>0)?(tagInfoSecondaryVertex().secondaryVertex(0).position.y):(0)',
'?(tagInfoSecondaryVertex().nVertices()>0)?(tagInfoSecondaryVertex().secondaryVertex(0).position.z):(0)',
)
process.patJets.userData.userFunctionLabels = cms.vstring('vtxMass','vtxNtracks','vtx3DVal','vtx3DSig')
process.patJets.userData.userFunctionLabels = cms.vstring('vtxMass','vtxNtracks','vtx3DVal','vtx3DSig','vtxPx','vtxPy','vtxPz','vtxPosX','vtxPosY','vtxPosZ')
process.patJets.tagInfoSources = cms.VInputTag(cms.InputTag("secondaryVertexTagInfos"))
process.patJets.addTagInfos = cms.bool(True)
#
Expand Down Expand Up @@ -185,6 +182,7 @@ def miniAOD_customizeMC(process):
process.photonMatch.matched = "prunedGenParticles"
process.photonMatch.src = cms.InputTag("reducedEgamma","reducedGedPhotons")
process.tauMatch.matched = "prunedGenParticles"
process.tauGenJets.GenParticles = "prunedGenParticles"
process.patJetPartonMatch.matched = "prunedGenParticles"
process.patJetPartonMatch.mcStatus = [ 3, 23 ]
process.patJetGenJetMatch.matched = "slimmedGenJets"
Expand Down
Expand Up @@ -2,6 +2,7 @@
packedGenParticles = cms.EDProducer("PATPackedGenParticleProducer",
inputCollection = cms.InputTag("genParticles"),
map = cms.InputTag("genParticles"),
inputOriginal = cms.InputTag("genParticles"),
inputVertices = cms.InputTag("offlineSlimmedPrimaryVertices"),
maxEta = cms.double(5)
maxEta = cms.double(6)
)
2 changes: 1 addition & 1 deletion PhysicsTools/PatAlgos/python/slimming/pileupJetId_cfi.py
Expand Up @@ -10,7 +10,7 @@
vertexes = cms.InputTag("offlinePrimaryVertices"),
algos = cms.VPSet(full_5x_chs),
rho = cms.InputTag("fixedGridRhoFastjetAll"),
jec = cms.string("AK5PFchs"),
jec = cms.string("AK4PFchs"),
applyJec = cms.bool(True),
inputIsCorrected = cms.bool(False),
residualsFromTxt = cms.bool(False),
Expand Down
Expand Up @@ -4,11 +4,11 @@
src = cms.InputTag("genParticles"),
select = cms.vstring(
"drop *", # this is the default
"keep status == 3 || status == 22 || status == 23", #keep event summary status3 (for pythia), 22,23 (pythia8)
"++keep abs(pdgId) == 11 || abs(pdgId) == 13 || abs(pdgId) == 15", # keep leptons, with history
"keep abs(pdgId) == 12 || abs(pdgId) == 14 || abs(pdgId) == 16", # keep neutrinos
"+keep pdgId == 22 && status == 1 && pt > 10", # keep gamma above 10 GeV
"drop status == 2", # drop the shower part of the history
"+keep pdgId == 22 && status == 1 && pt > 10", # keep gamma above 10 GeV and its first parent
"+keep pdgId == 11 && status == 1 && pt > 3", # keep first parent of electrons above 10 GeV
"keep++ abs(pdgId) == 15", # but keep keep taus with decays
"drop status > 30 && status < 70 ", #remove pythia8 garbage
"drop pdgId == 21 && pt < 5", #remove pythia8 garbage
Expand All @@ -25,6 +25,11 @@
"keep abs(pdgId) = 10411 || abs(pdgId) = 10421 || abs(pdgId) = 10413 || abs(pdgId) = 10423 || abs(pdgId) = 20413 || abs(pdgId) = 20423 || abs(pdgId) = 10431 || abs(pdgId) = 10433 || abs(pdgId) = 20433",
# additional b hadrons for jet fragmentation studies
"keep abs(pdgId) = 10511 || abs(pdgId) = 10521 || abs(pdgId) = 10513 || abs(pdgId) = 10523 || abs(pdgId) = 20513 || abs(pdgId) = 20523 || abs(pdgId) = 10531 || abs(pdgId) = 10533 || abs(pdgId) = 20533 || abs(pdgId) = 10541 || abs(pdgId) = 10543 || abs(pdgId) = 20543",
#keep SUSY particles
"keep (1000001 <= abs(pdgId) <= 1000039 ) || ( 2000001 <= abs(pdgId) <= 2000015)",
# keep protons
"keep pdgId = 2212",
"keep status == 3 || status == 22 || status == 23 || ( 11 <= status <= 19)", #keep event summary status3 (for pythia), 22,23 (pythia8)

)
)
3 changes: 2 additions & 1 deletion PhysicsTools/PatAlgos/python/slimming/slimmedGenJets_cfi.py
Expand Up @@ -2,7 +2,8 @@

slimmedGenJets = cms.EDProducer("PATGenJetSlimmer",
src = cms.InputTag("ak4GenJets"),
packedGenParticles = cms.InputTag("packedGenParticles"),
cut = cms.string("pt > 8"),
clearDaughters = cms.bool(True),
clearDaughters = cms.bool(False), #False means rekeying
dropSpecific = cms.bool(False),
)
12 changes: 6 additions & 6 deletions PhysicsTools/PatAlgos/python/slimming/slimming_cff.py
Expand Up @@ -46,13 +46,13 @@

'keep double_fixedGridRho*__*',

'keep *_selectedPatTrigger_*_PAT',
'keep patPackedTriggerPrescales_patTrigger__PAT',
'keep *_l1extraParticles_*_HLT',
'keep L1GlobalTriggerReadoutRecord_gtDigis_*_HLT',
'keep *_selectedPatTrigger_*_*',
'keep patPackedTriggerPrescales_patTrigger__*',
'keep *_l1extraParticles_*_*',
'keep L1GlobalTriggerReadoutRecord_gtDigis_*_*',
'keep *_TriggerResults_*_HLT',
'keep *_TriggerResults_*_PAT', # for MET filters
'keep patPackedCandidates_lostTracks_*_PAT',
'keep patPackedCandidates_lostTracks_*_*',
'keep HcalNoiseSummary_hcalnoise__*',
'keep *_caTopTagInfos_*_*'
)
Expand All @@ -62,7 +62,7 @@
)
MicroEventContentMC.outputCommands += [
'keep *_slimmedGenJets_*_*',
'keep *_packedGenParticles_*_*',
'keep patPackedGenParticles_packedGenParticles_*_*',
'keep recoGenParticles_prunedGenParticles_*_*',
'keep LHEEventProduct_*_*_*',
'keep PileupSummaryInfos_*_*_*',
Expand Down

0 comments on commit 9c8306e

Please sign in to comment.