CMS 3D CMS Logo

Classes | Functions | Variables
cmsBatch Namespace Reference

Classes

class  CmsBatchException
 
class  MyBatchManager
 

Functions

def batchScriptCCIN2P3 ()
 
def batchScriptCERN (remoteDir, index)
 
def batchScriptLocal (remoteDir, index)
 
def rootfiles_to_eos_script (index, remoteDir)
 

Variables

 action
 
 args
 
 argv
 
 batchManager
 
 cfgFile
 
 cfgFileName
 
 cfo
 
 default
 
 dest
 batchManager.parser_.add_option("-b", "--batch", dest="batch", help="batch command. default is: 'bsub -q 8nh < batchScript.sh'. You can also use 'nohup < ./batchScript.sh &' to run locally.", default="bsub -q 8nh < .batchScript.sh") More...
 
 doCVSTag
 
 file
 
 fullSource
 
 generator
 
 grouping
 
 handle
 
 help
 
 listOfValues
 
 log
 
 logDir
 
 nFiles
 
 nJobs
 
 oldPwd
 
 options
 
 process
 
 prog
 
 pycfg_params
 
 runningMode
 
 True
 
 trueArgv
 
 usage
 
 waitingTime
 

Function Documentation

def cmsBatch.batchScriptCCIN2P3 ( )

Definition at line 17 of file cmsBatch.py.

18  script = """!/usr/bin/env bash
19 #PBS -l platform=LINUX,u_sps_cmsf,M=2000MB,T=2000000
20 # sets the queue
21 #PBS -q T
22 #PBS -eo
23 #PBS -me
24 #PBS -V
25 
26 source $HOME/.bash_profile
27 
28 echo '***********************'
29 
30 ulimit -v 3000000
31 
32 # coming back to submission dir do setup the env
33 cd $PBS_O_WORKDIR
34 eval `scramv1 ru -sh`
35 
36 
37 # back to the worker
38 cd -
39 
40 # copy job dir here
41 cp -r $PBS_O_WORKDIR .
42 
43 # go inside
44 jobdir=`ls`
45 echo $jobdir
46 
47 cd $jobdir
48 
49 cat > sysinfo.sh <<EOF
50 #! env bash
51 echo '************** ENVIRONMENT ****************'
52 
53 env
54 
55 echo
56 echo '************** WORKER *********************'
57 echo
58 
59 free
60 cat /proc/cpuinfo
61 
62 echo
63 echo '************** START *********************'
64 echo
65 EOF
66 
67 source sysinfo.sh > sysinfo.txt
68 
69 cmsRun run_cfg.py
70 
71 # copy job dir do disk
72 cd -
73 cp -r $jobdir $PBS_O_WORKDIR
74 """
75  return script
76 
77 
78 
def batchScriptCCIN2P3()
Definition: cmsBatch.py:17
def cmsBatch.batchScriptCERN (   remoteDir,
  index 
)
prepare the LSF version of the batch script, to run on LSF

Definition at line 92 of file cmsBatch.py.

References rootfiles_to_eos_script().

Referenced by cmsBatch.MyBatchManager.PrepareJobUser().

92 def batchScriptCERN( remoteDir, index ):
93  '''prepare the LSF version of the batch script, to run on LSF'''
94  script = """#!/bin/bash
95 # sets the queue
96 #BSUB -q 8nm
97 
98 echo 'environment:'
99 echo
100 env
101 ulimit -v 3000000
102 echo 'copying job dir to worker'
103 cd $CMSSW_BASE/src
104 eval `scramv1 ru -sh`
105 cd -
106 cp -rf $LS_SUBCWD .
107 ls
108 cd `find . -type d | grep /`
109 echo 'running'
110 {prog} run_cfg.py
111 if [ $? != 0 ]; then
112  echo wrong exit code! removing all root files
113  rm *.root
114  exit 1
115 fi
116 echo 'sending the job directory back'
117 """.format(prog=prog)
118 
119  if remoteDir != '':
120  script += rootfiles_to_eos_script(index, remoteDir)
121 
122  script += 'cp -rf * $LS_SUBCWD\n'
123 
124  return script
125 
def rootfiles_to_eos_script(index, remoteDir)
Definition: cmsBatch.py:79
def batchScriptCERN(remoteDir, index)
Definition: cmsBatch.py:92
def cmsBatch.batchScriptLocal (   remoteDir,
  index 
)
prepare a local version of the batch script, to run using nohup

Definition at line 126 of file cmsBatch.py.

References rootfiles_to_eos_script().

Referenced by cmsBatch.MyBatchManager.PrepareJobUser().

126 def batchScriptLocal( remoteDir, index ):
127  '''prepare a local version of the batch script, to run using nohup'''
128 
129  script = """#!/bin/bash
130 echo 'running'
131 {prog} run_cfg.py
132 if [ $? != 0 ]; then
133  echo wrong exit code! removing all root files
134  rm *.root
135  exit 1
136 fi
137 echo 'sending the job directory back'
138 """.format(prog=prog)
139 
140  if remoteDir != '':
141  script += rootfiles_to_eos_script(index, remoteDir)
142 
143  return script
144 
145 
def rootfiles_to_eos_script(index, remoteDir)
Definition: cmsBatch.py:79
def batchScriptLocal(remoteDir, index)
Definition: cmsBatch.py:126
def cmsBatch.rootfiles_to_eos_script (   index,
  remoteDir 
)

Definition at line 79 of file cmsBatch.py.

References eostools.eosToLFN().

Referenced by batchScriptCERN(), and batchScriptLocal().

79 def rootfiles_to_eos_script(index, remoteDir):
80  remoteDir = eostools.eosToLFN(remoteDir)
81  return """
82 for file in *.root; do
83 newFileName=`echo $file | sed -r -e 's/\./_{index}\./'`
84 fullFileName={remoteDir}/$newFileName
85 {eos} cp $file /eos/cms/$fullFileName
86 {eos} chmod 755 /eos/cms/$fullFileName
87 rm *.root
88 done
89 """.format(index=index, remoteDir=remoteDir, eos=eostools.eos_select)
90 
91 
def rootfiles_to_eos_script(index, remoteDir)
Definition: cmsBatch.py:79
def eosToLFN(path)
Definition: eostools.py:65

Variable Documentation

cmsBatch.action

Definition at line 248 of file cmsBatch.py.

cmsBatch.args

Definition at line 251 of file cmsBatch.py.

cmsBatch.argv
cmsBatch.batchManager

Definition at line 198 of file cmsBatch.py.

cmsBatch.cfgFile

Definition at line 319 of file cmsBatch.py.

cmsBatch.cfgFileName

Definition at line 271 of file cmsBatch.py.

cmsBatch.cfo

Definition at line 285 of file cmsBatch.py.

cmsBatch.default

Definition at line 240 of file cmsBatch.py.

cmsBatch.dest

batchManager.parser_.add_option("-b", "--batch", dest="batch", help="batch command. default is: 'bsub -q 8nh < batchScript.sh'. You can also use 'nohup < ./batchScript.sh &' to run locally.", default="bsub -q 8nh < .batchScript.sh")

Definition at line 238 of file cmsBatch.py.

cmsBatch.doCVSTag

Definition at line 255 of file cmsBatch.py.

cmsBatch.file

Definition at line 201 of file cmsBatch.py.

cmsBatch.fullSource

Definition at line 294 of file cmsBatch.py.

cmsBatch.generator
cmsBatch.grouping

Definition at line 269 of file cmsBatch.py.

cmsBatch.handle

Definition at line 284 of file cmsBatch.py.

Referenced by fwlite::ObjectCountSelector< Collection >.accept(), pat::helper::NamedUserDataLoader< pat::helper::AddUserCand >.addData(), TriggerSummaryAnalyzerRAW.analyze(), TriggerSummaryAnalyzerAOD.analyze(), EcalGetLaserData.analyze(), EcalDccWeightBuilder.analyze(), NoiseRates.analyze(), HcalNoiseRates.analyze(), EcalTPGParamBuilder.analyze(), L1TriggerJSONMonitoring.analyze(), HLTriggerJSONMonitoring.analyze(), edm::EventContentAnalyzer.analyze(), LogErrorEventFilter.beginLuminosityBlock(), EcalPedOffset.beginRun(), EcalMipGraphs.beginRun(), EcalDisplaysByEvent.beginRun(), EcalCosmicsHists.beginRun(), ElectronHEEPIDValueMapProducer.calTrkIso(), SiStripGainFromCalibTree.connect(), connect(), ESDBCopy.copyToDB(), EcalTPGDBCopy.copyToDB(), EcalDBCopy.copyToDB(), FWEventItem.data(), edm::pathStatusExpression::Operand.evaluate(), L1GtPatternGenerator.extractGlobalTriggerData(), extractRecordData(), SummaryTableOutputBranches.fill(), TriggerOutputBranches.fill(), TableOutputBranches.fill(), GlobalVariablesTableProducer::VariableT< ValType, ColType, Converter >.fill(), reco::HcalNoiseInfoProducer.fillcalotwrs(), reco::HcalNoiseInfoProducer.filldigis(), edm::GetterOfProducts< trigger::HLTPrescaleTable >.fillHandles(), reco::HcalNoiseInfoProducer.fillrechits(), reco::HcalNoiseInfoProducer.filltracks(), L1GTPrescaler.filter(), L1TGlobalPrescaler.filter(), triggerExpression.get(), JME::JetResolution.get(), get(), JME::JetResolutionScaleFactor.get(), ConditionDumperInEdm.get(), PFClusterShapeProducer.getClusterCollection(), JetMatchingTools.getGenParticlesCollection(), ElectronHEEPIDValueMapProducer.getHandle(), JetCorrector.getJetCorrector(), PFClusterShapeProducer.getRecHitCollection(), PhysicsTools::MVATrainerContainerSaveImpl< Record_t >.getToCopy(), PhysicsTools::MVATrainerFileSaveImpl< Record_t >.getToPut(), PhysicsTools::MVATrainerSaveImpl< Record_t >.getToPut(), PhysicsTools::MVATrainerContainerSaveImpl< Record_t >.getToPut(), MVAValueMapProducer< ParticleType >.globalEndJob(), XrdAdaptor::RequestManager.handle(), HLTJetTagWithMatching< T >.hltFilter(), HLTJetTag< T >.hltFilter(), ElectronHEEPIDValueMapProducer.isEventAOD(), EgammaRegressionContainer.makePSetDescription(), ElectronHEEPIDValueMapProducer::DataFormat.operator()(), pat::PackedTriggerPrescales.PackedTriggerPrescales(), HLTDQMObjSelector< ObjType, ObjCollType >.produce(), PFClusterCollectionMerger.produce(), JetCorrectionESChain.produce(), pat::helper::AnythingToValueMap< Adaptor, Collection, value_type >.produce(), reco::CorrectedJetProducer< T >.produce(), CollectionCombiner< Collection >.produce(), cms::JetCorrectionProducer< T >.produce(), CalibratedPhotonProducerT< T >.produce(), BufferedBoostIOESProducer< DataType, MyRecord >.produce(), CalibratedElectronProducerT< T >.produce(), pat::helper::ManyThingsToValueMaps< Adaptor, Collection, value_type >.produce(), tensorflow::NTSession.PRunSetup(), edm::Ref< L1GctEmCandCollection >.Ref(), edm::Ref< C, T, F >.Ref(), edm::Ref< std::vector< E >, typename refhelper::ValueTrait< std::vector< E > >::value, typename refhelper::FindTrait< std::vector< E >, typename refhelper::ValueTrait< std::vector< E > >::value >::value >.Ref(), edm::RefToBaseProd< reco::GsfElectronCore >.RefToBaseProd(), edm::RefToBaseProd< T >.RefToBaseProd(), PFEGammaToCandidateRemapper.run(), pat::helper::AnyNumberAssociationAdaptor.run_(), l1t::WriterProxyT< Record, Type >.save(), TtFullHadHypothesis.setCandidate(), TtSemiLepHypothesis.setCandidate(), TtFullLepHypothesis.setCandidate(), MVAJetTagPlotter.setEventSetup(), PhysicsTools::MVAModuleHelper< Record, Object, Filler >.setEventSetup(), FWTableViewManager.setFrom(), pat::MatcherUsingTracks.storeValueMap(), TriggerMatcherToHLTDebug.storeValueMap(), FWTableViewManager.table(), FWTableViewManager.tableFormats(), EDMtoMEConverter::Tokens< T >.Tokens(), egHLT::OffHelper.trigCuts(), PhysicsTools::MVAComputerCache.update(), edm::detail::TriggerResultsBasedEventSelector.wantEvent(), ElectronIDValueMapProducer.writeValueMap(), MVAValueMapProducer< ParticleType >.writeValueMap(), PhotonIDValueMapProducer.writeValueMap(), ElectronHEEPIDValueMapProducer.writeValueMap(), PhotonRegressionValueMapProducer.writeValueMap(), ElectronRegressionValueMapProducer.writeValueMap(), MuonSimClassifier.writeValueMap(), MuonMCClassifier.writeValueMap(), AbsFFTJetRcdMapper< DataType >.~AbsFFTJetRcdMapper(), and pf2pat::TopProjectorAlgo< Top, Bottom >.~TopProjectorAlgo().

cmsBatch.help

Definition at line 239 of file cmsBatch.py.

cmsBatch.listOfValues

Definition at line 302 of file cmsBatch.py.

cmsBatch.log

Definition at line 341 of file cmsBatch.py.

Referenced by evf.__attribute__(), fit::Likelihood< Sample, PDF, Yield >.absoluteLog(), BPHFittedBasicSelect.accept(), WeakEffectsWeightProducer.alphaQED(), heppy::FSRWeightAlgo.alphaRatio(), FSRWeightProducer.alphaRatio(), DQMHOAlCaRecoStream.analyze(), L1CondDBIOVWriterExt.analyze(), ESTimingTask.analyze(), MCPhotonAnalyzer.analyze(), DQMSourceExample.analyze(), L1O2OTestAnalyzerExt.analyze(), TrackerHitAnalyzer.analyze(), ZMuMuEfficiency.analyze(), ValidationMisalignedTracker.analyze(), L1CondDBIOVWriter.analyze(), EcalPreshowerSimHitsValidation.analyze(), L1O2OTestAnalyzer.analyze(), EcalSimHitsValidation.analyze(), EcalRecHitsValidation.analyze(), EcalDigisValidation.analyze(), L1MuonRecoTreeProducer.analyze(), HcalDeterministicFit.apply(), approx_logf(), PhotonFix.asinh(), DAClusterizerInZ.beta0(), DAClusterizerInZ_vect.beta0(), DAClusterizerInZT_vect.beta0(), RapReweightUserHook.biasSelectionBy(), PtHatRapReweightUserHook.biasSelectionBy(), SiStripGainFromCalibTree.bookDQMHistos(), CastorRecHitMonitor.bookHistograms(), CTPPSPixelDQMSource.bookHistograms(), TopDiLeptonDQM.bookHistograms(), DQMPFCandidateAnalyzer.bookHistograms(), SiStripGainsPCLWorker.bookHistograms(), HcalSiPM.Borel(), BremsstrahlungSimulator.brem(), fastsim::Bremsstrahlung.brem(), HcalParametersFromDD.build(), FWPFEcalRecHitLegoProxyBuilder.build(), emtf.calc_eta_from_theta_rad(), CSCSectorReceiverMiniLUT.calcGlobalEtaMEMini(), LRHelpFunctions.calcLRval(), EnergyResolutionVsLumi.calcmuTot(), ClusterShapeAlgo.Calculate_Covariances(), PFEGammaAlgo.calculate_ele_mva(), ClusterShapeAlgo.Calculate_EnergyDepTopology(), PositionCalc.Calculate_Location(), TBPositionCalc.CalculateCMSPos(), calculateEta(), MuonNavigationSchool.calculateEta(), DirectTrackerNavigation.calculateEta(), ConversionLikelihoodCalculator.calculateLikelihood(), EcalClusterToolsT< noZS >.cluster2ndMoments(), GsfMultipleScatteringUpdator.compute(), MultipleScatteringSimulator.compute(), PairProductionSimulator.compute(), EnergyLossSimulator.compute(), BremsstrahlungSimulator.compute(), NuclearInteractionSimulator.compute(), VolumeEnergyLossEstimator.computeBetheBloch(), EnergyLossUpdator.computeBetheBloch(), TMarkov.computeChain(), PileupJetIdAlgo.computeCutIDflag(), VolumeEnergyLossEstimator.computeElectrons(), EnergyLossUpdator.computeElectrons(), pat::MuonMvaEstimator.computeMva(), HDRShower.computeShower(), EcalSelectiveReadoutValidation.configFirWeights(), DDHCalBarrelAlgo.constructMidLayer(), DDHCalBarrelAlgo.constructSideLayer(), CordicXilinx.CordicXilinx(), EGEnergyCorrector.CorrectedEnergyWithError(), HFRecoEcalCandidateAlgo.correctEPosition(), MuonMETAlgo.correctMETforMuon(), VVIObjDetails.cosint(), sistripvvi::VVIObjDetails.cosint(), PFClusterShapeAlgo.covariances(), EcalClusterToolsT< noZS >.covariances(), cond::RelationalAuthenticationService::RelationalAuthenticationService.credentials(), BTagLikeDeDxDiscriminator.dedx(), EvolutionECAL.DegradationMeanEM50GeV(), CastorTimeSlew.delay(), HcalTimeSlew.delay(), PFRecoTauDiscriminationByMVAIsolationRun2.discriminate(), PATTauDiscriminationByMVAIsolationRun2.discriminate(), PFRecoTauDiscriminationByIsolation.discriminate(), TemplatedSimpleSecondaryVertexComputer< IPTI, VTX >.discriminator(), TemplatedJetBProbabilityComputer< Container, Base >.discriminator(), PF_PU_AssoMapAlgos.dR(), ChargeDrifterFP420.drift(), DAClusterizerInZ.dump(), DAClusterizerInZ_vect.dump(), DAClusterizerInZT_vect.dump(), MuScleFit.duringFastLoop(), Pi0FixedMassWindowCalibration.duringLoop(), ECALPositionCalculator.ecalEta(), ContainmentCorrectionAnalyzer.ecalEta(), EgammaSuperClusters.ecalEta(), EgammaObjects.ecalEta(), EcalUncalibRecHitRecChi2Algo< C >.EcalUncalibRecHitRecChi2Algo(), Conv.elec(), EMShower.EMShower(), CalorimetryManager.EMShowerSimulation(), CaloTowersCreationAlgo.emShwrLogWeightPos(), TtSemiLepJetCombMVATrainer.endJob(), GsfElectronDataAnalyzer.endJob(), GsfElectronMCFakeAnalyzer.endJob(), GsfElectronFakeAnalyzer.endJob(), GsfElectronMCAnalyzer.endJob(), HLTExoticaSubAnalysis.endRun(), npstat::EquidistantInLogSpace.EquidistantInLogSpace(), hf_egamma.eSeLCorrected(), VolumeMultipleScatteringEstimator.estimate(), kinem.eta(), Geom::OnePiRange< T >.eta(), reco::GhostTrackPrediction.eta(), RawParticle.eta(), cscdqm::Detector.Eta(), fastmath.etaphi(), reco::btau.etaRel(), SimpleConvertedPhotonAnalyzer.etaTransformation(), PhotonsWithConversionsAnalyzer.etaTransformation(), MCElectronAnalyzer.etaTransformation(), MCPhotonAnalyzer.etaTransformation(), MCPizeroAnalyzer.etaTransformation(), SimplePhotonAnalyzer.etaTransformation(), TkConvValidator.etaTransformation(), PhotonValidator.etaTransformation(), ConversionProducer.etaTransformation(), VariablePower.eval(), ESRecHitAnalyticAlgo.EvalAmplitude(), ESRecHitSimAlgo.evalAmplitude(), PFPhotonAlgo.EvaluateLCorrMVA(), DDHCalFibreBundle.execute(), HistogramManager.executeHarvesting(), VVIObjDetails.expint(), sistripvvi::VVIObjDetails.expint(), sistripvvi::VVIObjDetails.f1(), sistripvvi::VVIObjDetails.f2(), FFTGenericScaleCalculator.f_safeLog(), fcnbg(), fcnsg(), HcalTestAnalysis.fill(), SimG4HcalValidation.fill(), HcalTB04Analysis.fillBuffer(), FWECALDetailViewBuilder.fillData(), DaqFakeReader.fillFEDs(), TrackerHitProducer.fillG4MC(), DeepBoostedJetTagInfoProducer.fillParticleFeatures(), DeepBoostedJetTagInfoProducer.fillSVFeatures(), PrimaryVertexValidation.fillTrackHistos(), EnergyScaleAnalyzer.fillTree(), ZeePlots.fillZMCInfo(), PythiaFilterMultiMother.filter(), MCSingleParticleYPt.filter(), PythiaFilter.filter(), DJpsiFilter.filter(), ElectronMcSignalPostValidator.finalize(), ElectronMcFakePostValidator.finalize(), TFParams.fitpj(), GflashHadronShowerProfile.fLnE1(), GflashHadronShowerProfile.fTanh(), FWExpressionValidator.FWExpressionValidator(), FWLegoCandidate.FWLegoCandidate(), GammaFunctionGenerator.gammaFrac(), GammaFunctionGenerator.gammaInt(), GammaLn(), Vx3DHLTAnalyzer.Gauss3DFunc(), PairProductionSimulator.gbteth(), BremsstrahlungSimulator.gbteth(), fastsim::PairProduction.gbteth(), fastsim::Bremsstrahlung.gbteth(), MuonBremsstrahlungSimulator.gbteth(), fastsim::MuonBremsstrahlung.gbteth(), GaussianTailNoiseGenerator.generate_gaussian_tail(), EcalTestDevDB.generateEcalLaserAPDPNRatios(), CSCGasCollisions.generateEnergyLoss(), BaseNumericalRandomGenerator.generateExp(), gen::Py8PtGun.generatePartonsAndHadronize(), gen::Py8JetGun.generatePartonsAndHadronize(), gen::Py8EGun.generatePartonsAndHadronize(), TrackerMap.getAutomaticRange(), ECalSD.getBirkL3(), TrackerMap.getcolor(), SteppingHelixPropagator.getDeDx(), reco::PFCluster.getDepthCorrection(), DetIdAssociator.getDetIdsCloseToAPoint(), ZdcSD.getEnergyDeposit(), CastorSD.getEnergyDeposit(), EcalClusterToolsT< noZS >.getEnergyDepTopology(), HcalGeomParameters.getEta(), HcalDDDSimConstants.getEta(), PtAssignmentEngineAux2016.getEtaFromThetaInt(), TopologyWorker.getetaphi(), IsolatedPixelTrackCandidateProducer.GetEtaPhiAtEcal(), IsolatedPixelTrackCandidateL1TProducer.GetEtaPhiAtEcal(), PythiaFilterIsolatedTrack.GetEtaPhiAtEcal(), IsoTrig.GetEtaPhiAtEcal(), HCALResponse.getHCALEnergyResponse(), EcalTrivialConditionRetriever.getIntercalibConstantsFromConfiguration(), npstat::GridAxis.getInterval(), CastorShowerLibraryMaker.GetKinematics(), HcalTB06BeamSD.getNames(), MaterialBudgetHcalHistos.getNames(), HCalSD.getNames(), popcon::EcalLaser_weekly_Linearization_Check.getNewObjects(), GflashHadronShowerProfile.getNumberOfSpots(), CastorShowerLibrary.getShowerHits(), HcalTB02HcalNumberingScheme.getUnitID(), EcalClusterLocalContCorrection.getValue(), EcalBasicClusterLocalContCorrection.getValue(), EcalClusterCrackCorrection.getValue(), JetCharge.getWeight(), hgcal::ClusterTools.getWidths(), HFGflash.gfParameterization(), GflashHadronShowerProfile.hadronicParameterization(), HCalSD.HCalSD(), HcalTB06BeamSD.HcalTB06BeamSD(), HDShower.HDShower(), HcalHF_S9S1algorithm.HFSetFlagFromS9S1(), HFShower.HFShower(), PixelTemplateSmearerBase.hitsMerge(), gen::Cascade2Hadronizer.imposeProperTime(), gen::Pythia6Hadronizer.imposeProperTime(), l1t::ClusterShapes.Init(), FastTimeDDDConstants.initialize(), cond::XMLAuthenticationService::XMLAuthenticationService.initialize(), npstat::GridAxis.initialize(), ParticlePropagator.initProperDecayTime(), fastsim::PairProduction.interact(), fastsim::EnergyLoss.interact(), fastsim::Bremsstrahlung.interact(), fastsim::MultipleScattering.interact(), fastsim::NuclearInteraction.interact(), heppy::IsolationComputer.isoSumNeutralsWeighted(), reco::TrackProbabilityTagInfo.jetProbability(), TemplatedJetProbabilityComputer< Container, Base >.jetProbability(), TemplatedJetBProbabilityComputer< Container, Base >.jetProbability(), EMECALShowerParametrization.k4(), LandauFP420.LandauFP420(), CSCTFPtMethods.Likelihood(), likelihood(), CSCTFPtMethods.Likelihood2(), CSCTFPtMethods.Likelihood2011(), CSCTFPtMethods.Likelihood2_2011(), npstat::GridAxis.linearInterval(), IncompleteGammaComplement.ln(), GaussianSumUtilities1D.lnPdf(), GeometryInterface.load(), CaloTPGTranscoderULUT.loadHCALCompress(), GflashAntiProtonShowerProfile.loadParameters(), GflashKaonMinusShowerProfile.loadParameters(), GflashKaonPlusShowerProfile.loadParameters(), GflashProtonShowerProfile.loadParameters(), GflashPiKShowerProfile.loadParameters(), EcalClusterLocal.localCoordsEB(), EcalClusterLocal.localCoordsEE(), EcalClusterToolsT< noZS >.localCovariances(), fit::Likelihood< Sample, PDF, Yield >.log(), fit::Likelihood< Sample, PDF, NoExtendedLikelihood >.log(), logarithm(), CSCCrossGap.logGamma(), fit::Likelihood< Sample, PDF, Yield >.logNFactorial(), SteppingHelixPropagator.makeAtomStep(), HFClusterAlgo.makeCluster(), FFTEtaLogPtConeRadiusMapper< MyJet, Adjustable >.map(), FFTGenericScaleCalculator.mapFFTJet(), L2AbsScaleCalculator.mapFFTJet(), EMECALShowerParametrization.meanLnAlphaHom(), EMECALShowerParametrization.meanLnAlphaSam(), EMECALShowerParametrization.meanLnTHom(), EMECALShowerParametrization.meanLnTSam(), GflashHadronShowerProfile.medianLateralArm(), MuonResidualsFitter_compute_log_convolution(), MuonResidualsFitter_logGaussPowerTails(), MuonResidualsFitter_logPowerLawTails(), MuonResidualsFitter_logPureGaussian(), MuonResidualsFitter_logPureGaussian2D(), MuonResidualsFitter_logROOTVoigt(), SoftElectronMVAEstimator.mva(), AntiElectronIDMVA5.MVAValue(), AntiElectronIDMVA6.MVAValue(), L1CaloHcalScaleConfigOnlineProd.newObject(), fastsim::ParticleManager.nextParticle(), GoldenPattern.normalise(), EMECALShowerParametrization.nSpotsHom(), oldComputeBetheBloch(), oldComputeElectrons(), ESRecHitSimAlgo.oldEvalAmplitude(), oldMUcompute(), LowPassFilterTiming.operator()(), TtDecayChannelSelector.operator()(), fftjetcms::EtaAndPtDependentPeakSelector.operator()(), reco::parser::log_f.operator()(), fit::HistoPoissonLikelihoodRatio< T >.operator()(), TtHadLRSignalSelObservables.operator()(), fit::Likelihood< Sample, PDF, Yield >.operator()(), FcnBeamSpotFitPV.operator()(), BSpdfsFcn.operator()(), TtSemiLRSignalSelObservables.operator()(), fftjetcms::EtaAndPtLookupPeakSelector.operator()(), fit::Likelihood< Sample, PDF, NoExtendedLikelihood >.operator()(), SimG4HcalHitCluster.operator+=(), EMECALShowerParametrization.p3(), logintpack.pack16log(), logintpack.pack16logCeil(), logintpack.pack16logClosed(), logintpack.pack8log(), logintpack.pack8logCeil(), logintpack.pack8logClosed(), SiPixelRecHitQuality::Packing.Packing(), GflashEMShowerProfile.parameterization(), reco::PFCandidateEGammaExtra.PFCandidateEGammaExtra(), reco::PFCandidateElectronExtra.PFCandidateElectronExtra(), PFPhotonClusters.PFCrystalCoor(), PFSCEnergyCalibration.PFSCEnergyCalibration(), HcalDeterministicFit.phase1Apply(), SiPixelTemplateSplit.PixelTempSplit(), JetPartonMatching.print(), TKinFitter.print(), TtSemiLeptonicEvent.print(), TtFullLeptonicEvent.print(), TtFullHadronicEvent.print(), TopGenEvent.print(), print_rates(), EcalSelectiveReadoutValidation.printAvailableHists(), TKinFitter.printMatrix(), l1t::Stage2TowerCompressAlgorithmFirmwareImp1.processEvent(), cond::XMLAuthenticationService::XMLAuthenticationService.processFile(), edm::FlatRandomOneOverPtGunProducer.produce(), QGTagger.produce(), CastorFastTowerProducer.produce(), CastorFastClusterProducer.produce(), DeltaBetaWeights.produce(), SoftPFMuonTagInfoProducer.produce(), SoftPFElectronTagInfoProducer.produce(), MuonSimHitProducer.produce(), EcalTrivialConditionRetriever.produceEcalLaserAPDPNRatios(), ecaldqm::RawDataClient.producePlots(), PtHatEmpReweightUserHook.PtHatEmpReweightUserHook(), RPCpg.rate(), PixelCPEBase.rawQualityWord(), heppy::Hemisphere.Reconstruct(), heppy::Hemisphere.RejectISR(), SoftLepton.relativeEta(), EvolutionECAL.ResolutionConstantTermEM50GeV(), ElectronLikelihood.resultLog(), EcalClusterToolsT< noZS >.roundnessSelectedBarrelRecHits(), RecoTracktoTP.s_eta(), TPtoRecoTrack.s_eta(), LandauFP420.SampleFluctuations(), TrackerMap.save(), TrackerMap.save_as_fectrackermap(), TrackerMap.save_as_fedtrackermap(), TrackerMap.save_as_HVtrackermap(), TrackerMap.save_as_psutrackermap(), BSFitter.scanPDF(), EcalClusterToolsT< noZS >.scLocalCovariances(), HDRShower.setFuncParam(), PFElectronAlgo.SetIDOutputs(), SiPixelRecHitQuality::Packing.setProbabilityQ(), SiPixelRecHitQuality::Packing.setProbabilityXY(), HBHEPulseShapeFlagSetter.SetPulseShapeFlags(), GaussianTail.shoot(), SiG4UniversalFluctuation.SiG4UniversalFluctuation(), WeakEffectsWeightProducer.sigma0_qqbarll(), cscdqm::Utility.SignificanceLevelHigh(), cscdqm::Utility.SignificanceLevelLow(), RPCSimParam.simulate(), GflashShowino.simulateFirstInteractionPoint(), GEMSimpleModel.simulateSignal(), ME0SimpleModel.simulateSignal(), VVIObjDetails.sincosint(), sistripvvi::VVIObjDetails.sincosint(), smearFunctionBase.smearEta(), HepMCValidationHelper.sortByRapidity(), TBposition(), hitfit.theta_to_eta(), TtEvent.topPair(), MuonNavigableLayer.trackingRange(), muon.trackProbability(), TtFullHadSignalSel.TtFullHadSignalSel(), HcalNumberingFromDDD.unitID(), PrintGeomInfoAction.update(), EcalSimHitsValidProducer.update(), TrackingVerboseAction.update(), HcalTestAnalysis.update(), HcalTB02Analysis.update(), DoCastorAnalysis.update(), ZdcTestAnalysis.update(), CastorTestAnalysis.update(), FP420Test.update(), BscTest.update(), FWBoxRecHit.updateScale(), FWPFLegoRecHit.updateScale(), IncompleteGammaComplement.value(), PuppiContainer.var_within_R(), cond::XMLAuthenticationService::XMLAuthenticationService.verifyFileName(), VVIObj.VVIObj(), sistripvvi::VVIObj.VVIObj(), kinem.y(), and EMECALShowerParametrization.z1().

cmsBatch.logDir

Definition at line 339 of file cmsBatch.py.

cmsBatch.nFiles
cmsBatch.nJobs

Definition at line 270 of file cmsBatch.py.

cmsBatch.oldPwd

Definition at line 337 of file cmsBatch.py.

cmsBatch.options

Definition at line 251 of file cmsBatch.py.

cmsBatch.process

Definition at line 286 of file cmsBatch.py.

cmsBatch.prog

Definition at line 254 of file cmsBatch.py.

cmsBatch.pycfg_params

Definition at line 275 of file cmsBatch.py.

cmsBatch.runningMode

Definition at line 262 of file cmsBatch.py.

cmsBatch.True

Definition at line 248 of file cmsBatch.py.

cmsBatch.trueArgv

Definition at line 276 of file cmsBatch.py.

cmsBatch.usage

Definition at line 205 of file cmsBatch.py.

cmsBatch.waitingTime

Definition at line 325 of file cmsBatch.py.