CMS 3D CMS Logo

Functions | Variables
makeMuonMisalignmentScenario Namespace Reference

Functions

def cholesky (A)
 
def mmult (a, b)
 Print out user's choices as diagnostics. More...
 
def mtrans (a)
 
def mvdot (m, v)
 
def random6dof ()
 Generate correlated random misalignments for all chambers. More...
 

Variables

 action
 
 args
 
int ave_phix = sum_phix/float(len(misal))
 
int ave_phixphix = sum_phixphix/float(len(misal))
 
int ave_phixphiy = sum_phixphiy/float(len(misal))
 
int ave_phixphiz = sum_phixphiz/float(len(misal))
 
int ave_phiy = sum_phiy/float(len(misal))
 
int ave_phiyphiy = sum_phiyphiy/float(len(misal))
 
int ave_phiyphiz = sum_phiyphiz/float(len(misal))
 
int ave_phiz = sum_phiz/float(len(misal))
 
int ave_phizphiz = sum_phizphiz/float(len(misal))
 
int ave_x = sum_x/float(len(misal))
 
int ave_xphix = sum_xphix/float(len(misal))
 
int ave_xphiy = sum_xphiy/float(len(misal))
 
int ave_xphiz = sum_xphiz/float(len(misal))
 
int ave_xx = sum_xx/float(len(misal))
 
int ave_xy = sum_xy/float(len(misal))
 
int ave_xz = sum_xz/float(len(misal))
 
int ave_y = sum_y/float(len(misal))
 
int ave_yphix = sum_yphix/float(len(misal))
 
int ave_yphiy = sum_yphiy/float(len(misal))
 
int ave_yphiz = sum_yphiz/float(len(misal))
 
int ave_yy = sum_yy/float(len(misal))
 
int ave_yz = sum_yz/float(len(misal))
 
int ave_z = sum_z/float(len(misal))
 
int ave_zphix = sum_zphix/float(len(misal))
 
int ave_zphiy = sum_zphiy/float(len(misal))
 
int ave_zphiz = sum_zphiz/float(len(misal))
 
int ave_zz = sum_zz/float(len(misal))
 
 cfgfile = file(outputName + "_convert_cfg.py", "w")
 Convert it to an SQLite file with CMSSW. More...
 
def chomat = cholesky(matrix)
 
string components = "xx", "xy", "xz", "xphix", "xphiy", "xphiz", "yy", "yz", "yphix", "yphiy", "yphiz", "zz", "zphix", "zphiy", "zphiz", "phixphix", "phixphiy", "phixphiz", "phiyphiy", "phiyphiz", "phizphiz"
 
 default
 
 dest
 
 endcap
 
def globalape = mmult(rot, mmult(localape, mtrans(rot)))
 
def globalxx = globalape[0][0]
 
def globalxy = globalape[0][1]
 
def globalxz = globalape[0][2]
 
def globalyy = globalape[1][1]
 
def globalyz = globalape[1][2]
 
def globalzz = globalape[2][2]
 
 help
 
list localape = [[xx, xy, xz], [xy, yy, yz], [xz, yz, zz]]
 
list matrix
 
dictionary misal = {}
 
 options
 
 outputName = args[0]
 
 parser = OptionParser(usage="Usage: python %prog outputName [options] (default is unit matrix times 1e-15)")
 Get variances and covariances from the commandline. More...
 
 rot = rotation[system, whendcap, station, ring, sector]
 
int sum_phix = 0.
 
int sum_phixphix = 0.
 
int sum_phixphiy = 0.
 
int sum_phixphiz = 0.
 
int sum_phiy = 0.
 
int sum_phiyphiy = 0.
 
int sum_phiyphiz = 0.
 
int sum_phiz = 0.
 
int sum_phizphiz = 0.
 
int sum_x = 0.
 More diagnostics. More...
 
int sum_xphix = 0.
 
int sum_xphiy = 0.
 
int sum_xphiz = 0.
 
int sum_xx = 0.
 
int sum_xy = 0.
 
int sum_xz = 0.
 
int sum_y = 0.
 
int sum_yphix = 0.
 
int sum_yphiy = 0.
 
int sum_yphiz = 0.
 
int sum_yy = 0.
 
int sum_yz = 0.
 
int sum_z = 0.
 
int sum_zphix = 0.
 
int sum_zphiy = 0.
 
int sum_zphiz = 0.
 
int sum_zz = 0.
 
 txtfile = file(outputName + "_correlations.txt", "w")
 Delete all three files at once to make sure the user never sees stale data (e.g. More...
 
 wheel
 
 xmlfile = file(outputName + ".xml", "w")
 Make an XML representation of the misalignment. More...
 

Function Documentation

◆ cholesky()

def makeMuonMisalignmentScenario.cholesky (   A)
Cholesky decomposition of the correlation matrix to properly normalize the transformed random deviates

Definition at line 112 of file makeMuonMisalignmentScenario.py.

References mmult(), FastTimerService_cff.range, and mathSSE.sqrt().

112 def cholesky(A):
113  """Cholesky decomposition of the correlation matrix to properly normalize the transformed random deviates"""
114 
115  # A = L * D * L^T = (L * D^0.5) * (L * D^0.5)^T where we want (L * D^0.5), the "square root" of A
116  # find L and D from A using recurrence relations
117  L = {}
118  D = {}
119  for j in range(len(A[0])):
120  D[j] = A[j][j] - sum([L[j,k]**2 * D[k] for k in range(j)])
121  for i in range(len(A)):
122  if i > j:
123  L[i,j] = (A[i][j] - sum([L[i,k] * L[j,k] * D[k] for k in range(j)])) / D[j]
124 
125  L = [[ 1., 0., 0., 0., 0., 0.],
126  [L[1,0], 1., 0., 0., 0., 0.],
127  [L[2,0], L[2,1], 1., 0., 0., 0.],
128  [L[3,0], L[3,1], L[3,2], 1., 0., 0.],
129  [L[4,0], L[4,1], L[4,2], L[4,1], 1., 0.],
130  [L[5,0], L[5,1], L[5,2], L[5,1], L[5,0], 1.]]
131 
132  Dsqrt = [[sqrt(D[0]), 0., 0., 0., 0., 0.],
133  [ 0., sqrt(D[1]), 0., 0., 0., 0.],
134  [ 0., 0., sqrt(D[2]), 0., 0., 0.],
135  [ 0., 0., 0., sqrt(D[3]), 0., 0.],
136  [ 0., 0., 0., 0., sqrt(D[4]), 0.],
137  [ 0., 0., 0., 0., 0., sqrt(D[5])]]
138 
139  return mmult(L, Dsqrt)
140 
T sqrt(T t)
Definition: SSEVec.h:23
def mmult(a, b)
Print out user's choices as diagnostics.

◆ mmult()

def makeMuonMisalignmentScenario.mmult (   a,
  b 
)

Print out user's choices as diagnostics.

Some useful mathematical transformations (why don't we have access to numpy?)

Matrix multiplication: mmult([[11, 12], [21, 22]], [[-1, 0], [0, 1]]) returns [[-11, 12], [-21, 22]]

Definition at line 100 of file makeMuonMisalignmentScenario.py.

References reco.zip().

Referenced by cholesky(), and mvdot().

100 def mmult(a, b):
101  """Matrix multiplication: mmult([[11, 12], [21, 22]], [[-1, 0], [0, 1]]) returns [[-11, 12], [-21, 22]]"""
102  return [[sum([i*j for i, j in zip(row, col)]) for col in zip(*b)] for row in a]
103 
ALPAKA_FN_HOST_ACC ALPAKA_FN_INLINE constexpr float zip(ConstView const &tracks, int32_t i)
Definition: TracksSoA.h:90
def mmult(a, b)
Print out user's choices as diagnostics.

◆ mtrans()

def makeMuonMisalignmentScenario.mtrans (   a)
Matrix transposition: mtrans([[11, 12], [21, 22]]) returns [[11, 21], [12, 22]]

Definition at line 108 of file makeMuonMisalignmentScenario.py.

References FastTimerService_cff.range.

108 def mtrans(a):
109  """Matrix transposition: mtrans([[11, 12], [21, 22]]) returns [[11, 21], [12, 22]]"""
110  return [[a[j][i] for j in range(len(a[i]))] for i in range(len(a))]
111 

◆ mvdot()

def makeMuonMisalignmentScenario.mvdot (   m,
  v 
)
Applies matrix m to vector v: mvdot([[-1, 0], [0, 1]], [12, 55]) returns [-12, 55]

Definition at line 104 of file makeMuonMisalignmentScenario.py.

References mmult().

Referenced by random6dof().

104 def mvdot(m, v):
105  """Applies matrix m to vector v: mvdot([[-1, 0], [0, 1]], [12, 55]) returns [-12, 55]"""
106  return [i[0] for i in mmult(m, [[vi] for vi in v])]
107 
def mmult(a, b)
Print out user's choices as diagnostics.

◆ random6dof()

def makeMuonMisalignmentScenario.random6dof ( )

Generate correlated random misalignments for all chambers.

Definition at line 152 of file makeMuonMisalignmentScenario.py.

References mvdot().

152 def random6dof():
153  randomunit = [gauss(0., 1.), gauss(0., 1.), gauss(0., 1.), gauss(0., 1.), gauss(0., 1.), gauss(0., 1.)]
154  return mvdot(chomat, randomunit)
155 
def random6dof()
Generate correlated random misalignments for all chambers.

Variable Documentation

◆ action

makeMuonMisalignmentScenario.action

Definition at line 40 of file makeMuonMisalignmentScenario.py.

◆ args

makeMuonMisalignmentScenario.args

Definition at line 42 of file makeMuonMisalignmentScenario.py.

◆ ave_phix

int makeMuonMisalignmentScenario.ave_phix = sum_phix/float(len(misal))

Definition at line 238 of file makeMuonMisalignmentScenario.py.

◆ ave_phixphix

int makeMuonMisalignmentScenario.ave_phixphix = sum_phixphix/float(len(misal))

Definition at line 257 of file makeMuonMisalignmentScenario.py.

◆ ave_phixphiy

int makeMuonMisalignmentScenario.ave_phixphiy = sum_phixphiy/float(len(misal))

Definition at line 258 of file makeMuonMisalignmentScenario.py.

◆ ave_phixphiz

int makeMuonMisalignmentScenario.ave_phixphiz = sum_phixphiz/float(len(misal))

Definition at line 259 of file makeMuonMisalignmentScenario.py.

◆ ave_phiy

int makeMuonMisalignmentScenario.ave_phiy = sum_phiy/float(len(misal))

Definition at line 239 of file makeMuonMisalignmentScenario.py.

◆ ave_phiyphiy

int makeMuonMisalignmentScenario.ave_phiyphiy = sum_phiyphiy/float(len(misal))

Definition at line 260 of file makeMuonMisalignmentScenario.py.

◆ ave_phiyphiz

int makeMuonMisalignmentScenario.ave_phiyphiz = sum_phiyphiz/float(len(misal))

Definition at line 261 of file makeMuonMisalignmentScenario.py.

◆ ave_phiz

int makeMuonMisalignmentScenario.ave_phiz = sum_phiz/float(len(misal))

Definition at line 240 of file makeMuonMisalignmentScenario.py.

◆ ave_phizphiz

int makeMuonMisalignmentScenario.ave_phizphiz = sum_phizphiz/float(len(misal))

Definition at line 262 of file makeMuonMisalignmentScenario.py.

◆ ave_x

int makeMuonMisalignmentScenario.ave_x = sum_x/float(len(misal))

Definition at line 235 of file makeMuonMisalignmentScenario.py.

◆ ave_xphix

int makeMuonMisalignmentScenario.ave_xphix = sum_xphix/float(len(misal))

Definition at line 245 of file makeMuonMisalignmentScenario.py.

◆ ave_xphiy

int makeMuonMisalignmentScenario.ave_xphiy = sum_xphiy/float(len(misal))

Definition at line 246 of file makeMuonMisalignmentScenario.py.

◆ ave_xphiz

int makeMuonMisalignmentScenario.ave_xphiz = sum_xphiz/float(len(misal))

Definition at line 247 of file makeMuonMisalignmentScenario.py.

◆ ave_xx

int makeMuonMisalignmentScenario.ave_xx = sum_xx/float(len(misal))

Definition at line 242 of file makeMuonMisalignmentScenario.py.

◆ ave_xy

int makeMuonMisalignmentScenario.ave_xy = sum_xy/float(len(misal))

Definition at line 243 of file makeMuonMisalignmentScenario.py.

◆ ave_xz

int makeMuonMisalignmentScenario.ave_xz = sum_xz/float(len(misal))

Definition at line 244 of file makeMuonMisalignmentScenario.py.

◆ ave_y

int makeMuonMisalignmentScenario.ave_y = sum_y/float(len(misal))

Definition at line 236 of file makeMuonMisalignmentScenario.py.

◆ ave_yphix

int makeMuonMisalignmentScenario.ave_yphix = sum_yphix/float(len(misal))

Definition at line 250 of file makeMuonMisalignmentScenario.py.

◆ ave_yphiy

int makeMuonMisalignmentScenario.ave_yphiy = sum_yphiy/float(len(misal))

Definition at line 251 of file makeMuonMisalignmentScenario.py.

◆ ave_yphiz

int makeMuonMisalignmentScenario.ave_yphiz = sum_yphiz/float(len(misal))

Definition at line 252 of file makeMuonMisalignmentScenario.py.

◆ ave_yy

int makeMuonMisalignmentScenario.ave_yy = sum_yy/float(len(misal))

Definition at line 248 of file makeMuonMisalignmentScenario.py.

◆ ave_yz

int makeMuonMisalignmentScenario.ave_yz = sum_yz/float(len(misal))

Definition at line 249 of file makeMuonMisalignmentScenario.py.

◆ ave_z

int makeMuonMisalignmentScenario.ave_z = sum_z/float(len(misal))

Definition at line 237 of file makeMuonMisalignmentScenario.py.

◆ ave_zphix

int makeMuonMisalignmentScenario.ave_zphix = sum_zphix/float(len(misal))

Definition at line 254 of file makeMuonMisalignmentScenario.py.

◆ ave_zphiy

int makeMuonMisalignmentScenario.ave_zphiy = sum_zphiy/float(len(misal))

Definition at line 255 of file makeMuonMisalignmentScenario.py.

◆ ave_zphiz

int makeMuonMisalignmentScenario.ave_zphiz = sum_zphiz/float(len(misal))

Definition at line 256 of file makeMuonMisalignmentScenario.py.

◆ ave_zz

int makeMuonMisalignmentScenario.ave_zz = sum_zz/float(len(misal))

Definition at line 253 of file makeMuonMisalignmentScenario.py.

◆ cfgfile

makeMuonMisalignmentScenario.cfgfile = file(outputName + "_convert_cfg.py", "w")

Convert it to an SQLite file with CMSSW.

Definition at line 352 of file makeMuonMisalignmentScenario.py.

◆ chomat

def makeMuonMisalignmentScenario.chomat = cholesky(matrix)

Definition at line 148 of file makeMuonMisalignmentScenario.py.

◆ components

string makeMuonMisalignmentScenario.components = "xx", "xy", "xz", "xphix", "xphiy", "xphiz", "yy", "yz", "yphix", "yphiy", "yphiz", "zz", "zphix", "zphiy", "zphiz", "phixphix", "phixphiy", "phixphiz", "phiyphiy", "phiyphiz", "phizphiz"

Definition at line 58 of file makeMuonMisalignmentScenario.py.

Referenced by MultiTrajectoryStateAssembler.addState(), TrackerOfflineValidation.bookDirHists(), FitWithRooFit.buildModel(), FitWithRooFit.buildSignalModel(), DAFTrackProducerAlgorithm.calculateNdof(), DAFTrackProducerAlgorithm.checkHits(), ForwardDetLayer.computeSurface(), MuonSeedOrcaPatternRecognition.countHits(), DAFTrackProducerAlgorithm.countingGoodHits(), converter::helper::ConcreteCreator.create(), converter::helper::PolymorphicCreator.create(), edm::eventsetup::EventSetupProvider.determinePreferred(), MRHChi2MeasurementEstimator.estimate(), edm::eventsetup::EventSetupRecordProvider.fillReferencedDataKeys(), GsfTrackProducerBase.fillStates(), DAFTrackProducerAlgorithm.filter(), TICLGraph.findSubComponents(), TICLGraph.getConnectedComponents(), PedeSteerer.hierarchyConstraint(), ticl::TracksterLinkingbySkeletons.linkTracksters(), AlignableCompositeBuilder.maxNumComponents(), multiTrajectoryStateMode.momentumFromModeCartesian(), multiTrajectoryStateMode.momentumFromModePPhiEta(), GaussianStateConversions.multiGaussianStateFromTSOS(), GaussianStateConversions.multiGaussianStateFromVertex(), MultiGaussianStateTransform.multiState(), MultiGaussianStateTransform.multiState1D(), PFGsfHelper.PFGsfHelper(), multiTrajectoryStateMode.positionFromModeCartesian(), edm::eventsetup.preferEverything(), TrackerOfflineValidation.prepareSummaryHists(), MuonAlignment.recursiveCopySurveyToAlignment(), MultiTrajectoryStateTransform.stateOnSurface(), TrajAnnealing.TrajAnnealing(), GaussianStateConversions.tsosFromMultiGaussianState(), GaussianStateConversions.vertexFromMultiGaussianState(), and MuonAlignmentOutputXML.writeComponents().

◆ default

makeMuonMisalignmentScenario.default

Definition at line 13 of file makeMuonMisalignmentScenario.py.

◆ dest

makeMuonMisalignmentScenario.dest

Definition at line 13 of file makeMuonMisalignmentScenario.py.

◆ endcap

makeMuonMisalignmentScenario.endcap

Definition at line 320 of file makeMuonMisalignmentScenario.py.

Referenced by CSCReadoutMapping.addRecord(), AlignmentMonitorMuonResiduals.afterAlignment(), CSCChamberFitter.alignableId(), L1TStage2EMTF.analyze(), L1TStage2RegionalShower.analyze(), MuonTiming.analyze(), SiPixelDigiSource.analyze(), EcalTPInputAnalyzer.analyze(), SiPixelTrackResidualSource.analyze(), MuonAlignmentAnalyzer.analyze(), MuonIdVal.analyze(), L1TCSCTF.analyze(), emtf::phase2::algo::OutputLayer.apply(), CSCAlignmentCorrections.applyAlignment(), SegmentsTrackAssociator.associate(), SiPixelTrackResidualModule.book(), SiPixelHitEfficiencyModule.book(), AlignmentMonitorSegmentDifferences.book(), AlignmentMonitorMuonSystemMap1D.book(), SiPixelDigiModule.book(), SiPixelClusterModule.book(), SiPixelRecHitModule.book(), MuonIdVal.bookHistograms(), CSCRecHitDBuilder.build(), Traj2TrackHits.build(), L1TPhase2GMTEndcapStubProcessor.buildCSCOnlyStub(), MuonRPCDetLayerGeometryBuilder.buildEndcapLayers(), MuonME0DetLayerGeometryBuilder.buildEndcapLayers(), MuonCSCDetLayerGeometryBuilder.buildLayer(), ETLDetLayerGeometryBuilder.buildLayer(), MuonME0DetLayerGeometryBuilder.buildLayer(), MuonRPCDetLayerGeometryBuilder.buildLayer(), MuonCSCDetLayerGeometryBuilder.buildLayers(), ETLDetLayerGeometryBuilder.buildLayers(), emtf.calc_eta_from_theta_deg(), emtf.calc_theta_int(), emtf.calc_theta_int_rpc(), PtAssignmentEngineAux2017.calcBendFromPattern(), PtAssignmentEngineAux2017.calcBends(), CSCSectorReceiverMiniLUT.calcGlobalEtaMEMini(), CSCSectorReceiverMiniLUT.calcGlobalPhiMBMini(), CSCSectorReceiverMiniLUT.calcGlobalPhiMEMini(), emtf::phase2::tp.calcThetaInt(), PtAssignmentEngine2017.calculate_address(), PtAssignmentEngine2017.calculate_pt_xml(), cscmap1.chamber(), CSCGeometry.chamber(), CSCReadoutMapping.chamber(), CSCTriggerMapping.chamber(), CSCIndexer.chamberIndex(), CSCIndexerBase.chamberIndex(), CSCIndexer.chipIndex(), CSCIndexerBase.chipIndex(), SimpleDAFHitCollector.clone(), Traj2TrackHits.clone(), ResidualRefitting.CollectTrackHits(), SiPixelHitEfficiencyModule.computeEfficiencies(), DDPixFwdBlades.computeNippleParameters(), AngleCalculation.configure(), BestTrackSelection.configure(), PrimitiveSelection.configure(), SingleHitTrack.configure(), PrimitiveConversion.configure(), PrimitiveMatching.configure(), PatternRecognition.configure(), PtAssignment.configure(), SectorProcessorShower.configure(), SectorProcessor.configure(), CSCValHists.crate_lookup(), cscmap1.cratedmb(), CSCAnodeLCTProcessor.CSCAnodeLCTProcessor(), CSCCathodeLCTProcessor.CSCCathodeLCTProcessor(), CSCMotherboard.CSCMotherboard(), CSCMuonPortCard.CSCMuonPortCard(), MuonShowerInformationFiller.cscPositionToDets(), CSCTFSectorProcessor.CSCTFSectorProcessor(), CSCTFUnpacker.CSCTFUnpacker(), CSCReadoutMapping.detId(), CSCTriggerMapping.detId(), CSCIndexerPostls1.detIdFromChipIndex(), CSCIndexer.detIdFromLayerIndex(), CSCIndexerBase.detIdFromLayerIndex(), CSCIndexerPostls1.detIdFromStripChannelIndex(), emtf.dump_fw_raw_input(), DDPixFwdBlades.execute(), SiPixelHitEfficiencyModule.fill(), SiPixelTrackResidualModule.fill(), SiPixelRawDataErrorModule.fill(), SiPixelClusterModule.fill(), SiPixelRecHitModule.fill(), SiPixelDigiModule.fill(), CSCValHists.fill1DHistByChamber(), CSCValHists.fill1DHistByLayer(), CSCValHists.fill1DHistByStation(), CSCValHists.fill1DHistByType(), CSCValHists.fill2DHistByChamber(), CSCValHists.fill2DHistByEvent(), CSCValHists.fill2DHistByLayer(), CSCValHists.fill2DHistByStation(), CSCValHists.fill2DHistByType(), MuonAlignmentFromReference.fillNtuple(), CSCValHists.fillProfileByChamber(), CSCValHists.fillProfileByType(), CSCEfficiency.fillRechitsSegments_info(), CSCEfficiency.filter(), CSCReadoutMapping.findHardwareId(), CSCIndexer.gasGainIndex(), CSCIndexerBase.gasGainIndex(), CSCTriggerContainer< csc::L1Track >.get(), PtAssignmentEngineAux2017.get8bMode15(), PtAssignmentEngineAux2017.getCLCT(), MuonAlignmentInputXML.getCSCnode(), cscdqm::Utility.getCSCTypeLabel(), MuonAlignmentInputXML.getGEMnode(), PtAssignmentEngineAux.getGMTEta(), TrackerMuonHitExtractor.getMuonHits(), CachedTrajectory.getTrajectory(), ecal::reconstruction.hashedIndexEE(), CSCSimHitMatcher.hitStation(), HLTCSCRing2or3Filter.hltFilter(), HLTCSCOverlapFilter.hltFilter(), HLTPixelAsymmetryFilter.hltFilter(), CSCTriggerSimpleMapping.hwId(), TrackerMuonHitExtractor.init(), MuonAlignmentFromReference.initialize(), DDPixFwdBlades.initialize(), CSCBadChambers.isInBadChamber(), MuonTrackResidualAnalyzer.isInTheAcceptance(), MuonTrackAnalyzer.isInTheAcceptance(), L1TCSCTF.L1TCSCTF(), L1TMuonEndCapShowerProducer.L1TMuonEndCapShowerProducer(), ALPAKA_ACCELERATOR_NAMESPACE::ecal::reconstruction.laserMonitoringRegionEE(), CSCIndexer.layerIndex(), CSCIndexerBase.layerIndex(), CSCTFSPCoreLogic.loadData(), GeometryInterface.loadFromTopology(), CSCMuonPortCard.loadLCTs(), MuonDetLayerGeometry.makeDetLayerId(), FWRPZViewGeometry.makeMuonGeometryRhoZ(), omtf.mapEleIndex2CscDet(), MuonScenarioBuilder.moveCSCSectors(), MSLayer.MSLayer(), MTDRecHitProducer.MTDRecHitProducer(), MTDUncalibratedRecHitProducer.MTDUncalibratedRecHitProducer(), MuonGeometrySanityCheckPoint.MuonGeometrySanityCheckPoint(), MuonNavigationSchool.MuonNavigationSchool(), SiPixelTrackResidualModule.nfill(), SiPixelRecHitModule.nfill(), XMLEventWriter.observeProcesorBegin(), XMLEventWriter.observeProcesorEmulation(), OmtfName.OmtfName(), MSLayer.operator<(), MuonAlignmentFromReference.parseReference(), DiElectronVertexValidation.passLooseSelection(), PFRecHitDualNavigator< D1, barrel, D2, endcap >.PFRecHitDualNavigator(), CSCChipSpeedCorrectionDBConditions.prefillDBChipSpeedCorrection(), CSCGasGainCorrectionDBConditions.prefillDBGasGainCorrection(), EcalSelectiveReadout.printDccChMap(), EcalSelectiveReadout.printEndcap(), TrackFinder.process(), PrimitiveSelection.process(), AlignmentMonitorMuonSystemMap1D.processMuonResidualsFromTrack(), MuonTrackProducer.produce(), L1TMuonEndCapShowerProducer.produce(), CSCTFUnpacker.produce(), EcalTrigPrimProducer.produce(), spr.propagateHCAL(), spr.propagateTrackerEnd(), CSCChannelMapperStartup.rawCSCDetId(), CSCChannelTranslator.rawCSCDetId(), AlignmentProducerBase.readInSurveyRcds(), MuonResiduals6DOFrphiFitter.readNtuple(), CSCEfficiency.recHitSegment_Efficiencies(), cscmap1.ruiddu(), CSCTFSPCoreLogic.run(), emtf::phase2::CSCTPSelector.select(), set_tracker_endcap_visibility(), L1Analysis::L1AnalysisCSCTF.SetLCTs(), L1Analysis::L1AnalysisCSCTF.SetTracks(), CSCIndexer.stripChannelIndex(), CSCIndexerBase.stripChannelIndex(), CSCEfficiency.stripWire_Efficiencies(), MSLayer.sumX0D(), CSCTriggerMapping.swId(), CSCReadoutMapping.swId(), emtf::phase2::TrackFinder.TrackFinder(), HGCalClusteringImpl.triggerCellReshuffling(), CSCOfflineMonitor.typeIndex(), PtAssignmentEngineAux2017.unpack8bMode15(), PtAssignmentEngineAux2017.unpackCLCT(), ValidateGeometry.validateCSChamberGeometry(), ValidateGeometry.validateCSCLayerGeometry(), MuonAlignmentOutputXML.writeComponents(), and OMTFReconstruction.writeResultToXML().

◆ globalape

def makeMuonMisalignmentScenario.globalape = mmult(rot, mmult(localape, mtrans(rot)))

Definition at line 324 of file makeMuonMisalignmentScenario.py.

◆ globalxx

def makeMuonMisalignmentScenario.globalxx = globalape[0][0]

Definition at line 325 of file makeMuonMisalignmentScenario.py.

◆ globalxy

def makeMuonMisalignmentScenario.globalxy = globalape[0][1]

Definition at line 326 of file makeMuonMisalignmentScenario.py.

◆ globalxz

def makeMuonMisalignmentScenario.globalxz = globalape[0][2]

Definition at line 327 of file makeMuonMisalignmentScenario.py.

◆ globalyy

def makeMuonMisalignmentScenario.globalyy = globalape[1][1]

Definition at line 328 of file makeMuonMisalignmentScenario.py.

◆ globalyz

def makeMuonMisalignmentScenario.globalyz = globalape[1][2]

Definition at line 329 of file makeMuonMisalignmentScenario.py.

◆ globalzz

def makeMuonMisalignmentScenario.globalzz = globalape[2][2]

Definition at line 330 of file makeMuonMisalignmentScenario.py.

◆ help

makeMuonMisalignmentScenario.help

Definition at line 13 of file makeMuonMisalignmentScenario.py.

◆ localape

list makeMuonMisalignmentScenario.localape = [[xx, xy, xz], [xy, yy, yz], [xz, yz, zz]]

Definition at line 323 of file makeMuonMisalignmentScenario.py.

◆ matrix

list makeMuonMisalignmentScenario.matrix
Initial value:
1 = [[ xx, xy, xz, xphix, xphiy, xphiz],
2  [ xy, yy, yz, yphix, yphiy, yphiz],
3  [ xz, yz, zz, zphix, zphiy, zphiz],
4  [xphix, yphix, zphix, phixphix, phixphiy, phixphiz],
5  [xphiy, yphiy, zphiy, phixphiy, phiyphiy, phiyphiz],
6  [xphiz, yphiz, zphiz, phixphiz, phiyphiz, phizphiz]]

Definition at line 141 of file makeMuonMisalignmentScenario.py.

Referenced by MuonErrorMatrix.adjust(), TestPortableAnalyzer.analyze(), TestOutliers.analyze(), BeamSpotCompatibilityChecker.analyze(), TestAlpakaAnalyzer.analyze(), clone(), DTGeometryValidate.compareTransform(), RPCGeometryValidate.compareTransform(), GEMGeometryValidate.compareTransform(), ME0GeometryValidate.compareTransform(), CSCGeometryValidate.compareTransform(), ValidateGeometry.compareTransform(), reco::GsfComponent5D.covariance(), reco::BeamSpot.covariance3D(), PhysicsTools::VarProcessor.deriv(), CSCSegFit.derivativeMatrix(), MuonSegFit.derivativeMatrix(), l1HPSPFTauEmu.emulateEvent(), AlcaBeamSpotFromDB.endLuminosityBlockProduce(), CSCDbStripConditions.fetchNoisifier(), BSFitter.Fit(), BSFitter.Fit_d0phi(), BSFitter.Fit_d_likelihood(), BSFitter.Fit_d_z_likelihood(), BSFitter.Fit_dres_z_likelihood(), BSFitter.Fit_z_chi2(), BSFitter.Fit_z_likelihood(), FakeBeamMonitor.FitAndFill(), get_transform(), DTMuonMillepede.getbcsMatrix(), OnlineMetaDataRawToDigi.getBeamSpot(), DTMuonMillepede.getbqcMatrix(), DTMuonMillepede.getbsurveyMatrix(), DTMuonMillepede.getCcsMatrix(), DTMuonMillepede.getCqcMatrix(), DTMuonMillepede.getCsurveyMatrix(), DTMuonMillepede.getLagMatrix(), matrixSaver.getMatrix(), FWGeometry.getMatrix(), matrixSaver.getMatrixVector(), OnlineBeamMonitor.globalBeginLuminosityBlock(), AlcaBeamMonitor.globalBeginLuminosityBlock(), reco::GsfComponent5D.GsfComponent5D(), initializeMatrix(), FWGeometry.initMap(), FWGeometry.loadMap(), CSCConfigurableStripConditions.makeNoisifier(), ALPAKA_ACCELERATOR_NAMESPACE::TestAlgoKernel.operator()(), BlockSolver.operator()(), ALPAKA_ACCELERATOR_NAMESPACE::TestAlgoMultiKernel2.operator()(), ALPAKA_ACCELERATOR_NAMESPACE::TestAlgoMultiKernel3.operator()(), operator>>(), MultiTrackVertexLinkKinematicConstraint.parametersDerivative(), MultiTrackPointingKinematicConstraint.parametersDerivative(), CombinedKinematicConstraint.parametersDerivative(), DDCoreToDDXMLOutput.position(), MultiTrackVertexLinkKinematicConstraint.positionDerivative(), MultiTrackPointingKinematicConstraint.positionDerivative(), CombinedKinematicConstraint.positionDerivative(), TKinFitter.printMatrix(), BeamSpotProducer.produce(), BeamSpotOnlineProducer.produce(), KfComponentsHolder.projection(), KFBasedPixelFitter::MyBeamSpotHit.projectionMatrix(), DTMuonSLToSL.returnbSLMatrix(), DTMuonSLToSL.returnCSLMatrix(), reco::BeamSpot.rotatedCovariance3D(), cms::rotation_utils.rotHash(), PVFitter.runBXFitter(), PVFitter.runFitter(), BeamFitter.runPVandTrkFitter(), BlockSolver.shrink(), cudatest.testAlgoKernel(), GsfMatrixTools.trace(), cms::DDFilteredView.translation(), SignCaloSpecificAlgo.usePreviousSignif(), CSCGeometryValidate.validateCSCChamberGeometry(), ValidateGeometry.validateCSChamberGeometry(), ValidateGeometry.validateCSCLayerGeometry(), DTGeometryValidate.validateDTChamberGeometry(), ValidateGeometry.validateDTChamberGeometry(), DTGeometryValidate.validateDTLayerGeometry(), ValidateGeometry.validateDTLayerGeometry(), GEMGeometryValidate.validateGEMChamberGeometry(), ME0GeometryValidate.validateME0ChamberGeometry(), ME0GeometryValidate.validateME0EtaPartitionGeometry2(), RPCGeometryValidate.validateRPCChamberGeometry(), ValidateGeometry.validateRPCGeometry(), ValidateGeometry.validateTrackerGeometry(), CSCSegFit.weightMatrix(), MuonSegFit.weightMatrix(), EcalTBWeightsXMLTranslator.writeChi2WeightMatrix(), and EcalTBWeightsXMLTranslator.writeWeightMatrix().

◆ misal

dictionary makeMuonMisalignmentScenario.misal = {}

Definition at line 156 of file makeMuonMisalignmentScenario.py.

Referenced by IdealResult.solve().

◆ options

makeMuonMisalignmentScenario.options

Definition at line 42 of file makeMuonMisalignmentScenario.py.

◆ outputName

makeMuonMisalignmentScenario.outputName = args[0]

Definition at line 46 of file makeMuonMisalignmentScenario.py.

Referenced by ecaldqm::MLClient.producePlots().

◆ parser

makeMuonMisalignmentScenario.parser = OptionParser(usage="Usage: python %prog outputName [options] (default is unit matrix times 1e-15)")

Get variances and covariances from the commandline.

Definition at line 11 of file makeMuonMisalignmentScenario.py.

◆ rot

makeMuonMisalignmentScenario.rot = rotation[system, whendcap, station, ring, sector]

Definition at line 322 of file makeMuonMisalignmentScenario.py.

Referenced by CreateIdealTkAlRecords.addAlignmentInfo(), AlignableDetUnit.addAlignmentPositionErrorFromLocalRotation(), AlignableModifier.addAlignmentPositionErrorFromLocalRotation(), AlignableComposite.addAlignmentPositionErrorFromLocalRotation(), AlignableDet.addAlignmentPositionErrorFromRotation(), AlignableDetUnit.addAlignmentPositionErrorFromRotation(), AlignableModifier.addAlignmentPositionErrorFromRotation(), FWTGeoRecoGeometryESProducer.addCaloTowerGeometry(), FWTGeoRecoGeometryESProducer.addHcalCaloGeometryBarrel(), FWTGeoRecoGeometryESProducer.addHcalCaloGeometryEndcap(), FWTGeoRecoGeometryESProducer.addHcalCaloGeometryForward(), FWTGeoRecoGeometryESProducer.addHcalCaloGeometryOuter(), cms::DDNamespace.addRotation(), cms::rotation_utils.addRotWithNewName(), TrackerGeometryCompare.addSurveyInfo(), AlignmentProducerBase.addSurveyInfo(), MuonAlignmentInputSurveyDB.addSurveyInfo_(), algorithm(), AlignableDet.alignments(), AlignableBeamSpot.alignments(), AlignableDetUnit.alignments(), BeamSpotAlignmentParameters.apply(), RigidBodyAlignmentParameters.apply(), BowedSurfaceAlignmentParameters.apply(), TwoBowedSurfacesAlignmentParameters.apply(), HGCalTrackCollectionProducer.beginLuminosityBlock(), CtfSpecialSeedGenerator.beginRun(), SiPixelPhase1Analyzer.BookForwardBins(), PixelTrackBuilder.build(), RPCGeometryBuilderFromCondDB.build(), ME0GeometryBuilderFromCondDB.build(), Cone.build(), CylinderBuilderFromDet.build(), Cylinder.build(), magneticfield::InterpolatorBuilder.build(), RPCGeometryBuilder.buildGeometry(), RPCGeometryParsFromDD.buildGeometry(), MagGeoBuilderFromDDD.buildInterpolator(), PPSGeometryBuilder.buildItemFromDetGeomDesc(), HGCalCellUV.cellUVFromXY1(), HGCalCellUV.cellUVFromXY2(), HGCalCellUV.cellUVFromXY3(), ALIUtils.checkMatrixEquations(), OpticalObject.checkMatrixEquations(), ConversionProducer.checkPhi(), MuonGeometryArrange.compareGeometries(), TrackerGeometryCompare.compareGeometries(), comparisonScript(), JacobianCurvilinearToLocal.compute(), JacobianLocalToCurvilinear.compute(), TIDLayer.computeDisk(), tkDetUtil.computeDisk(), BarrelDetLayer.computeSurface(), ForwardDetLayer.computeSurface(), MTDSectorForwardDoubleLayer.computeSurface(), MuRingForwardDoubleLayer.computeSurface(), ticl::SuperclusteringDNNInputV2.computeVector(), DDHGCalTBModuleX.constructBlocks(), DDHCalBarrelAlgo.constructGeneralVolume(), DDHCalEndcapAlgo.constructGeneralVolume(), HCalEndcapAlgo.constructGeneralVolume(), DDHCalBarrelAlgo.constructInsideLayers(), HcalBarrelAlgo.constructInsideLayers(), DDHCalEndcapModuleAlgo.constructInsideModule(), DDHCalEndcapAlgo.constructInsideModule(), HCalEndcapModuleAlgo.constructInsideModule(), HCalEndcapAlgo.constructInsideModule(), DDHCalEndcapModuleAlgo.constructInsideModule0(), DDHCalEndcapAlgo.constructInsideModule0(), HCalEndcapModuleAlgo.constructInsideModule0(), HCalEndcapAlgo.constructInsideModule0(), DDAHcalModuleAlgo.constructLayers(), DDHGCalTBModule.constructLayers(), DDHGCalTBModuleX.constructLayers(), DDHGCalModule.constructLayers(), DDHGCalModuleAlgo.constructLayers(), DDHGCalEEAlgo.constructLayers(), DDHGCalHEAlgo.constructLayers(), DDHGCalHEFileAlgo.constructLayers(), DDHGCalEEFileAlgo.constructLayers(), DDHGCalMixLayer.constructLayers(), DDHGCalSiliconModule.constructLayers(), DDHGCalMixRotatedCassette.constructLayers(), DDHGCalMixRotatedFineCassette.constructLayers(), DDHGCalMixRotatedLayer.constructLayers(), DDHGCalSiliconRotatedCassette.constructLayers(), DDHGCalSiliconRotatedModule.constructLayers(), TSCPBuilderNoMaterial.createFTSatTransverseImpactPointCharged(), TGeoMgrFromDdd.createShape(), L1MuonRecoTreeProducer.cylExtrapTrkSam(), ResidualRefitting.cylExtrapTrkSam(), DDanonymousRot(), DDrot(), DDRotation.DDRotation(), DDrotPtr(), DDrotReflect(), DetGeomDesc.DetGeomDesc(), align.diffAlignables(), TrackerGeometryCompare.diffCommonTrackerSystem(), align.diffRot(), MuonAlignmentInputXML.do_setposition(), Decay3Body.doDecay(), DDTECModuleAlgo.doPos(), DDEcalPreshowerAlgoTB.doSens(), DDHGCalCell.execute(), DDHGCalWafer8.execute(), DDTOBRodAlgo.execute(), DDTrackerXYZPosAlgo.execute(), DDTrackerZPosAlgo.execute(), DDTIDModulePosAlgo.execute(), DDHGCalPassivePartial.execute(), DDHGCalWaferP.execute(), DDTrackerLinear.execute(), DDHGCalWafer.execute(), DDHGCalWaferPartialRotated.execute(), DDHCalLinearXY.execute(), DDHGCalPassiveFull.execute(), DDPixFwdDiskAlgo.execute(), DDTIDModuleAlgo.execute(), DDRPDPosition.execute(), DDPixPhase1FwdDiskAlgo.execute(), DDHCalTBZposAlgo.execute(), DDHGCalWaferFullRotated.execute(), DDHGCalWaferF.execute(), DDHCalForwardAlgo.execute(), DDPixBarLayerAlgo.execute(), DDPixBarLayerUpgradeAlgo.execute(), DDBHMAngular.execute(), DDHCalTBCableAlgo.execute(), DDHGCalPassive.execute(), DDHCalFibreBundle.execute(), TrajectoryExtrapolatorToLine.extrapolate(), AnalyticalImpactPointExtrapolator.extrapolateSingleState(), AnalyticalTrajectoryExtrapolatorToLine.extrapolateSingleState(), AlCaHOCalibProducer.fillHOStore(), MuonGeometryArrange.fillTree(), TrackerGeometryCompare.fillTree(), SurveyMisalignmentInput.getAlignableSurface(), CocoaDBMgr.GetAlignInfoFromOptO(), ME0GeometryParsFromDD.getRotation(), GEMGeometryParsFromDD.getRotation(), HCalEndcapModuleAlgo.getRotation(), HCalEndcapAlgo.getRotation(), HcalBarrelAlgo.getRotation(), ALIUtils.getRotationAnglesFromMatrix(), SurveyDBUploader.getSurveyInfo(), ConversionProducer.getTrackImpactPosition(), HcalBarrelAlgo.HcalBarrelAlgo(), HGCalMouseBite.HGCalMouseBite(), HGCalSiliconModule.HGCalSiliconModule(), HGCalSiliconRotatedCassette.HGCalSiliconRotatedCassette(), HGCalSiliconRotatedModule.HGCalSiliconRotatedModule(), RectangularEtaPhiTrackingRegion.hits(), CosmicTrackingRegion.hits_(), initBarrel(), initCylinder(), initNegative(), initPositive(), SmartPropagator.initTkVolume(), RecoIdealGeometry.insert(), ClusterShapeHitFilter.isNormalOriented(), JacobianCartesianToLocal.JacobianCartesianToLocal(), JacobianCurvilinearToLocal.JacobianCurvilinearToLocal(), JacobianLocalToCartesian.JacobianLocalToCartesian(), JacobianLocalToCurvilinear.JacobianLocalToCurvilinear(), riemannFit.lineFit(), ALPAKA_ACCELERATOR_NAMESPACE::riemannFit.lineFit(), MuonScenarioBuilder.moveChamberInSector(), MTDSectorForwardLayer.MTDSectorForwardLayer(), MuRingForwardLayer.MuRingForwardLayer(), TransverseBoundPlaneFactory.operator()(), PerpendicularBoundPlaneBuilder.operator()(), MTDDiskSectorBuilderFromDet.operator()(), ForwardDiskSectorBuilderFromWedges.operator()(), ForwardDiskSectorBuilderFromDet.operator()(), ForwardRingDiskBuilderFromDet.operator()(), CylinderBuilderFromDet.operator()(), PlaneBuilder.plane(), DTGeometryBuilderFromDD4hep.plane(), cms::DTGeometryBuilder.plane(), DDCompactViewImpl.position(), DDCoreToDDXMLOutput.position(), DDCompactView.position(), DDHGCalHEAlgo.positionMix(), DDHGCalHEFileAlgo.positionMix(), DDHGCalMixLayer.positionMix(), DDHGCalMixRotatedCassette.positionMix(), DDHGCalMixRotatedFineCassette.positionMix(), DDHGCalMixRotatedLayer.positionMix(), printRot(), DDLRotationSequence.processElement(), DDLRotationByAxis.processElement(), SeedProducerFromSoAT< TrackerTraits >.produce(), TkMSParameterizationBuilder.produce(), PixelTrackProducerFromSoAAlpaka< TrackerTraits >.produce(), PixelTrackProducerFromSoAT< TrackerTraits >.produce(), MuonSimHitProducer.produce(), PGeometricDetBuilder.putOne(), AlignableDataIORoot.readAbsRaw(), AlignableDataIORoot.readRelRaw(), CocoaAnalyzer.readXMLFile(), TkConvValidator.recalculateMomentumAtFittedVertex(), align.rectify(), MuonAlignment.recursiveCopySurveyToAlignment(), DDEcalEndcapTrapX.rotate(), DDEcalEndcapTrap.rotate(), Alignable.rotateAroundGlobalX(), Alignable.rotateAroundGlobalY(), Alignable.rotateAroundGlobalZ(), Alignable.rotateAroundLocalX(), Alignable.rotateAroundLocalY(), Alignable.rotateAroundLocalZ(), DDCoreToDDXMLOutput.rotation(), BeamSpotAlignmentParameters.rotation(), RigidBodyAlignmentParameters.rotation(), brokenline.rotationMatrix(), ALPAKA_ACCELERATOR_NAMESPACE::brokenline.rotationMatrix(), cms::rotation_utils.rotHash(), cms::rotation_utils.rotName(), MuonAlignment.saveCSCSurveyToDB(), MuonAlignment.saveDTSurveyToDB(), SurveyResidual.sensorResidual(), MuonAlignmentInputXML.set_one_position(), TrackerGeometryCompare.setCommonTrackerSystem(), SurveyAlignment.shiftSensors(), AlignmentProducerBase.simpleMisalignment(), DDCoreToDDXMLOutput.solid(), SeedFromNuclearInteraction.stateWithError(), CosmicMuonUtilities.stepPropagate(), L1MuonRecoTreeProducer.surfExtrapTrkSam(), MuCSCTnPFlatTableProducer.surfExtrapTrkSam(), TrackerGeometryCompare.surveyToTracker(), align.toAngles(), FrameChanger.toFrame(), AlignableSurface.toGlobal(), AlignableSurface.toLocal(), TFitParticleMCMomDev.transform(), TFitParticleEMomDev.transform(), TFitParticleMomDev.transform(), TFitParticleEScaledMomDev.transform(), FrameToFrameDerivative.transform(), FrameChanger.transformPlane(), HGCalGeomRotation.uvMappingFrom120DegreeSector0(), HGCalGeomRotation.uvMappingFrom60DegreeSector0(), HGCalGeomRotation.uvMappingTo120DegreeSector0(), HGCalGeomRotation.uvMappingTo60DegreeSector0(), AlignableDataIO.writeAbsPos(), AlignableDataIORoot.writeAbsRaw(), MuonAlignmentOutputXML.writeComponents(), AlignableDataIO.writeOrgPos(), AlignableDataIO.writeRelPos(), and AlignableDataIORoot.writeRelRaw().

◆ sum_phix

int makeMuonMisalignmentScenario.sum_phix = 0.

Definition at line 179 of file makeMuonMisalignmentScenario.py.

◆ sum_phixphix

int makeMuonMisalignmentScenario.sum_phixphix = 0.

Definition at line 198 of file makeMuonMisalignmentScenario.py.

◆ sum_phixphiy

int makeMuonMisalignmentScenario.sum_phixphiy = 0.

Definition at line 199 of file makeMuonMisalignmentScenario.py.

◆ sum_phixphiz

int makeMuonMisalignmentScenario.sum_phixphiz = 0.

Definition at line 200 of file makeMuonMisalignmentScenario.py.

◆ sum_phiy

int makeMuonMisalignmentScenario.sum_phiy = 0.

Definition at line 180 of file makeMuonMisalignmentScenario.py.

◆ sum_phiyphiy

int makeMuonMisalignmentScenario.sum_phiyphiy = 0.

Definition at line 201 of file makeMuonMisalignmentScenario.py.

◆ sum_phiyphiz

int makeMuonMisalignmentScenario.sum_phiyphiz = 0.

Definition at line 202 of file makeMuonMisalignmentScenario.py.

◆ sum_phiz

int makeMuonMisalignmentScenario.sum_phiz = 0.

Definition at line 181 of file makeMuonMisalignmentScenario.py.

◆ sum_phizphiz

int makeMuonMisalignmentScenario.sum_phizphiz = 0.

Definition at line 203 of file makeMuonMisalignmentScenario.py.

◆ sum_x

int makeMuonMisalignmentScenario.sum_x = 0.

◆ sum_xphix

int makeMuonMisalignmentScenario.sum_xphix = 0.

Definition at line 186 of file makeMuonMisalignmentScenario.py.

◆ sum_xphiy

int makeMuonMisalignmentScenario.sum_xphiy = 0.

Definition at line 187 of file makeMuonMisalignmentScenario.py.

◆ sum_xphiz

int makeMuonMisalignmentScenario.sum_xphiz = 0.

Definition at line 188 of file makeMuonMisalignmentScenario.py.

◆ sum_xx

int makeMuonMisalignmentScenario.sum_xx = 0.

◆ sum_xy

int makeMuonMisalignmentScenario.sum_xy = 0.

Definition at line 184 of file makeMuonMisalignmentScenario.py.

◆ sum_xz

int makeMuonMisalignmentScenario.sum_xz = 0.

Definition at line 185 of file makeMuonMisalignmentScenario.py.

◆ sum_y

int makeMuonMisalignmentScenario.sum_y = 0.

◆ sum_yphix

int makeMuonMisalignmentScenario.sum_yphix = 0.

Definition at line 191 of file makeMuonMisalignmentScenario.py.

◆ sum_yphiy

int makeMuonMisalignmentScenario.sum_yphiy = 0.

Definition at line 192 of file makeMuonMisalignmentScenario.py.

◆ sum_yphiz

int makeMuonMisalignmentScenario.sum_yphiz = 0.

Definition at line 193 of file makeMuonMisalignmentScenario.py.

◆ sum_yy

int makeMuonMisalignmentScenario.sum_yy = 0.

Definition at line 189 of file makeMuonMisalignmentScenario.py.

◆ sum_yz

int makeMuonMisalignmentScenario.sum_yz = 0.

Definition at line 190 of file makeMuonMisalignmentScenario.py.

◆ sum_z

int makeMuonMisalignmentScenario.sum_z = 0.

Definition at line 178 of file makeMuonMisalignmentScenario.py.

◆ sum_zphix

int makeMuonMisalignmentScenario.sum_zphix = 0.

Definition at line 195 of file makeMuonMisalignmentScenario.py.

◆ sum_zphiy

int makeMuonMisalignmentScenario.sum_zphiy = 0.

Definition at line 196 of file makeMuonMisalignmentScenario.py.

◆ sum_zphiz

int makeMuonMisalignmentScenario.sum_zphiz = 0.

Definition at line 197 of file makeMuonMisalignmentScenario.py.

◆ sum_zz

int makeMuonMisalignmentScenario.sum_zz = 0.

Definition at line 194 of file makeMuonMisalignmentScenario.py.

◆ txtfile

makeMuonMisalignmentScenario.txtfile = file(outputName + "_correlations.txt", "w")

Delete all three files at once to make sure the user never sees stale data (e.g.

from a stopped process due to failed conversion) Print out the list of correlations

Definition at line 296 of file makeMuonMisalignmentScenario.py.

Referenced by TrackerMap.printall(), and TrackerMap.printonline().

◆ wheel

makeMuonMisalignmentScenario.wheel

Definition at line 319 of file makeMuonMisalignmentScenario.py.

Referenced by L1MuBMSectorReceiver.address2wheel(), L1MuDTSectorReceiver.address2wheel(), FWTGeoRecoGeometryESProducer.addTIDGeometry(), AlignmentMonitorMuonResiduals.afterAlignment(), RPCDigiValid.analyze(), DTTnPEfficiencyTask.analyze(), DTSurveyConvert.analyze(), DTOccupancyEfficiency.analyze(), L1TDTTF.analyze(), DTChamberEfficiencyTask.analyze(), MuonDTDigis.analyze(), MuonIdVal.analyze(), MuonAlignmentAnalyzer.analyze(), DTLocalTriggerLutTask.analyze(), DTLocalTriggerSynchTask.analyze(), DTTriggerEfficiencyTask.analyze(), DTCCBConfig.appendConfigKey(), DTnoiseDBValidation.beginRun(), DTt0DBValidation.beginRun(), DTNoiseComputation.beginRun(), RPCSummaryMapHisto.book(), AlignmentMonitorSegmentDifferences.book(), AlignmentMonitorMuonVsCurvature.book(), AlignmentMonitorMuonSystemMap1D.book(), RPCRollMapHisto.bookBarrel(), DTTriggerEfficiencyTask.bookChamberHistos(), DTRunConditionVar.bookChamberHistos(), DTLocalTriggerEfficiencyTest.bookChambHistos(), DTLocalTriggerSynchTest.bookChambHistos(), DTTriggerEfficiencyTest.bookChambHistos(), DTTnPEfficiencyTask.bookHistograms(), RPCTnPEfficiencyTask.bookHistograms(), DTtTrigDBValidation.bookHistograms(), DTPreCalibrationTask.bookHistograms(), DTOccupancyEfficiency.bookHistograms(), DTDCSByLumiTask.bookHistograms(), DTEfficiencyTask.bookHistograms(), DTCalibValidation.bookHistograms(), DTRunConditionVar.bookHistograms(), DTSegmentAnalysisTask.bookHistograms(), DTCalibValidationFromMuons.bookHistograms(), DTDataIntegrityTask.bookHistograms(), MuonIdVal.bookHistograms(), DTChamberEfficiency.bookHistograms(), DTResolutionAnalysisTest.bookHistos(), DTVDriftSegmentCalibration.bookHistos(), DTNoiseAnalysisTest.bookHistos(), DTTTrigOffsetCalibration.bookHistos(), DTSegmentAnalysisTest.bookHistos(), DTt0DBValidation.bookHistos(), DTResolutionTest.bookHistos(), DTChamberEfficiencyTest.bookHistos(), DTChamberEfficiencyClient.bookHistos(), DTEfficiencyTest.bookHistos(), DTOccupancyTest.bookHistos(), DTNoiseTask.bookHistos(), DTOccupancyTestML.bookHistos(), DTtTrigDBValidation.bookHistos(), DTDataIntegrityTask.bookHistos(), DTChamberEfficiencyTask.bookHistos(), DTLocalTriggerSynchTask.bookHistos(), DTLocalTriggerTask.bookHistos(), DTResolutionAnalysisTask.bookHistos(), DTLocalTriggerLutTask.bookHistos(), DTSegmentAnalysisTask.bookHistos(), DTLocalTriggerBaseTask.bookHistos(), DTDataIntegrityTask.bookHistosROS(), DTPreCalibrationTask.bookOccupancyPlot(), DTLocalTriggerBaseTest.bookSectorHistos(), RPCMonitorDigi.bookSectorRingME(), DTPreCalibrationTask.bookTimeBoxes(), RPCMonitorDigi.bookWheelDiskME(), DTTnPEfficiencyTask.bookWheelHistos(), RPCTnPEfficiencyTask.bookWheelHistos(), DTTriggerEfficiencyTest.bookWheelHistos(), DTTriggerEfficiencyTask.bookWheelHistos(), DTRunConditionVarClient.bookWheelHistos(), DTLocalTriggerBaseTest.bookWheelHistos(), DTLocalTriggerTask.bookWheelHistos(), MuonRPCDetLayerGeometryBuilder.buildBarrelLayers(), L1TPhase2GMTEndcapStubProcessor.buildCSCOnlyStub(), MuonDTDetLayerGeometryBuilder.buildLayers(), L1TPhase2GMTEndcapStubProcessor.buildRPCOnlyStub(), DTCompactMapWriter.buildSteering(), L1TMuonBarrelKalmanStubProcessor.buildStub(), L1TPhase2GMTBarrelStubProcessor.buildStubNoEta(), L1TMuonBarrelKalmanStubProcessor.buildStubNoEta(), DTRPCBxCorrection.BxCorrection(), L1TPhase2GMTBarrelStubProcessor.calculateEta(), L1TMuonBarrelKalmanStubProcessor.calculateEta(), Phase2L1GMT::KMTFCore.calculateEta(), L1TMuonBarrelKalmanAlgo.calculateEta(), DTMuonMillepede.calculationMillepede(), DTMuonSLToSL.calculationSLToSL(), RPCNameHelper.chamberName(), DTTFFEDReader.channel(), DTMapGenerator.checkWireExist(), L1MuTMChambPhContainer.chPhiSegm(), L1MuTMChambPhContainer.chPhiSegm1(), L1MuDTChambPhContainer.chPhiSegm1(), DTTrig.chPhiSegm1(), L1MuTMChambPhContainer.chPhiSegm2(), L1MuDTChambPhContainer.chPhiSegm2(), DTTrig.chPhiSegm2(), DTTrig.chSectCollPhSegm1(), DTTrig.chSectCollPhSegm2(), DTTrig.chSectCollThSegm(), L1MuDTChambThContainer.chThetaSegm(), DTTrig.chThetaSegm(), RPCClusterSizeTest.clientOperation(), ResidualRefitting.CollectTrackHits(), DTParametrizedDriftAlgo.compute(), DTRecHitQuality.compute(), DTCCBConfig.configKey(), RBCProcessRPCDigis.configure(), DTTrig.constTrigUnit(), dtCalibration::DTT0FEBPathCorrection.correction(), dtCalibration::DTTTrigResidualCorrection.correction(), l1trigger::Counters.Counters(), DTDigiToRaw.createFedBuffers(), MuonGeometrySanityCheckPoint.detName(), DTSegment4DQuality.dqmAnalyze(), DTDCSByLumiTask.dqmBeginLuminosityBlock(), DTOfflineSummaryClients.dqmEndJob(), DTCertificationSummary.dqmEndJob(), DTChamberEfficiencyClient.dqmEndJob(), DTRunConditionVarClient.dqmEndJob(), DTDCSSummary.dqmEndLuminosityBlock(), DTCertificationSummary.dqmEndLuminosityBlock(), DTDAQInfo.dqmEndLuminosityBlock(), DTDataIntegrityTest.dqmEndLuminosityBlock(), DTBlockedROChannelsTest.dqmEndLuminosityBlock(), DTSummaryClients.dqmEndLuminosityBlock(), DTNoiseAnalysisTest.dqmEndLuminosityBlock(), DTDCSByLumiTask.dqmEndLuminosityBlock(), DTResolutionTest.dqmEndLuminosityBlock(), DTChamberEfficiencyTest.dqmEndLuminosityBlock(), DTEfficiencyTest.dqmEndLuminosityBlock(), DTConfigLUTs.DTConfigLUTs(), DTBlockedROChannelsTest::DTLinkBinsMap.DTLinkBinsMap(), DTNoiseCalibration.DTNoiseCalibration(), DTObjectMap.DTObjectMap(), DTT0Calibration.DTT0Calibration(), DTT0CalibrationRMS.DTT0CalibrationRMS(), L1MuDTTrackContainer.dtTrackCand1(), L1MuDTTrackContainer.dtTrackCand2(), Phase2L1GMT::KMTFCore.encode(), DTMapGenerator.endJob(), MuonAlignmentAnalyzer.endJob(), DTnoiseDBValidation.endRun(), EMTFSubsystemCollector.extractPrimitives(), L1TMuon::DTCollector.extractPrimitives(), DTBlockedROChannelsTest.fillChamberMap(), MuonShowerInformationFiller.fillHitsByStation(), MuonAlignmentFromReference.fillNtuple(), DTCompactMapWriter.fillReadOutMap(), DTCompactMapWriter.fillROSMap(), MuDTTPGThetaFlatTableProducer.fillTable(), MuDTTPGPhiFlatTableProducer.fillTable(), MuDTSegmentExtTableProducer.fillTable(), DTCompactMapWriter.fillTDCMap(), DTHVHandler.get(), DTDeadFlag.getCellDead_HV(), DTDeadFlag.getCellDead_RO(), DTDeadFlag.getCellDead_TP(), DTDeadFlag.getCellDiscCat(), DTRunConditionVarClient.getChamberHistos(), MuonAlignmentInputXML.getDTnode(), DTLocalTriggerSynchTest.getFloatFromME(), dtCalibration::DTVDriftSegment.getHistoName(), dtCalibration::DTTTrigT0SegCorrection.getHistoName(), dtCalibration::DTTTrigResidualCorrection.getHistoName(), ReadPGInfo.getId(), DTResolutionAnalysisTest.getMEName(), DTTriggerEfficiencyTest.getMEName(), DTSegmentAnalysisTest.getMEName(), DTNoiseAnalysisTest.getMEName(), DTResolutionTest.getMEName(), DTChamberEfficiencyTest.getMEName(), DTOccupancyTest.getMEName(), DTEfficiencyTest.getMEName(), DTOccupancyTestML.getMEName(), DTResolutionTest.getMEName2D(), RPCDqmClient.getMonitorElements(), TrackerMuonHitExtractor.getMuonHits(), RPCAMCLinkMapHandler.getNewObjects(), DTKeyedConfigHandler.getNewObjects(), DTUserKeyedConfigHandler.getNewObjects(), AngleConverter.getProcessorPhi(), MuonSeedPtExtractor.getPt(), GlobalMuonRefitter.getRidOfSelectStationHits(), DTNoiseAnalysisTest.getSynchNoiseMEName(), SiStripApvSimulationParameters.getTEC(), SiStripApvSimulationParameters.getTID(), RPCTechnicalTrigger::TTUResults.getTriggerForWheel(), ReadPGInfo.giveQC(), ReadPGInfo.giveQCCal(), ReadPGInfo.giveR(), ReadPGInfo.giveSurvey(), HOTPDigiTwinMux.HOTPDigiTwinMux(), DTSequentialCellNumber.id(), DTSequentialLayerNumber.id(), TrackerMuonHitExtractor.init(), L1TMuonBarrelKalmanSectorProcessor.L1TMuonBarrelKalmanSectorProcessor(), LinkBoardSpec.linkBoardName(), L1TMuonBarrelKalmanStubProcessor.makeInputPattern(), L1TPhase2GMTBarrelStubProcessor.makeStubs(), L1TMuonBarrelKalmanStubProcessor.makeStubs(), Phase2L1GMT::KMTFCore.match(), L1TMuonBarrelKalmanAlgo.match(), DTLowQMatching.Matching(), SiStripCondVisualizer.module_location_type(), MuonScenarioBuilder.moveDTSectors(), MuonGeometrySanityCheckPoint.MuonGeometrySanityCheckPoint(), TrackTransformerForGlobalCosmicMuons.MuonKeep(), L1MuBMSectorProcessor.neighbour(), L1MuDTSectorProcessor.neighbour(), RBCProcessRPCDigis.next(), RBCProcessRPCSimDigis.next(), MuonAlignmentFromReference.parseReference(), DTBlockedROChannelsTest.performClientDiagnostic(), DTLocalTriggerBaseTest.phiRange(), CSCTFDTReceiver.process(), DTTFFEDReader.process(), DTDataIntegrityTask.processFED(), L1TTwinMuxRawToDigi.processFed(), AlignmentMonitorMuonVsCurvature.processMuonResidualsFromTrack(), MuonAlignmentFromReference.processMuonResidualsFromTrack(), DTDataIntegrityTask.processuROS(), MuonTrackProducer.produce(), SiStripApvSimulationParameters.putTEC(), SiStripApvSimulationParameters.putTID(), popcon::RPCEMapSourceHandler.readEMap1(), MuonResiduals5DOFFitter.readNtuple(), MuonResiduals6DOFFitter.readNtuple(), DTDataIntegrityTest.readOutToGeometry(), DTBlockedROChannelsTest.readOutToGeometry(), L1MuDTEtaProcessor.receiveAddresses(), L1MuBMEtaProcessor.receiveAddresses(), L1MuBMSectorReceiver.receiveBBMXData(), L1MuDTSectorReceiver.receiveCSCData(), L1MuDTEtaProcessor.receiveData(), L1MuBMEtaProcessor.receiveData(), L1MuDTSectorReceiver.receiveDTBXData(), PseudoBayesGrouping.RecognisePatternsByLayerPairs(), AlignTrackSegments.run(), RPCtoDTTranslator.run(), IOPrinter.run(), L1TTwinMuxAlgorithm.run(), L1MuBMWedgeSorter.run(), L1MuDTWedgeSorter.run(), L1MuDTEtaProcessor.runEtaTrackFinder(), L1MuBMEtaProcessor.runEtaTrackFinder(), DTLocalTriggerTask.runSegmentAnalysis(), SiStripApvSimulationParameters.sampleTEC(), SiStripApvSimulationParameters.sampleTID(), DTTrig.SCUnit(), DTT0.set(), RPCRollMapHisto.setBarrelRollAxis(), RPCSummaryMapHisto.setBinBarrel(), RPCSummaryMapHisto.setBinsBarrel(), DTStatusFlag.setCellDead(), DTDeadFlag.setCellDead_HV(), DTDeadFlag.setCellDead_RO(), DTDeadFlag.setCellDead_TP(), DTDeadFlag.setCellDiscCat(), DTStatusFlag.setCellFEMask(), DTStatusFlag.setCellNoHV(), DTStatusFlag.setCellNoise(), DTStatusFlag.setCellTDCMask(), DTStatusFlag.setCellTrigMask(), DTCCBConfig.setConfigKey(), DTHVStatus.setFlagA(), DTHVStatus.setFlagC(), DTLVStatus.setFlagCFE(), DTLVStatus.setFlagCMC(), DTLVStatus.setFlagDFE(), DTLVStatus.setFlagDMC(), DTHVStatus.setFlagS(), L1GctGlobalEnergyAlgos.setInputWheelEt(), L1GctGlobalEnergyAlgos.setInputWheelEx(), L1GctGlobalEnergyAlgos.setInputWheelEy(), L1GctGlobalEnergyAlgos.setInputWheelHt(), L1GctGlobalEnergyAlgos.setInputWheelHx(), L1GctGlobalEnergyAlgos.setInputWheelHy(), L1TDTTPGClient.setMapPhLabel(), L1TDTTPG.setMapPhLabel(), L1TDTTPGClient.setMapThLabel(), L1TDTTPG.setMapThLabel(), L1Analysis::L1AnalysisL1UpgradeTfMuon.SetTfMuon(), DTConfigLUTs.setWHEEL(), tmtt::StubFEWindows.storedWindowSize(), ResidualRefitting.StoreTrackerRecHits(), TrackerTopology.tecDetId(), TrackerTopology.tecDetIdWheelComparator(), TrackerTopology.tidDetId(), TrackerTopology.tidDetIdWheelComparator(), DTTPGParameters.totalTime(), LASGeometryUpdater.TrackerUpdate(), DTTrig.trigUnit(), l1t::stage2.unpacking_bmtf(), ScBMTFRawToDigi.unpackOrbit(), MuonDTDigis.WheelHistos(), and hTimes< hTime >.WheelHistos().

◆ xmlfile

makeMuonMisalignmentScenario.xmlfile = file(outputName + ".xml", "w")

Make an XML representation of the misalignment.

Definition at line 313 of file makeMuonMisalignmentScenario.py.

Referenced by TrackerMap.printlayers().