Skip to content
Draft
Show file tree
Hide file tree
Changes from all commits
Commits
File filter

Filter by extension

Filter by extension

Conversations
Failed to load comments.
Loading
Jump to
The table of contents is too big for display.
Diff view
Diff view
  •  
  •  
  •  
4 changes: 2 additions & 2 deletions Alignment/CocoaFit/src/Fit.cc
Original file line number Diff line number Diff line change
Expand Up @@ -1311,7 +1311,7 @@ void Fit::printCentreInOptOFrame(const OpticalObject* opto,
<< " parent GLOB " << optoAncestor->centreGlob() << std::endl;
ALIUtils::dumprm(optoAncestor->rmGlob(), " parent rm ");
}
std::vector<Entry*> entries = opto->CoordinateEntryList();
const std::vector<Entry*>& entries = opto->CoordinateEntryList();
for (ALIuint ii = 0; ii < 3; ii++) {
/* double entryvalue = getEntryValue( entries[ii] );
ALIdouble entryvalue;
Expand All @@ -1333,7 +1333,7 @@ void Fit::printRotationAnglesInOptOFrame(const OpticalObject* opto,
ALIFileOut& fileout,
ALIbool printErrors,
ALIbool printOrig) {
std::vector<Entry*> entries = opto->CoordinateEntryList();
const std::vector<Entry*>& entries = opto->CoordinateEntryList();
std::vector<double> entryvalues = opto->getRotationAnglesInOptOFrame(optoAncestor, entries);
//- std::cout << " after return entryvalues[0] " << entryvalues[0] << " entryvalues[1] " << entryvalues[1] << " entryvalues[2] " << entryvalues[2] << std::endl;
for (ALIuint ii = 3; ii < entries.size(); ii++) {
Expand Down
2 changes: 1 addition & 1 deletion Alignment/CocoaFit/src/NtupleManager.cc
Original file line number Diff line number Diff line change
Expand Up @@ -291,7 +291,7 @@ void NtupleManager::FillMeasurements() {
for (vmcite = Model::MeasurementList().begin(); vmcite != Model::MeasurementList().end(); ++vmcite) {
std::vector<ALIstring> optonamelist = (*vmcite)->OptONameList();
int last = optonamelist.size() - 1;
ALIstring LastOptOName = optonamelist[last];
const ALIstring& LastOptOName = optonamelist[last];
int optoind = -999;
for (int no = 0; no < NOptObjects; no++) {
OptObject* optobj = (OptObject*)CloneOptObject->At(no);
Expand Down
6 changes: 5 additions & 1 deletion Alignment/CocoaModel/src/CocoaDaqReaderRoot.cc
Original file line number Diff line number Diff line change
Expand Up @@ -125,6 +125,7 @@ OpticalAlignMeasurementInfo CocoaDaqReaderRoot::GetMeasFromPosition2D(AliDaqPosi
meas.name_ = std::string(pos2D->GetID().Data());
//- std::vector<std::string> measObjectNames_;
std::vector<bool> isSimu;
isSimu.reserve(2);
for (size_t jj = 0; jj < 2; jj++) {
isSimu.push_back(false);
}
Expand Down Expand Up @@ -155,6 +156,7 @@ OpticalAlignMeasurementInfo CocoaDaqReaderRoot::GetMeasFromPositionCOPS(AliDaqPo
meas.name_ = std::string(posCOPS->GetID().Data());
//- std::vector<std::string> measObjectNames_;
std::vector<bool> isSimu;
isSimu.reserve(4);
for (size_t jj = 0; jj < 4; jj++) {
isSimu.push_back(false);
}
Expand Down Expand Up @@ -198,6 +200,7 @@ OpticalAlignMeasurementInfo CocoaDaqReaderRoot::GetMeasFromTilt(AliDaqTilt* tilt
meas.name_ = std::string(tilt->GetID().Data());
//- std::vector<std::string> measObjectNames_;
std::vector<bool> isSimu;
isSimu.reserve(2);
for (size_t jj = 0; jj < 2; jj++) {
isSimu.push_back(false);
}
Expand All @@ -222,6 +225,7 @@ OpticalAlignMeasurementInfo CocoaDaqReaderRoot::GetMeasFromDist(AliDaqDistance*
meas.name_ = std::string(dist->GetID().Data());
//- std::vector<std::string> measObjectNames_;
std::vector<bool> isSimu;
isSimu.reserve(2);
for (size_t jj = 0; jj < 2; jj++) {
isSimu.push_back(false);
}
Expand Down Expand Up @@ -265,7 +269,7 @@ void CocoaDaqReaderRoot::BuildMeasurementsFromOptAlign(std::vector<OpticalAlignM
//---------- loop measurements read from ROOT
ALIint ii;
for (ii = 0; ii < nMeasRoot; ii++) {
OpticalAlignMeasurementInfo measInfo = measList[ii];
const OpticalAlignMeasurementInfo& measInfo = measList[ii];
std::cout << " measurement name ROOT " << measInfo.name_ << " Model= " << (*vmcite)->name() << " short " << oname
<< std::endl;

Expand Down
2 changes: 1 addition & 1 deletion Alignment/CocoaModel/src/Model.cc
Original file line number Diff line number Diff line change
Expand Up @@ -372,7 +372,7 @@ void Model::readSystemDescription() {
if (ALIUtils::debug >= 3) {
std::vector<std::vector<ALIstring> >::iterator itevs;
for (itevs = OptODictionary().begin(); itevs != OptODictionary().end(); ++itevs) {
std::vector<ALIstring> ptemp = *itevs;
const std::vector<ALIstring>& ptemp = *itevs;
ALIUtils::dumpVS(ptemp, " SYSTEM TREE DESCRIPTION: after ordering: OBJECT ", std::cout);
}
}
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -222,7 +222,7 @@ double TwoBowedSurfacesAlignmentParameters::ySplitFromAlignable(const Alignable
if (!ali)
return 0.;

const align::PositionType pos(ali->globalPosition());
const align::PositionType &pos(ali->globalPosition());
const double r = pos.perp();

// The returned numbers for TEC are calculated as stated below from
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -801,7 +801,7 @@ void HIPAlignmentAlgorithm::run(const edm::EventSetup& setup, const EventInfo& e
// loop over measurements
std::vector<TrajectoryMeasurement> measurements = traj->measurements();
for (std::vector<TrajectoryMeasurement>::iterator im = measurements.begin(); im != measurements.end(); ++im) {
TrajectoryMeasurement meas = *im;
const TrajectoryMeasurement& meas = *im;

// const TransientTrackingRecHit* ttrhit = &(*meas.recHit());
// const TrackingRecHit *hit = ttrhit->hit();
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -591,7 +591,7 @@ void MillePedeMonitor::fillTrack(const reco::Track *track,
if (!track)
return;

const reco::TrackBase::Vector p(track->momentum());
const reco::TrackBase::Vector &p(track->momentum());

static const int iPtLog = this->GetIndex(trackHists1D, "ptTrackLogBins");
trackHists1D[iPtLog]->Fill(track->pt());
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -463,7 +463,7 @@ double PedeSteererWeakModeConstraints::getX0(const std::pair<Alignable*, std::li
double x0 = 0.0;

for (const auto& ali : iHLS.second) {
align::PositionType pos = ali->globalPosition();
const align::PositionType& pos = ali->globalPosition();
bool alignableIsFloating = false; //means: true=alignable is able to move in at least one direction

//test whether at least one variable has been selected in the configuration
Expand Down
2 changes: 1 addition & 1 deletion Alignment/OfflineValidation/plugins/JetHTAnalyzer.cc
Original file line number Diff line number Diff line change
Expand Up @@ -186,7 +186,7 @@ void JetHTAnalyzer::analyze(const edm::Event& iEvent, const edm::EventSetup& iSe
h_ntrks->Fill(ntrks);

for (uint tracksIt = 0; tracksIt < ntrks; tracksIt++) {
auto tk = allTracks.at(tracksIt);
const auto& tk = allTracks.at(tracksIt);

double dxyRes = tk.dxy(pos_) * cmToum;
double dzRes = tk.dz(pos_) * cmToum;
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -331,7 +331,7 @@ void PrimaryVertexValidation::analyze(const edm::Event& iEvent, const edm::Event
double chi2prob = 0.;

if (!vsorted.at(0).isFake()) {
Vertex pv = vsorted.at(0);
const Vertex& pv = vsorted.at(0);

ntracks = pv.tracksSize();
chi2ndf = pv.normalizedChi2();
Expand Down
4 changes: 2 additions & 2 deletions Alignment/OfflineValidation/plugins/SplitVertexResolution.cc
Original file line number Diff line number Diff line change
Expand Up @@ -458,8 +458,8 @@ void SplitVertexResolution::analyze(const edm::Event& iEvent, const edm::EventSe

// split into two sets equally populated
for (uint tracksIt = 0; tracksIt < even_ntrks; tracksIt = tracksIt + 2) {
reco::Track firstTrk = allTracks.at(tracksIt);
reco::Track secondTrk = allTracks.at(tracksIt + 1);
const reco::Track& firstTrk = allTracks.at(tracksIt);
const reco::Track& secondTrk = allTracks.at(tracksIt + 1);
auto dis = std::uniform_int_distribution<>(0, 1); // [0, 1]

if (dis(engine_) > 0.5) {
Expand Down
1 change: 1 addition & 0 deletions Alignment/OfflineValidation/src/PrepareDMRTrends.cc
Original file line number Diff line number Diff line change
Expand Up @@ -124,6 +124,7 @@ void PrepareDMRTrends::compileDMRTrends(vector<int> IOVlist,
vector<float> runs = geom.Run();
size_t n = runs.size();
vector<float> emptyvec;
emptyvec.reserve(runs.size());
for (size_t i = 0; i < runs.size(); i++)
emptyvec.push_back(0.);
for (size_t iVar = 0; iVar < variables.size(); iVar++) {
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -19,6 +19,7 @@ void SurveyAlignmentAlgorithm::initialize(
// - check this, when resurrecting this code in the future
AlignableObjectId alignableObjectId{AlignableObjectId::Geometry::General};

levels.reserve(theLevels.size());
for (unsigned int l = 0; l < theLevels.size(); ++l) {
levels.push_back(alignableObjectId.stringToId(theLevels[l].c_str()));
}
Expand Down
11 changes: 6 additions & 5 deletions CalibCalorimetry/EcalTPGTools/plugins/EcalTPGParamBuilder.cc
Original file line number Diff line number Diff line change
Expand Up @@ -996,7 +996,7 @@ void EcalTPGParamBuilder::analyze(const edm::Event& evt, const edm::EventSetup&
int SLBch = (towerInTCC - 1) % 8 + 1;
int cmsswId = id.rawId();
int ixtal = (id.ism() - 1) * 1700 + (id.ic() - 1);
EcalLogicID logicId = my_EcalLogicId[ixtal];
const EcalLogicID& logicId = my_EcalLogicId[ixtal];
int dbId = logicId.getLogicID();
int val[] = {dccNb + 600,
tccNb,
Expand Down Expand Up @@ -1272,7 +1272,7 @@ void EcalTPGParamBuilder::analyze(const edm::Event& evt, const edm::EventSetup&
if (writeToDB_) {
// 1700 crystals/SM in the ECAL barrel
int ixtal = (id.ism() - 1) * 1700 + (id.ic() - 1);
EcalLogicID logicId = my_EcalLogicId[ixtal];
const EcalLogicID& logicId = my_EcalLogicId[ixtal];
pedset[logicId] = pedDB;
linset[logicId] = linDB;
}
Expand Down Expand Up @@ -2141,7 +2141,7 @@ void EcalTPGParamBuilder::analyze(const edm::Event& evt, const edm::EventSetup&
for (int ich = 0; ich < (int)my_StripEcalLogicId.size(); ich++) {
// EB
FEConfigFgrEEStripDat zut;
EcalLogicID thestrip = my_StripEcalLogicId[ich];
const EcalLogicID& thestrip = my_StripEcalLogicId[ich];
uint32_t elStripId = stripMapEB[ich];
map<uint32_t, uint32_t>::const_iterator it = stripMapEBsintheta.find(elStripId);
if (it != stripMapEBsintheta.end())
Expand Down Expand Up @@ -2191,7 +2191,7 @@ void EcalTPGParamBuilder::analyze(const edm::Event& evt, const edm::EventSetup&
for (int ich = 0; ich < (int)my_TTEcalLogicId_EB_by_TCC.size(); ich++) {
FEConfigTimingDat delay;

EcalLogicID logiciddelay = my_TTEcalLogicId_EB_by_TCC[ich];
const EcalLogicID& logiciddelay = my_TTEcalLogicId_EB_by_TCC[ich];
int id1_tcc = logiciddelay.getID1(); // the TCC
int id2_tt = logiciddelay.getID2(); // the tower
std::map<int, vector<int>>::const_iterator ittEB = delays_EB_.find(id1_tcc);
Expand Down Expand Up @@ -2244,7 +2244,7 @@ void EcalTPGParamBuilder::analyze(const edm::Event& evt, const edm::EventSetup&
for (int ich = 0; ich < (int)my_StripEcalLogicId_EE_strips_by_TCC.size(); ich++) {
FEConfigTimingDat delay;

EcalLogicID logiciddelay = my_StripEcalLogicId_EE_strips_by_TCC[ich];
const EcalLogicID& logiciddelay = my_StripEcalLogicId_EE_strips_by_TCC[ich];
int id1_tcc = logiciddelay.getID1(); // the TCC
int id2_tt = logiciddelay.getID2(); // the tower
int id3_st = logiciddelay.getID3(); // the strip
Expand Down Expand Up @@ -2882,6 +2882,7 @@ std::vector<unsigned int> EcalTPGParamBuilder::computeWeights(EcalShapeBase& sha
edm::LogInfo("TopInfo") << ss.str();

std::vector<unsigned int> theWeights;
theWeights.reserve(nSample_);
for (unsigned int sample = 0; sample < nSample_; sample++)
theWeights.push_back(iweight[sample]);

Expand Down
2 changes: 1 addition & 1 deletion CalibFormats/SiPixelObjects/src/PixelCalibConfiguration.cc
Original file line number Diff line number Diff line change
Expand Up @@ -543,7 +543,7 @@ void PixelCalibConfiguration::buildROCAndModuleLists(const PixelNameTranslation*
for (std::vector<std::string>::iterator rocListInstructions_itr = rocListInstructions_.begin();
rocListInstructions_itr != rocListInstructions_.end();
++rocListInstructions_itr) {
std::string instruction = *rocListInstructions_itr;
const std::string& instruction = *rocListInstructions_itr;

if (instruction == "+") {
addNext = true;
Expand Down
2 changes: 1 addition & 1 deletion CalibFormats/SiPixelObjects/src/PixelDACSettings.cc
Original file line number Diff line number Diff line change
Expand Up @@ -178,7 +178,7 @@ PixelDACSettings::PixelDACSettings(std::vector<std::vector<std::string> >& table
*/
// std::multimap<std::string,std::pair<std::string,int > > pDSM;
// std::stringstream currentRocName;
std::vector<std::string> ins = tableMat[0];
const std::vector<std::string>& ins = tableMat[0];
std::string mthn("[PixelDACSettings::PixelDACSettings()] ");
std::string dacName;
std::istringstream dbin;
Expand Down
2 changes: 1 addition & 1 deletion CalibFormats/SiPixelObjects/src/PixelDetectorConfig.cc
Original file line number Diff line number Diff line change
Expand Up @@ -21,7 +21,7 @@ using namespace pos;
PixelDetectorConfig::PixelDetectorConfig(std::vector<std::vector<std::string> > &tableMat)
: PixelConfigBase("", "", "") {
std::string mthn = "]\t[PixelDetectorConfig::PixelDetectorConfig()]\t\t ";
std::vector<std::string> ins = tableMat[0];
const std::vector<std::string> &ins = tableMat[0];
std::map<std::string, int> colM;
std::vector<std::string> colNames;
/*
Expand Down
2 changes: 1 addition & 1 deletion CalibFormats/SiPixelObjects/src/PixelFEDCard.cc
Original file line number Diff line number Diff line change
Expand Up @@ -392,7 +392,7 @@ PixelFEDCard::PixelFEDCard(vector<vector<string> > &tableMat) : PixelConfigBase(

void PixelFEDCard::readDBTBMLevels(std::vector<std::vector<std::string> > &tableMat, int firstRow, int lastRow) {
string mthn = "[PixelFEDCard::readDBTBMLevels()] ";
vector<string> ins = tableMat[firstRow];
const vector<string> &ins = tableMat[firstRow];
map<string, int> colM;
vector<string> colNames;

Expand Down
1 change: 0 additions & 1 deletion CalibFormats/SiPixelObjects/src/PixelFEDConfig.cc
Original file line number Diff line number Diff line change
Expand Up @@ -18,7 +18,6 @@ using namespace std;
PixelFEDConfig::PixelFEDConfig(std::vector<std::vector<std::string> > &tableMat) : PixelConfigBase(" ", " ", " ") {
std::string mthn = "[PixelFEDConfig::PixelFEDConfig()]\t\t\t ";

std::vector<std::string> ins = tableMat[0];
std::map<std::string, int> colM;
std::vector<std::string> colNames;
/*
Expand Down
2 changes: 1 addition & 1 deletion CalibFormats/SiPixelObjects/src/PixelGlobalDelay25.cc
Original file line number Diff line number Diff line change
Expand Up @@ -19,7 +19,7 @@ using namespace std;

PixelGlobalDelay25::PixelGlobalDelay25(vector<vector<string> > &tableMat) : PixelConfigBase(" ", " ", " ") {
std::string mthn = "[PixelGlobalDelay25::PixelGlobalDelay25()]\t\t ";
vector<string> ins = tableMat[0];
const vector<string> &ins = tableMat[0];
map<string, int> colM;
vector<string> colNames;

Expand Down
2 changes: 1 addition & 1 deletion CalibFormats/SiPixelObjects/src/PixelMaskAllPixels.cc
Original file line number Diff line number Diff line change
Expand Up @@ -28,7 +28,7 @@ PixelMaskAllPixels::PixelMaskAllPixels(std::vector<std::vector<std::string> > &t
std::string mthn = "[PixelMaskAllPixels::PixelMaskAllPixels()]\t\t ";
//std::cout << __LINE__ << "]\t" << mthn << "Table Size in const: " << tableMat.size() << std::endl;

std::vector<std::string> ins = tableMat[0];
const std::vector<std::string> &ins = tableMat[0];
std::map<std::string, int> colM;
std::vector<std::string> colNames;

Expand Down
2 changes: 1 addition & 1 deletion CalibFormats/SiPixelObjects/src/PixelPortcardMap.cc
Original file line number Diff line number Diff line change
Expand Up @@ -18,7 +18,7 @@ using namespace std;

PixelPortcardMap::PixelPortcardMap(std::vector<std::vector<std::string> > &tableMat) : PixelConfigBase(" ", " ", " ") {
std::string mthn = "[PixelPortcardMap::PixelPortcardMap()]\t\t\t ";
std::vector<std::string> ins = tableMat[0];
const std::vector<std::string> &ins = tableMat[0];
std::map<std::string, int> colM;
std::vector<std::string> colNames;
/*
Expand Down
2 changes: 1 addition & 1 deletion CalibFormats/SiPixelObjects/src/PixelTBMSettings.cc
Original file line number Diff line number Diff line change
Expand Up @@ -19,7 +19,7 @@ using namespace pos;

PixelTBMSettings::PixelTBMSettings(std::vector<std::vector<std::string> > &tableMat) : PixelConfigBase("", "", "") {
std::string mthn = "]\t[PixelTBMSettings::PixelTBMSettings()]\t\t\t ";
std::vector<std::string> ins = tableMat[0];
const std::vector<std::string> &ins = tableMat[0];
std::map<std::string, int> colM;
std::vector<std::string> colNames;

Expand Down
2 changes: 1 addition & 1 deletion CalibPPS/AlignmentRelative/src/JanAlignmentAlgorithm.cc
Original file line number Diff line number Diff line change
Expand Up @@ -434,7 +434,7 @@ unsigned int JanAlignmentAlgorithm::solve(const std::vector<AlignmentConstraint>

// eigen analysis of CS matrix
TMatrixDSymEigen CS_eig(CS);
TVectorD CS_eigVal = CS_eig.GetEigenValues();
const TVectorD &CS_eigVal = CS_eig.GetEigenValues();
TMatrixD CS_eigVec = CS_eig.GetEigenVectors();

// check regularity of CS matrix
Expand Down
6 changes: 3 additions & 3 deletions CalibTracker/SiStripHitEfficiency/plugins/HitEff.cc
Original file line number Diff line number Diff line change
Expand Up @@ -662,7 +662,7 @@ void HitEff::analyze(const edm::Event& e, const edm::EventSetup& es) {
}
}
if (!tmpTmeas.empty() && !foundConsMissingHits) {
TrajectoryMeasurement TM_tmp(tmpTmeas.back());
const TrajectoryMeasurement& TM_tmp(tmpTmeas.back());
unsigned int iidd_tmp = TM_tmp.recHit()->geographicalId().rawId();
if (iidd_tmp != 0) {
LogDebug("SiStripHitEfficiency:HitEff") << " hit actually being added to TM vector";
Expand Down Expand Up @@ -779,7 +779,7 @@ void HitEff::analyze(const edm::Event& e, const edm::EventSetup& es) {
// take the last of the TMs, which is always an invalid hit
// if no detId is available, ie detId==0, then no compatible layer was crossed
// otherwise, use that TM for the efficiency measurement
TrajectoryMeasurement tob6TM(tmp.back());
const TrajectoryMeasurement& tob6TM(tmp.back());
const auto& tob6Hit = tob6TM.recHit();

if (tob6Hit->geographicalId().rawId() != 0) {
Expand Down Expand Up @@ -827,7 +827,7 @@ void HitEff::analyze(const edm::Event& e, const edm::EventSetup& es) {
// take the last of the TMs, which is always an invalid hit
// if no detId is available, ie detId==0, then no compatible layer was crossed
// otherwise, use that TM for the efficiency measurement
TrajectoryMeasurement tec9TM(tmp.back());
const TrajectoryMeasurement& tec9TM(tmp.back());
const auto& tec9Hit = tec9TM.recHit();

unsigned int tec9id = tec9Hit->geographicalId().rawId();
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -791,7 +791,7 @@ void SiStripHitEfficiencyWorker::analyze(const edm::Event& e, const edm::EventSe
}
}
if (!tmpTmeas.empty() && !foundConsMissingHits) {
TrajectoryMeasurement TM_tmp(tmpTmeas.back());
const TrajectoryMeasurement& TM_tmp(tmpTmeas.back());
unsigned int iidd_tmp = TM_tmp.recHit()->geographicalId().rawId();
if (iidd_tmp != 0) {
LogDebug("SiStripHitEfficiency:HitEff") << " hit actually being added to TM vector";
Expand Down
Original file line number Diff line number Diff line change
Expand Up @@ -576,7 +576,7 @@ void SelectedElectronFEDListProducer<TEle, TCand>::produce(edm::Event& iEvent, c
if (R - sqrt(pow(regionDimension_.first / 2, 2) + pow(regionDimension_.second / 2, 2)) > dRStripRegion_)
continue;
//get vector of subdets within region
const SiStripRegionCabling::RegionCabling regSubdets = SiStripCabling[iCabling];
const SiStripRegionCabling::RegionCabling& regSubdets = SiStripCabling[iCabling];
//cycle on subdets
for (uint32_t idet = 0; idet < SiStripRegionCabling::ALLSUBDETS; idet++) { //cicle between 1 and 4
//get vector of layers whin subdet of region
Expand Down
1 change: 1 addition & 0 deletions Calibration/IsolatedParticles/plugins/IsoTrig.cc
Original file line number Diff line number Diff line change
Expand Up @@ -1837,6 +1837,7 @@ void IsoTrig::chgIsolation(double &etaTriggered,
spr::propagateCALO(trkCollection, geo_, bField_, theTrackQuality_, trkCaloDirections1, ((verbosity_ / 100) % 10 > 2));
if (verbosity_ % 10 > 0)
edm::LogVerbatim("IsoTrack") << "Propagated TrkCollection";
maxP.reserve(pixelIsolationConeSizeAtEC_.size());
for (unsigned int k = 0; k < pixelIsolationConeSizeAtEC_.size(); ++k)
maxP.push_back(0);
unsigned i = pixelTrackRefsHE_.size();
Expand Down
2 changes: 2 additions & 0 deletions Calibration/LumiAlCaRecoProducers/plugins/CorrPCCProducer.cc
Original file line number Diff line number Diff line change
Expand Up @@ -208,6 +208,7 @@ float CorrPCCProducer::getMaximum(std::vector<float> lumi_vector) {
// the follow non-active bunch crossing to estimate the spill over fraction (type 1 afterglow).
void CorrPCCProducer::estimateType1Frac(std::vector<float> uncorrPCCPerBX, float& type1Frac) {
std::vector<float> corrected_tmp_;
corrected_tmp_.reserve(uncorrPCCPerBX.size());
for (size_t i = 0; i < uncorrPCCPerBX.size(); i++) {
corrected_tmp_.push_back(uncorrPCCPerBX.at(i));
}
Expand Down Expand Up @@ -309,6 +310,7 @@ void CorrPCCProducer::calculateCorrections(std::vector<float> uncorrected,
type1Frac = std::max(0.0, (double)type1Frac);

std::vector<float> corrected_tmp_;
corrected_tmp_.reserve(uncorrected.size());
for (size_t i = 0; i < uncorrected.size(); i++) {
corrected_tmp_.push_back(uncorrected.at(i));
}
Expand Down
1 change: 1 addition & 0 deletions CaloOnlineTools/EcalTools/bin/TPGTreeReader.cpp
Original file line number Diff line number Diff line change
Expand Up @@ -146,6 +146,7 @@ int main(int argc, char** argv) {

std::vector<int> algobits;
std::vector<std::string> algos = split(l1algo, ",");
algobits.reserve(algos.size());
for (unsigned int i = 0; i < algos.size(); i++)
algobits.push_back(atoi(algos[i].c_str()));

Expand Down
2 changes: 1 addition & 1 deletion CaloOnlineTools/EcalTools/plugins/EcalTPGAnalyzer.cc
Original file line number Diff line number Diff line change
Expand Up @@ -112,7 +112,7 @@ void EcalTPGAnalyzer::analyze(edm::Event const& iEvent, edm::EventSetup const& i
DecisionWord dWord = gtRecord->decisionWord(); // this will get the decision word *before* masking disabled bits

const auto& l1GtTmAlgo = iSetup.getData(l1GtMaskToken_);
std::vector<unsigned int> triggerMaskAlgoTrig = l1GtTmAlgo.gtTriggerMask();
const std::vector<unsigned int>& triggerMaskAlgoTrig = l1GtTmAlgo.gtTriggerMask();

// apply masks on algo
int iDaq = 0;
Expand Down
Loading