Skip to content

Commit

Permalink
clang check RecoEgamma
Browse files Browse the repository at this point in the history
  • Loading branch information
davidlange6 committed Oct 8, 2017
1 parent 5349f79 commit a3c7739
Show file tree
Hide file tree
Showing 249 changed files with 711 additions and 711 deletions.
Original file line number Diff line number Diff line change
Expand Up @@ -44,16 +44,16 @@ class BarrelMeasurementEstimator : public MeasurementEstimator
{ theZMin=zmin ; theZMax=zmax ; }

// zero value indicates incompatible ts - hit pair
virtual std::pair<bool,double> estimate( const TrajectoryStateOnSurface & ts, const TrackingRecHit & hit ) const ;
std::pair<bool,double> estimate( const TrajectoryStateOnSurface & ts, const TrackingRecHit & hit ) const override ;
virtual std::pair<bool,double> estimate( const TrajectoryStateOnSurface & ts, const GlobalPoint & gp ) const ;
virtual std::pair<bool,double> estimate( const GlobalPoint & vprim, const TrajectoryStateOnSurface & ts, const GlobalPoint & gp ) const ;
virtual bool estimate( const TrajectoryStateOnSurface & ts, const BoundPlane & plane) const ;
bool estimate( const TrajectoryStateOnSurface & ts, const BoundPlane & plane) const override ;

virtual BarrelMeasurementEstimator* clone() const
BarrelMeasurementEstimator* clone() const override
{ return new BarrelMeasurementEstimator(*this) ; }

MeasurementEstimator::Local2DVector
maximalLocalDisplacement( const TrajectoryStateOnSurface & ts, const BoundPlane & plane) const ;
maximalLocalDisplacement( const TrajectoryStateOnSurface & ts, const BoundPlane & plane) const override ;

private:

Expand Down
6 changes: 3 additions & 3 deletions RecoEgamma/EgammaElectronAlgos/interface/ElectronHcalHelper.h
Original file line number Diff line number Diff line change
Expand Up @@ -43,9 +43,9 @@ class ElectronHcalHelper {
void readEvent( const edm::Event & ) ;
~ElectronHcalHelper() ;

double hcalESum( const reco::SuperCluster & , const std::vector<CaloTowerDetId> * excludeTowers = 0) ;
double hcalESumDepth1( const reco::SuperCluster &, const std::vector<CaloTowerDetId> * excludeTowers = 0) ;
double hcalESumDepth2( const reco::SuperCluster & ,const std::vector<CaloTowerDetId> * excludeTowers = 0 ) ;
double hcalESum( const reco::SuperCluster & , const std::vector<CaloTowerDetId> * excludeTowers = nullptr) ;
double hcalESumDepth1( const reco::SuperCluster &, const std::vector<CaloTowerDetId> * excludeTowers = nullptr) ;
double hcalESumDepth2( const reco::SuperCluster & ,const std::vector<CaloTowerDetId> * excludeTowers = nullptr ) ;
double hOverEConeSize() const { return cfg_.hOverEConeSize ; }

// Behind clusters
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -42,16 +42,16 @@ class ForwardMeasurementEstimator
{ theRMinI = rmin ; theRMaxI = rmax ; }

// zero value indicates incompatible ts - hit pair
virtual std::pair<bool,double> estimate( const TrajectoryStateOnSurface & ts, const TrackingRecHit & hit ) const ;
std::pair<bool,double> estimate( const TrajectoryStateOnSurface & ts, const TrackingRecHit & hit ) const override ;
virtual std::pair<bool,double> estimate( const TrajectoryStateOnSurface & ts, const GlobalPoint & gp ) const ;
virtual std::pair<bool,double> estimate( const GlobalPoint & vprim, const TrajectoryStateOnSurface & ts, const GlobalPoint & gp ) const ;
virtual bool estimate( const TrajectoryStateOnSurface & ts, const BoundPlane & plane ) const ;
bool estimate( const TrajectoryStateOnSurface & ts, const BoundPlane & plane ) const override ;

virtual ForwardMeasurementEstimator* clone() const
ForwardMeasurementEstimator* clone() const override
{ return new ForwardMeasurementEstimator(*this) ; }

MeasurementEstimator::Local2DVector
maximalLocalDisplacement( const TrajectoryStateOnSurface & ts, const BoundPlane & plane) const ;
maximalLocalDisplacement( const TrajectoryStateOnSurface & ts, const BoundPlane & plane) const override ;

private :

Expand Down
4 changes: 2 additions & 2 deletions RecoEgamma/EgammaElectronAlgos/interface/TrajSeedMatcher.h
Original file line number Diff line number Diff line change
Expand Up @@ -177,7 +177,7 @@ class TrajSeedMatcher {
class MatchingCutsV1 : public MatchingCuts {
public:
explicit MatchingCutsV1(const edm::ParameterSet& pset);
bool operator()(const SCHitMatch& scHitMatch)const;
bool operator()(const SCHitMatch& scHitMatch)const override;
private:
float getDRZCutValue(const float scEt, const float scEta)const;
private:
Expand All @@ -191,7 +191,7 @@ class TrajSeedMatcher {
class MatchingCutsV2 : public MatchingCuts {
public:
explicit MatchingCutsV2(const edm::ParameterSet& pset);
bool operator()(const SCHitMatch& scHitMatch)const;
bool operator()(const SCHitMatch& scHitMatch)const override;
private:
size_t getBinNr(float eta)const;
float getCutValue(float et, float highEt, float highEtThres, float lowEtGrad)const{
Expand Down
8 changes: 4 additions & 4 deletions RecoEgamma/EgammaElectronAlgos/src/ElectronHcalHelper.cc
Original file line number Diff line number Diff line change
Expand Up @@ -9,7 +9,7 @@
using namespace reco ;

ElectronHcalHelper::ElectronHcalHelper( const Configuration & cfg )
: cfg_(cfg), caloGeomCacheId_(0), hcalIso_(0), towerIso1_(0), towerIso2_(0),hadTower_(0)
: cfg_(cfg), caloGeomCacheId_(0), hcalIso_(nullptr), towerIso1_(nullptr), towerIso2_(nullptr),hadTower_(nullptr)
{ }

void ElectronHcalHelper::checkSetup( const edm::EventSetup & es )
Expand Down Expand Up @@ -42,8 +42,8 @@ void ElectronHcalHelper::readEvent( const edm::Event & evt )

if (cfg_.useTowers)
{
delete towerIso1_ ; towerIso1_ = 0 ;
delete towerIso2_ ; towerIso2_ = 0 ;
delete towerIso1_ ; towerIso1_ = nullptr ;
delete towerIso2_ ; towerIso2_ = nullptr ;

edm::Handle<CaloTowerCollection> towersH_ ;
if (!evt.getByToken(cfg_.hcalTowers,towersH_)){
Expand All @@ -56,7 +56,7 @@ void ElectronHcalHelper::readEvent( const edm::Event & evt )
}
else
{
delete hcalIso_ ; hcalIso_ = 0 ;
delete hcalIso_ ; hcalIso_ = nullptr ;

edm::Handle<HBHERecHitCollection> hbhe_;
if (!evt.getByToken(cfg_.hcalRecHits,hbhe_)) {
Expand Down
14 changes: 7 additions & 7 deletions RecoEgamma/EgammaElectronAlgos/src/ElectronSeedGenerator.cc
Original file line number Diff line number Diff line change
Expand Up @@ -77,11 +77,11 @@ ElectronSeedGenerator::ElectronSeedGenerator(const edm::ParameterSet &pset,
deltaPhi1Low_(pset.getParameter<double>("DeltaPhi1Low")),
deltaPhi1High_(pset.getParameter<double>("DeltaPhi1High")),
deltaPhi1Coef1_(0.), deltaPhi1Coef2_(0.),
myMatchEle(0), myMatchPos(0),
thePropagator(0),
theMeasurementTracker(0),
myMatchEle(nullptr), myMatchPos(nullptr),
thePropagator(nullptr),
theMeasurementTracker(nullptr),
theMeasurementTrackerEventTag(ts.token_measTrkEvt),
theSetup(0),
theSetup(nullptr),
cacheIDMagField_(0),/*cacheIDGeom_(0),*/cacheIDNavSchool_(0),cacheIDCkfComp_(0),cacheIDTrkGeom_(0)
{
// so that deltaPhi1 = deltaPhi1Coef1_ + deltaPhi1Coef2_/clusterEnergyT
Expand Down Expand Up @@ -457,7 +457,7 @@ void ElectronSeedGenerator::seedsFromRecHits
{ continue ; }
reco::ElectronSeed seed(pts_,recHits_,dir) ;
seed.setCaloCluster(cluster) ;
addSeed(seed,0,positron,out) ;
addSeed(seed,nullptr,positron,out) ;
}
}

Expand Down Expand Up @@ -594,8 +594,8 @@ bool ElectronSeedGenerator::prepareElTrackSeed

recHits_.clear();

SiPixelRecHit *pixhit=0;
SiStripMatchedRecHit2D *striphit=0;
SiPixelRecHit *pixhit=nullptr;
SiStripMatchedRecHit2D *striphit=nullptr;
const SiPixelRecHit* constpixhit = dynamic_cast <const SiPixelRecHit*> (innerhit->hit());
if (constpixhit) {
pixhit=new SiPixelRecHit(*constpixhit);
Expand Down
2 changes: 1 addition & 1 deletion RecoEgamma/EgammaElectronAlgos/src/PixelHitMatcher.cc
Original file line number Diff line number Diff line change
Expand Up @@ -25,7 +25,7 @@ PixelHitMatcher::PixelHitMatcher
meas1stBLayer(phi1min,phi1max,0.,0.), meas2ndBLayer(phi2minB,phi2maxB,z2minB,z2maxB),
meas1stFLayer(phi1min,phi1max,0.,0.), meas2ndFLayer(phi2minF,phi2maxF,r2minF,r2maxF),
startLayers(),
prop1stLayer(0), prop2ndLayer(0),theGeometricSearchTracker(0),theTrackerEvent(0),theTracker(0),vertex_(0.),
prop1stLayer(nullptr), prop2ndLayer(nullptr),theGeometricSearchTracker(nullptr),theTrackerEvent(nullptr),theTracker(nullptr),vertex_(0.),
searchInTIDTEC_(searchInTIDTEC), useRecoVertex_(false)
{
meas1stFLayer.setRRangeI(rMinI,rMaxI) ;
Expand Down
4 changes: 2 additions & 2 deletions RecoEgamma/EgammaElectronAlgos/src/RegressionHelper.cc
Original file line number Diff line number Diff line change
Expand Up @@ -107,7 +107,7 @@ void RegressionHelper::checkSetup(const edm::EventSetup & es) {

// read weights from file - for debugging. Even if it is one single files, 4 files should b set in the vector
if(!cfg_.ecalWeightsFromDB && !ecalRegressionInitialized_ &&
cfg_.ecalRegressionWeightFiles.size() ) {
!cfg_.ecalRegressionWeightFiles.empty() ) {
TFile file0 (edm::FileInPath(cfg_.ecalRegressionWeightFiles[0].c_str()).fullPath().c_str());
ecalRegBarrel_ = (const GBRForest*)file0.Get(cfg_.ecalRegressionWeightLabels[0].c_str());
file0.Close();
Expand All @@ -124,7 +124,7 @@ void RegressionHelper::checkSetup(const edm::EventSetup & es) {
}

if(!cfg_.combinationWeightsFromDB && !combinationRegressionInitialized_ &&
cfg_.combinationRegressionWeightFiles.size() )
!cfg_.combinationRegressionWeightFiles.empty() )
{
TFile file0 (edm::FileInPath(cfg_.combinationRegressionWeightFiles[0].c_str()).fullPath().c_str());
combinationReg_ = (const GBRForest*)file0.Get(cfg_.combinationRegressionWeightLabels[0].c_str());
Expand Down
2 changes: 1 addition & 1 deletion RecoEgamma/EgammaElectronAlgos/src/SeedFilter.cc
Original file line number Diff line number Diff line change
Expand Up @@ -71,7 +71,7 @@ SeedFilter::SeedFilter(const edm::ParameterSet& conf,
edm::ParameterSet seedCreatorPSet = conf.getParameter<edm::ParameterSet>("SeedCreatorPSet");
std::string seedCreatorType = seedCreatorPSet.getParameter<std::string>("ComponentName");

combinatorialSeedGenerator = new SeedGeneratorFromRegionHits(hitsGenerator,0,
combinatorialSeedGenerator = new SeedGeneratorFromRegionHits(hitsGenerator,nullptr,
SeedCreatorFactory::get()->create(seedCreatorType, seedCreatorPSet)
);
beamSpotTag_ = tokens.token_bs; ;
Expand Down
10 changes: 5 additions & 5 deletions RecoEgamma/EgammaElectronAlgos/src/SiStripElectronAlgo.cc
Original file line number Diff line number Diff line change
Expand Up @@ -896,9 +896,9 @@ bool SiStripElectronAlgo::projectPhiBand(float chargeHypothesis, const reco::Sup
debugstr5 << " Chi1 " << chi1 << " Chi2 " << chi2 <<"\n";
#endif
if( chi1< chi2 ){
uselist[j] = 0;
uselist[j] = false;
}else{
uselist[i] = 0;
uselist[i] = false;
}

} // end of Det check
Expand Down Expand Up @@ -930,7 +930,7 @@ bool SiStripElectronAlgo::projectPhiBand(float chargeHypothesis, const reco::Sup
<< " Chi2 " << (philist[i]-(rlist[i]-scr)*phiVsRSlope)*(philist[i]-(rlist[i]-scr)*phiVsRSlope)*w2list[i]
<< " \n" ;
#endif
uselist[i]=0 ;
uselist[i]=false ;
}
}
}
Expand Down Expand Up @@ -1093,7 +1093,7 @@ bool SiStripElectronAlgo::projectPhiBand(float chargeHypothesis, const reco::Sup
// Now we have intercept, slope, and chi2; uselist to tell us which hits are used, and hitlist for the hits

// Identify the innermost hit
const SiStripRecHit2D* innerhit = (SiStripRecHit2D*)(0);
const SiStripRecHit2D* innerhit = (SiStripRecHit2D*)nullptr;
double innerhitRadius = -1.; // meaningless until innerhit is defined

// Copy hits into an OwnVector, which we put in the TrackCandidate
Expand All @@ -1111,7 +1111,7 @@ bool SiStripElectronAlgo::projectPhiBand(float chargeHypothesis, const reco::Sup
const SiStripRecHit2D* hit = hitlist[i];

// Keep track of the innermost hit
if (innerhit == (SiStripRecHit2D*)(0) || r < innerhitRadius) {
if (innerhit == (SiStripRecHit2D*)nullptr || r < innerhitRadius) {
innerhit = hit;
innerhitRadius = r;
}
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -49,9 +49,9 @@ Description: SiStrip-driven electron seed finding algorithm.

SiStripElectronSeedGenerator::SiStripElectronSeedGenerator(const edm::ParameterSet &pset, const SiStripElectronSeedGenerator::Tokens& tokens)
: beamSpotTag_(tokens.token_bs),
theUpdator(0),thePropagator(0),theMeasurementTracker(0),
theUpdator(nullptr),thePropagator(nullptr),theMeasurementTracker(nullptr),
theMeasurementTrackerEventTag(tokens.token_mte),
theSetup(0), theMatcher_(0),
theSetup(nullptr), theMatcher_(nullptr),
cacheIDMagField_(0),cacheIDCkfComp_(0),cacheIDTrkGeom_(0),
tibOriginZCut_(pset.getParameter<double>("tibOriginZCut")),
tidOriginZCut_(pset.getParameter<double>("tidOriginZCut")),
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -44,9 +44,9 @@ class ElectronNHitSeedProducer : public edm::stream::EDProducer<> {


explicit ElectronNHitSeedProducer( const edm::ParameterSet & ) ;
virtual ~ElectronNHitSeedProducer()=default;
~ElectronNHitSeedProducer() override =default;

virtual void produce( edm::Event &, const edm::EventSetup & ) override final;
void produce( edm::Event &, const edm::EventSetup & ) final;

static void fillDescriptions(edm::ConfigurationDescriptions& descriptions);

Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -46,11 +46,11 @@ class ElectronSeedProducer : public edm::stream::EDProducer<>
//static void fillDescriptions( edm::ConfigurationDescriptions & ) ;

explicit ElectronSeedProducer( const edm::ParameterSet & ) ;
virtual void beginRun( edm::Run const&, edm::EventSetup const & ) override final;
virtual void endRun( edm::Run const&, edm::EventSetup const & ) override final;
virtual ~ElectronSeedProducer() ;
void beginRun( edm::Run const&, edm::EventSetup const & ) final;
void endRun( edm::Run const&, edm::EventSetup const & ) final;
~ElectronSeedProducer() override ;

virtual void produce( edm::Event &, const edm::EventSetup & ) override final;
void produce( edm::Event &, const edm::EventSetup & ) final;

static void fillDescriptions(edm::ConfigurationDescriptions& descriptions);
private:
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -12,8 +12,8 @@ class GEDGsfElectronCoreProducer : public GsfElectronCoreBaseProducer
static void fillDescriptions( edm::ConfigurationDescriptions & ) ;

explicit GEDGsfElectronCoreProducer( const edm::ParameterSet & conf ) ;
virtual ~GEDGsfElectronCoreProducer() ;
virtual void produce( edm::Event&, const edm::EventSetup & ) ;
~GEDGsfElectronCoreProducer() override ;
void produce( edm::Event&, const edm::EventSetup & ) override ;

private:

Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -19,9 +19,9 @@ class GEDGsfElectronFinalizer : public edm::stream::EDProducer<>
{
public:
explicit GEDGsfElectronFinalizer (const edm::ParameterSet &);
~GEDGsfElectronFinalizer();
~GEDGsfElectronFinalizer() override;

virtual void produce(edm::Event &, const edm::EventSetup&);
void produce(edm::Event &, const edm::EventSetup&) override;

private:
edm::EDGetTokenT<reco::GsfElectronCollection> previousGsfElectrons_;
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -13,8 +13,8 @@ class GEDGsfElectronProducer : public GsfElectronBaseProducer
//static void fillDescriptions( edm::ConfigurationDescriptions & ) ;

explicit GEDGsfElectronProducer( const edm::ParameterSet &, const gsfAlgoHelpers::HeavyObjectCache* ) ;
virtual ~GEDGsfElectronProducer() ;
virtual void produce( edm::Event &, const edm::EventSetup & ) ;
~GEDGsfElectronProducer() override ;
void produce( edm::Event &, const edm::EventSetup & ) override ;

private:
edm::EDGetTokenT<reco::PFCandidateCollection> egmPFCandidateCollection_;
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -33,7 +33,7 @@ class GsfElectronBaseProducer : public edm::stream::EDProducer< edm::GlobalCache
static void fillDescription( edm::ParameterSetDescription & ) ;

explicit GsfElectronBaseProducer( const edm::ParameterSet &, const gsfAlgoHelpers::HeavyObjectCache* ) ;
virtual ~GsfElectronBaseProducer() ;
~GsfElectronBaseProducer() override ;

static std::unique_ptr<gsfAlgoHelpers::HeavyObjectCache>
initializeGlobalCache( const edm::ParameterSet& conf ) {
Expand All @@ -50,7 +50,7 @@ class GsfElectronBaseProducer : public edm::stream::EDProducer< edm::GlobalCache
void beginEvent( edm::Event &, const edm::EventSetup & ) ;
void fillEvent( edm::Event & ) ;
void endEvent() ;
reco::GsfElectron * newElectron() { return 0 ; }
reco::GsfElectron * newElectron() { return nullptr ; }
const edm::OrphanHandle<reco::GsfElectronCollection> & orphanHandle() const { return orphanHandle_;}

// configurables
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -35,7 +35,7 @@ class GsfElectronCoreBaseProducer : public edm::stream::EDProducer<>
static void fillDescription( edm::ParameterSetDescription & ) ;

explicit GsfElectronCoreBaseProducer( const edm::ParameterSet & conf ) ;
virtual ~GsfElectronCoreBaseProducer() ;
~GsfElectronCoreBaseProducer() override ;


protected:
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -11,8 +11,8 @@ class GsfElectronCoreEcalDrivenProducer : public GsfElectronCoreBaseProducer
//static void fillDescriptions( edm::ConfigurationDescriptions & ) ;

explicit GsfElectronCoreEcalDrivenProducer( const edm::ParameterSet & conf ) ;
virtual ~GsfElectronCoreEcalDrivenProducer() ;
virtual void produce( edm::Event&, const edm::EventSetup & ) ;
~GsfElectronCoreEcalDrivenProducer() override ;
void produce( edm::Event&, const edm::EventSetup & ) override ;

private:

Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -13,8 +13,8 @@ class GsfElectronCoreProducer : public GsfElectronCoreBaseProducer
//static void fillDescriptions( edm::ConfigurationDescriptions & ) ;

explicit GsfElectronCoreProducer( const edm::ParameterSet & ) ;
virtual ~GsfElectronCoreProducer() ;
virtual void produce( edm::Event &, const edm::EventSetup & ) ;
~GsfElectronCoreProducer() override ;
void produce( edm::Event &, const edm::EventSetup & ) override ;

private:

Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -11,8 +11,8 @@ class GsfElectronEcalDrivenProducer : public GsfElectronBaseProducer
//static void fillDescriptions( edm::ConfigurationDescriptions & ) ;

explicit GsfElectronEcalDrivenProducer( const edm::ParameterSet &, const gsfAlgoHelpers::HeavyObjectCache* ) ;
virtual ~GsfElectronEcalDrivenProducer() ;
virtual void produce( edm::Event &, const edm::EventSetup & ) ;
~GsfElectronEcalDrivenProducer() override ;
void produce( edm::Event &, const edm::EventSetup & ) override ;

} ;

Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -108,7 +108,7 @@ void GsfElectronFull5x5Filler::calculateShowerShape_full5x5( const reco::SuperCl
DetId seedXtalId = seedCluster.hitsAndFractions()[0].first ;
int detector = seedXtalId.subdetId() ;

const EcalRecHitCollection * recHits = 0 ;
const EcalRecHitCollection * recHits = nullptr ;
if (detector==EcalBarrel)
{
recHits = _ebRecHits.product() ;
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -17,8 +17,8 @@ class GsfElectronFull5x5Filler : public edm::stream::EDProducer<>
//static void fillDescriptions( edm::ConfigurationDescriptions & ) ;

explicit GsfElectronFull5x5Filler( const edm::ParameterSet & ) ;
virtual ~GsfElectronFull5x5Filler() ;
virtual void produce( edm::Event &, const edm::EventSetup & ) override ;
~GsfElectronFull5x5Filler() override ;
void produce( edm::Event &, const edm::EventSetup & ) override ;
void calculateShowerShape_full5x5(const reco::SuperClusterRef & theClus, bool pflow, reco::GsfElectron::ShowerShape & showerShape);

void beginLuminosityBlock(edm::LuminosityBlock const&,
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -11,8 +11,8 @@ class GsfElectronProducer : public GsfElectronBaseProducer
//static void fillDescriptions( edm::ConfigurationDescriptions & ) ;

explicit GsfElectronProducer( const edm::ParameterSet &, const gsfAlgoHelpers::HeavyObjectCache* ) ;
virtual ~GsfElectronProducer();
virtual void produce( edm::Event &, const edm::EventSetup & ) ;
~GsfElectronProducer() override;
void produce( edm::Event &, const edm::EventSetup & ) override ;

protected:

Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -42,10 +42,10 @@
class SiStripElectronAssociator : public edm::stream::EDProducer<> {
public:
explicit SiStripElectronAssociator(const edm::ParameterSet&);
~SiStripElectronAssociator();
~SiStripElectronAssociator() override;


virtual void produce(edm::Event&, const edm::EventSetup&);
void produce(edm::Event&, const edm::EventSetup&) override;
private:
// ----------member data ---------------------------
edm::EDGetTokenT<reco::SiStripElectronCollection> siStripElectronCollection_;
Expand Down
Loading

0 comments on commit a3c7739

Please sign in to comment.