Namespaces | |
expression | |
geometry | |
table | |
Classes | |
class | Context |
struct | jetScaleMarker |
class | OptionNode |
struct | OptionNodePtrCompare |
struct | OptionNodePtrEqual |
struct | PaletteExtraTopBottomIndices |
struct | scaleMarker |
struct | State |
class | StateOrdering |
Functions | |
bool | acceptDataFormatsVersion (TString &n) |
void | addBox (const std::vector< float > &corners, TEveElement *, FWProxyBuilderBase *) |
void | addCircle (double eta, double phi, double radius, const unsigned int nLineSegments, TEveElement *comp, FWProxyBuilderBase *pb) |
void | addDashedArrow (double phi, double size, TEveElement *comp, FWProxyBuilderBase *pb) |
void | addDashedLine (double phi, double theta, double size, TEveElement *comp, FWProxyBuilderBase *pb) |
void | addDoubleLines (double phi, TEveElement *comp, FWProxyBuilderBase *pb) |
void | addRhoZEnergyProjection (FWProxyBuilderBase *, TEveElement *, double r_ecal, double z_ecal, double theta_min, double theta_max, double phi) |
void | addSiStripClusters (const FWEventItem *iItem, const reco::Track &t, class TEveElement *tList, bool addNearbyClusters, bool master) |
void | addStraightLineSegment (TEveStraightLineSet *marker, reco::Candidate const *cand, double scale_factor=2) |
const TGGC & | boldGC () |
void | createSegment (int detector, bool matchedSegment, float segmentLength, float segmentLimit, float *segmentPosition, float *segmentDirection, float *segmentInnerPoint, float *segmentOuterPoint) |
const TString | datadir ("/src/Fireworks/Core/") |
void | drawEnergyScaledBox3D (const float *corners, float scale, TEveElement *, FWProxyBuilderBase *, bool invert=false) |
void | drawEnergyTower3D (const float *corners, float scale, TEveElement *, FWProxyBuilderBase *, bool reflect=false) |
void | drawEtScaledBox3D (const float *corners, float energy, float maxEnergy, TEveElement *, FWProxyBuilderBase *, bool reflect=false) |
void | drawEtTower3D (const float *corners, float scale, TEveElement *, FWProxyBuilderBase *, bool reflect=false) |
void | energyScaledBox3DCorners (const float *corners, float scale, std::vector< float > &, bool invert=false) |
void | energyTower3DCorners (const float *corners, float scale, std::vector< float > &, bool reflect=false) |
void | etScaledBox3DCorners (const float *corners, float energy, float maxEnergy, std::vector< float > &scaledCorners, bool reflect=false) |
void | etTower3DCorners (const float *corners, float scale, std::vector< float > &, bool reflect=false) |
const SiStripCluster * | extractClusterFromTrackingRecHit (const TrackingRecHit *rh) |
void | GetColorValuesForPaletteExtra (float(*iColors)[3], unsigned int iSize, FWColorManager::EPalette id, bool isWhiteBg) |
void | getDecomposedVersion (const TString &s, int *out) |
std::string | getLocalTime (const edm::EventBase &event) |
std::pair< double, double > | getPhiRange (const std::vector< double > &phis, double phi) |
TEveGeoShape * | getShape (const char *name, TGeoBBox *shape, Color_t color) |
std::string | getTimeGMT (const edm::EventBase &event) |
const TGGC & | greenGC () |
std::string | info (const DetId &) |
std::string | info (const std::set< DetId > &) |
std::string | info (const std::vector< DetId > &) |
void | invertBox (std::vector< float > &corners) |
const TGGC & | italicGC () |
void | localSiStrip (short strip, float *localTop, float *localBottom, const float *pars, unsigned int id) |
TEveJetCone * | makeEveJetCone (const reco::Jet &iData, const fireworks::Context &context) |
bool | makeRhoPhiSuperCluster (FWProxyBuilderBase *, const reco::SuperClusterRef &iCluster, float iPhi, TEveElement &oItemHolder) |
bool | makeRhoZSuperCluster (FWProxyBuilderBase *, const reco::SuperClusterRef &iCluster, float iPhi, TEveElement &oItemHolder) |
float | phase2PixelLocalX (const double mpx, const float *, const float *) |
float | phase2PixelLocalY (const double mpy, const float *, const float *) |
float | pixelLocalX (const double mpx, const float *) |
float | pixelLocalY (const double mpy, const float *) |
TEveTrack * | prepareCandidate (const reco::Candidate &track, TEveTrackPropagator *propagator) |
TEveTrack * | prepareTrack (const reco::Track &track, TEveTrackPropagator *propagator, const std::vector< TEveVector > &extraRefPoints=std::vector< TEveVector >()) |
void | pushNearbyPixelHits (std::vector< TVector3 > &pixelPoints, const FWEventItem &iItem, const reco::Track &t) |
void | pushPixelCluster (std::vector< TVector3 > &pixelPoints, const FWGeometry &geom, DetId id, const SiPixelCluster &c, const float *pars) |
void | pushPixelHits (std::vector< TVector3 > &pixelPoints, const FWEventItem &iItem, const reco::Track &t) |
const TGGC & | redGC () |
void | setPath (TString &v) |
void | setTrackTypePF (const reco::PFCandidate &pfCand, TAttLine *track) |
void | setupAddElement (TEveElement *el, TEveElement *parent, const FWEventItem *item, bool master, bool color) |
int * | supportedDataFormatsVersion () |
std::vector< std::pair< double, double > > | thetaBins () |
Variables | |
static const double | MICRON = 1. / 1000. / 1000. |
const TString | p1 = gSystem->Getenv("CMSSW_BASE") + datadir |
const TString | p2 = gSystem->Getenv("CMSSW_RELEASE_BASE") + datadir |
static const std::string | subdets [7] = {"UNKNOWN", "PXB", "PXF", "TIB", "TID", "TOB", "TEC"} |
bool fireworks::acceptDataFormatsVersion | ( | TString & | n | ) |
Definition at line 60 of file fwPaths.cc.
References data, getDecomposedVersion(), and supportedDataFormatsVersion().
Referenced by FWFileEntry::openFile().
void fireworks::addBox | ( | const std::vector< float > & | corners, |
TEveElement * | comp, | ||
FWProxyBuilderBase * | pb | ||
) |
Definition at line 152 of file BuilderUtils.cc.
References AlCaHLTBitMon_QueryRunRegistry::comp, and FWProxyBuilderBase::setupAddElement().
Referenced by drawEnergyScaledBox3D(), drawEnergyTower3D(), drawEtScaledBox3D(), and drawEtTower3D().
void fireworks::addCircle | ( | double | eta, |
double | phi, | ||
double | radius, | ||
const unsigned int | nLineSegments, | ||
TEveElement * | comp, | ||
FWProxyBuilderBase * | pb | ||
) |
Definition at line 161 of file BuilderUtils.cc.
References AlCaHLTBitMon_QueryRunRegistry::comp, funct::cos(), PVValHelper::eta, hcalRecHitTable_cff::iphi, M_PI, phi, CosmicsPD_Skims::radius, FWProxyBuilderBase::setupAddElement(), and funct::sin().
Referenced by FWJetLegoProxyBuilder::build(), FWL1JetParticleLegoProxyBuilder::build(), FWL1MuonParticleLegoProxyBuilder::build(), and FWPFTauProxyBuilder::buildViewType().
void fireworks::addDashedArrow | ( | double | phi, |
double | size, | ||
TEveElement * | comp, | ||
FWProxyBuilderBase * | pb | ||
) |
Definition at line 180 of file BuilderUtils.cc.
References AlCaHLTBitMon_QueryRunRegistry::comp, funct::cos(), phi, FWProxyBuilderBase::setupAddElement(), funct::sin(), and findQualityFiles::size.
Referenced by FWMETGlimpseProxyBuilder::build(), and FWL1EtMissParticleGlimpseProxyBuilder::build().
void fireworks::addDashedLine | ( | double | phi, |
double | theta, | ||
double | size, | ||
TEveElement * | comp, | ||
FWProxyBuilderBase * | pb | ||
) |
Definition at line 190 of file BuilderUtils.cc.
References fireworks::Context::caloR1(), fireworks::Context::caloZ2(), AlCaHLTBitMon_QueryRunRegistry::comp, visDQMUpload::context, FWProxyBuilderBase::context(), funct::cos(), M_PI, phi, alignCSCRings::r, FWProxyBuilderBase::setupAddElement(), funct::sin(), findQualityFiles::size, and theta().
Referenced by FWL1EmParticleProxyBuilder::build(), FWL1MuonParticleProxyBuilder::build(), FWL1JetParticleProxyBuilder::build(), and FWL1EtMissParticleProxyBuilder::build().
void fireworks::addDoubleLines | ( | double | phi, |
TEveElement * | comp, | ||
FWProxyBuilderBase * | pb | ||
) |
Definition at line 209 of file BuilderUtils.cc.
References AlCaHLTBitMon_QueryRunRegistry::comp, M_PI, phi, and FWProxyBuilderBase::setupAddElement().
Referenced by FWMETLegoProxyBuilder::build(), and FWL1EtMissParticleLegoProxyBuilder::build().
void fireworks::addRhoZEnergyProjection | ( | FWProxyBuilderBase * | pb, |
TEveElement * | container, | ||
double | r_ecal, | ||
double | z_ecal, | ||
double | theta_min, | ||
double | theta_max, | ||
double | phi | ||
) |
Definition at line 58 of file BuilderUtils.cc.
References diffTwoXMLs::r2, FWProxyBuilderBase::setupAddElement(), submitPVValidationJobs::t, funct::tan(), and testProducerWithPsetDescEmpty_cfi::z2.
Referenced by FWTauProxyBuilderBase::buildBaseTau(), FWMETProxyBuilder::buildViewType(), and makeRhoZSuperCluster().
void fireworks::addSiStripClusters | ( | const FWEventItem * | iItem, |
const reco::Track & | t, | ||
class TEveElement * | tList, | ||
bool | addNearbyClusters, | ||
bool | master | ||
) |
Definition at line 336 of file TrackUtils.cc.
References edmNew::DetSet< T >::begin(), edmNew::DetSet< T >::end(), edmNew::DetSetVector< T >::end(), extractClusterFromTrackingRecHit(), edmNew::DetSetVector< T >::find(), SiStripCluster::firstStrip(), fwLog, TrackingRecHit::geographicalId(), relativeConstraints::geom, edm::EventBase::get(), FWEventItem::getEvent(), FWEventItem::getGeom(), hit::id, TrackingRecHit::isValid(), ALPAKA_ACCELERATOR_NAMESPACE::vertexFinder::it, fwlog::kDebug, fwlog::kError, localSiStrip(), volumeBasedMagneticField_160812_cfi::master, edm::Handle< T >::product(), DetId::rawId(), setupAddElement(), and submitPVValidationJobs::t.
Referenced by FWConvTrackHitsDetailView::addHits(), FWTrackHitsDetailView::addHits(), and FWTracksRecHitsProxyBuilder::build().
void fireworks::addStraightLineSegment | ( | TEveStraightLineSet * | marker, |
reco::Candidate const * | cand, | ||
double | scale_factor = 2 |
||
) |
Definition at line 19 of file CandidateUtils.cc.
References funct::cos(), funct::sin(), and theta().
Referenced by FWMuonGlimpseProxyBuilder::build(), and FWElectronGlimpseProxyBuilder::build().
const TGGC & fireworks::boldGC | ( | ) |
Definition at line 11 of file GlobalContexts.cc.
References submitPVResolutionJobs::pool.
Referenced by FWPSetTableManager::cellRenderer().
void fireworks::createSegment | ( | int | detector, |
bool | matchedSegment, | ||
float | segmentLength, | ||
float | segmentLimit, | ||
float * | segmentPosition, | ||
float * | segmentDirection, | ||
float * | segmentInnerPoint, | ||
float * | segmentOuterPoint | ||
) |
Definition at line 9 of file SegmentUtils.cc.
References funct::cos(), MuonSubdetId::CSC, hgcalTestNeighbor_cfi::detector, MuonSubdetId::DT, fwLog, MuonSubdetId::GEM, fwlog::kWarning, mag(), MuonSubdetId::ME0, mathSSE::sqrt(), funct::tan(), and theta().
const TString fireworks::datadir | ( | "/src/Fireworks/Core/" | ) |
void fireworks::drawEnergyScaledBox3D | ( | const float * | corners, |
float | scale, | ||
TEveElement * | comp, | ||
FWProxyBuilderBase * | pb, | ||
bool | invert = false |
||
) |
Definition at line 245 of file BuilderUtils.cc.
References addBox(), AlCaHLTBitMon_QueryRunRegistry::comp, energyScaledBox3DCorners(), l1tstage2_dqm_sourceclient-live_cfg::invert, and pfClustersFromCombinedCaloHF_cfi::scale.
void fireworks::drawEnergyTower3D | ( | const float * | corners, |
float | scale, | ||
TEveElement * | comp, | ||
FWProxyBuilderBase * | pb, | ||
bool | reflect = false |
||
) |
Definition at line 322 of file BuilderUtils.cc.
References addBox(), AlCaHLTBitMon_QueryRunRegistry::comp, energyTower3DCorners(), and pfClustersFromCombinedCaloHF_cfi::scale.
void fireworks::drawEtScaledBox3D | ( | const float * | corners, |
float | energy, | ||
float | maxEnergy, | ||
TEveElement * | comp, | ||
FWProxyBuilderBase * | pb, | ||
bool | reflect = false |
||
) |
Definition at line 279 of file BuilderUtils.cc.
References addBox(), AlCaHLTBitMon_QueryRunRegistry::comp, hcalRecHitTable_cff::energy, etScaledBox3DCorners(), l1tstage2_dqm_sourceclient-live_cfg::invert, and particleFlowClusterECALTimeSelected_cfi::maxEnergy.
void fireworks::drawEtTower3D | ( | const float * | corners, |
float | scale, | ||
TEveElement * | comp, | ||
FWProxyBuilderBase * | pb, | ||
bool | reflect = false |
||
) |
Definition at line 365 of file BuilderUtils.cc.
References addBox(), AlCaHLTBitMon_QueryRunRegistry::comp, etTower3DCorners(), and pfClustersFromCombinedCaloHF_cfi::scale.
void fireworks::energyScaledBox3DCorners | ( | const float * | corners, |
float | scale, | ||
std::vector< float > & | scaledCorners, | ||
bool | invert = false |
||
) |
Definition at line 222 of file BuilderUtils.cc.
References f, mps_fire::i, l1tstage2_dqm_sourceclient-live_cfg::invert, invertBox(), and pfClustersFromCombinedCaloHF_cfi::scale.
Referenced by drawEnergyScaledBox3D().
void fireworks::energyTower3DCorners | ( | const float * | corners, |
float | scale, | ||
std::vector< float > & | scaledCorners, | ||
bool | reflect = false |
||
) |
Definition at line 287 of file BuilderUtils.cc.
References change_name::diff, mps_fire::i, and pfClustersFromCombinedCaloHF_cfi::scale.
Referenced by FWPRCaloTowerProxyBuilder::build(), FWPCaloHitProxyBuilder::build(), FWCaloClusterProxyBuilder::build(), and drawEnergyTower3D().
void fireworks::etScaledBox3DCorners | ( | const float * | corners, |
float | energy, | ||
float | maxEnergy, | ||
std::vector< float > & | scaledCorners, | ||
bool | reflect = false |
||
) |
Definition at line 252 of file BuilderUtils.cc.
References HltBtagPostValidation_cff::c, hcalRecHitTable_cff::energy, f, mps_fire::i, l1tstage2_dqm_sourceclient-live_cfg::invert, invertBox(), particleFlowClusterECALTimeSelected_cfi::maxEnergy, pfClustersFromCombinedCaloHF_cfi::scale, and funct::sin().
Referenced by drawEtScaledBox3D().
void fireworks::etTower3DCorners | ( | const float * | corners, |
float | scale, | ||
std::vector< float > & | scaledCorners, | ||
bool | reflect = false |
||
) |
Definition at line 330 of file BuilderUtils.cc.
References change_name::diff, mps_fire::i, pfClustersFromCombinedCaloHF_cfi::scale, and funct::sin().
Referenced by drawEtTower3D().
const SiStripCluster * fireworks::extractClusterFromTrackingRecHit | ( | const TrackingRecHit * | rh | ) |
Definition at line 318 of file TrackUtils.cc.
References fwLog, and fwlog::kDebug.
Referenced by addSiStripClusters(), and FWTrajectorySeedProxyBuilder::build().
void fireworks::GetColorValuesForPaletteExtra | ( | float(*) | iColors[3], |
unsigned int | iSize, | ||
FWColorManager::EPalette | id, | ||
bool | isWhiteBg | ||
) |
Definition at line 135 of file fwPaletteExtra.cc.
References b, f, g, mps_fire::i, FWColorManager::kArctic, FWColorManager::kFall, FWColorManager::kPurple, FWColorManager::kSpring, METSkim_cff::Min, AlCaHLTBitMon_ParallelJobs::p, and alignCSCRings::s.
Referenced by FWColorManager::initColorTable().
void fireworks::getDecomposedVersion | ( | const TString & | s, |
int * | out | ||
) |
Definition at line 26 of file fwPaths.cc.
References MillePedeFileConverter_cfg::out, and alignCSCRings::s.
Referenced by acceptDataFormatsVersion(), FWFileEntry::openFile(), and supportedDataFormatsVersion().
std::string fireworks::getLocalTime | ( | const edm::EventBase & | event | ) |
Definition at line 119 of file BuilderUtils.cc.
References AlCaHLTBitMon_QueryRunRegistry::string, submitPVValidationJobs::t, submitPVValidationJobs::text, and geometryCSVtoXML::xx.
Referenced by CmsShowMainFrame::loadEvent(), and FWEventAnnotation::updateOverlayText().
std::pair< double, double > fireworks::getPhiRange | ( | const std::vector< double > & | phis, |
double | phi | ||
) |
Definition at line 21 of file BuilderUtils.cc.
References mps_fire::i, M_PI, SiStripPI::max, and SiStripPI::min.
Referenced by FWTauProxyBuilderBase::buildBaseTau(), and makeRhoPhiSuperCluster().
TEveGeoShape * fireworks::getShape | ( | const char * | name, |
TGeoBBox * | shape, | ||
Color_t | color | ||
) |
Definition at line 44 of file BuilderUtils.cc.
References HltBtagPostValidation_cff::c, Skims_PA_cff::name, and l1trig_cff::shape.
Referenced by FWTauProxyBuilderBase::buildBaseTau(), FWMETProxyBuilder::buildViewType(), FWGlimpseView::FWGlimpseView(), and makeRhoPhiSuperCluster().
std::string fireworks::getTimeGMT | ( | const edm::EventBase & | event | ) |
Definition at line 109 of file BuilderUtils.cc.
References AlCaHLTBitMon_QueryRunRegistry::string, submitPVValidationJobs::t, and submitPVValidationJobs::text.
const TGGC & fireworks::greenGC | ( | ) |
Definition at line 37 of file GlobalContexts.cc.
std::string fireworks::info | ( | const DetId & | id | ) |
Definition at line 599 of file TrackUtils.cc.
References DetId::Calo, MuonSubdetId::CSC, hcalRecHitTable_cff::detId, MuonSubdetId::DT, DetId::Ecal, EcalBarrel, EcalEndcap, EcalLaserPnDiode, EcalPreshower, EcalTriggerTower, MuonSubdetId::GEM, fireworks::Context::getGeom(), fireworks::Context::getInstance(), FWGeometry::getTrackerTopology(), DetId::Hcal, HcalBarrel, HcalEmpty, HcalEndcap, HcalForward, HcalOther, HcalOuter, HcalTriggerTower, MuonSubdetId::ME0, DetId::Muon, TrackerTopology::print(), nano_mu_digi_cff::rawId, MuonSubdetId::RPC, and DetId::Tracker.
Referenced by FWConvTrackHitsDetailView::addModules(), FWTrackHitsDetailView::addModules(), FWTracksModulesProxyBuilder::build(), and info().
std::string fireworks::info | ( | const std::set< DetId > & | idSet | ) |
Definition at line 716 of file TrackUtils.cc.
References l1ctLayer2EG_cff::id, info(), AlCaHLTBitMon_QueryRunRegistry::string, and submitPVValidationJobs::text.
std::string fireworks::info | ( | const std::vector< DetId > & | idSet | ) |
Definition at line 725 of file TrackUtils.cc.
References l1ctLayer2EG_cff::id, info(), AlCaHLTBitMon_QueryRunRegistry::string, and submitPVValidationJobs::text.
void fireworks::invertBox | ( | std::vector< float > & | corners | ) |
Definition at line 134 of file BuilderUtils.cc.
References edm::swap().
Referenced by energyScaledBox3DCorners(), etScaledBox3DCorners(), and FWCaloRecHitDigitSetProxyBuilder::viewContextBoxScale().
const TGGC & fireworks::italicGC | ( | ) |
Definition at line 49 of file GlobalContexts.cc.
References submitPVResolutionJobs::pool.
Referenced by FWPSetTableManager::cellRenderer().
void fireworks::localSiStrip | ( | short | strip, |
float * | localTop, | ||
float * | localBottom, | ||
const float * | pars, | ||
unsigned int | id | ||
) |
Definition at line 263 of file TrackUtils.cc.
References dumpMFGeometry_cfg::delta, fwLog, fwlog::kError, hltrates_dqm_sourceclient-live_cfg::offset, nano_mu_digi_cff::strip, funct::tan(), and HLT_2024v10_cff::topology.
Referenced by addSiStripClusters(), FWSiStripClusterProxyBuilder::build(), FWSiStripDigiProxyBuilder::build(), and FWTrajectorySeedProxyBuilder::build().
TEveJetCone * fireworks::makeEveJetCone | ( | const reco::Jet & | iData, |
const fireworks::Context & | context | ||
) |
Definition at line 6 of file makeEveJetCone.cc.
References HltBtagPostValidation_cff::c, visDQMUpload::context, reco::LeafCandidate::eta(), reco::Jet::etaetaMoment(), reco::Jet::getJetConstituents(), metsig::jet, reco::LeafCandidate::phi(), reco::Jet::phiphiMoment(), mathSSE::sqrt(), funct::tan(), and reco::LeafCandidate::vertex().
Referenced by FWTauProxyBuilderBase::buildBaseTau(), and FWJetProxyBuilder::requestCommon().
bool fireworks::makeRhoPhiSuperCluster | ( | FWProxyBuilderBase * | pb, |
const reco::SuperClusterRef & | iCluster, | ||
float | iPhi, | ||
TEveElement & | oItemHolder | ||
) |
Definition at line 29 of file makeSuperCluster.cc.
References fireworks::Context::caloR1(), FWDisplayProperties::color(), FWProxyBuilderBase::context(), FWEventItem::defaultDisplayProperties(), FWGeometry::getCorners(), fireworks::Context::getGeom(), getPhiRange(), getShape(), mps_fire::i, l1ctLayer2EG_cff::id, edm::Ref< C, T, F >::isAvailable(), FWProxyBuilderBase::item(), M_PI, VtxSmearedParameters_cfi::Phi, FWProxyBuilderBase::setupAddElement(), and trackerHitRTTI::vector.
Referenced by FWPhotonProxyBuilder::buildViewType(), and FWElectronProxyBuilder::buildViewType().
bool fireworks::makeRhoZSuperCluster | ( | FWProxyBuilderBase * | pb, |
const reco::SuperClusterRef & | iCluster, | ||
float | iPhi, | ||
TEveElement & | oItemHolder | ||
) |
Definition at line 69 of file makeSuperCluster.cc.
References addRhoZEnergyProjection(), Reference_intrackfit_cff::barrel, fireworks::Context::caloR1(), fireworks::Context::caloR2(), fireworks::Context::caloTransAngle(), fireworks::Context::caloZ1(), fireworks::Context::caloZ2(), visDQMUpload::context, FWProxyBuilderBase::context(), FWGeometry::getCorners(), fireworks::Context::getGeom(), mps_fire::i, l1ctLayer2EG_cff::id, edm::Ref< C, T, F >::isAvailable(), Pi, theta(), and trackerHitRTTI::vector.
Referenced by FWPhotonProxyBuilder::buildViewType(), and FWElectronProxyBuilder::buildViewType().
float fireworks::phase2PixelLocalX | ( | const double | mpx, |
const float * | par, | ||
const float * | shape | ||
) |
Definition at line 249 of file TrackUtils.cc.
References l1trig_cff::shape.
Referenced by FWPhase2TrackerCluster1DProxyBuilder::build().
float fireworks::phase2PixelLocalY | ( | const double | mpy, |
const float * | par, | ||
const float * | shape | ||
) |
float fireworks::pixelLocalX | ( | const double | mpx, |
const float * | par | ||
) |
Definition at line 159 of file TrackUtils.cc.
References fireworks::Context::getInstance(), createfilelist::int, MICRON, and EcalSCDynamicDPhiParametersESProducer_cfi::xoffset.
Referenced by FWSiPixelDigiProxyBuilder::build(), FWSiPixelClusterProxyBuilder::build(), FWTrajectorySeedProxyBuilder::build(), pushPixelCluster(), and ValidateGeometry::validatePixelTopology().
float fireworks::pixelLocalY | ( | const double | mpy, |
const float * | par | ||
) |
Definition at line 209 of file TrackUtils.cc.
References ALPAKA_ACCELERATOR_NAMESPACE::brokenline::constexpr(), fireworks::Context::getInstance(), createfilelist::int, dqmiolumiharvest::j, pfDeepBoostedJetPreprocessParams_cfi::lower_bound, MICRON, and EcalSCDynamicDPhiParametersESProducer_cfi::yoffset.
Referenced by FWSiPixelDigiProxyBuilder::build(), FWSiPixelClusterProxyBuilder::build(), FWTrajectorySeedProxyBuilder::build(), pushPixelCluster(), and ValidateGeometry::validatePixelTopology().
TEveTrack * fireworks::prepareCandidate | ( | const reco::Candidate & | track, |
TEveTrackPropagator * | propagator | ||
) |
Definition at line 9 of file CandidateUtils.cc.
References TrackCandidateProducer_cfi::propagator, submitPVValidationJobs::t, and HLT_2024v10_cff::track.
Referenced by FWElectronLegoProxyBuilder::build(), FWCandidatePtrProxyBuilder::build(), FWSecVertexCandidateProxyBuilder::build(), FWGenParticleProxyBuilder::build(), FWCandidateProxyBuilder::build(), FWVertexCandidateProxyBuilder::build(), FWMuonBuilder::buildMuon(), and FWElectronProxyBuilder::requestCommon().
TEveTrack * fireworks::prepareTrack | ( | const reco::Track & | track, |
TEveTrackPropagator * | propagator, | ||
const std::vector< TEveVector > & | extraRefPoints = std::vector<TEveVector>() |
||
) |
Definition at line 62 of file TrackUtils.cc.
References cms::cuda::assert(), f, mps_fire::i, dqmiolumiharvest::j, AlCaHLTBitMon_ParallelJobs::p, point, position, TrackCandidateProducer_cfi::propagator, jetUpdater_cfi::sort, submitPVValidationJobs::t, HLT_2024v10_cff::track, reco::btau::trackMomentum, findQualityFiles::v, and validateGeometry_cfg::valid.
Referenced by FWTauProxyBuilderBase::addConstituentTracks(), FWTauProxyBuilderBase::addLeadTrack(), DummyEvelyser::analyze(), FWElectronLegoProxyBuilder::build(), FWTrackProxyBuilder::build(), FWTrackHitsDetailView::build(), FWConvTrackHitsDetailView::build(), FWMuonBuilder::buildMuon(), and FWElectronProxyBuilder::requestCommon().
void fireworks::pushNearbyPixelHits | ( | std::vector< TVector3 > & | pixelPoints, |
const FWEventItem & | iItem, | ||
const reco::Track & | t | ||
) |
Definition at line 480 of file TrackUtils.cc.
References edmNew::DetSet< T >::begin(), edmNew::DetSet< T >::end(), edmNew::DetSetVector< T >::end(), edmNew::DetSetVector< T >::find(), fwLog, relativeConstraints::geom, edm::EventBase::get(), FWEventItem::getEvent(), FWEventItem::getGeom(), hit::id, createfilelist::int, ALPAKA_ACCELERATOR_NAMESPACE::vertexFinder::it, fwlog::kError, muonClassificationByHits_cfi::pixel, PixelSubdetector::PixelBarrel, PixelSubdetector::PixelEndcap, edm::Handle< T >::product(), pushPixelCluster(), nano_mu_digi_cff::rawId, and submitPVValidationJobs::t.
Referenced by FWConvTrackHitsDetailView::addHits(), and FWTrackHitsDetailView::addHits().
void fireworks::pushPixelCluster | ( | std::vector< TVector3 > & | pixelPoints, |
const FWGeometry & | geom, | ||
DetId | id, | ||
const SiPixelCluster & | c, | ||
const float * | pars | ||
) |
Definition at line 570 of file TrackUtils.cc.
References HltBtagPostValidation_cff::c, cuy::col, fwLog, relativeConstraints::geom, fwlog::kDebug, DTRecHitClients_cfi::local, pixelLocalX(), and pixelLocalY().
Referenced by pushNearbyPixelHits(), and pushPixelHits().
void fireworks::pushPixelHits | ( | std::vector< TVector3 > & | pixelPoints, |
const FWEventItem & | iItem, | ||
const reco::Track & | t | ||
) |
Definition at line 533 of file TrackUtils.cc.
References HltBtagPostValidation_cff::c, PVValHelper::dz, fwLog, relativeConstraints::geom, FWEventItem::getGeom(), createfilelist::int, ALPAKA_ACCELERATOR_NAMESPACE::vertexFinder::it, fwlog::kDebug, fwlog::kError, muonClassificationByHits_cfi::pixel, PixelSubdetector::PixelBarrel, PixelSubdetector::PixelEndcap, pushPixelCluster(), subdets, submitPVValidationJobs::t, and run3scouting_cff::vz.
Referenced by FWConvTrackHitsDetailView::addHits(), FWTrackHitsDetailView::addHits(), and FWTracksRecHitsProxyBuilder::build().
const TGGC & fireworks::redGC | ( | ) |
Definition at line 43 of file GlobalContexts.cc.
void fireworks::setPath | ( | TString & | v | ) |
Definition at line 15 of file fwPaths.cc.
References fwLog, fwlog::kError, p1, p2, and findQualityFiles::v.
Referenced by CmsShowHelpPopup::CmsShowHelpPopup(), main(), CmsShowMainBase::sendVersionInfo(), and CmsShowMainFrame::showFWorksInfo().
void fireworks::setTrackTypePF | ( | const reco::PFCandidate & | pfCand, |
TAttLine * | track | ||
) |
void fireworks::setupAddElement | ( | TEveElement * | el, |
TEveElement * | parent, | ||
const FWEventItem * | item, | ||
bool | master, | ||
bool | color | ||
) |
Definition at line 299 of file TrackUtils.cc.
References cms::cuda::assert(), B2GTnPMonitor_cfi::item, volumeBasedMagneticField_160812_cfi::master, and class-composition::parent.
Referenced by addSiStripClusters(), and FWDTRecHitProxyBuilder::buildViewType().
int * fireworks::supportedDataFormatsVersion | ( | ) |
Definition at line 35 of file fwPaths.cc.
References compareTotals::fs, getDecomposedVersion(), and findQualityFiles::v.
Referenced by acceptDataFormatsVersion(), CmsShowSearchFiles::CmsShowSearchFiles(), FWFileEntry::openFile(), and CmsShowSearchFiles::readInfo().
std::vector< std::pair< double, double > > fireworks::thetaBins | ( | ) |
Definition at line 46 of file thetaBins.cc.
References JetChargeProducer_cfi::exp, mps_fire::i, fw3dlego::xbins, and fw3dlego::xbins_n.
|
static |
Definition at line 57 of file TrackUtils.cc.
Referenced by pixelLocalX(), and pixelLocalY().
const TString fireworks::p1 = gSystem->Getenv("CMSSW_BASE") + datadir |
Definition at line 12 of file fwPaths.cc.
Referenced by setPath().
const TString fireworks::p2 = gSystem->Getenv("CMSSW_RELEASE_BASE") + datadir |
Definition at line 13 of file fwPaths.cc.
Referenced by setPath().
|
static |
Definition at line 60 of file TrackUtils.cc.
Referenced by MixCollectionValidation::bookHistograms(), edm::CFWriter::CFWriter(), DMRChecker::endJob(), HcalDetIdTableProducer::globalBeginRunProduce(), HcalHitFilter< HcalForward >::HcalHitFilter(), edm::MixingModule::MixingModule(), pushPixelHits(), and HcalFrontEndId::rbx().