Functions | |
def | createCanvasesList (fname="canvases_list.js") |
def | createCanvasToIDList (fname="canvas2id_list.js") |
def | createDirectoryStructure (iteration_name) |
def | dirToID (d) |
def | doCurvaturePlotsDT (dt_basedir, tfiles_plotting) |
def | doFitFunctionsPlotsCSC (csc_basedir, iter_tfile, iter_reports) |
def | doFitFunctionsPlotsDT (dt_basedir, iter_tfile, iter_reports) |
def | doIterationPlots (iteration_directory, tfiles_plotting, iter_tfile, iter_reports) |
def | doMapPlotsCSC (csc_basedir, tfiles_plotting) |
def | doMapPlotsDT (dt_basedir, tfiles_plotting) |
def | doSegDiffPlotsCSC (csc_basedir, tfiles_plotting, iter_reports) |
def | doSegDiffPlotsDT (dt_basedir, tfiles_plotting, iter_reports) |
def | idsForFile (dir_name, file_name) |
def | isFileUnderDir (dir_name, file_name) |
functions definitions More... | |
def | saveAs (nm) |
Variables | |
action | |
string | allOptions = "-l "+options.runLabel+" -i "+options.inputDir+" --i1 "+options.i1+" --iN "+options.iN |
args | |
binsdxdz | |
binsdydz | |
binsx | |
binsy | |
c1 = ROOT.TCanvas("c1","c1",800,600) | |
do drawing More... | |
list | CANVASES_LIST_TEMPLATE |
string | comdir = "common/" |
setup output: More... | |
default | |
dest | |
bool | DO_CSC = False |
bool | DO_CURVATURE = False |
DO_DIAGNOSTIC = options.diagnostic | |
bool | DO_DT = False |
bool | DO_FIT = False |
bool | DO_MAP = False |
bool | DO_MEDIAN = False |
bool | DO_SEGDIFF = False |
string | fname = options.inputDir+'/'+options.i1+'/'+i1prefix |
main script More... | |
help | |
i1prefix = options.i1prefix | |
iNprefix = options.iNprefix | |
list | iter1_reports = [] |
iter1_tfile = None | |
string | iteration1 = "iter1" |
string | iterationN = "iterN" |
list | iterN_reports = [] |
iterN_tfile = None | |
options | |
outdir = options.outputDir | |
parser = optparse.OptionParser(usage) | |
def | pic_ids = createCanvasToIDList("canvas2id_list.js") |
int | QUICKTESTN = 10000 |
bool | SINGLE_ITERATION = False |
list | tfiles1_plotting = [] |
list | tfilesN_plotting = [] |
type | |
string | usage = '%prog [options]\n'+\ |
To parse commandline args. More... | |
windowdxdz | |
windowdydz | |
windowx | |
windowy | |
def alignmentValidation.createCanvasesList | ( | fname = "canvases_list.js" | ) |
Use CANVASES_LIST_TEMPLATE as a template to create a canvases list include for the browser. Write out only those canvases which have existing filename.png plots.
Definition at line 862 of file alignmentValidation.py.
References isFileUnderDir(), and print().
def alignmentValidation.createCanvasToIDList | ( | fname = "canvas2id_list.js" | ) |
Writes out a canvas-2-ids list include for the browser. Write out only those canvases which have existing filename.png plots. Returns: list of unique IDs that have existing filename.png plots.
Definition at line 882 of file alignmentValidation.py.
References idsForFile(), and print().
def alignmentValidation.createDirectoryStructure | ( | iteration_name | ) |
Definition at line 309 of file alignmentValidation.py.
References print(), and FastTimerService_cff.range.
def alignmentValidation.dirToID | ( | d | ) |
def alignmentValidation.doCurvaturePlotsDT | ( | dt_basedir, | |
tfiles_plotting | |||
) |
write DT curvature plots "wheel%s_sector%s" % (wheel, sector) wheel in "m2", "m1", "z", "p1", "p2" station 1 only! sector in "01", ..., "12" "param" may be one of "deltax" (Delta x position residuals), "deltadxdz" (Delta (dx/dz) angular residuals), "curverr" (Delta x * d(Delta q/pT)/d(Delta x) = Delta q/pT in the absence of misalignment) - not necessary made for all (wheel,station=1,sector) combinations Interface: could be accesses through a general DT chambers map for station=1 chambers.
Definition at line 541 of file alignmentValidation.py.
References plotscripts.curvatureplot(), print(), FastTimerService_cff.range, and saveAs().
Referenced by doIterationPlots().
def alignmentValidation.doFitFunctionsPlotsCSC | ( | csc_basedir, | |
iter_tfile, | |||
iter_reports | |||
) |
write fit functions plots for CSC CSC bellcurves and polynomials set of plots of bellcurves rphi, drphidz, rphi vs. drphidz set of plots of polynomials rphi vs. rphi pos, rphi vs drphidz angle drphidz vs. rphi pos, drphidz vs drphidz angle made for all (endcap,station,ring,chamber) combinations Interface: could be accesses through a general CSC chambers map.
Definition at line 798 of file alignmentValidation.py.
References plotscripts.bellcurves(), plotscripts.clearDDT(), plotscripts.polynomials(), print(), FastTimerService_cff.range, and saveAs().
Referenced by doIterationPlots().
def alignmentValidation.doFitFunctionsPlotsDT | ( | dt_basedir, | |
iter_tfile, | |||
iter_reports | |||
) |
write fit functions plots for DT DT bellcurves and polynomials set of plots of bellcurves x, dxdz, x vs. dxdz (for all 4 stations) y, dydz, x vs. dxdz (only for stations 1-3?) set of plots of polynomials -- for stations 1-3 only?? x vs. xpos, x vs ypos, x vs dxdz angle, x vs dydz angle y vs. xpos, y vs ypos, y vs dxdz angle, y vs dydz angle dxdz vs. xpos, dxdz vs ypos, dxdz vs dxdz angle, dxdz vs dydz angle dydz vs. xpos, dydz vs ypos, dydz vs dxdz angle, dydz vs dydz angle set of plots of polynomials -- for station 4 only?? x vs. xpos, x vs dxdz angle dxdz vs. xpos, dxdz vs dxdz angle made for all (wheel,station,sector) combinations Interface: could be accesses through a general DT chambers map.
Definition at line 754 of file alignmentValidation.py.
References plotscripts.bellcurves(), plotscripts.clearDDT(), createfilelist.int, plotscripts.polynomials(), print(), FastTimerService_cff.range, saveAs(), and plotscripts.wheelLetter().
Referenced by doIterationPlots().
def alignmentValidation.doIterationPlots | ( | iteration_directory, | |
tfiles_plotting, | |||
iter_tfile, | |||
iter_reports | |||
) |
Definition at line 837 of file alignmentValidation.py.
References doCurvaturePlotsDT(), doFitFunctionsPlotsCSC(), doFitFunctionsPlotsDT(), doMapPlotsCSC(), doMapPlotsDT(), doSegDiffPlotsCSC(), and doSegDiffPlotsDT().
def alignmentValidation.doMapPlotsCSC | ( | csc_basedir, | |
tfiles_plotting | |||
) |
write CSC map plots "CSCvsphi_me%s%d%d" % (endcap, station, ring) plots "integrated" over ALL SECTORS: of rphi, drphi/dz vs. phi made for all (endcap,station,ring) combinations Interface: may be arranged into two station(1 .. 4) vs. R(1 .. 4) maps for both endcaps with R range (1 .. 4) for stations 2-4 It could be incorporated into a general CSC chambers map (column1: endcap, column2: station, column3: ring, columns4-40 correspond to chamber #) by making ring numbers in column 3 clickable. "CSCvsr_me%s%dch%02d" % (endcap, station, chamberNumber) plots "integrated" over ALL RINGS: of rphi, drphi/dz vs. z made for all (endcap,station,chamber) combinations Interface: may be arranged into two station(1 .. 4) vs. chamber(1 .. 36) maps for both endcaps It could be incorporated into an EXTENDED general CSC chambers map (extended by adding an identifier "ALL" in column3 for ring number). "CSCvsr_me%s%dchALL" % (endcap, station) plots spanning over ALL RINGS along r and integrated over all SECTORS: of rphi, drphi/dz vs. z made for all (endcap,station) combinations Interface: may be arranged into two station(1 .. 4) maps for both endcaps It could be incorporated into an EXTENDED general CSC chambers map (extended by adding an identifier "ALL" in column3 for ring number).
Definition at line 455 of file alignmentValidation.py.
References plotscripts.mapplot(), FastTimerService_cff.range, and plotscripts.saveTestResultsMap().
Referenced by doIterationPlots().
def alignmentValidation.doMapPlotsDT | ( | dt_basedir, | |
tfiles_plotting | |||
) |
write DT map plots "DTvsphi_st%dwh%s" % (station, wheelletter): plots "integrated" over ALL SECTORS: of x, y, dxdz, dydz vs. phi (y and dydz only for stations 1-3) made for all (station,wheel) combinations Access interface may be arranged into station(1 .. 4) vs. wheel(-2 .. +2) map. It could be incorporated into a general DT chambers map (column1: wheel, column2: station, columns3-16 correspond to sector #) by making station numbers in column 2 clickable. "DTvsz_st%dsec%02d" % (station, sector) plots "integrated" over ALL WHEELS: of x, y, dxdz, dydz vs. z (y and dydz only for stations 1-3) made for all (station,sector) combinations Interface: may be arranged into station(1 .. 4) vs. sector(1 .. 14) map with sector range (1 .. 12) for stations 1-3. It could be incorporated into an EXTENDED general DT chambers map (extended by adding an identifier "ALL" in column1 for wheel number). "DTvsz_st%dsecALL" % (station) plots spanning in z over ALL WHEELS and "integrated" over all sectors: of x, y, dxdz, dydz vs. z (y and dydz only for stations 1-3) made for all stations Interface: may be arranged into station(1 .. 4) map It could be incorporated into an EXTENDED general DT chambers map (extended by adding an identifier "ALL" in column1 for wheel number).
Definition at line 349 of file alignmentValidation.py.
References createfilelist.int, plotscripts.mapplot(), print(), FastTimerService_cff.range, plotscripts.saveTestResultsMap(), and plotscripts.wheelLetter().
Referenced by doIterationPlots().
def alignmentValidation.doSegDiffPlotsCSC | ( | csc_basedir, | |
tfiles_plotting, | |||
iter_reports | |||
) |
write segment-difference plots for CSC segdiff "csc_resid" and "csc_slope" set of plots of rphi vs qpt, rphi for positive, rphi for negative ("csc_resid") drphidz vs qpt, drphidz for positive, drphidz for negative ("csc_slope") done for ME1-ME2, ME2-ME3, and ME3-ME4 stations combinations with endcap "m" or "p" ring 1 or 2 chamber 1-18 (r1) or 1-36 (r2) note: there's no ME3-ME4 plots for R2 Interface: could be accessed through a general CSC chambers map, but only for chambers in stations 2-4 (e.g., station 2 would provide ME1-ME2 plots).
Definition at line 691 of file alignmentValidation.py.
References createfilelist.int, FastTimerService_cff.range, plotscripts.segdiff(), and plotscripts.segdiffvsphicsc().
Referenced by doIterationPlots().
def alignmentValidation.doSegDiffPlotsDT | ( | dt_basedir, | |
tfiles_plotting, | |||
iter_reports | |||
) |
write segment-difference plots for DT segdiff "dt13_resid" and "dt13_slope" set of plots of x vs qpt, x for positive, x for negative ("dt13_resid") dxdz vs qpt, dxdz for positive, dxdz for negative ("dt13_slope") done for MB1-MB2, MB2-MB3, and MB3-MB4 stations combinations with all possible (wheel, sector) Interface: could be accessed through a general DT chambers map, but only for chambers in stations 2-4 (e.g., station 2 would provide MB1-MB2 plots). segdiff "dt2_resid" and "dt2_slope" set of plots of y vs q/pt, y for positive, y for negative ("dt2_resid") dydz vs q/pt, dydz for positive, dydz for negative ("dt2_slope") done for MB1-MB2, MB2-MB3 stations combinations with all possible (wheel, sector) Interface: then the interface would still be a general DT map, but the info only available from station 2 & 3 chambers.
Definition at line 582 of file alignmentValidation.py.
References funct.abs(), createfilelist.int, FastTimerService_cff.range, plotscripts.segdiff(), plotscripts.segdiff_xalign(), plotscripts.segdiffvsphi(), and plotscripts.segdiffvsphi_xalign().
Referenced by doIterationPlots().
def alignmentValidation.idsForFile | ( | dir_name, | |
file_name | |||
) |
Recursively looks for file named file_name under dir_name directory and fill the list with dir names converted to IDs
Definition at line 911 of file alignmentValidation.py.
References dirToID().
Referenced by createCanvasToIDList().
def alignmentValidation.isFileUnderDir | ( | dir_name, | |
file_name | |||
) |
functions definitions
Recursively looks for file named file_name under dir_name directory
Definition at line 281 of file alignmentValidation.py.
Referenced by createCanvasesList().
def alignmentValidation.saveAs | ( | nm | ) |
Definition at line 301 of file alignmentValidation.py.
Referenced by doCurvaturePlotsDT(), doFitFunctionsPlotsCSC(), and doFitFunctionsPlotsDT().
alignmentValidation.action |
Definition at line 82 of file alignmentValidation.py.
string alignmentValidation.allOptions = "-l "+options.runLabel+" -i "+options.inputDir+" --i1 "+options.i1+" --iN "+options.iN |
Definition at line 200 of file alignmentValidation.py.
alignmentValidation.args |
Definition at line 146 of file alignmentValidation.py.
alignmentValidation.binsdxdz |
Definition at line 1040 of file alignmentValidation.py.
alignmentValidation.binsdydz |
Definition at line 1040 of file alignmentValidation.py.
alignmentValidation.binsx |
Definition at line 1040 of file alignmentValidation.py.
Referenced by CSCValHists.fill2DHist(), CSCValHists.fill2DHistByChamber(), CSCValHists.fill2DHistByCrate(), CSCValHists.fill2DHistByLayer(), CSCValHists.fill2DHistByStation(), CSCValHists.fill2DHistByType(), CSCValHists.fill2DProfile(), CSCValHists.fillProfile(), CSCValHists.fillProfileByChamber(), and CSCValHists.fillProfileByType().
alignmentValidation.binsy |
Definition at line 1040 of file alignmentValidation.py.
Referenced by CSCValHists.fill2DHist(), CSCValHists.fill2DHistByChamber(), CSCValHists.fill2DHistByCrate(), CSCValHists.fill2DHistByLayer(), CSCValHists.fill2DHistByStation(), CSCValHists.fill2DHistByType(), and CSCValHists.fill2DProfile().
alignmentValidation.c1 = ROOT.TCanvas("c1","c1",800,600) |
do drawing
Definition at line 1025 of file alignmentValidation.py.
Referenced by reco::NamedCompositeCandidate.addDaughter(), reco::CompositeCandidate.addDaughter(), HcalPulseShapes.analyticPulseShapeSiPMHO(), reco::NamedCompositeCandidate.applyRoles(), reco::CompositeCandidate.applyRoles(), trklet::TrackletCalculatorDisplaced.approxtracklet(), CaloGeometryHelper.borderCrossing(), BPHDecayToV0SameMassBuilder.buildCandidate(), BPHDecayToV0DiffMassBuilder.buildCandidate(), TwoBodyDecayModel.cartesianSecondaryMomenta(), condbon.cdbon_write(), HGCalCellUV.cellUVFromXY2(), checkPhiInRange(), NamedCandCombinerBase.combine(), CandCombinerBase< OutputCollection, Cloner::CandPtr >.combine(), HLTDoubletDZ< T1, T2 >.computeDZ(), ConversionEqualByTrack(), ConversionLessByChi2(), PFAlgo.createCandidatesHF(), CTPPSGeometryESModule.CTPPSGeometryESModule(), PFBenchmarkAlgo.deltaEt(), PFBenchmarkAlgo.deltaEta(), PFBenchmarkAlgo.deltaPhi(), PFBenchmarkAlgo.deltaR(), ParabolaFit.det(), HiggsDQM.Distance(), DQMExample_Step1.Distance(), HiggsDQM.DistancePhi(), DQMExample_Step1.DistancePhi(), dqm::impl::MonitorElement.divide(), TwoBodyDecayDerivatives.dqsdm(), TwoBodyDecayDerivatives.dqsdphi(), TwoBodyDecayDerivatives.dqsdpx(), TwoBodyDecayDerivatives.dqsdpy(), TwoBodyDecayDerivatives.dqsdpz(), TwoBodyDecayDerivatives.dqsdtheta(), DTNoiseComputation.endJob(), fastInvertPDM2(), CMTRawAnalyzer.fillDigiAmplitude(), CMTRawAnalyzer.fillDigiAmplitudeHF(), CMTRawAnalyzer.fillDigiAmplitudeHFQIE10(), CMTRawAnalyzer.fillDigiAmplitudeHO(), CMTRawAnalyzer.fillDigiAmplitudeQIE11(), SiStripQualityDQM.fillGrandSummaryMEs(), SiStripHistoPlotter.fillNamedImageBuffer(), SiStripApvGainsDQM.fillSummaryMEs(), SiStripPedestalsDQM.fillSummaryMEs(), SiStripLorentzAngleDQM.fillSummaryMEs(), SiStripQualityDQM.fillSummaryMEs(), SiStripBackPlaneCorrectionDQM.fillSummaryMEs(), SiStripBaseCondObjDQM.fillSummaryMEs(), heppy::Davismt2.find_high(), PFBenchmarkAlgo.findAllInCone(), PFBenchmarkAlgo.findAllInEtWindow(), cscdqm::StripClusterFinder.FindAndMatch(), hitfit::Chisq_Constrainer.fit(), DiMuonMassBiasClient.fitBWTimesCB(), DiMuonMassBiasClient.fitLineShape(), DTLinearFit.fitNpar(), SiStripCablingDQM.getActiveDetIds(), lumi::fPoly.getCorrection(), GridInterpolator3DException.GridInterpolator3DException(), HLTDoubletDZ< T1, T2 >.haveSameSuperCluster(), MonitorElementsDb.htmlOutput(), PFDisplacedVertexHelper.identifyVertex(), CSCWireGeometry.intersection(), CSCLayerGeometry.intersectionOfTwoLines(), PerigeeConversions.jacobianParameters2Cartesian(), cscdqm::StripClusterFinder.KillCluster(), PFDisplacedVertexHelper.lambdaCP(), EvolutionECAL.LightCollectionEfficiency(), EvolutionECAL.LightCollectionEfficiencyWeighted(), GEMStripTopology.localError(), CSCRadialStripTopology.localError(), TkRadialStripTopology.localError(), main(), makeCompositeCandidate(), makeCompositeCandidateWithRefsToMaster(), makeCompositePtrCandidate(), makeNamedCompositeCandidate(), makeNamedCompositeCandidateWithRefsToMaster(), makePlots(), MatcherUsingTracksAlgorithm.match(), FastTrackerRecHitMatcher.match(), SiStripRecHitMatcher.match(), matchByCommonParentSuperClusterRef(), matchByCommonSourceCandidatePtr(), PFBenchmarkAlgo.matchByDeltaEt(), PFBenchmarkAlgo.matchByDeltaR(), reco::modulesNew::Matcher< C1, C2, S, D >.matchDistance(), reco::modules::Matcher< C1, C2, S, D, M >.matchDistance(), GlobalTrackerMuonAlignment.misalignMuon(), GlobalTrackerMuonAlignment.misalignMuonL(), heppy::Davismt2.mt2_bisect(), heppy::Davismt2.nsols(), Clusterizer1DCommons::ComparePairs< T >.operator()(), DistanceToCell.operator()(), OverlapChecker.operator()(), CompareHFCore.operator()(), PseudoBayesGrouping::CandPointGreat.operator()(), SortCandByDecreasingPt.operator()(), deltaRSorter< T, U >.operator()(), deltaEtSorter< T, U >.operator()(), reco.operator==(), HLTDoubletDZ< T1, T2 >.passCutMinDeltaR(), PhiInterval.PhiInterval(), PlotAlignmentValidation.plotOutlierModules(), NamedCandCombinerBase.preselect(), CandCombinerBase< OutputCollection, Cloner::CandPtr >.preselect(), proxim(), CSCTFPtMethods.Pt3Stn(), DTConfigDBProducer.readDTCCBConfig(), RectangularEtaPhiRegion.RectangularEtaPhiRegion(), ResolutionPlots_HistoMaker(), reco::modulesNew::Matcher< C1, C2, S, D >.select(), reco::modules::Matcher< C1, C2, S, D, M >.select(), reco::PhysObjectMatcher< C1, C2, S, D, Q >.select(), CandCombiner< Selector, PairSelector, Cloner, OutputCollection, Setup >.selectPair(), PFBenchmarkAlgo.sortByDeltaEt(), PFBenchmarkAlgo.sortByDeltaR(), SuperClusterHelper.sortClusters(), p2eg.stitchClusterOverRegionBoundary(), heppy::mt2w_bisect::mt2w.teco(), align.toMatrix(), egamma.towersOf(), PFBenchmarkAlgo.vector_add(), VVIObj.VVIObj(), sistripvvi::VVIObj.VVIObj(), VVIObjF.VVIObjF(), CSCWireGeometry.wireEnds(), GlobalTrackerMuonAlignment.writeGlPosRcd(), and ZMassBinFit_OldTool().
list alignmentValidation.CANVASES_LIST_TEMPLATE |
Definition at line 224 of file alignmentValidation.py.
string alignmentValidation.comdir = "common/" |
setup output:
Definition at line 1010 of file alignmentValidation.py.
alignmentValidation.default |
Definition at line 41 of file alignmentValidation.py.
alignmentValidation.dest |
Definition at line 42 of file alignmentValidation.py.
bool alignmentValidation.DO_CSC = False |
Definition at line 169 of file alignmentValidation.py.
bool alignmentValidation.DO_CURVATURE = False |
Definition at line 184 of file alignmentValidation.py.
alignmentValidation.DO_DIAGNOSTIC = options.diagnostic |
Definition at line 198 of file alignmentValidation.py.
bool alignmentValidation.DO_DT = False |
Definition at line 168 of file alignmentValidation.py.
bool alignmentValidation.DO_FIT = False |
Definition at line 185 of file alignmentValidation.py.
bool alignmentValidation.DO_MAP = False |
Definition at line 182 of file alignmentValidation.py.
bool alignmentValidation.DO_MEDIAN = False |
Definition at line 186 of file alignmentValidation.py.
bool alignmentValidation.DO_SEGDIFF = False |
Definition at line 183 of file alignmentValidation.py.
string alignmentValidation.fname = options.inputDir+'/'+options.i1+'/'+i1prefix |
main script
Definition at line 959 of file alignmentValidation.py.
Referenced by L1TMuonGlobalParams.absIsoCheckMemLUTPath(), L1TMuonGlobalParamsHelper.absIsoCheckMemLUTPath(), HcalTBWriter.analyze(), module::EcalSRCondTools.analyze(), SiStripCondVisualizer.beginRun(), L1TMuonGlobalParams.bEtaExtrapolationLUTPath(), L1TMuonGlobalParamsHelper.bEtaExtrapolationLUTPath(), L1TMuonGlobalParams.bONegMatchQualLUTPath(), L1TMuonGlobalParamsHelper.bONegMatchQualLUTPath(), SiStripCondVisualizer.bookModuleHistograms(), L1TMuonGlobalParams.bOPosMatchQualLUTPath(), L1TMuonGlobalParamsHelper.bOPosMatchQualLUTPath(), L1TMuonGlobalParams.bPhiExtrapolationLUTPath(), L1TMuonGlobalParamsHelper.bPhiExtrapolationLUTPath(), clangcms::EDMPluginDumper.checkASTDecl(), FileBlob.computeFileSize(), RntDumper.Create(), dd_to_html(), GeometryInfoDump.dumpInfo(), DDLSAX2Handler.dumpStats(), ExternalLHEAsciiDumper.endRun(), TSGForOIDNN.evaluateClassifier(), TSGForOIDNN.evaluateRegressor(), L1TMuonGlobalParams.fEtaExtrapolationLUTPath(), L1TMuonGlobalParamsHelper.fEtaExtrapolationLUTPath(), FileBlob.FileBlob(), trklet::TrackDerTable.fillTable(), L1TMuonGlobalParams.fONegMatchQualLUTPath(), L1TMuonGlobalParamsHelper.fONegMatchQualLUTPath(), L1TMuonGlobalParams.fOPosMatchQualLUTPath(), L1TMuonGlobalParamsHelper.fOPosMatchQualLUTPath(), L1TMuonGlobalParams.fPhiExtrapolationLUTPath(), L1TMuonGlobalParamsHelper.fPhiExtrapolationLUTPath(), L1TMuonGlobalParams.fwdNegSingleMatchQualLUTPath(), L1TMuonGlobalParamsHelper.fwdNegSingleMatchQualLUTPath(), L1TMuonGlobalParams.fwdPosSingleMatchQualLUTPath(), L1TMuonGlobalParamsHelper.fwdPosSingleMatchQualLUTPath(), getCompressedBuffer(), MatacqProducer.getMatacqFile(), DDLParser.getNameSpace(), popcon::EcalTPGFineGrainStripfromFile.getNewObjects(), popcon::EcalTPGFineGrainTowerfromFile.getNewObjects(), popcon::EcalSRPHandler.getNewObjects(), popcon::EcalTPGSpikeThresholdfromFile.getNewObjects(), popcon::EcalLaser_weekly_Linearization.getNewObjects(), popcon::EcalLaser_weekly_Linearization_Check.getNewObjects(), popcon::EcalTPGPhysicsConstfromFile.getNewObjects(), popcon::EcalTPGLinPed.getNewObjects(), popcon::EcalTPGPedfromFile.getNewObjects(), popcon::EcalLaser_weekly_Handler.getNewObjects(), TrackingUtility.goToDir(), SiStripUtility.goToDir(), L1TMuonGlobalParams.idxSelMemEtaLUTPath(), L1TMuonGlobalParamsHelper.idxSelMemEtaLUTPath(), L1TMuonGlobalParams.idxSelMemPhiLUTPath(), L1TMuonGlobalParamsHelper.idxSelMemPhiLUTPath(), L1PrefiringWeightProducer.L1PrefiringWeightProducer(), PreparePVTrends.list_files(), load_dddefinition(), mkfit::ConfigJson.load_File(), main(), L1MuGMTLUT.MakeSubClass(), l1t::MicroGMTAbsoluteIsolationCheckLUT.MicroGMTAbsoluteIsolationCheckLUT(), l1t::MicroGMTCaloIndexSelectionLUT.MicroGMTCaloIndexSelectionLUT(), l1t::MicroGMTExtrapolationLUT.MicroGMTExtrapolationLUT(), l1t::MicroGMTMatchQualFineLUT.MicroGMTMatchQualFineLUT(), l1t::MicroGMTMatchQualSimpleLUT.MicroGMTMatchQualSimpleLUT(), l1t::MicroGMTRankPtQualLUT.MicroGMTRankPtQualLUT(), l1t::MicroGMTRelativeIsolationCheckLUT.MicroGMTRelativeIsolationCheckLUT(), L1TMuonGlobalParams.oEtaExtrapolationLUTPath(), L1TMuonGlobalParamsHelper.oEtaExtrapolationLUTPath(), trklet::Globals.ofstream(), HcalLuttoDB.openChecksums(), trklet::MemoryBase.openFile(), trklet.openfile(), edm.openFileHdl(), HcalLuttoDB.openPerCrate(), HcalLuttoDB.openPerLut1(), HcalLuttoDB.openPerLut2(), mkfit::DataFile.openRead(), mkfit::DataFile.openWrite(), L1TMuonGlobalParams.oPhiExtrapolationLUTPath(), L1TMuonGlobalParamsHelper.oPhiExtrapolationLUTPath(), L1TMuonGlobalParams.ovlNegSingleMatchQualLUTPath(), L1TMuonGlobalParamsHelper.ovlNegSingleMatchQualLUTPath(), L1TMuonGlobalParams.ovlPosSingleMatchQualLUTPath(), L1TMuonGlobalParamsHelper.ovlPosSingleMatchQualLUTPath(), parse_jet_member_function(), parse_peak_member_function(), DDLParser.parseFile(), mkfit::ConfigJson.patch_Files(), mkfit::ConfigJson.patchLoad_File(), MODCCSHFDat.populateClob(), IODConfig.populateClob(), L1TTwinMuxRawToDigi.processFed(), RPCTriggerConfig.produce(), LRHelpFunctions.purityPlot(), FileBlob.read(), mkfit::TrackerInfo.read_bin_file(), MuonResiduals6DOFrphiFitter.readNtuple(), MuonResiduals5DOFFitter.readNtuple(), MuonResiduals6DOFFitter.readNtuple(), L1TMuonGlobalParams.relIsoCheckMemLUTPath(), L1TMuonGlobalParamsHelper.relIsoCheckMemLUTPath(), RntDumper.RntDumper(), mkfit::ConfigJson.save_Iterations(), trklet::TrackletConfigBuilder.setDTCphirange(), ODLTCConfig.setParameters(), ODTTCFConfig.setParameters(), ODTTCciConfig.setParameters(), ODDCCConfig.setParameters(), ODSRPConfig.setParameters(), ODLaserConfig.setParameters(), CmsShowMain.setupDataHandling(), LRHelpFunctions.singlePlot(), L1TMuonGlobalParams.sortRankLUTPath(), L1TMuonGlobalParamsHelper.sortRankLUTPath(), LRHelpFunctions.storeControlPlots(), LRHelpFunctions.storeToROOTfile(), FileBlob.write(), mkfit::TrackerInfo.write_bin_file(), trklet::AllProjectionsMemory.writeAP(), trklet::CandidateMatchMemory.writeCM(), trklet::CleanTrackMemory.writeCT(), MODCCSHFDat.writeDB(), trklet::FullMatchMemory.writeMC(), trklet::StubPairsMemory.writeSP(), trklet::StubTripletsMemory.writeST(), trklet::VMStubsMEMemory.writeStubs(), trklet::TrackFitMemory.writeTF(), trklet::TrackletParametersMemory.writeTPAR(), trklet::TrackletProjectionsMemory.writeTPROJ(), and trklet::VMProjectionsMemory.writeVMPROJ().
alignmentValidation.help |
Definition at line 39 of file alignmentValidation.py.
alignmentValidation.i1prefix = options.i1prefix |
Definition at line 157 of file alignmentValidation.py.
alignmentValidation.iNprefix = options.iNprefix |
Definition at line 160 of file alignmentValidation.py.
alignmentValidation.iter1_reports = [] |
Definition at line 962 of file alignmentValidation.py.
alignmentValidation.iter1_tfile = None |
Definition at line 961 of file alignmentValidation.py.
string alignmentValidation.iteration1 = "iter1" |
Definition at line 1011 of file alignmentValidation.py.
string alignmentValidation.iterationN = "iterN" |
Definition at line 1012 of file alignmentValidation.py.
alignmentValidation.iterN_reports = [] |
Definition at line 983 of file alignmentValidation.py.
alignmentValidation.iterN_tfile = None |
Definition at line 982 of file alignmentValidation.py.
alignmentValidation.options |
Definition at line 146 of file alignmentValidation.py.
alignmentValidation.outdir = options.outputDir |
Definition at line 154 of file alignmentValidation.py.
Referenced by main().
alignmentValidation.parser = optparse.OptionParser(usage) |
Definition at line 36 of file alignmentValidation.py.
def alignmentValidation.pic_ids = createCanvasToIDList("canvas2id_list.js") |
Definition at line 1047 of file alignmentValidation.py.
int alignmentValidation.QUICKTESTN = 10000 |
Definition at line 217 of file alignmentValidation.py.
alignmentValidation.SINGLE_ITERATION = False |
Definition at line 179 of file alignmentValidation.py.
list alignmentValidation.tfiles1_plotting = [] |
Definition at line 960 of file alignmentValidation.py.
list alignmentValidation.tfilesN_plotting = [] |
Definition at line 981 of file alignmentValidation.py.
alignmentValidation.type |
Definition at line 40 of file alignmentValidation.py.
string alignmentValidation.usage = '%prog [options]\n'+\ |
To parse commandline args.
Definition at line 19 of file alignmentValidation.py.
alignmentValidation.windowdxdz |
Definition at line 1040 of file alignmentValidation.py.
alignmentValidation.windowdydz |
Definition at line 1040 of file alignmentValidation.py.
alignmentValidation.windowx |
Definition at line 1040 of file alignmentValidation.py.
alignmentValidation.windowy |
Definition at line 1040 of file alignmentValidation.py.