CMS 3D CMS Logo

Functions | Variables

AlCaHLTBitMon_ParallelJobs Namespace Reference

Functions

def defineOptions
def getConfigTemplateFilename
def mkHLTKeyListList
def parallelJobs

Variables

int DEBUG = 0
 DEBUG.
tuple options = defineOptions()
tuple p

Function Documentation

def AlCaHLTBitMon_ParallelJobs::defineOptions ( )

Definition at line 97 of file AlCaHLTBitMon_ParallelJobs.py.

00098                    :
00099     parser = OptionParser()
00100     
00101     parser.add_option("-k", "--keylist",
00102                       dest="hltKeyListFile",
00103                       default="lista_key.txt",
00104                       help="text file with HLT keys")
00105 
00106     parser.add_option("-j", "--json",
00107                       dest="jsonDir",
00108                       help="directory with the corresponding json files")
00109     
00110     parser.add_option("-g", "--globalTag",
00111                       dest="globalTag",
00112                       help="the global tag to use in the config files")
00113 
00114     parser.add_option("-t", "--template",
00115                       dest="template",
00116                       default="default",
00117                       help="the template to use for the config files")
00118 
00119     parser.add_option("-q", "--queue",
00120                       dest="queue",
00121                       default="cmscaf1nd",
00122                       help="the queue to use (default=cmscaf1nd)")
00123 
00124     parser.add_option("-c", "--cafsetup", action="store_true",
00125                       dest="cafsetup",
00126                       default=False,
00127                       help="wether the caf setup is sourced in the scripts")
00128    
00129     (options, args) = parser.parse_args()
00130 
00131     if len(sys.argv) == 1:
00132         print("\nUsage: %s --help"%sys.argv[0])
00133         sys.exit(0)
00134 
00135     if str(options.hltKeyListFile) == 'None':
00136         print("Please provide a file with HLT keys")
00137         sys.exit(0)
00138 
00139     if str(options.jsonDir) == 'None':
00140         print("Please provide a directory containing the json files")
00141         sys.exit(0)
00142 
00143     if str(options.globalTag) == 'None':
00144         print("Please provide a global tag")
00145         sys.exit(0)
00146     
00147     return options
00148 
00149 
00150 #---------------------------------------------MAIN

def AlCaHLTBitMon_ParallelJobs::getConfigTemplateFilename ( )

Definition at line 23 of file AlCaHLTBitMon_ParallelJobs.py.

00024                                :
00025     template = os.path.expandvars('$CMSSW_BASE/src/Alignment/CommonAlignmentProducer/data/AlCaHLTBitMon_cfg_template_py')
00026     if os.path.exists(template):
00027         return template
00028     template = os.path.expandvars('$CMSSW_RELEASE_BASE/src/Alignment/CommonAlignmentProducer/data/AlCaHLTBitMon_cfg_template_py')
00029     if os.path.exists(template):
00030         return template
00031     return 'None'

def AlCaHLTBitMon_ParallelJobs::mkHLTKeyListList (   hltkeylistfile)

Definition at line 32 of file AlCaHLTBitMon_ParallelJobs.py.

00033                                     :
00034     keylistlist = []
00035     f = open(hltkeylistfile, 'r')
00036     for line in f:
00037         keylistlist.append(line.replace('\n',''))
00038     f.close()
00039     return keylistlist

def AlCaHLTBitMon_ParallelJobs::parallelJobs (   hltkeylistfile,
  jsonDir,
  globalTag,
  templateName,
  queue,
  cafsetup 
)

Definition at line 40 of file AlCaHLTBitMon_ParallelJobs.py.

00041                                                                               :
00042     PWD = os.path.abspath('.')
00043 
00044     if templateName == 'default':
00045         templateFile = getConfigTemplateFilename()
00046     else:
00047         templateFile = os.path.abspath(os.path.expandvars(templateName))
00048         
00049     tfile = open(templateFile, 'r')
00050     template = tfile.read()
00051     tfile.close()
00052     template = template.replace('%%%GLOBALTAG%%%', globalTag)
00053 
00054     keylistlist = mkHLTKeyListList(hltkeylistfile)
00055     index = 0
00056     for keylist in keylistlist:
00057         
00058         configName = 'AlCaHLTBitMon_%d_cfg.py'%index
00059         jobName = 'AlCaHLTBitMon_%d_job.csh'%index
00060         jsonFile = os.path.abspath('%(dir)s/%(index)d.json' % {'dir' : jsonDir, 'index' : index})
00061         dataFile = os.path.abspath('%(dir)s/%(index)d.data' % {'dir' : jsonDir, 'index' : index})
00062         logFile = 'AlCaHLTBitMon_%d'%index
00063         
00064         dfile = open(dataFile, 'r')
00065         data = dfile.read()
00066         dfile.close()
00067 
00068         config = template.replace('%%%JSON%%%', jsonFile);
00069         config = config.replace('%%%DATA%%%', data);
00070         config = config.replace('%%%KEYNAME%%%', keylist);
00071         config = config.replace('%%%LOGFILE%%%', logFile);
00072 
00073         cfile = open(configName, 'w')
00074         for line in config:
00075             cfile.write(line)
00076         cfile.close()
00077 
00078         jfile = open(jobName, 'w')
00079         jfile.write('#!/bin/tcsh\n\n')
00080         if cafsetup == True:
00081             jfile.write('source /afs/cern.ch/cms/caf/setup.csh\n\n')
00082             
00083         jfile.write('cd $1\n\n')
00084         jfile.write('eval `scramv1 run -csh`\n\n')
00085         jfile.write('cmsRun %s\n\n'%configName)
00086         jfile.write('cp %s.log $2'%logFile)
00087         jfile.close()
00088 
00089         if os.path.exists('./%s'%keylist) == False:
00090             os.system('mkdir ./%s'%keylist)
00091             
00092         os.system('chmod u+x %s'%jobName)
00093         #print('bsub -q %(queue)s %(jobname)s %(pwd)s %(pwd)s/%(outdir)s' % {'queue' : queue, 'jobname' : jobName, 'pwd' : PWD, 'outdir' : keylist})
00094         os.system('bsub -q %(queue)s %(jobname)s %(pwd)s %(pwd)s/%(outdir)s' % {'queue' : queue, 'jobname' : jobName, 'pwd' : PWD, 'outdir' : keylist})
00095 
00096         index = index + 1


Variable Documentation

DEBUG.

Definition at line 21 of file AlCaHLTBitMon_ParallelJobs.py.

tuple AlCaHLTBitMon_ParallelJobs::options = defineOptions()
Initial value:
00001 parallelJobs(options.hltKeyListFile,
00002                  options.jsonDir,
00003                  options.globalTag,
00004                  options.template,
00005                  options.queue,
00006                  options.cafsetup)

Definition at line 152 of file AlCaHLTBitMon_ParallelJobs.py.

Referenced by GenParticleDecaySelector::add(), helper::CandDecayStoreManager::add(), FWTGeoRecoGeometryESProducer::addCSCGeometry(), TrackerGeometry::addDet(), TrackerGeometry::addDetUnit(), FWTGeoRecoGeometryESProducer::addDTGeometry(), edmNew::DetSetVector< T >::addItem(), FastL1GlobalAlgo::addJet(), ReferenceTrajectory::addMaterialEffectsBrl(), GaussNoiseFP420::addNoise(), SiGaussianTailNoiseAdder::addNoise(), FBaseSimEvent::addParticles(), FWTGeoRecoGeometryESProducer::addPixelBarrelGeometry(), FWTGeoRecoGeometryESProducer::addPixelForwardGeometry(), ParabolaFit::addPoint(), PFTrackTransformer::addPoints(), PFTrackTransformer::addPointsAndBrems(), FWTGeoRecoGeometryESProducer::addRPCGeometry(), BetaCalculatorECAL::addStepToXtal(), FWTGeoRecoGeometryESProducer::addTECGeometry(), FWTGeoRecoGeometryESProducer::addTIBGeometry(), FWTGeoRecoGeometryESProducer::addTIDGeometry(), FWTGeoRecoGeometryESProducer::addTOBGeometry(), edm::ProductRegistryHelper::addToRegistry(), SiStripGainRandomCalculator::algoAnalyze(), SiStripGainCosmicCalculator::algoBeginJob(), SiStripCalibLorentzAngle::algoBeginJob(), BlockWipedPool::allocator(), AnalyticalPropagatorESProducer::AnalyticalPropagatorESProducer(), EnergyScaleAnalyzer::analyze(), HcalSimHitsValidation::analyze(), ParticleTreeDrawer::analyze(), IsolatedGenParticles::analyze(), evf::Vulture::analyze(), ESSummaryClient::analyze(), ResolutionCreator::analyze(), L2TauAnalyzer::analyze(), JetAnaPythia< Jet >::analyze(), EcalTPGParamBuilder::analyze(), EcalRecHitsValidation::analyze(), ParticleListDrawer::analyze(), edm::FlatEGunASCIIWriter::analyze(), EwkMuLumiMonitorDQM::analyze(), Rivet::CMS_2010_S8656010::analyze(), Rivet::CMS_2011_S8884919::analyze(), RPCDigiValid::analyze(), HcalCorrPFCalculation::analyze(), EcalDigisValidation::analyze(), HLTMonSimpleBTag::analyze(), Rivet::CMS_2010_S8547297::analyze(), Rivet::MC_LES_HOUCHES_SYSTEMATICS_CMS::analyze(), HLTrigReport::analyze(), HiBasicGenTest::analyze(), CaloTowersValidation::analyze(), HcalRecHitsValidation::analyze(), ElectronSeedAnalyzer::analyze(), HLTMCtruth::analyze(), TrackBuildingAnalyzer::analyze(), ElectronTagProbeAnalyzer::analyze(), myFastSimVal::analyze(), IsolatedParticlesGeneratedJets::analyze(), FourVectorHLT::analyze(), HLTMonHcalIsoTrack::analyze(), SimplePhotonAnalyzer::analyze(), DQMHcalIsoTrackHLT::analyze(), Rivet::CMS_2011_S8978280::analyze(), TrackParameterAnalyzer::analyze(), EcalSimHitsValidation::analyze(), TestOutliers::analyze(), HeavyFlavorValidation::analyze(), HLTTauDQMCaloPlotter::analyze(), Rivet::CMS_2010_S8808686::analyze(), Rivet::CMS_FWD_10_011::analyze(), Rivet::CMS_QCD_10_010::analyze(), TrackerHitAnalyzer::analyze(), ImpactParameterCalibration::analyze(), ParticleDecayDrawer::analyze(), ListIds::analyze(), MuTriggerAnalyzer::analyze(), EcalPreshowerSimHitsValidation::analyze(), EcalMixingModuleValidation::analyze(), TopValidation::analyze(), ElectronStudy::analyze(), MuScleFitUtils::applyScale(), L1MuDTEtaProcessor::assign(), CSCDriftSim::avalancheCharge(), Basic3DVector< long double >::Basic3DVector(), Basic3DVector< align::Scalar >::Basic3DVector(), AlignmentMuonSelector::basicCuts(), AlignmentTrackSelector::basicCuts(), HcalSimpleReconstructor::beginRun(), TSGFromL1Muon::beginRun(), ZdcHitReconstructor::beginRun(), HcalHitReconstructor::beginRun(), HcalShapes::beginRun(), HcalDetDiagLEDMonitor::beginRun(), HcalDetDiagPedestalMonitor::beginRun(), HcalDigiMonitor::beginRun(), HcalPulseShapes::beginRun(), SiStripLAProfileBooker::beginRun(), HcalMonitorClient::beginRun(), HcalBeamMonitor::beginRun(), HcalDeadCellMonitor::beginRun(), CtfSpecialSeedGenerator::beginRun(), HcalDetDiagLaserMonitor::beginRun(), ZdcSimpleReconstructor::beginRun(), CastorSimpleReconstructor::beginRun(), DTTracoChip::bestCand(), edm::binary_search_all(), PhysicsTools::BitSet::bits(), GctFormatTranslateV35::blockToFibres(), GctFormatTranslateV38::blockToFibres(), GctFormatTranslateMCLegacy::blockToFibres(), GctFormatTranslateV35::blockToGctInternEmCand(), GctFormatTranslateV38::blockToGctInternEmCand(), GctFormatTranslateV35::blockToGctInternEtSums(), GctFormatTranslateV38::blockToGctInternEtSums(), GctFormatTranslateV35::blockToGctInternEtSumsAndJetCluster(), GctFormatTranslateV38::blockToGctInternEtSumsAndJetCluster(), GctFormatTranslateV38::blockToGctInternHtMissPostWheel(), GctFormatTranslateV38::blockToGctInternHtMissPreWheel(), GctFormatTranslateV35::blockToGctInternRingSums(), GctFormatTranslateV38::blockToGctInternRingSums(), GctFormatTranslateV35::blockToGctJetClusterMinimal(), GctFormatTranslateV38::blockToGctJetClusterMinimal(), GctFormatTranslateV35::blockToGctJetPreCluster(), GctFormatTranslateV38::blockToGctJetPreCluster(), GctFormatTranslateV35::blockToGctTrigObjects(), GctFormatTranslateV38::blockToGctTrigObjects(), GctFormatTranslateV35::blockToGctWheelInputInternEtAndRingSums(), GctFormatTranslateV38::blockToGctWheelInputInternEtAndRingSums(), GctFormatTranslateV35::blockToGctWheelOutputInternEtAndRingSums(), GctFormatTranslateV38::blockToGctWheelOutputInternEtAndRingSums(), GctFormatTranslateV35::blockToRctCaloRegions(), GctFormatTranslateV38::blockToRctCaloRegions(), GctFormatTranslateV35::blockToRctEmCand(), GctFormatTranslateV38::blockToRctEmCand(), GctFormatTranslateMCLegacy::blockToRctEmCand(), blockWipedPool(), SiPixelActionExecutor::bookTrackerMaps(), RawParticle::boost(), BtagPerformanceESProducer::BtagPerformanceESProducer(), DTBtiCard::btiList(), DTTrig::BtiTrigs(), TkTransientTrackingRecHitBuilder::build(), FWConvTrackHitsDetailView::build(), GeometricSearchTrackerBuilder::build(), FWTrackHitsDetailView::build(), HcalDigitizer::buildHOSiPMCells(), Ntuple2HepMCFiller::buildProductionVertex(), cond::buildTechnologyProxy(), TrackProducerAlgorithm< reco::Track >::buildTrack(), TrackProducerAlgorithm< reco::GsfTrack >::buildTrack(), MuonSeedTrack::buildTrackAtPCA(), MuonTrackLoader::buildTrackAtPCA(), MuonTrackLoader::buildTrackExtra(), MuonTrackLoader::buildTrackUpdatedAtPCA(), ConstrainedTreeBuilder::buildTree(), ConstrainedTreeBuilderT::buildTree(), FWTableWidget::buttonReleasedInBody(), reco::TauMassTagInfo::calculateTrkP4(), FreeTrajectoryState::canReach(), TwoBodyDecayModel::cartesianSecondaryMomenta(), condbon::cdbon_read_rec(), FWGeometryTableViewBase::cdNode(), FWGeometryTableViewBase::cdUp(), spr::cGenSimInfo(), RectangularPixelTopology::channel(), spr::chargeIsolation(), spr::chargeIsolationCone(), spr::chargeIsolationEcal(), spr::chargeIsolationHcal(), BasicTrajectoryState::checkGlobalParameters(), MuonSeedSimpleCleaner::checkPt(), VZeroFinder::checkTrackPair(), Chi2MeasurementEstimatorESProducer::Chi2MeasurementEstimatorESProducer(), edm::JobReport::childAfterFork(), CkfDebugTrajectoryBuilderESProducer::CkfDebugTrajectoryBuilderESProducer(), CkfTrajectoryBuilderESProducer::CkfTrajectoryBuilderESProducer(), DTBtiChip::clear(), edm::ViewBase::clone(), MuonsFromRefitTracksProducer::cloneAndSwitchTrack(), cloneDecayTree(), SiStripFineDelayHit::closestCluster(), CMSMonopolePhysics::CMSMonopolePhysics(), CmsShowMain::CmsShowMain(), L1MuGMTMatrix< T >::colAny(), CmsShowModelPopup::colorSetChanged(), CmsShowEDI::colorSetChanged(), cms::MD5Result::compactForm(), GsfBetheHeitlerUpdator::compute(), MultipleScatteringUpdator::compute(), GsfMultipleScatteringUpdator::compute(), TEveEllipsoidProjected::ComputeBBox(), VolumeEnergyLossEstimator::computeBetheBloch(), EnergyLossUpdator::computeBetheBloch(), EnergyLossUpdator::computeElectrons(), VolumeEnergyLossEstimator::computeElectrons(), AnalyticalCurvilinearJacobian::computeInfinitesimalJacobian(), PlaneBuilderForGluedDet::computeRectBounds(), spr::coneChargeIsolation(), EcalTrigTowerConstituentsMap::constituentsOf(), TwoBodyDecayTrajectory::constructSingleTsosWithErrors(), converter::SuperClusterToCandidate::convert(), converter::StandAloneMuonTrackToCandidate::convert(), converter::TrackToCandidate::convert(), CaloTowersCreationAlgo::convert(), OwnerPolicy::Transfer::copy(), SimpleZSPJPTJetCorrector::correctionEtEtaPhiP(), SimpleZSPJPTJetCorrector::correctionPUEtEtaPhiP(), VVIObjDetails::cosint(), popcon::EcalChannelStatusHandler::cosmicsAnalysis(), cms::CRC32Calculator::CRC32Calculator(), DDI::Store< N, I, K >::create(), spu::create_dir(), spu::create_file(), TruncatedPyramid::createCorners(), TSLToyGen::createHists(), MuonSensitiveDetector::createHit(), BasicTrajectoryState::createLocalParameters(), SiStripMonitorMuonHLT::createMEs(), Ntuple2HepMCFiller::createParticle(), evf::FUShmBuffer::createShmBuffer(), ThePEG::HepMCConverter< HepMCEventT, Traits >::createVertex(), CaloDetIdAssociator::crossedElement(), TtFullLepKinSolver::cubic(), CustomPhysicsList::CustomPhysicsList(), muonisolation::IsolatorByNominalEfficiency::cuts(), DaqData< Format >::DaqData(), popcon::EcalChannelStatusHandler::daqOut(), DD_NC(), DDTokenize(), BlockWipedAllocated< _bqueue_item< T > >::dealloc(), Histos::debug(), FWGUIEventFilter::deleteEntry(), reco::parser::ExpressionVar::delStorage(), fftjetcms::densePeakTreeFromStorable(), PhysicsTools::VarProcessor::deriv(), RingMaker::determineExtensions(), JetBProbabilityComputer::discriminator(), JetProbabilityComputer::discriminator(), DisplayManager::displayAll(), DisplayManager::displayPFBlock(), VertexCompatibleWithBeam::distanceToBeam(), DTTracoChip::DoAdjBtiLts(), SiStripPlotGain::DoAnalysis(), FWRPZView::doFishEyeDistortion(), lhef::domToLines(), FWRPZView::doShiftOriginToBeamSpot(), TSLToyGen::doToyExperiments(), TwoBodyDecayDerivatives::dqsdpx(), TwoBodyDecayDerivatives::dqsdpy(), TwoBodyDecayDerivatives::dqsdpz(), DisplayManager::drawGObject(), DisplayManager::drawWithNewGraphicAttributes(), DTBtiChip::DTBtiChip(), DTConfigDBProducer::DTConfigDBProducer(), DTSC::DTSectCollsort1(), DTSC::DTSectCollsort2(), DTTracoChip::DTTracoChip(), cond::PayLoadInspector< DataT >::dump(), LMFDat::dump(), TimingReport::dump(), cmsutil::SimpleAllocHashMultiMap< K, V, Hasher, Equals, Alloc >::dump(), hitfit::Top_Decaykin::dump_ev(), CastorDumpConditions::dumpIt(), edmtest::HcalDumpConditions::dumpIt(), HLTrigReport::dumpReport(), ResidualRefitting::dumpTrackRef(), ZeeCalibration::duringLoop(), ECALRegFEDSelector::ECALRegFEDSelector(), DTTracoChip::edgeBTI(), EgammaHLTTrackIsolation::electronIsolation(), CaloTowersCreationAlgo::emShwrLogWeightPos(), CaloTowersCreationAlgo::emShwrPos(), lhef::LHEReader::XMLHandler::endElement(), PrimaryVertexAnalyzer4PU::endJob(), RPCEfficiencySecond::endRun(), edmNew::DetSetVector< T >::equal_range(), DTBtiChip::eraseTrigger(), BinomialProbability::error(), VolumeMultipleScatteringEstimator::estimate(), VariablePower::eval(), metsig::SignAlgoResolutions::eval(), MuonCaloCompatibility::evaluate(), L1ExtraParticleMapProd::evaluateQuadSameObjectTrigger(), evf::EvffedFillerRB::EvffedFillerRB(), DDName::exists(), edm::EventExtractor::extract(), edm::JobHeaderExtractor::extract(), TrajectoryExtrapolatorToLine::extrapolate(), AnalyticalTrajectoryExtrapolatorToLine::extrapolateSingleState(), AnalyticalImpactPointExtrapolator::extrapolateSingleState(), vdt::fast_asin(), FastPixelCPEESProducer::FastPixelCPEESProducer(), FastStripCPEESProducer::FastStripCPEESProducer(), edm::CFWriter::fctTest(), ODBadTTDat::fetchData(), MonPulseShapeDat::fetchData(), MonPNRedDat::fetchData(), MonLaserGreenDat::fetchData(), MonH4TablePositionDat::fetchData(), DCULVRTempsDat::fetchData(), DCUIDarkDat::fetchData(), CaliTempDat::fetchData(), CaliHVScanRatioDat::fetchData(), MonShapeQualityDat::fetchData(), FEConfigBadXTDat::fetchData(), ITimingDat::fetchData(), MonMemTTConsistencyDat::fetchData(), DCUCCSDat::fetchData(), MonPedestalsOnlineDat::fetchData(), RunTTErrorsDat::fetchData(), ODVfeToRejectDat::fetchData(), ODTowersToByPassDat::fetchData(), MonTestPulseDat::fetchData(), MonPNIRedDat::fetchData(), MonMemChConsistencyDat::fetchData(), MonDelaysTTDat::fetchData(), MODCCSTRDat::fetchData(), MonLaserRedDat::fetchData(), MonLaserPulseDat::fetchData(), MonLaserIRedDat::fetchData(), CaliGainRatioDat::fetchData(), ODDelaysDat::fetchData(), MonPNLed1Dat::fetchData(), MonPNGreenDat::fetchData(), MonLaserBlueDat::fetchData(), DCUVFETempDat::fetchData(), DCUIDarkPedDat::fetchData(), CaliGeneralDat::fetchData(), MonPNLed2Dat::fetchData(), MonPNBlueDat::fetchData(), MonLed2Dat::fetchData(), MODDCCDetailsDat::fetchData(), CaliCrystalIntercalDat::fetchData(), ODWeightsSamplesDat::fetchData(), ODGolBiasCurrentDat::fetchData(), MonPNPedDat::fetchData(), MonLed1Dat::fetchData(), ODWeightsDat::fetchData(), MonPNMGPADat::fetchData(), MonLaserStatusDat::fetchData(), MODCCSFEDat::fetchData(), FEConfigBadStripDat::fetchData(), DCULVRVoltagesDat::fetchData(), ODBadXTDat::fetchData(), MonPedestalOffsetsDat::fetchData(), MonOccupancyDat::fetchData(), MonCrystalConsistencyDat::fetchData(), DCULVRBTempsDat::fetchData(), ODPedestalOffsetsDat::fetchData(), MonTTConsistencyDat::fetchData(), MODCCSHFDat::fetchData(), DCUCapsuleTempDat::fetchData(), MODDCCOperationDat::fetchData(), FEConfigBadTTDat::fetchData(), DCUCapsuleTempRawDat::fetchData(), RunDCSHVDat::fetchHistoricalData(), RunDCSMagnetDat::fetchLastData(), fftjetcms::fftjet_Function_parser(), fftjetcms::fftjet_PeakSelector_parser(), Var::fill(), HcalTB06Analysis::fillBuffer(), HcalTB04Analysis::fillBuffer(), AnalysisRootpleProducer::fillCaloJet(), AnalysisRootpleProducer::fillChargedJet(), AnalysisRootpleProducerOnlyMC::fillChargedJet(), CmsShowEDI::fillEDIFrame(), ZeePlots::fillEleMCInfo(), edm::Schedule::fillEndPath(), TrackAnalyzer::fillHistosForState(), AnalysisRootpleProducer::fillInclusiveJet(), AnalysisRootpleProducerOnlyMC::fillInclusiveJet(), GenParticleProducer::fillIndices(), HLTOniaSource::fillInvariantMass(), objMon< T >::fillL1MCMatch(), objMon< T >::fillMC(), AnalysisRootpleProducer::fillMCParticles(), AnalysisRootpleProducerOnlyMC::fillMCParticles(), ecaldqm::fillME(), objMon< T >::fillOffMCMatch(), objMon< T >::fillOnMCMatch(), TSLToyGen::fillPar(), StripCPE::fillParams(), QcdLowPtDQM::fillPixelClusterInfos(), TSLToyGen::fillPull1(), TSLToyGen::fillPull2(), Histograms::fillRecHistograms(), recoBSVTagInfoValidationAnalyzer::fillRecoToSim(), SVTagInfoValidationAnalyzer::fillRecoToSim(), TopDecaySubset::fillReferences(), SVTagInfoValidationAnalyzer::fillSimToReco(), recoBSVTagInfoValidationAnalyzer::fillSimToReco(), FastTimerServiceClient::fillSummaryPlots(), RunDCSMagnetDat::fillTheMap(), RunDCSHVDat::fillTheMapByTime(), MillePedeMonitor::fillTrack(), AnalysisRootpleProducer::fillTracks(), AnalysisRootpleProducer::fillTracksJet(), edm::Schedule::fillTrigPath(), EopVariables::fillVariables(), ZeePlots::fillZMCInfo(), PythiaFilterZJetWithOutBg::filter(), HZZ4lFilter::filter(), PythiaFilterTTBar::filter(), BTagSkimMC::filter(), ProtonTaggerFilter::filter(), PythiaFilterEMJetHeep::filter(), MCMultiParticleFilter::filter(), MCParticlePairFilter::filter(), MCZll::filter(), PythiaFilterGammaJet::filter(), PythiaFilterGammaJetIsoPi0::filter(), PythiaFilterEMJet::filter(), PythiaFilterGammaJetWithOutBg::filter(), PythiaDauVFilter::filter(), PythiaFilterGammaJetWithBg::filter(), PythiaFilterIsolatedTrack::filter(), STFilter::filter(), TwoVBGenFilter::filter(), Zto2lFilter::filter(), PythiaFilterZJet::filter(), HighMultiplicityGenFilter::filter(), PythiaDauFilter::filter(), MCSmartSingleParticleFilter::filter(), JetVertexChecker::filter(), MCLongLivedParticles::filter(), JetFlavourFilter::filter(), MCDijetResonance::filter(), PythiaFilterGammaGamma::filter(), HerwigMaxPtPartonFilter::filter(), JetFlavourCutFilter::filter(), ZgMassFilter::filter(), MCDecayingPionKaonFilter::filter(), PythiaFilter::filter(), PythiaHLTSoupFilter::filter(), DJpsiFilter::filter(), FourLepFilter::filter(), PythiaFilterZgamma::filter(), LQGenFilter::filter(), MCSingleParticleFilter::filter(), cond::IOVSequence::find(), edm::DataFrameContainer::find(), edm::DetSetVector< T >::find(), edm::MapOfVectors< std::string, AnalysisDescription * >::find(), edm::DetSetLazyVector< T >::find(), edm::DetSetRefVector< T, C >::find(), edmNew::DetSetVector< T >::find(), edm::find_if_in_all(), edm::DetSetVector< T >::find_or_insert(), DisplayManager::findBlock(), LocalFileSystem::findCachePath(), edmNew::DetSetVector< T >::findItem(), FastL1GlobalAlgo::findJets(), edm::MapOfVectors< std::string, AnalysisDescription * >::findKey(), ElectronCalibration::findMaxHit(), DQMImplNet< DQMNet::Object >::findObject(), BsJpsiPhiFilter::findParticle(), BdecayFilter::findParticle(), JetFlavourFilter::findParticle(), JetFlavourCutFilter::findParticle(), pat::PATGenCandsFromSimTracksProducer::findRef(), cond::IOVSequence::findSince(), edm::eventsetup::heterocontainer::HCTypeTag::findType(), SymmetryFit::fit(), LA_Filler_Fitter::fit_width_profile(), CSCSegAlgoHitPruning::fitSlopes(), CSCSegAlgoST::fitSlopes(), CSCSegAlgoTC::fitSlopes(), CSCSegAlgoSK::fitSlopes(), spf::SherpackFetcher::FnFileGet(), ora::Version::fromString(), GammaFunctionGenerator::gammaFrac(), GeantPropagatorESProducer::GeantPropagatorESProducer(), edm::RangeMap< det_id_type, edm::OwnVector< B > >::get(), funct::Primitive< Parameter >::get(), evf::evtn::get(), get_4(), edm::Schedule::getAllModuleDescriptions(), SiStripQuality::getBadApvs(), SiStripQuality::getBadFibers(), EcalSelectiveReadoutProducer::getBinOfMax(), UtilsClient::getBinStatistics(), MatacqProducer::getCalibTriggerType(), TtSemiEvtSolution::getCalLept(), TtSemiEvtSolution::getCalLepW(), DTTSS::getCarry(), CaloSubdetectorGeometry::getCells(), EcalEndcapGeometry::getCells(), HcalGeometry::getCells(), EcalBarrelGeometry::getCells(), TiXmlBase::GetChar(), CaloSubdetectorGeometry::getClosestCell(), EcalPreshowerGeometry::getClosestCellInPlane(), L1GtVhdlWriterCore::getCondChipVhdContentFromTriggerMenu(), HLTPixelClusterShapeFilter::getContainedHits(), HIPixelClusterVtxProducer::getContainedHits(), PixelVertexProducerClusters::getContainedHits(), IdealCastorTrapezoid::getCorners(), IdealZPrism::getCorners(), IdealZDCTrapezoid::getCorners(), IdealObliquePrism::getCorners(), HLTScalersClient::CountLSFifo_t::getCount(), SiStripThreshold::getData(), TFitParticleMCPInvSpher::getDerivative(), LaserSorter::getDetailedTriggerType(), SiStripPedestals::getDetIds(), mySiStripNoises::getDetIds(), SiStripNoises::getDetIds(), SiPixelGainCalibrationForHLT::getDetIds(), SiPixelGainCalibrationOffline::getDetIds(), SiStripBadStrip::getDetIds(), SiStripSummary::getDetIds(), SiPixelGainCalibration::getDetIds(), HDQMSummary::getDetIds(), SiStripThreshold::getDetIds(), EcalShowerProperties::getDistance(), DTSC::getDTSectCollPhCand(), DTSectColl::getDTSectCollPhCand(), DTSectColl::getDTSectCollThCand(), DTSC::getDTSectCollThCand(), DTTSS::getDTTSCand(), DTTSM::getDTTSCand(), DTTSPhi::getDTTSS(), L2TauModularIsolationProducer::getECALHits(), L2TauNarrowConeIsolationProducer::getECALHits(), L2TauIsolationProducer::getECALHits(), pftools::CaloEllipse::getEccentricity(), TiXmlBase::GetEntity(), edm::getEnvironmentVariable(), TopologyWorker::getetaphi(), L1TauAnalyzer::getGenObjects(), ClusterShapeTrackFilter::getGlobalDirs(), HCALResponse::getHCALEnergyResponse(), HFShowerLibrary::getHits(), HFShower::getHits(), L1TauAnalyzer::getL1extraObjects(), StEvtSolution::getLept(), TtDilepEvtSolution::getLeptNeg(), TtDilepEvtSolution::getLeptPos(), StEvtSolution::getLepW(), TwoBodyDecayLinearizationPointFinder::getLinearizationPoint(), pftools::CaloEllipse::getMajorMinorAxes(), StorageFactory::getMaker(), HLTPerformanceInfo::getModuleOnPath(), SiPixelGainCalibration::getNCols(), SiPixelGainCalibrationForHLT::getNCols(), SiPixelGainCalibrationOffline::getNCols(), popcon::EcalTPGFineGrainEBGroupHandler::getNewObjects(), popcon::EcalTPGFineGrainTowerEEHandler::getNewObjects(), popcon::EcalTPGWeightGroupHandler::getNewObjects(), popcon::EcalTPGBadXTHandler::getNewObjects(), popcon::EcalTPGWeightIdMapHandler::getNewObjects(), popcon::EcalDAQHandler::getNewObjects(), popcon::EcalSRPHandler::getNewObjects(), popcon::EcalTPGBadTTHandler::getNewObjects(), popcon::EcalTPGSpikeThresholdHandler::getNewObjects(), popcon::EcalTPGPedestalsHandler::getNewObjects(), popcon::EcalTPGSlidingWindowHandler::getNewObjects(), popcon::EcalTPGFineGrainEBIdMapHandler::getNewObjects(), popcon::EcalTPGLinConstHandler::getNewObjects(), popcon::EcalTPGLutIdMapHandler::getNewObjects(), popcon::EcalTPGBadStripHandler::getNewObjects(), popcon::EcalTPGFineGrainStripEEHandler::getNewObjects(), popcon::EcalTPGLutGroupHandler::getNewObjects(), popcon::EcalPedestalsHandler::getNewObjectsH2(), popcon::EcalPedestalsHandler::getNewObjectsP5(), NuclearTrackCorrector::getNewTrackExtra(), BdecayFilter::getNextBs(), BsJpsiPhiFilter::getNextBs(), MixCollection< PSimHit >::getObject(), LMFCorrCoefDat::getParameters(), ClusterShapeHitFilter::getpd(), TMom::getPeak(), L2TauModularIsolationProducer::getPFClusters(), PlotRecTracks::getPixelInfo(), pftools::CaloEllipse::getPosition(), edm::getProduct(), TkSimHitPrinter::getPropagationSign(), edm::getPtr(), edm::refitem::GetPtrImpl< C, T, F, KEY >::getPtr_(), HDRShower::getR(), SiPixelGainCalibration::getRange(), SiStripPedestals::getRange(), SiStripBadStrip::getRange(), SiPixelGainCalibrationOffline::getRange(), SiStripSummary::getRange(), SiStripThreshold::getRange(), mySiStripNoises::getRange(), SiStripNoises::getRange(), HDQMSummary::getRange(), SiPixelGainCalibrationForHLT::getRange(), SiStripApvGain::getRange(), SiPixelGainCalibrationOffline::getRangeAndNCols(), SiPixelGainCalibration::getRangeAndNCols(), SiPixelGainCalibrationForHLT::getRangeAndNCols(), cond::SQLiteProxy::getRealConnectString(), TtSemiEvtSolution::getRecLept(), StEvtSolution::getRecLept(), TtSemiEvtSolution::getRecLepW(), edm::Event::getRefBeforePut(), edm::getRegFromFile(), SiStripApvGain::getRegistryPointers(), pat::helper::ResolutionHelper::getResolE(), pat::helper::ResolutionHelper::getResolEt(), pat::helper::ResolutionHelper::getResolPt(), pat::helper::ResolutionHelper::getResolPx(), pat::helper::ResolutionHelper::getResolPy(), pat::helper::ResolutionHelper::getResolPz(), pat::helper::ResolutionHelper::getResolTheta(), evf::FUShmBuffer::getShmBuffer(), PrimaryVertexAnalyzer4PU::getSimTrkParameters(), PlotRecTracks::getStripInfo(), pftools::CaloEllipse::getTheta(), DTTSS::getTrack(), DTTSM::getTrack(), DTSectColl::getTrackPh(), DTSC::getTrackPh(), DTSC::getTrackTh(), DTSectColl::getTrackTh(), TruncatedPyramid::getTransform(), CaloCellGeometry::getTransform(), ConversionSeedFilter::getTSOS(), StormLcgGtStorageMaker::getTURL(), StormStorageMaker::getTURL(), reco::GhostTrackPrediction::GhostTrackPrediction(), GlobalTrackerMuonAlignment::gradientGlobal(), GroupedCkfTrajectoryBuilderESProducer::GroupedCkfTrajectoryBuilderESProducer(), GsfMaterialEffectsESProducer::GsfMaterialEffectsESProducer(), GsfTrajectoryFitterESProducer::GsfTrajectoryFitterESProducer(), GsfTrajectorySmootherESProducer::GsfTrajectorySmootherESProducer(), CaloTowersCreationAlgo::hadShwrPos(), FWPSetCellEditor::HandleKey(), objMon< T >::hasBPartonInCone(), PrimaryVertexValidation::hasFirstLayerPixelHits(), HelixExtrapolatorToLine2Order::HelixExtrapolatorToLine2Order(), Generator::HepMC2G4(), QualityCutsAnalyzer::histogram_element_t::histogram_element_t(), HLTPixelIsolTrackFilter::hltFilter(), HLTmmkFilter::hltFilter(), HLTDoubletDZ< T1, T2 >::hltFilter(), HLTMuonTrimuonL3Filter::hltFilter(), HLTDoublet< T1, T2 >::hltFilter(), HLTMuonDimuonL2Filter::hltFilter(), HLTMuonDimuonL3Filter::hltFilter(), HLTmmkkFilter::hltFilter(), evf::IndependentWebGUI::htmlHeadline(), TrackerGeometry::idToDet(), TrackerGeometry::idToDetUnit(), edm::WorkerMaker< T >::implSwapModule(), ora::Record::index(), triggerExpression::HLTReader::init(), ThePEG::HepMCConverter< HepMCEventT, Traits >::init(), FWViewContextMenuHandlerGL::init(), L1MuGMTMatrix< T >::init(), DTBtiChip::init(), fit::RootMinuit< Function >::init(), pftools::LinearCalibrator::initEijMatrix(), LocalFileSystem::initFSInfo(), CMSCGEN::initialize(), SiStripDetVOffFakeBuilder::initialize(), edm::Schedule::initializeEarlyDelete(), EcalEndcapGeometry::initializeParms(), MuonHOAcceptance::initIds(), FastL1GlobalAlgo::InitL1Regions(), edm::JobHeaderInserter::insert(), EcalCondDBInterface::insertConfigDataSet(), EcalCondDBInterface::insertDataSet(), popcon::EcalDCSHandler::insertHVDataSetToOffline(), popcon::EcalDCSHandler::insertLVDataSetToOffline(), CaloCellGeometry::inside(), EcalHitMaker::inside3D(), SimpleProfiler::instance(), HLTTauDQMCaloPlotter::inverseMatch(), SiStripQuality::IsApvBad(), ThirdHitPrediction::isCompatibleWithMultipleScattering(), SiStripQuality::IsFiberBad(), HiGammaJetSignalDef::IsIsolated(), HiGammaJetSignalDef::IsIsolatedJP(), HiGammaJetSignalDef::IsIsolatedPP(), L1MuGMTMatrix< T >::isMax(), L1MuGMTMatrix< T >::isMin(), SiStripQuality::IsModuleBad(), SiStripDetVOff::IsModuleHVOff(), SiStripDetVOff::IsModuleLVOff(), SiStripQuality::IsModuleUsable(), SiStripDetVOff::IsModuleVOff(), pat::helper::ParametrizationHelper::isPhysical(), edmNew::DetSetVector< T >::isValid(), FWInteractionList::itemChanged(), FFTJetProducer::iterateJetReconstruction(), edm::iterateTrieLeaves(), IterativeHelixExtrapolatorToLine::IterativeHelixExtrapolatorToLine(), JacobianCartesianToCurvilinear::JacobianCartesianToCurvilinear(), JacobianCartesianToLocal::JacobianCartesianToLocal(), PerigeeConversions::jacobianCurvilinear2Perigee(), JacobianCurvilinearToCartesian::JacobianCurvilinearToCartesian(), PerigeeConversions::jacobianPerigee2Curvilinear(), fftjetcms::jetFromStorable(), join(), Tokenizer::join(), ConfigFile::keyExists(), KFFittingSmootherESProducer::KFFittingSmootherESProducer(), KFSwitching1DUpdatorESProducer::KFSwitching1DUpdatorESProducer(), KFTrajectoryFitterESProducer::KFTrajectoryFitterESProducer(), KFTrajectorySmootherESProducer::KFTrajectorySmootherESProducer(), KFUpdatorESProducer::KFUpdatorESProducer(), hitfit::Lepjets_Event::kt(), langaupro(), HDQMUtil::langaupro(), popcon::EcalChannelStatusHandler::laserAnalysis(), PerformancePayloadFromBinnedTFormula::limitPos(), PerformancePayloadFromTFormula::limitPos(), edmplugin::PluginManager::load(), cond::KeyList::load(), G4SimEvent::load(), DTTSTheta::loadDTTSTheta(), TiXmlDocument::LoadFile(), DisplayManager::loadGGenParticles(), HcalPatternSource::loadPatterns(), DTSectColl::loadSectColl(), DTTracoCard::loadTRACO(), DTTSPhi::loadTSPhi(), LoadWeights(), LocalCacheFile::LocalCacheFile(), DTBtiCard::localClear(), DTTracoCard::localClear(), IdealObliquePrism::localCorners(), IdealZPrism::localCorners(), FWPFEcalRecHitLegoProxyBuilder::localModelChanges(), StripCPEgeometric::localParameters(), StripCPEfromTemplate::localParameters(), StripCPE::localParameters(), StripCPEfromTrackAngle::localParameters(), fit::Likelihood< Sample, PDF, Yield >::log(), cond::Logger::logFailedOperationNow(), cond::Logger::logOperationNow(), QualityCutsAnalyzer::LoopOverJetTracksAssociation(), PixelCPEBase::lorentzShiftX(), PixelCPEBase::lorentzShiftY(), edm::lower_bound_all(), main(), HFClusterAlgo::makeCluster(), TagProbeFitter::makeEfficiencyPlot1D(), DTSurveyChamber::makeErrors(), edmtest::makeFile(), HSCPValidator::makeGenPlots(), DTSurveyChamber::makeMatrix(), DQMImplNet< DQMNet::Object >::makeObject(), HSCPValidator::makeRecoPlots(), makeVecForEventShape(), DTSurveyChamber::makeVector(), edm::reftobase::IndirectHolder< T >::makeVectorHolder(), SiPixelActionExecutor::mapMax(), SiPixelActionExecutor::mapMin(), edm::MapOfVectors< std::string, AnalysisDescription * >::MapOfVectors(), DQMImplNet< DQMNet::Object >::markObjectsDead(), L1TOccupancyClientHistogramService::maskBins(), MuScleFitUtils::massProb(), MuScleFitUtils::massResolution(), SiStripRecHitMatcher::match(), PrimaryVertexAnalyzer4PU::matchRecTracksToVertex(), PerformancePayloadFromTable::maxPos(), RectangularPixelTopology::measurementPosition(), MeasurementTrackerESProducer::MeasurementTrackerESProducer(), PerformancePayloadFromTable::minPos(), FWDigitSetProxyBuilder::modelChanges(), FWInteractionList::modelChanges(), HLTPerformanceInfo::moduleIndexInPath(), CurvilinearState::momentum(), CosmicParametersDefinerForTP::momentum(), ParametersDefinerForTP::momentum(), RKCurvilinearDistance< T, N >::momentum(), MultiTrajectoryStateMode::momentumFromModeP(), MultiTrajectoryStateMode::momentumFromModePPhiEta(), objMon< T >::monitorL1(), objMon< T >::monitorOffline(), objMon< T >::monitorOnline(), MRHChi2MeasurementEstimatorESProducer::MRHChi2MeasurementEstimatorESProducer(), mtrReset(), MuonCkfTrajectoryBuilderESProducer::MuonCkfTrajectoryBuilderESProducer(), MuonRoadTrajectoryBuilder::MuonRoadTrajectoryBuilder(), ZMuMuIsolationAnalyzer::muTag(), CmsTrackerStringToEnum::name(), popcon::EcalChannelStatusHandler::nBadLaserModules(), DTBtiChip::nCellHit(), cms::MuonTCMETValueMapProducer::nLayers(), TCMETAlgo::nLayers(), DCacheStorageMaker::normalise(), DTTSPhi::nSegm(), DTTSTheta::nSegm(), DTSectColl::nSegmPh(), DTSectColl::nSegmTh(), pat::ObjectResolutionCalc::ObjectResolutionCalc(), edm::MapOfVectors< std::string, AnalysisDescription * >::offset(), oldMUcompute(), DQMNet::onPeerConnect(), BlockWipedPoolAllocated::operator delete(), BlockWipedAllocated< _bqueue_item< T > >::operator new(), BlockWipedPoolAllocated::operator new(), ROOT::Math::Transform3DPJ::operator()(), MuonTkNavigationSchool::delete_layer::operator()(), hitfit::LeptonTranslatorBase< ALepton >::operator()(), TrackingParticleSelector::operator()(), hitfit::JetTranslatorBase< AJet >::operator()(), TrackClassFilter::operator()(), ExtractBarrelDetLayerR::operator()(), VertexCompatibleWithBeam::operator()(), MuonNavigationSchool::delete_layer::operator()(), fftjetcms::Polynomial::operator()(), edm::service::close_and_delete::operator()(), L1MuGMTMatrix< T >::operator()(), PropagationDirectionChooser::operator()(), TrackClassMatch::operator()(), ZGoldenFilter::operator()(), L1MuGMTMatrix< T >::operator*=(), L1MuGMTMatrix< T >::operator+=(), hitfit::Lepjets_Event_Lep::operator<(), operator<<(), edm::Guid::operator=(), DTBtiChip::operator=(), L1MuGMTMatrix< T >::operator=(), DTTracoChip::operator=(), OwnIt< T >::operator=(), edm::Guid::operator==(), TimingReport::operator[](), edmNew::DetSetVector< T >::operator[](), TopDecaySubset::p4(), pat::helper::ParametrizationHelper::p4fromParameters(), L1GTDigiToRaw::packGMT(), hitfit::Pair_Table::Pair_Table(), G4SimEvent::param(), fit::RootMinuitCommands< Function >::parameter(), fit::RootMinuit< Function >::parameterIndex(), TrackAssociatorByChi2::parametersAtClosestApproach(), edm::JobReport::parentBeforeFork(), TiXmlElement::Parse(), TiXmlComment::Parse(), TiXmlAttribute::Parse(), TiXmlDocument::Parse(), TiXmlDeclaration::Parse(), TiXmlUnknown::Parse(), TiXmlText::Parse(), spu::parseoct(), Generator::particleAssignDaughters(), DDSelLevelCollector::path(), HLTFilter::path(), popcon::EcalChannelStatusHandler::pedAnalysis(), hitfit::Resolution::pick(), PixelCPEGenericESProducer::PixelCPEGenericESProducer(), PixelCPETemplateRecoESProducer::PixelCPETemplateRecoESProducer(), pos::PixelPortCardConfig::PixelPortCardConfig(), root::plot(), cond::PayLoadInspector< DataT >::plot(), SymmetryFit::pol2_from_pol2(), SymmetryFit::pol2_from_pol3(), pat::helper::ParametrizationHelper::polarP4fromParameters(), edmNew::DetSetVector< T >::pop_back(), TrackingAction::PostUserTrackingAction(), CmsShowSearchFiles::prefixChoosen(), fireworks::prepareTrack(), SiPixelActionExecutor::prephistosB(), L1MuDTEtaProcessor::print(), DTConfigBti::print(), L1MuGMTMatrix< T >::print(), edm::ParameterSwitchBase::printCaseT(), SiStripPsuDetIdMap::printControlMap(), PlotEcalRecHits::printEcalRecHit(), DisplayManager::printGenParticleInfo(), PFRootEventManager::printGenParticles(), sistrip::printHex(), JetFlavourCutFilter::printHisto(), JetFlavourFilter::printHisto(), popcon::EcalDCSHandler::printHVDataSet(), popcon::EcalDCSHandler::printLVDataSet(), SiStripPsuDetIdMap::printMap(), FBaseSimEvent::printMCTruth(), SiStripMonitorMuonHLT::PrintNormalization(), PlotRecHits::printPixelRecHit(), PlotRecTracks::printRecTracks(), PrimaryVertexAnalyzer4PU::printRecTrks(), PlotSimTracks::printSimTracks(), PlotRecHits::printStripRecHit(), PlotRecHits::printStripRecHits(), IsolatedTracksNxN::printTrack(), IsolatedTracksCone::printTrack(), PFTauElecRejectionBenchmark::process(), sistrip::MeasureLA::process_reports(), PFAlgoTestBenchElectrons::processBlock(), HcalNZSMonitor::processEvent(), HcalBeamMonitor::processEvent(), FWGeoTopNodeGL::ProcessSelection(), JetCrystalsAssociator::produce(), edm::ExpoRandomPtGunProducer::produce(), MCTrackMatcher::produce(), SiStripRegFEDSelector::produce(), TtSemiEvtSolutionMaker::produce(), CastorSimpleReconstructor::produce(), FlavorHistoryProducer::produce(), edm::FlatRandomEGunSource::produce(), CastorFastTowerProducer::produce(), edm::BeamHaloProducer::produce(), TtHadEvtSolutionMaker::produce(), GenParticleProducer::produce(), edm::FileRandomKEThetaGunProducer::produce(), edm::ExpoRandomPtGunSource::produce(), L2TauIsolationSelector::produce(), GoodSeedProducer::produce(), ZdcHitReconstructor::produce(), edm::FlatRandomOneOverPtGunProducer::produce(), ParticleDecayProducer::produce(), ECALRegFEDSelector::produce(), HcalHitReconstructor::produce(), edm::FlatRandomPtGunProducer::produce(), edm::FlatRandomEThetaGunProducer::produce(), EcalIsolatedParticleCandidateProducer::produce(), L2TauRelaxingIsolationSelector::produce(), HLTTauProducer::produce(), CaloTowerCreatorForTauHLT::produce(), GenParticlePruner::produce(), ParticleReplacerClass::produce(), PFConversionProducer::produce(), edm::FlatRandomPtGunSource::produce(), edm::FlatRandomEGunProducer::produce(), TrackIPProducer::produce(), edm::FlatRandomPtThetaGunProducer::produce(), LHE2HepMCConverter::produce(), HLTDisplacedmumumuVtxProducer::produce(), L2TauModularIsolationSelector::produce(), FastPrimaryVertexProducer::produce(), edm::MultiParticleInConeGunProducer::produce(), HLTTauMCProducer::produce(), CastorFastClusterProducer::produce(), HLTDisplacedmumuVtxProducer::produce(), IPTCorrector::produce(), ConeIsolation::produce(), CaloTowerCandidateCreator::produce(), edm::MultiParticleInConeGunSource::produce(), edm::FlatRandomPtThetaGunSource::produce(), reco::modules::CaloRecHitCandidateProducer< HitCollection >::produce(), IsolatedPixelTrackCandidateProducer::produce(), TrajectorySeedProducer::produce(), PFTrackProducer::produce(), ConvBremSeedProducer::produce(), ShallowDigisProducer::produce(), ImpactParameter::produce(), edm::FlatRandomEThetaGunSource::produce(), edm::BeamHaloSource::produce(), cms::HITrackVertexMaker::produceTracks(), TrackingRecHitPropagator::project(), cms::HICMuonPropagator::propagate(), spr::propagateCALO(), AnalyticalPropagator::propagateParametersOnCylinder(), AnalyticalPropagator::propagateParametersOnPlane(), AnalyticalPropagator::propagateWithPath(), StraightLinePropagator::propagateWithPath(), PropagatorWithMaterialESProducer::PropagatorWithMaterialESProducer(), HITSiStripRawToClustersRoI::ptracks(), PTrajectoryStateOnDet::PTrajectoryStateOnDet(), HTrack::pull(), stor::DQMEventStore< DQMEventMsg, EventRetriever< RegInfo, QueueCollectionPtr >, StateMachine >::purge(), DQMImplNet< DQMNet::Object >::purgeDeadObjects(), edm::RefToBaseVector< T >::push_back(), SiStripPedestals::put(), HDQMSummary::put(), SiPixelGainCalibrationForHLT::put(), edm::RangeMap< det_id_type, edm::OwnVector< B > >::put(), SiPixelGainCalibrationOffline::put(), SiStripThreshold::put(), SiStripBadStrip::put(), SiStripDetVOff::put(), SiStripApvGain::put(), SiStripNoises::put(), SiStripSummary::put(), mySiStripNoises::put(), SiPixelGainCalibration::put(), SiStripQuality::put_replace(), GsfTrackProducerBase::putInEvt(), KfTrackProducerBase::putInEvt(), TrackProducerWithSCAssociation::putInEvt(), ThirdHitPredictionFromCircle::HelixRZ::rAtZ(), HepMCFileReader::rdstate(), ConfigFile::read(), LaserSorter::readFormatVersion(), EcalTPGDBApp::readFromConfDB_TPGPedestals(), edm::readHeaderFromStream(), ConfigFile::readInto(), TiXmlBase::ReadName(), AsciiNeutronReader::readNextEvent(), ReadPatterns(), TiXmlBase::ReadText(), TiXmlElement::ReadValue(), HemisphereAlgo::reconstruct(), TrackClassifier::reconstructionInformation(), HITRegionalPixelSeedGenerator::regions(), CondDBESSource::registerProxies(), evf::FUShmBuffer::releaseSharedMemory(), OwnerPolicy::Clone::remove(), OwnerPolicy::Replica::remove(), OwnerPolicy::Copy::remove(), OwnerPolicy::Transfer::remove(), DQMImplNet< DQMNet::Object >::removePeer(), DisplayManager::reset(), own_ptr< std::ifstream >::reset(), HLTrigReport::reset(), LA_Filler_Fitter::result(), PerformancePayloadFromTFormula::resultPos(), PerformancePayloadFromTable::resultPos(), PerformancePayloadFromBinnedTFormula::resultPos(), Combinatorics::Rotate(), TwoBodyDecayModel::rotationMatrix(), L1MuGMTMatrix< T >::rowAny(), DTTSS::run(), HIPAlignmentAlgorithm::run(), DTTSM::run(), DTSC::run(), DQMNet::run(), ConvBremPFTrackFinder::runConvBremFinder(), DTTSTheta::runDTTSTheta(), L1MuDTEtaProcessor::runEtaMatchingUnit(), edm::UnscheduledCallProducer::runNow(), DTTSPhi::runTSPhi(), ora::NamedRef< T >::safePtr(), BSFitter::scanPDF(), DTTrig::SCPhTrigs(), DTTrig::SCThTrigs(), edm::search_if_in_all(), DTSectColl::SectCollPhSegment(), DTSectColl::SectCollThSegment(), DTTSPhi::segment(), DTTSTheta::segment(), CaloConeSelector::select(), CaloDualConeSelector::select(), MuScleFit::selGlobalMuon(), MuScleFitMuonSelector::selGlobalMuon(), BPhysicsOniaDQM::selGlobalMuon(), MuScleFitMuonSelector::selTrackerMuon(), BPhysicsOniaDQM::selTrackerMuon(), MuScleFit::selTrackerMuon(), DQMImplNet< DQMNet::Object >::sendObjectListToPeers(), CandCommonVertexFitterBase::set(), CandKinematicVertexFitter::set(), ora::AnyTypeHandler< bool * >::set(), ora::SimpleTypeHandler< T >::set(), PFCandCommonVertexFitterBase::set(), ora::VoidStarHandler::set(), L1MuGMTMatrix< T >::set(), hitfit::Fourvec_Event::set_nu_p(), hitfit::Fourvec_Event::set_obj_p(), hitfit::Fourvec_Event::set_x_p(), EcalUncalibRecHitWorkerFixedAlphaBetaFit::setAlphaBeta(), pos::PixelPortCardConfig::setAOHGain(), cond::DbConnectionConfiguration::setAuthenticationPath(), ecaldqm::setBinContentME(), ecaldqm::setBinEntriesME(), ecaldqm::setBinErrorME(), edm::Provenance::setBranchDescription(), TrackInformation::setCaloSurfaceParticleP(), FWRPZView::setContext(), pos::PixelPortCardConfig::setDataBaseAOHGain(), DTConfigBti::setDefaults(), pos::PixelPortCardConfig::setdeviceValues(), EcalUncalibRecHitFixedAlphaBetaAlgo< C >::SetDynamicPedestal(), reco::FFTJet< float >::setFourVec(), TrackInformation::setGenParticleP(), EcalSimRawData::setHParity(), TrackInformation::setIDonCaloSurface(), MonLaserStatusDat::setLaserFanout(), MonLaserStatusDat::setLaserFilter(), MonLaserStatusDat::setLaserPower(), MonLaserStatusDat::setLaserWavelength(), MEzCalculator::SetLepton(), L1TOccupancyClientHistogramService::setMaskedBins(), METzCalculator::SetMET(), MEzCalculator::SetMET(), METzCalculator::SetMuon(), SiStripSummary::setObj(), HDQMSummary::setObj(), LRHelpFunctions::setObsFitParameters(), SiPixelDbItem::setPackedVal(), FWGeoTopNodeGLScene::SetPad(), DDI::Solid::setParameters(), TotemG4Hit::setParentId(), BscG4Hit::setParentId(), FP420G4Hit::setParentId(), TMCReader::setpartition(), TopologyWorker::setPartList(), PFAlgo::setPFPhotonParameters(), reco::FFTJet< float >::setPileup(), CrossingFrame< T >::setPileups(), reco::CaloCluster::setPosition(), Signal::setprintable(), MonLaserPulseDat::setPulseHeightMean(), MonLaserPulseDat::setPulseHeightRMS(), MonLaserPulseDat::setPulseWidthMean(), MonLaserPulseDat::setPulseWidthRMS(), HLTPerformanceInfo::setStatusOfModulesFromPath(), TrackAlgoCompareUtil::SetTrackingParticleD0Dz(), TPtoRecoTrack::SetTrackingParticleMomentumPCA(), RecoTracktoTP::SetTrackingParticleMomentumPCA(), PdtEntry::setup(), PhiSymmetryCalibration_step2_SM::setUp(), PhiSymmetryCalibration_step2::setUp(), ecaldqm::shift(), hitfit::Resolution::sigma(), SimpleZSPJPTJetCorrector::SimpleZSPJPTJetCorrector(), VVIObjDetails::sincosint(), VVIObjDetails::sinint(), SiPixelDigitizerAlgorithm::SiPixelDigitizerAlgorithm(), SiStripRecHitMatcherESProducer::SiStripRecHitMatcherESProducer(), TiXmlBase::SkipWhiteSpace(), cond::SmallWORMDict::SmallWORMDict(), pat::ObjectSpatialResolution< T >::smearAngles(), TSLToyGen::smearParticles(), DDStreamer::solids_read(), DDStreamer::solids_write(), PhotonCoreProducer::solveAmbiguity(), edm::sort_all(), DTTSM::sortTSM1(), DTTSM::sortTSM2(), DTTSS::sortTSS1(), DTTSS::sortTSS2(), fftjetcms::sparsePeakTreeFromStorable(), TrackClusterSplitter::splitClusters(), LumiCalculator::splitpathstr(), edm::stable_sort_all(), TiXmlParsingData::Stamp(), SteppingHelixPropagatorESProducer::SteppingHelixPropagatorESProducer(), sistrip::MeasureLA::store_calibrations(), sistrip::MeasureLA::store_methods_and_granularity(), StraightLinePropagatorESProducer::StraightLinePropagatorESProducer(), streamSolid(), TiXmlBase::StringEqual(), StripCPEESProducer::StripCPEESProducer(), LA_Filler_Fitter::subset_probability(), hitfit::Lepjets_Event::sum(), LA_Filler_Fitter::summarize_ensembles(), cond::PayLoadInspector< DataT >::summary(), evf::FUEventProcessor::supervisor(), PTrajectoryStateOnDet::surfaceSide(), TimingReport::switchOn(), root::tf1(), root::tf1_t(), TFileAdaptor::TFileAdaptor(), HDRShower::thetaFunction(), CSCFitAFEBThr::ThresholdNoise(), DTBtiChip::tick(), SiStripFineDelayTOF::timeOfFlightCosmic(), TkTransientTrackingRecHitBuilderESProducer::TkTransientTrackingRecHitBuilderESProducer(), cms::MD5Result::toString(), reco::TransientTrackFromFTS::track(), TrackerStablePhiSort(), TrackingRecHitPropagatorESProducer::TrackingRecHitPropagatorESProducer(), QcdUeDQM::trackSelection(), DTTracoCard::tracoList(), DTTrig::TracoTrigs(), ExhaustiveMuonTrajectoryBuilder::trajectories(), TrackTransformer::transform(), edm::TransientDataFrame< SIZE >::TransientDataFrame(), TransientTrackBuilderESProducer::TransientTrackBuilderESProducer(), cond::PayLoadInspector< DataT >::trend_plot(), DTTracoChip::trigger(), DTBtiChip::trigger(), DTBtiChip::triggerData(), DTTracoChip::triggerData(), edmplugin::PluginManager::tryToLoad(), TSCBLBuilderWithPropagatorESProducer::TSCBLBuilderWithPropagatorESProducer(), DTTrig::TSPhTrigs(), DTTrig::TSThTrigs(), CmsTrackerStringToEnum::type(), SimpleJetCorrectionUncertainty::uncertaintyBin(), HLTPerformanceInfo::uniqueModule(), L1GlobalTriggerRawToDigi::unpackGMT(), BasicTrajectoryState::update(), MonopoleSteppingAction::update(), HLTScalersClient::CountLSFifo_t::update(), CmsShowModelPopup::updateDisplay(), DisplayManager::updateDisplay(), MuonSensitiveDetector::updateHit(), CurvilinearTrajectoryParameters::updateP(), LocalTrajectoryParameters::updateP(), CSCSegAlgoShowering::updateParameters(), CSCSegAlgoDF::updateParameters(), SteppingAction::UserSteppingAction(), L1MuonPixelTrackFitter::valInversePt(), VertexClassifier::vertexInformation(), TrackClassifier::vertexInformation(), QcdLowPtDQM::vertexZFromClusters(), edm::View< T >::View(), edm::walkTrie(), MonLaserIRedDat::writeArrayDB(), FEConfigWeightGroupDat::writeArrayDB(), FEConfigWeightDat::writeArrayDB(), FEConfigFgrParamDat::writeArrayDB(), MonPedestalOffsetsDat::writeArrayDB(), FEConfigLinDat::writeArrayDB(), FEConfigFgrEETowerDat::writeArrayDB(), MonMemChConsistencyDat::writeArrayDB(), MonLed2Dat::writeArrayDB(), MonH4TablePositionDat::writeArrayDB(), MODCCSHFDat::writeArrayDB(), MonLed1Dat::writeArrayDB(), MonLaserBlueDat::writeArrayDB(), MonPNGreenDat::writeArrayDB(), MonPNBlueDat::writeArrayDB(), FEConfigPedDat::writeArrayDB(), DCUVFETempDat::writeArrayDB(), MonPNLed1Dat::writeArrayDB(), MODDCCOperationDat::writeArrayDB(), FEConfigLUTParamDat::writeArrayDB(), CaliCrystalIntercalDat::writeArrayDB(), MonShapeQualityDat::writeArrayDB(), MonPNPedDat::writeArrayDB(), MonPNLed2Dat::writeArrayDB(), FEConfigParamDat::writeArrayDB(), FEConfigFgrEEStripDat::writeArrayDB(), DCUCCSDat::writeArrayDB(), MonTTConsistencyDat::writeArrayDB(), MonTestPulseDat::writeArrayDB(), MODCCSFEDat::writeArrayDB(), FEConfigLinParamDat::writeArrayDB(), DCUIDarkDat::writeArrayDB(), DCUCapsuleTempRawDat::writeArrayDB(), FEConfigLUTGroupDat::writeArrayDB(), FEConfigLUTDat::writeArrayDB(), MonPNRedDat::writeArrayDB(), MonDelaysTTDat::writeArrayDB(), DCUIDarkPedDat::writeArrayDB(), DCUCapsuleTempDat::writeArrayDB(), CaliGainRatioDat::writeArrayDB(), MonPNMGPADat::writeArrayDB(), MonLaserRedDat::writeArrayDB(), MODCCSTRDat::writeArrayDB(), FEConfigSpikeDat::writeArrayDB(), DCULVRVoltagesDat::writeArrayDB(), MonPedestalsDat::writeArrayDB(), MonOccupancyDat::writeArrayDB(), MonLaserPulseDat::writeArrayDB(), DCULVRBTempsDat::writeArrayDB(), CaliTempDat::writeArrayDB(), MonPedestalsOnlineDat::writeArrayDB(), FEConfigTimingDat::writeArrayDB(), FEConfigSlidingDat::writeArrayDB(), FEConfigFgrDat::writeArrayDB(), MonLaserGreenDat::writeArrayDB(), MonCrystalConsistencyDat::writeArrayDB(), MonPNIRedDat::writeArrayDB(), MonMemTTConsistencyDat::writeArrayDB(), MODDCCDetailsDat::writeArrayDB(), FEConfigFgrGroupDat::writeArrayDB(), ITimingDat::writeArrayDB(), edm::RootOutputFile::writeBranchIDListRegistry(), edm::RootOutputFile::writeProcessConfigurationRegistry(), edm::RootOutputFile::writeProcessHistoryRegistry(), GctFormatTranslateBase::writeRawHeader(), and L1MuGMTMatrix< T >::~L1MuGMTMatrix().