Skip to content

Commit

Permalink
DQM* -- changes for large object passed by value found by clang stati…
Browse files Browse the repository at this point in the history
…c analyzer cms.ArgSizeChecker
  • Loading branch information
gartung committed Sep 19, 2013
1 parent b515b3c commit c5ab2f4
Show file tree
Hide file tree
Showing 75 changed files with 171 additions and 164 deletions.
4 changes: 2 additions & 2 deletions DQM/BeamMonitor/plugins/BeamMonitorBx.cc
Original file line number Diff line number Diff line change
Expand Up @@ -217,7 +217,7 @@ void BeamMonitorBx::BookTables(int nBx, map<string,string> & vMap, string suffix

//--------------------------------------------------------
void BeamMonitorBx::BookTrendHistos(bool plotPV,int nBx,map<string,string> & vMap,
string subDir_, TString prefix_, TString suffix_) {
string subDir_, const TString& prefix_, const TString& suffix_) {
int nType_ = 2;
if (plotPV) nType_ = 4;
std::ostringstream ss;
Expand Down Expand Up @@ -465,7 +465,7 @@ void BeamMonitorBx::FillTables(int nthbx,int nthbin_,

//--------------------------------------------------------
void BeamMonitorBx::FillTrendHistos(int nthBx, int nPVs_, map<string,string> & vMap,
reco::BeamSpot & bs_, TString prefix_) {
reco::BeamSpot & bs_, const TString& prefix_) {
map<TString,pair<double,double> > val_;
val_[TString(prefix_+"_x")] = pair<double,double>(bs_.x0(),bs_.x0Error());
val_[TString(prefix_+"_y")] = pair<double,double>(bs_.y0(),bs_.y0Error());
Expand Down
4 changes: 2 additions & 2 deletions DQM/BeamMonitor/plugins/BeamMonitorBx.h
Original file line number Diff line number Diff line change
Expand Up @@ -57,11 +57,11 @@ class BeamMonitorBx : public edm::EDAnalyzer {
void FitAndFill(const edm::LuminosityBlock& lumiSeg, int&, int&, int&);
void BookTables(int, std::map<std::string,std::string>&,std::string);
void BookTrendHistos(bool, int, std::map<std::string,std::string>&,
std::string, TString, TString);
std::string, const TString&, const TString&);
void FillTables(int, int, std::map<std::string,std::string>&,
reco::BeamSpot&, std::string);
void FillTrendHistos(int, int, std::map<std::string,std::string>&,
reco::BeamSpot&, TString);
reco::BeamSpot&, const TString&);
void weight(BeamSpotMapBx&, const BeamSpotMapBx&);
void weight(double& mean,double& meanError,const double& val,const double& valError);
const char * formatFitTime( const std::time_t&);
Expand Down
20 changes: 10 additions & 10 deletions DQM/CSCMonitorModule/plugins/CSCDQM_Summary.cc
Original file line number Diff line number Diff line change
Expand Up @@ -396,7 +396,7 @@ namespace cscdqm {
* @param adr Address to be updated
* @param bit Status bit to set
*/
void Summary::ReSetValue(Address adr, const HWStatusBit bit) {
void Summary::ReSetValue(const Address& adr, const HWStatusBit bit) {
SetValue(adr, bit, 0);
}

Expand All @@ -417,8 +417,8 @@ namespace cscdqm {
* @param bit Status bit to set
* @param value Value to be set
*/
void Summary::SetValue(Address adr, const HWStatusBit bit, const int value) {

void Summary::SetValue(const Address& _adr, const HWStatusBit bit, const int value) {
Address adr = _adr;
if (!adr.mask.side) {
adr.mask.side = true;
for (adr.side = 1; adr.side <= N_SIDES; adr.side++) SetValue(adr, bit, value);
Expand Down Expand Up @@ -549,9 +549,9 @@ namespace cscdqm {
* @param adr Address to watch efficiency for
* @return Subdetector efficiency rate (0..1)
*/
const double Summary::GetEfficiencyHW(Address adr) const {
const double Summary::GetEfficiencyHW(const Address& _adr) const {
double sum = 0.0;

Address adr = _adr;
if (!adr.mask.side) {
adr.mask.side = true;
for (adr.side = 1; adr.side <= N_SIDES; adr.side++) sum += GetEfficiencyHW(adr);
Expand Down Expand Up @@ -622,7 +622,7 @@ namespace cscdqm {
* @param adr Address
* @return Area in eta/phi space
*/
const double Summary::GetEfficiencyArea(Address adr) const {
const double Summary::GetEfficiencyArea(const Address& adr) const {
double all_area = 1;

if (adr.mask.side == false &&
Expand All @@ -645,9 +645,9 @@ namespace cscdqm {
* @param adr Address to calculate
* @return Area in eta/phi space
*/
const double Summary::GetReportingArea(Address adr) const {
const double Summary::GetReportingArea(const Address& _adr) const {
double sum = 0.0;

Address adr = _adr;
if (!adr.mask.side) {
adr.mask.side = true;
for (adr.side = 1; adr.side <= N_SIDES; adr.side++) sum += GetReportingArea(adr);
Expand Down Expand Up @@ -732,8 +732,8 @@ namespace cscdqm {
* @param adr Address of atomic element to return value from
* @return Value of the requested element
*/
const HWStatusBitSet Summary::GetValue(Address adr) const {

const HWStatusBitSet Summary::GetValue(const Address& _adr) const {
Address adr = _adr;
HWStatusBitSet state;
state.reset();

Expand Down
12 changes: 6 additions & 6 deletions DQM/CSCMonitorModule/plugins/CSCDQM_Summary.h
Original file line number Diff line number Diff line change
Expand Up @@ -97,19 +97,19 @@ class Summary {
void WriteChamberState(TH2*& h2, const int mask, const int value = 1, const bool reset = true, const bool op_any = false) const;

void ReSetValue(const HWStatusBit bit);
void ReSetValue(Address adr, const HWStatusBit bit);
void ReSetValue(const Address& adr, const HWStatusBit bit);
void SetValue(const HWStatusBit bit, const int value = 1);
void SetValue(Address adr, const HWStatusBit bit, const int value = 1);
void SetValue(const Address& adr, const HWStatusBit bit, const int value = 1);

const HWStatusBitSet GetValue(Address adr) const;
const HWStatusBitSet GetValue(const Address& adr) const;
const int IsPhysicsReady(const unsigned int px, const unsigned int py);
//const int IsPhysicsReady(const float xmin, const float xmax, const float ymin, const float ymax) const;

const double GetEfficiencyHW() const;
const double GetEfficiencyHW(const unsigned int station) const;
const double GetEfficiencyHW(Address adr) const;
const double GetEfficiencyHW(const Address& adr) const;
const double GetEfficiencyArea(const unsigned int station) const;
const double GetEfficiencyArea(Address adr) const;
const double GetEfficiencyArea(const Address& adr) const;

bool isChamberStandby(unsigned int side, unsigned int station, unsigned int ring, unsigned int chamber) const;
bool isChamberStandby(CSCDetId cid) const;
Expand All @@ -118,7 +118,7 @@ class Summary {

const bool ChamberCoordsToAddress(const unsigned int x, const unsigned int y, Address& adr) const;
const bool ChamberAddressToCoords(const Address& adr, unsigned int& x, unsigned int& y) const;
const double GetReportingArea(Address adr) const;
const double GetReportingArea(const Address& adr) const;

/** Atomic HW element status matrix */
HWStatusBitSet map[N_SIDES][N_STATIONS][N_RINGS][N_CHAMBERS][N_LAYERS][N_CFEBS][N_HVS];
Expand Down
2 changes: 1 addition & 1 deletion DQM/CastorMonitor/interface/CastorDigiMonitor.h
Original file line number Diff line number Diff line change
Expand Up @@ -26,7 +26,7 @@ class CastorDigiMonitor: public CastorBaseMonitor {
void reset();

private:
void perChanHists(std::vector<HcalCastorDetId> detID, std::vector<int> capID, std::vector<float> peds,
void perChanHists(const std::vector<HcalCastorDetId>& detID, const std::vector<int>& capID, const std::vector<float>& peds,
std::map<HcalCastorDetId, std::map<int, MonitorElement*> > &toolP,
////// std::map<HcalCastorDetId, std::map<int, MonitorElement*> > &toolS,
std::string baseFolder);
Expand Down
2 changes: 1 addition & 1 deletion DQM/CastorMonitor/interface/CastorPSMonitor.h
Original file line number Diff line number Diff line change
Expand Up @@ -18,7 +18,7 @@ class CastorPSMonitor: public CastorBaseMonitor {

void setup(const edm::ParameterSet& ps, DQMStore* dbe);
void beginRun(const edm::Run& iRun, const edm::EventSetup& iSetup);
void processEvent(const CastorDigiCollection& castorDigis, const CastorDbService& conditions, std::vector<HcalGenericDetId> listEMap, int iBunch, float PedSigmaInChannel[14][16]);
void processEvent(const CastorDigiCollection& castorDigis, const CastorDbService& conditions, const std::vector<HcalGenericDetId>& listEMap, int iBunch, float PedSigmaInChannel[14][16]);
void reset();

private:
Expand Down
2 changes: 1 addition & 1 deletion DQM/CastorMonitor/src/CastorDigiMonitor.cc
Original file line number Diff line number Diff line change
Expand Up @@ -227,7 +227,7 @@ void CastorDigiMonitor::done()
//======================= perChanHists ============================//
//==================================================================//
////---- do histograms per channel
void CastorDigiMonitor::perChanHists( std::vector<HcalCastorDetId> detID, std::vector<int> capID, std::vector<float> peds,
void CastorDigiMonitor::perChanHists( const std::vector<HcalCastorDetId>& detID, const std::vector<int>& capID, const std::vector<float>& peds,
std::map<HcalCastorDetId, std::map<int, MonitorElement*> > &toolP,
////// std::map<HcalCastorDetId, std::map<int, MonitorElement*> > &toolS,
std::string baseFolder)
Expand Down
2 changes: 1 addition & 1 deletion DQM/CastorMonitor/src/CastorPSMonitor.cc
Original file line number Diff line number Diff line change
Expand Up @@ -170,7 +170,7 @@ void CastorPSMonitor::beginRun(const edm::Run& iRun, const edm::EventSetup& iSet
//================== processEvent ==========================//
//==========================================================//

void CastorPSMonitor::processEvent(const CastorDigiCollection& castorDigis, const CastorDbService& conditions, std::vector<HcalGenericDetId> listEMap, int iBunch, float PedSigmaInChannel[14][16])
void CastorPSMonitor::processEvent(const CastorDigiCollection& castorDigis, const CastorDbService& conditions, const std::vector<HcalGenericDetId>& listEMap, int iBunch, float PedSigmaInChannel[14][16])
{
if(fVerbosity>0) std::cout << "CastorPSMonitor::processEvent (begin)" << std::endl;

Expand Down
2 changes: 1 addition & 1 deletion DQM/DTMonitorModule/interface/DTCalibValidation.h
Original file line number Diff line number Diff line change
Expand Up @@ -115,7 +115,7 @@ class DTCalibValidation: public edm::EDAnalyzer{
template <typename type>
void compute(const DTGeometry *dtGeom,
const DTRecSegment4D& segment,
std::map<DTWireId, std::vector<type> > recHitsPerWire,
const std::map<DTWireId, std::vector<type> >& recHitsPerWire,
int step);

// Book a set of histograms for a give chamber
Expand Down
3 changes: 2 additions & 1 deletion DQM/DTMonitorModule/src/DTCalibValidation.cc
Original file line number Diff line number Diff line change
Expand Up @@ -347,8 +347,9 @@ DTCalibValidation::recHitPosition(const DTRecHit1D& recHit, const DTLayer* layer
template <typename type>
void DTCalibValidation::compute(const DTGeometry *dtGeom,
const DTRecSegment4D& segment,
std::map<DTWireId, std::vector<type> > recHitsPerWire,
const std::map<DTWireId, std::vector<type> >& _recHitsPerWire,
int step) {
std::map<DTWireId, std::vector<type> > recHitsPerWire = _recHitsPerWire;
bool computeResidual = true;

// Get all 1D RecHits at step 3 within the 4D segment
Expand Down
2 changes: 1 addition & 1 deletion DQM/DTMonitorModule/src/DTChamberEfficiency.cc
Original file line number Diff line number Diff line change
Expand Up @@ -287,7 +287,7 @@ bool DTChamberEfficiency::chamberSelection(const DetId& idDetLay, reco::Transien

//riempi una per ogni segmento e una per segmento sopra 12 hit

MeasurementContainer DTChamberEfficiency::segQualityCut(const MeasurementContainer seg_list) const
MeasurementContainer DTChamberEfficiency::segQualityCut(const MeasurementContainer& seg_list) const
{

MeasurementContainer result;
Expand Down
2 changes: 1 addition & 1 deletion DQM/DTMonitorModule/src/DTChamberEfficiency.h
Original file line number Diff line number Diff line change
Expand Up @@ -75,7 +75,7 @@ class DTChamberEfficiency : public edm::EDAnalyzer


void bookHistos();
MeasurementContainer segQualityCut(const MeasurementContainer seg_list) const;
MeasurementContainer segQualityCut(const MeasurementContainer& seg_list) const;
bool chamberSelection(const DetId& idDetLay, reco::TransientTrack& trans_track) const;
inline edm::ESHandle<Propagator> propagator() const;

Expand Down
6 changes: 3 additions & 3 deletions DQM/DataScouting/interface/AlphaTVarProducer.h
Original file line number Diff line number Diff line change
Expand Up @@ -19,9 +19,9 @@ class AlphaTVarProducer : public edm::EDProducer {
virtual void produce(edm::Event&, const edm::EventSetup&);

private:
double CalcAlphaT(std::vector<TLorentzVector>);
static double CalcHT(const std::vector<TLorentzVector>);
static double CalcMHT(const std::vector<TLorentzVector>);
double CalcAlphaT(const std::vector<TLorentzVector>&);
static double CalcHT(const std::vector<TLorentzVector>&);
static double CalcMHT(const std::vector<TLorentzVector>&);
static double deltaHt(const std::vector<double>&);
static double alphaT(const double, const double, const double);

Expand Down
4 changes: 2 additions & 2 deletions DQM/DataScouting/interface/RazorVarProducer.h
Original file line number Diff line number Diff line change
Expand Up @@ -16,8 +16,8 @@ class RazorVarProducer : public edm::EDProducer {
~RazorVarProducer();
virtual void produce(edm::Event&, const edm::EventSetup&);

double CalcMR(TLorentzVector ja,TLorentzVector jb);
double CalcR(double MR, TLorentzVector ja,TLorentzVector jb, edm::Handle<reco::CaloMETCollection> met, std::vector<math::XYZTLorentzVector> muons);
double CalcMR(const TLorentzVector& ja,const TLorentzVector& jb);
double CalcR(double MR, const TLorentzVector& ja,const TLorentzVector& jb, edm::Handle<reco::CaloMETCollection> met, const std::vector<math::XYZTLorentzVector>& muons);

private:

Expand Down
6 changes: 3 additions & 3 deletions DQM/DataScouting/src/AlphaTVarProducer.cc
Original file line number Diff line number Diff line change
Expand Up @@ -69,7 +69,7 @@ AlphaTVarProducer::produce(edm::Event& iEvent, const edm::EventSetup& iSetup)
}

double
AlphaTVarProducer::CalcAlphaT(std::vector<TLorentzVector> jets){
AlphaTVarProducer::CalcAlphaT(const std::vector<TLorentzVector>& jets){
std::vector<double> ETs;
TVector3 MHT = CalcMHT(jets);
float HT = CalcHT(jets);
Expand Down Expand Up @@ -105,7 +105,7 @@ double AlphaTVarProducer::alphaT(const double HT, const double DHT, const double
}

double
AlphaTVarProducer::CalcHT(std::vector<TLorentzVector> jets){
AlphaTVarProducer::CalcHT(const std::vector<TLorentzVector>& jets){

double HT = 0;
for(unsigned int i = 0; i < jets.size(); i++){
Expand All @@ -116,7 +116,7 @@ AlphaTVarProducer::CalcHT(std::vector<TLorentzVector> jets){

}

double AlphaTVarProducer::CalcMHT(std::vector<TLorentzVector> jets){
double AlphaTVarProducer::CalcMHT(const std::vector<TLorentzVector>& jets){
TVector3 MHT;
for(unsigned int i = 0; i < jets.size(); i++){
if(jets[i].Et() > 50. && fabs(jets[i].Eta()) < 2.5) MHT -= jets[i].Vect();
Expand Down
6 changes: 4 additions & 2 deletions DQM/DataScouting/src/RazorVarProducer.cc
Original file line number Diff line number Diff line change
Expand Up @@ -73,7 +73,9 @@ RazorVarProducer::produce(edm::Event& iEvent, const edm::EventSetup& iSetup)
}

double
RazorVarProducer::CalcMR(TLorentzVector ja, TLorentzVector jb){
RazorVarProducer::CalcMR(const TLorentzVector& _ja, const TLorentzVector& _jb){
TLorentzVector ja = _ja;
TLorentzVector jb = _jb;
if(ja.Pt()<=0.1) return -1;

ja.SetPtEtaPhiM(ja.Pt(),ja.Eta(),ja.Phi(),0.0);
Expand Down Expand Up @@ -107,7 +109,7 @@ RazorVarProducer::CalcMR(TLorentzVector ja, TLorentzVector jb){
}

double
RazorVarProducer::CalcR(double MR, TLorentzVector ja, TLorentzVector jb, edm::Handle<reco::CaloMETCollection> inputMet, std::vector<math::XYZTLorentzVector> muons){
RazorVarProducer::CalcR(double MR, const TLorentzVector& ja, const TLorentzVector& jb, edm::Handle<reco::CaloMETCollection> inputMet, const std::vector<math::XYZTLorentzVector>& muons){
//now we can calculate MTR
TVector3 met;
met.SetPtEtaPhi((inputMet->front()).pt(),0.0,(inputMet->front()).phi());
Expand Down
2 changes: 1 addition & 1 deletion DQM/EcalBarrelMonitorClient/interface/EBSummaryClient.h
Original file line number Diff line number Diff line change
Expand Up @@ -67,7 +67,7 @@ inline int getEvtPerJob() { return ievt_; }
inline int getEvtPerRun() { return jevt_; }

/// Set Clients
inline void setFriends(std::vector<EBClient*> clients) { clients_ = clients; }
inline void setFriends(const std::vector<EBClient*>& clients) { clients_ = clients; }

private:

Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -252,7 +252,7 @@ int dccIndex(int i, int j) const;
* the hardware representation.
* @param weightsForZsFIR weights from configuration file
*/
void configFirWeights(std::vector<double> weightsForZsFIR);
void configFirWeights(const std::vector<double>& weightsForZsFIR);

/** Emulates the DCC zero suppression FIR filter. If one of the time sample
* is not in gain 12, numeric_limits<int>::max() is returned.
Expand Down
2 changes: 1 addition & 1 deletion DQM/EcalBarrelMonitorTasks/src/EBSelectiveReadoutTask.cc
Original file line number Diff line number Diff line change
Expand Up @@ -938,7 +938,7 @@ EBSelectiveReadoutTask::getFIRWeights(const std::vector<double>&
}

void
EBSelectiveReadoutTask::configFirWeights(std::vector<double> weightsForZsFIR){
EBSelectiveReadoutTask::configFirWeights(const std::vector<double>& weightsForZsFIR){
bool notNormalized = false;
bool notInt = false;
for(unsigned i=0; i < weightsForZsFIR.size(); ++i){
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -259,7 +259,7 @@ int dccIndex(int iDet, int i, int j) const;
* the hardware representation.
* @param weightsForZsFIR weights from configuration file
*/
void configFirWeights(std::vector<double> weightsForZsFIR);
void configFirWeights(const std::vector<double>& weightsForZsFIR);

/** Emulates the DCC zero suppression FIR filter. If one of the time sample
* is not in gain 12, numeric_limits<int>::max() is returned.
Expand Down
2 changes: 1 addition & 1 deletion DQM/EcalEndcapMonitorTasks/src/EESelectiveReadoutTask.cc
Original file line number Diff line number Diff line change
Expand Up @@ -1231,7 +1231,7 @@ EESelectiveReadoutTask::getFIRWeights(const std::vector<double>&
}

void
EESelectiveReadoutTask::configFirWeights(std::vector<double> weightsForZsFIR){
EESelectiveReadoutTask::configFirWeights(const std::vector<double>& weightsForZsFIR){
bool notNormalized = false;
bool notInt = false;
for(unsigned i=0; i < weightsForZsFIR.size(); ++i){
Expand Down
2 changes: 1 addition & 1 deletion DQM/EcalPreshowerMonitorClient/interface/ESSummaryClient.h
Original file line number Diff line number Diff line change
Expand Up @@ -50,7 +50,7 @@ class ESSummaryClient : public ESClient {
inline int getEvtPerRun() { return jevt_; }

/// Set Clients
inline void setFriends(std::vector<ESClient*> clients) { clients_ = clients; }
inline void setFriends(const std::vector<ESClient*>& clients) { clients_ = clients; }

/// EndLumiAnalyze
void endLumiAnalyze();
Expand Down
6 changes: 3 additions & 3 deletions DQM/HLTEvF/interface/FourVectorHLTOnline.h
Original file line number Diff line number Diff line change
Expand Up @@ -93,7 +93,7 @@ class FourVectorHLTOnline : public edm::EDAnalyzer {
// EndRun
void endRun(const edm::Run& run, const edm::EventSetup& c);
void fillHltMatrix(const edm::TriggerNames & triggerNames);
void setupHltMatrix(std::string label, std::vector<std::string> paths);
void setupHltMatrix(std::string label, const std::vector<std::string>& paths);

void setupHltLsPlots();
void setupHltBxPlots();
Expand Down Expand Up @@ -595,9 +595,9 @@ class objMonData:public BaseMonitor {
EtMin_= etMin;
DRMatch_= drMatch;
}
void setTriggerType(std::vector<int> trigType) { triggerType_ = trigType; }
void setTriggerType(const std::vector<int>& trigType) { triggerType_ = trigType; }
void pushTriggerType(int trigType) { triggerType_.push_back(trigType); }
void setL1TriggerType(std::vector<int> trigType) { l1triggerType_ = trigType; }
void setL1TriggerType(const std::vector<int>& trigType) { l1triggerType_ = trigType; }
void pushL1TriggerType(int trigType) { l1triggerType_.push_back(trigType); }
void setPath(FourVectorHLTOnline::PathInfoCollection::iterator v) { v_ = v; }
void setReco(edm::Handle<T> offColl) { offColl_ = offColl; }
Expand Down
2 changes: 1 addition & 1 deletion DQM/HLTEvF/interface/HLTAlCaMonPi0.h
Original file line number Diff line number Diff line change
Expand Up @@ -26,7 +26,7 @@ typedef std::map<DetId, EcalRecHit> RecHitsMap;
class ecalRecHitLess : public std::binary_function<EcalRecHit, EcalRecHit, bool>
{
public:
bool operator()(EcalRecHit x, EcalRecHit y)
bool operator()(const EcalRecHit& x, const EcalRecHit& y)
{
return (x.energy() > y.energy());
}
Expand Down
2 changes: 1 addition & 1 deletion DQM/HLTEvF/interface/HLTMonBitSummary.h
Original file line number Diff line number Diff line change
Expand Up @@ -37,7 +37,7 @@ class HLTMonBitSummary : public edm::EDAnalyzer {
virtual void endJob() ;
virtual void beginRun(const edm::Run & r, const edm::EventSetup &);
// virtual void endRun(const edm::Run &, const edm::EventSetup &);
virtual void configSelector(std::vector<std::string > selectTriggers, std::vector<std::string > & theSelectTriggers );
virtual void configSelector(const std::vector<std::string >& selectTriggers, std::vector<std::string > & theSelectTriggers );

edm::InputTag inputTag_;
DQMStore * dbe_;
Expand Down
4 changes: 2 additions & 2 deletions DQM/HLTEvF/interface/TrigResRateMon.h
Original file line number Diff line number Diff line change
Expand Up @@ -363,7 +363,7 @@ class TrigResRateMon : public edm::EDAnalyzer {
// function to set the paths and
// create zeroed counts per path

void setPaths (std::vector<std::string> inputPaths){
void setPaths (const std::vector<std::string>& inputPaths){
pathNames = inputPaths;
for (std::vector<std::string>::const_iterator iPath = pathNames.begin();
iPath != pathNames.end();
Expand Down Expand Up @@ -461,7 +461,7 @@ class TrigResRateMon : public edm::EDAnalyzer {
}
}// end fill RawCountsForPath

void setMaskedPaths (std::vector<std::string> inputPaths) {
void setMaskedPaths (const std::vector<std::string>& inputPaths) {
for (unsigned i=0; i < inputPaths.size(); i++) {
std::string maskSubString = inputPaths[i];
for (unsigned j=0; j < pathNames.size(); j++) {
Expand Down
4 changes: 2 additions & 2 deletions DQM/HLTEvF/plugins/FourVectorHLTOnline.cc
Original file line number Diff line number Diff line change
Expand Up @@ -1402,8 +1402,8 @@ void FourVectorHLTOnline::cleanDRMatchSet(mmset& tempSet)

}

void FourVectorHLTOnline::setupHltMatrix(std::string label, std::vector<std::string> paths) {

void FourVectorHLTOnline::setupHltMatrix(std::string label, const std::vector<std::string>& _paths) {
std::vector<std::string> paths = _paths;
//string groupLabelAny = "HLT_"+label+"_Any";
//paths.push_back(groupLabelAny.c_str());
paths.push_back("HLT_"+label+"_L1_Any");
Expand Down
Loading

0 comments on commit c5ab2f4

Please sign in to comment.