CMS 3D CMS Logo

 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Properties Friends Macros Pages
Classes | Functions | Variables
cmsBatch Namespace Reference

Classes

class  CmsBatchException
 
class  MyBatchManager
 

Functions

def batchScriptCCIN2P3
 
def batchScriptCERN
 
def batchScriptLocal
 

Variables

tuple batchManager = MyBatchManager()
 
tuple cfgFile = open(batchManager.outputDir_+'/base_cfg.py','w')
 
list cfgFileName = args[1]
 
tuple cfo = imp.load_source("pycfg", cfgFileName, handle)
 
string default = "cmsRun"
 
 doCVSTag = options.tagPackages
 
tuple file = open('cmsBatch.txt', 'w')
 
tuple fullSource = process.source.clone()
 
 generator = False
 
tuple grouping = int(args[0])
 
tuple handle = open(cfgFileName, 'r')
 
string help = "program to run on your cfg file"
 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...
 
list listOfValues = [i+1 for i in range( nJobs )]
 
tuple log = logger( logDir )
 
string logDir = 'Logger'
 
tuple nFiles = len(process.source.fileNames)
 
 nJobs = grouping
 
tuple oldPwd = os.getcwd()
 
 process = cfo.process
 
 prog = options.prog
 
 pycfg_params = options.cmdargs
 
 runningMode = None
 
 trueArgv = sys.argv
 
int waitingTime = 1
 

Function Documentation

def cmsBatch.batchScriptCCIN2P3 ( )

Definition at line 19 of file cmsBatch.py.

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

Definition at line 80 of file cmsBatch.py.

Referenced by cmsBatch.MyBatchManager.PrepareJobUser().

80 
81 def batchScriptCERN( remoteDir, index ):
82  '''prepare the LSF version of the batch script, to run on LSF'''
83  script = """#!/bin/bash
84 # sets the queue
85 #BSUB -q 8nm
86 
87 echo 'environment:'
88 echo
89 env
90 ulimit -v 3000000
91 echo 'copying job dir to worker'
92 cd $CMSSW_BASE/src
93 eval `scramv1 ru -sh`
94 cd -
95 cp -rf $LS_SUBCWD .
96 ls
97 cd `find . -type d | grep /`
98 echo 'running'
99 %s run_cfg.py
100 if [ $? != 0 ]; then
101  echo wrong exit code! removing all root files
102  rm *.root
103  exit 1
104 fi
105 echo 'sending the job directory back'
106 """ % prog
107 
108  if remoteDir != '':
109  remoteDir = castortools.eosToLFN(remoteDir) #remoteDir.replace('/eos/cms','')
110  script += """
111 for file in *.root; do
112 newFileName=`echo $file | sed -r -e 's/\./_%s\./'`
113 fullFileName=%s/$newFileName
114 #this does cmsStage, but with retries
115 cmsStageWithFailover.py -f $file $fullFileName
116 #write the files as user readable but not writable
117 eos chmod 755 /eos/cms/$fullFileName
118 done
119 """ % (index, remoteDir)
120  script += 'rm *.root\n'
121  script += 'cp -rf * $LS_SUBCWD\n'
122 
123  return script
124 
def batchScriptCERN
Definition: cmsBatch.py:80
def cmsBatch.batchScriptLocal (   remoteDir,
  index 
)
prepare a local version of the batch script, to run using nohup

Definition at line 125 of file cmsBatch.py.

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 %s 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 """ % prog
139 
140  if remoteDir != '':
141  remoteDir = castortools.eosToLFN(remoteDir)
142  script += """
143 for file in *.root; do
144 newFileName=`echo $file | sed -r -e 's/\./_%s\./'`
145 cmsStageWithFailover.py -f $file $fullFileName
146 eos chmod 755 /eos/cms/$fullFileName
147 done
148 """ % (index, remoteDir)
149  script += 'rm *.root\n'
150  return script
151 
def batchScriptLocal
Definition: cmsBatch.py:125

Variable Documentation

tuple cmsBatch.batchManager = MyBatchManager()

Definition at line 204 of file cmsBatch.py.

tuple cmsBatch.cfgFile = open(batchManager.outputDir_+'/base_cfg.py','w')

Definition at line 325 of file cmsBatch.py.

list cmsBatch.cfgFileName = args[1]

Definition at line 277 of file cmsBatch.py.

tuple cmsBatch.cfo = imp.load_source("pycfg", cfgFileName, handle)

Definition at line 291 of file cmsBatch.py.

string cmsBatch.default = "cmsRun"

Definition at line 246 of file cmsBatch.py.

cmsBatch.doCVSTag = options.tagPackages

Definition at line 261 of file cmsBatch.py.

tuple cmsBatch.file = open('cmsBatch.txt', 'w')

Definition at line 207 of file cmsBatch.py.

tuple cmsBatch.fullSource = process.source.clone()

Definition at line 300 of file cmsBatch.py.

cmsBatch.generator = False

Definition at line 301 of file cmsBatch.py.

tuple cmsBatch.grouping = int(args[0])

Definition at line 275 of file cmsBatch.py.

tuple cmsBatch.handle = open(cfgFileName, 'r')

Definition at line 290 of file cmsBatch.py.

string cmsBatch.help = "program to run on your cfg file"

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 245 of file cmsBatch.py.

list cmsBatch.listOfValues = [i+1 for i in range( nJobs )]

Definition at line 308 of file cmsBatch.py.

tuple cmsBatch.log = logger( logDir )

Definition at line 347 of file cmsBatch.py.

Referenced by WeakEffectsWeightProducer.alphaQED(), heppy::FSRWeightAlgo.alphaRatio(), FSRWeightProducer.alphaRatio(), DQMHOAlCaRecoStream.analyze(), evf::ExceptionGenerator.analyze(), HcalNoiseMonitor.analyze(), ESTimingTask.analyze(), MCPhotonAnalyzer.analyze(), DQMSourceExample.analyze(), TrackerHitAnalyzer.analyze(), ValidationMisalignedTracker.analyze(), ZMuMuEfficiency.analyze(), L1CondDBIOVWriter.analyze(), EcalPreshowerSimHitsValidation.analyze(), L1O2OTestAnalyzer.analyze(), EcalSimHitsValidation.analyze(), EcalRecHitsValidation.analyze(), EcalDigisValidation.analyze(), PrimaryVertexAnalyzer4PU.analyzeVertexCollection(), PrimaryVertexAnalyzer4PU.analyzeVertexCollectionTP(), PhotonFix.asinh(), DAClusterizerInZ.beta0(), DAClusterizerInZ_vect.beta0(), RapReweightUserHook.biasSelectionBy(), PtHatRapReweightUserHook.biasSelectionBy(), TopDiLeptonDQM.bookHistograms(), BremsstrahlungSimulator.brem(), FWPFEcalRecHitLegoProxyBuilder.build(), 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(), l1t::Stage2Layer2JetAlgorithmFirmwareImp1.calibFit(), 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(), 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(), PFRecoTauDiscriminationByIsolation.discriminate(), TemplatedSimpleSecondaryVertexComputer< IPTI, VTX >.discriminator(), TemplatedJetBProbabilityComputer< Container, Base >.discriminator(), PF_PU_AssoMapAlgos.dR(), ChargeDrifterFP420.drift(), DAClusterizerInZ.dump(), DAClusterizerInZ_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(), 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(), PhotonsWithConversionsAnalyzer.etaTransformation(), SimpleConvertedPhotonAnalyzer.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(), VVIObjDetails.expint(), sistripvvi::VVIObjDetails.expint(), sistripvvi::VVIObjDetails.f1(), sistripvvi::VVIObjDetails.f2(), FFTGenericScaleCalculator.f_safeLog(), fcnbg(), fcnsg(), HcalTestAnalysis.fill(), SimG4HcalValidation.fill(), HcalTB06Analysis.fillBuffer(), HcalTB04Analysis.fillBuffer(), DaqFakeReader.fillFEDs(), TrackerHitProducer.fillG4MC(), PrimaryVertexAnalyzer4PU.fillTrackHistos(), EnergyScaleAnalyzer.fillTree(), ZeePlots.fillZMCInfo(), PythiaFilter.filter(), DJpsiFilter.filter(), ElectronMcSignalPostValidator.finalize(), ElectronMcFakePostValidator.finalize(), TFParams.fitpj(), GflashHadronShowerProfile.fLnE1(), GflashHadronShowerProfile.fTanh(), FWExpressionValidator.FWExpressionValidator(), FWLegoCandidate.FWLegoCandidate(), GammaFunctionGenerator.gammaFrac(), GammaFunctionGenerator.gammaInt(), GammaLn(), Gauss3DFunc(), PairProductionSimulator.gbteth(), BremsstrahlungSimulator.gbteth(), MuonBremsstrahlungSimulator.gbteth(), GaussianTailNoiseGenerator.generate_gaussian_tail(), EcalTestDevDB.generateEcalLaserAPDPNRatios(), CSCGasCollisions.generateEnergyLoss(), BaseNumericalRandomGenerator.generateExp(), TrackerMap.getAutomaticRange(), ECalSD.getBirkL3(), TrackerMap.getcolor(), SteppingHelixPropagator.getDeDx(), reco::PFCluster.getDepthCorrection(), DetIdAssociator.getDetIdsCloseToAPoint(), ZdcSD.getEnergyDeposit(), CastorSD.getEnergyDeposit(), EcalClusterToolsT< noZS >.getEnergyDepTopology(), HcalNumberingFromDDD.getEta(), TopologyWorker.getetaphi(), PythiaFilterIsolatedTrack.GetEtaPhiAtEcal(), IsolatedPixelTrackCandidateProducer.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(), HFGflash.gfParameterization(), GflashHadronShowerProfile.hadronicParameterization(), HCalSD.HCalSD(), HcalTB06BeamSD.HcalTB06BeamSD(), HDShower.HDShower(), HcalHF_S9S1algorithm.HFSetFlagFromS9S1(), HFShower.HFShower(), gen::Cascade2Hadronizer.imposeProperTime(), gen::Pythia6Hadronizer.imposeProperTime(), cond::XMLAuthenticationService::XMLAuthenticationService.initialize(), npstat::GridAxis.initialize(), ParticlePropagator.initProperDecayTime(), 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(), CaloTPGTranscoderULUT.loadHCALCompress(), GflashKaonMinusShowerProfile.loadParameters(), GflashAntiProtonShowerProfile.loadParameters(), GflashPiKShowerProfile.loadParameters(), GflashProtonShowerProfile.loadParameters(), GflashKaonPlusShowerProfile.loadParameters(), EcalClusterLocal.localCoordsEB(), EcalClusterLocal.localCoordsEE(), EcalClusterToolsT< noZS >.localCovariances(), fit::Likelihood< Sample, PDF, Yield >.log(), fit::Likelihood< Sample, PDF, NoExtendedLikelihood >.log(), 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(), L1CaloHcalScaleConfigOnlineProd.newObject(), EMECALShowerParametrization.nSpotsHom(), oldComputeBetheBloch(), oldComputeElectrons(), ESRecHitSimAlgo.oldEvalAmplitude(), oldMUcompute(), LowPassFilterTiming.operator()(), funct::LogStruct< T >.operator()(), TtDecayChannelSelector.operator()(), reco::parser::log_f.operator()(), fftjetcms::EtaAndPtDependentPeakSelector.operator()(), fit::HistoPoissonLikelihoodRatio< T >.operator()(), TtHadLRSignalSelObservables.operator()(), FcnBeamSpotFitPV.operator()(), BSpdfsFcn.operator()(), TtSemiLRSignalSelObservables.operator()(), fftjetcms::EtaAndPtLookupPeakSelector.operator()(), SimG4HcalHitCluster.operator+=(), EMECALShowerParametrization.p3(), logintpack.pack8log(), logintpack.pack8logCeil(), logintpack.pack8logClosed(), SiPixelRecHitQuality::Packing.Packing(), GflashEMShowerProfile.parameterization(), reco::PFCandidateEGammaExtra.PFCandidateEGammaExtra(), reco::PFCandidateElectronExtra.PFCandidateElectronExtra(), PFPhotonClusters.PFCrystalCoor(), PFSCEnergyCalibration.PFSCEnergyCalibration(), SiPixelTemplateSplit.PixelTempSplit(), PlotOccupancyMap(), PlotOccupancyMapPhase2(), JetPartonMatching.print(), TKinFitter.print(), TtSemiLeptonicEvent.print(), TtFullLeptonicEvent.print(), TtFullHadronicEvent.print(), TopGenEvent.print(), EcalSelectiveReadoutValidation.printAvailableHists(), TKinFitter.printMatrix(), l1t::Stage2TowerCompressAlgorithmFirmwareImp1.processEvent(), HcalBeamMonitor.processEvent(), cond::XMLAuthenticationService::XMLAuthenticationService.processFile(), QGTagger.produce(), edm::FlatRandomOneOverPtGunProducer.produce(), CastorFastTowerProducer.produce(), CastorFastClusterProducer.produce(), DeltaBetaWeights.produce(), SoftPFMuonTagInfoProducer.produce(), SoftPFElectronTagInfoProducer.produce(), MuonSimHitProducer.produce(), EcalTrivialConditionRetriever.produceEcalLaserAPDPNRatios(), ecaldqm::RawDataClient.producePlots(), RPCpg.rate(), PixelCPEBase.rawQualityWord(), heppy::Hemisphere.Reconstruct(), heppy::Hemisphere.RejectISR(), SoftLepton.relativeEta(), cond::SQLMonitoringService.report(), cond::SQLMonitoringService.reportToOutputStream(), 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(), VVIObjDetails.sincosint(), sistripvvi::VVIObjDetails.sincosint(), smearFunctionBase.smearEta(), HepMCValidationHelper.sortByRapidity(), PrimaryVertexAnalyzer4PU.supf(), TBposition(), hitfit.theta_to_eta(), MuonNavigableLayer.trackingRange(), muon.trackProbability(), TtFullHadSignalSel.TtFullHadSignalSel(), HcalNumberingFromDDD.unitID(), PrintGeomInfoAction.update(), PrintGeomMatInfo.update(), EcalSimHitsValidProducer.update(), TrackingVerboseAction.update(), HcalTestAnalysis.update(), HcalTB02Analysis.update(), DoCastorAnalysis.update(), ZdcTestAnalysis.update(), CastorTestAnalysis.update(), FP420Test.update(), BscTest.update(), FWPFLegoRecHit.updateScale(), IncompleteGammaComplement.value(), PuppiContainer.var_within_R(), cond::XMLAuthenticationService::XMLAuthenticationService.verifyFileName(), VVIObj.VVIObj(), sistripvvi::VVIObj.VVIObj(), kinem.y(), and EMECALShowerParametrization.z1().

string cmsBatch.logDir = 'Logger'

Definition at line 345 of file cmsBatch.py.

tuple cmsBatch.nFiles = len(process.source.fileNames)

Definition at line 312 of file cmsBatch.py.

Referenced by SiStripSpyMonitorModule.analyze(), FFTJetPileupProcessor.mixExtraGrid(), SiStripSpyMonitorModule.SiStripSpyMonitorModule(), and SiStripSpyMonitorModule.~SiStripSpyMonitorModule().

int cmsBatch.nJobs = grouping

Definition at line 276 of file cmsBatch.py.

tuple cmsBatch.oldPwd = os.getcwd()

Definition at line 343 of file cmsBatch.py.

cmsBatch.process = cfo.process

Definition at line 292 of file cmsBatch.py.

cmsBatch.prog = options.prog

Definition at line 260 of file cmsBatch.py.

cmsBatch.pycfg_params = options.cmdargs

Definition at line 281 of file cmsBatch.py.

tuple cmsBatch.runningMode = None

Definition at line 268 of file cmsBatch.py.

cmsBatch.trueArgv = sys.argv

Definition at line 282 of file cmsBatch.py.

int cmsBatch.waitingTime = 1

Definition at line 331 of file cmsBatch.py.