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 | 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 float | s_forBlack [][3] |
static const float | s_forWhite [][3] |
static const unsigned int | s_size = sizeof(s_forBlack)/sizeof(s_forBlack[0]) |
static const std::string | subdets [7] = { "UNKNOWN", "PXB", "PXF", "TIB", "TID", "TOB", "TEC" } |
bool fireworks::acceptDataFormatsVersion | ( | TString & | n | ) |
Definition at line 71 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 148 of file BuilderUtils.cc.
References 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 158 of file BuilderUtils.cc.
References funct::cos(), M_PI, FWProxyBuilderBase::setupAddElement(), and funct::sin().
Referenced by FWJetLegoProxyBuilder::build(), FWL1MuonParticleLegoProxyBuilder::build(), FWL1JetParticleLegoProxyBuilder::build(), FWPFTauProxyBuilder::buildViewType(), and FWCaloTauProxyBuilder::buildViewType().
void fireworks::addDashedArrow | ( | double | phi, |
double | size, | ||
TEveElement * | comp, | ||
FWProxyBuilderBase * | pb | ||
) |
Definition at line 174 of file BuilderUtils.cc.
References funct::cos(), create_public_lumi_plots::marker, FWProxyBuilderBase::setupAddElement(), and funct::sin().
Referenced by FWL1EtMissParticleGlimpseProxyBuilder::build(), and FWMETGlimpseProxyBuilder::build().
void fireworks::addDashedLine | ( | double | phi, |
double | theta, | ||
double | size, | ||
TEveElement * | comp, | ||
FWProxyBuilderBase * | pb | ||
) |
Definition at line 185 of file BuilderUtils.cc.
References fireworks::Context::caloR1(), fireworks::Context::caloZ2(), FWProxyBuilderBase::context(), funct::cos(), M_PI, create_public_lumi_plots::marker, alignCSCRings::r, FWProxyBuilderBase::setupAddElement(), and funct::sin().
Referenced by FWL1EmParticleProxyBuilder::build(), FWL1MuonParticleProxyBuilder::build(), FWL1JetParticleProxyBuilder::build(), and FWL1EtMissParticleProxyBuilder::build().
void fireworks::addDoubleLines | ( | double | phi, |
TEveElement * | comp, | ||
FWProxyBuilderBase * | pb | ||
) |
Definition at line 201 of file BuilderUtils.cc.
References M_PI, and FWProxyBuilderBase::setupAddElement().
Referenced by FWL1EtMissParticleLegoProxyBuilder::build(), and FWMETLegoProxyBuilder::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 60 of file BuilderUtils.cc.
References diffTwoXMLs::r1, diffTwoXMLs::r2, FWProxyBuilderBase::setupAddElement(), lumiQTWidget::t, and funct::tan().
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 352 of file TrackUtils.cc.
References edmNew::DetSet< T >::begin(), SiStripRecHit1D::cluster(), SiStripRecHit2D::cluster(), FWGeometry::contains(), 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(), FWGeometry::getParameters(), edm::Ref< C, T, F >::id(), edm::Ref< C, T, F >::isAvailable(), edm::Ref< C, T, F >::isNonnull(), TrackingRecHit::isValid(), fwlog::kDebug, fwlog::kError, localSiStrip(), FWGeometry::localToGlobal(), edm::Handle< T >::product(), DetId::rawId(), reco::Track::recHitsBegin(), reco::Track::recHitsEnd(), and setupAddElement().
Referenced by FWTrackHitsDetailView::addHits(), FWConvTrackHitsDetailView::addHits(), FWTracksRecHitsProxyBuilder::build(), and fireworks::StateOrdering::operator()().
void fireworks::addStraightLineSegment | ( | TEveStraightLineSet * | marker, |
reco::Candidate const * | cand, | ||
double | scale_factor = 2 |
||
) |
Definition at line 23 of file CandidateUtils.cc.
References funct::cos(), reco::Candidate::phi(), reco::Candidate::pt(), funct::sin(), findQualityFiles::size, reco::Candidate::theta(), and theta().
Referenced by FWMuonGlimpseProxyBuilder::build(), and FWElectronGlimpseProxyBuilder::build().
const TGGC & fireworks::boldGC | ( | ) |
Definition at line 12 of file GlobalContexts.cc.
References edmIntegrityCheck::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 10 of file SegmentUtils.cc.
References funct::cos(), MuonSubdetId::CSC, 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 241 of file BuilderUtils.cc.
References addBox(), and energyScaledBox3DCorners().
void fireworks::drawEnergyTower3D | ( | const float * | corners, |
float | scale, | ||
TEveElement * | comp, | ||
FWProxyBuilderBase * | pb, | ||
bool | reflect = false |
||
) |
Definition at line 325 of file BuilderUtils.cc.
References addBox(), and energyTower3DCorners().
void fireworks::drawEtScaledBox3D | ( | const float * | corners, |
float | energy, | ||
float | maxEnergy, | ||
TEveElement * | comp, | ||
FWProxyBuilderBase * | pb, | ||
bool | reflect = false |
||
) |
Definition at line 278 of file BuilderUtils.cc.
References addBox(), and etScaledBox3DCorners().
void fireworks::drawEtTower3D | ( | const float * | corners, |
float | scale, | ||
TEveElement * | comp, | ||
FWProxyBuilderBase * | pb, | ||
bool | reflect = false |
||
) |
Definition at line 374 of file BuilderUtils.cc.
References addBox(), and etTower3DCorners().
void fireworks::energyScaledBox3DCorners | ( | const float * | corners, |
float | scale, | ||
std::vector< float > & | scaledCorners, | ||
bool | invert = false |
||
) |
Definition at line 215 of file BuilderUtils.cc.
References f, mps_fire::i, and invertBox().
Referenced by drawEnergyScaledBox3D().
void fireworks::energyTower3DCorners | ( | const float * | corners, |
float | scale, | ||
std::vector< float > & | scaledCorners, | ||
bool | reflect = false |
||
) |
Definition at line 286 of file BuilderUtils.cc.
References diffTreeTool::diff, mps_fire::i, and Scenarios_cff::scale.
Referenced by FWPRCaloTowerProxyBuilder::build(), FWCaloClusterProxyBuilder::build(), FWPCaloHitProxyBuilder::build(), and drawEnergyTower3D().
void fireworks::etScaledBox3DCorners | ( | const float * | corners, |
float | energy, | ||
float | maxEnergy, | ||
std::vector< float > & | scaledCorners, | ||
bool | reflect = false |
||
) |
Definition at line 249 of file BuilderUtils.cc.
References EnergyCorrector::c, f, mps_fire::i, invertBox(), Scenarios_cff::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 334 of file BuilderUtils.cc.
References diffTreeTool::diff, mps_fire::i, and funct::sin().
Referenced by drawEtTower3D().
const SiStripCluster * fireworks::extractClusterFromTrackingRecHit | ( | const TrackingRecHit * | rh | ) |
Definition at line 329 of file TrackUtils.cc.
References fwLog, and fwlog::kDebug.
Referenced by addSiStripClusters(), FWTrajectorySeedProxyBuilder::build(), and fireworks::StateOrdering::operator()().
void fireworks::GetColorValuesForPaletteExtra | ( | float(*) | iColors[3], |
unsigned int | iSize, | ||
FWColorManager::EPalette | id, | ||
bool | isWhiteBg | ||
) |
Definition at line 152 of file fwPaletteExtra.cc.
References b, f, g, mps_fire::i, fireworks::PaletteExtraTopBottomIndices::InitArctic(), fireworks::PaletteExtraTopBottomIndices::InitFall(), fireworks::PaletteExtraTopBottomIndices::InitPurple(), fireworks::PaletteExtraTopBottomIndices::InitSpring(), FWColorManager::kArctic, FWColorManager::kFall, FWColorManager::kPurple, FWColorManager::kSpring, Min(), AlCaHLTBitMon_ParallelJobs::p, alignCSCRings::r, and alignCSCRings::s.
Referenced by FWColorManager::initColorTable().
void fireworks::getDecomposedVersion | ( | const TString & | s, |
int * | out | ||
) |
Definition at line 30 of file fwPaths.cc.
Referenced by acceptDataFormatsVersion(), FWFileEntry::openFile(), and supportedDataFormatsVersion().
std::string fireworks::getLocalTime | ( | const edm::EventBase & | event | ) |
Definition at line 113 of file BuilderUtils.cc.
References AlCaHLTBitMon_QueryRunRegistry::string, lumiQTWidget::t, RecoTauValidation_cfi::text, edm::EventBase::time(), edm::Timestamp::value(), 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 min().
Referenced by FWTauProxyBuilderBase::buildBaseTau(), and makeRhoPhiSuperCluster().
TEveGeoShape * fireworks::getShape | ( | const char * | name, |
TGeoBBox * | shape, | ||
Color_t | color | ||
) |
Definition at line 42 of file BuilderUtils.cc.
References EnergyCorrector::c.
Referenced by FWTauProxyBuilderBase::buildBaseTau(), FWMETProxyBuilder::buildViewType(), FWGlimpseView::FWGlimpseView(), HcalPulseShapes::hoShape(), and makeRhoPhiSuperCluster().
std::string fireworks::getTimeGMT | ( | const edm::EventBase & | event | ) |
Definition at line 103 of file BuilderUtils.cc.
References AlCaHLTBitMon_QueryRunRegistry::string, lumiQTWidget::t, RecoTauValidation_cfi::text, edm::EventBase::time(), and edm::Timestamp::value().
const TGGC & fireworks::greenGC | ( | ) |
Definition at line 39 of file GlobalContexts.cc.
std::string fireworks::info | ( | const DetId & | id | ) |
Definition at line 659 of file TrackUtils.cc.
References DetId::Calo, ME0DetId::chamber(), CSCDetId::chamber(), GEMDetId::chamber(), MuonSubdetId::CSC, HcalDetId::depth(), MuonSubdetId::DT, DetId::Ecal, EcalBarrel, EcalEndcap, EcalLaserPnDiode, EcalPreshower, EcalTriggerTower, CSCDetId::endcap(), MuonSubdetId::GEM, fireworks::Context::getGeom(), fireworks::Context::getInstance(), FWGeometry::getTrackerTopology(), DetId::Hcal, HcalBarrel, HcalEmpty, HcalEndcap, HcalForward, HcalOther, HcalOuter, HcalTriggerTower, EEDetId::ic(), CaloTowerDetId::ieta(), EBDetId::ieta(), HcalDetId::ieta(), CaloTowerDetId::iphi(), EBDetId::iphi(), HcalDetId::iphi(), EEDetId::iquadrant(), EEDetId::isc(), EEDetId::ix(), EEDetId::iy(), ME0DetId::layer(), CSCDetId::layer(), GEMDetId::layer(), RPCDetId::layer(), MuonSubdetId::ME0, DetId::Muon, TrackerTopology::print(), ME0DetId::region(), GEMDetId::region(), RPCDetId::region(), GEMDetId::ring(), RPCDetId::ring(), CSCDetId::ring(), RPCDetId::roll(), MuonSubdetId::RPC, DTChamberId::sector(), RPCDetId::sector(), DTChamberId::station(), GEMDetId::station(), CSCDetId::station(), RPCDetId::station(), AlCaHLTBitMon_QueryRunRegistry::string, HcalDetId::subdet(), RPCDetId::subsector(), EBDetId::tower_ieta(), EBDetId::tower_iphi(), DetId::Tracker, and DTChamberId::wheel().
Referenced by FWTrackHitsDetailView::addModules(), FWConvTrackHitsDetailView::addModules(), FWTracksModulesProxyBuilder::build(), and info().
std::string fireworks::info | ( | const std::set< DetId > & | idSet | ) |
Definition at line 832 of file TrackUtils.cc.
References triggerObjects_cff::id, info(), AlCaHLTBitMon_QueryRunRegistry::string, and RecoTauValidation_cfi::text.
std::string fireworks::info | ( | const std::vector< DetId > & | idSet | ) |
Definition at line 843 of file TrackUtils.cc.
References triggerObjects_cff::id, info(), AlCaHLTBitMon_QueryRunRegistry::string, and RecoTauValidation_cfi::text.
void fireworks::invertBox | ( | std::vector< float > & | corners | ) |
Definition at line 129 of file BuilderUtils.cc.
References std::swap().
Referenced by energyScaledBox3DCorners(), etScaledBox3DCorners(), and FWCaloRecHitDigitSetProxyBuilder::viewContextBoxScale().
const TGGC & fireworks::italicGC | ( | ) |
Definition at line 53 of file GlobalContexts.cc.
References edmIntegrityCheck::pool.
Referenced by FWPSetTableManager::cellRenderer().
void fireworks::localSiStrip | ( | short | strip, |
float * | localTop, | ||
float * | localBottom, | ||
const float * | pars, | ||
unsigned int | id | ||
) |
Definition at line 262 of file TrackUtils.cc.
References delta, fwLog, fwlog::kError, PFRecoTauDiscriminationByIsolation_cfi::offset, funct::tan(), and ecaldqm::topology().
Referenced by addSiStripClusters(), FWSiStripClusterProxyBuilder::build(), FWSiStripDigiProxyBuilder::build(), FWTrajectorySeedProxyBuilder::build(), and fireworks::StateOrdering::operator()().
TEveJetCone * fireworks::makeEveJetCone | ( | const reco::Jet & | iData, |
const fireworks::Context & | context | ||
) |
Definition at line 7 of file makeEveJetCone.cc.
References EnergyCorrector::c, fireworks::Context::caloMaxEta(), fireworks::Context::caloR1(), fireworks::Context::caloR2(), fireworks::Context::caloTransAngle(), fireworks::Context::caloZ1(), fireworks::Context::caloZ2(), 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 28 of file makeSuperCluster.cc.
References fireworks::Context::caloR1(), FWDisplayProperties::color(), FWProxyBuilderBase::context(), FWEventItem::defaultDisplayProperties(), end, FWGeometry::getCorners(), fireworks::Context::getGeom(), getPhiRange(), getShape(), mps_fire::i, triggerObjects_cff::id, edm::Ref< C, T, F >::isAvailable(), FWProxyBuilderBase::item(), M_PI, colinearityKinematic::Phi, alignCSCRings::r, SimDataFormats::CaloAnalysis::sc, and FWProxyBuilderBase::setupAddElement().
Referenced by FWPhotonProxyBuilder::buildViewType(), and FWElectronProxyBuilder::buildViewType().
bool fireworks::makeRhoZSuperCluster | ( | FWProxyBuilderBase * | pb, |
const reco::SuperClusterRef & | iCluster, | ||
float | iPhi, | ||
TEveElement & | oItemHolder | ||
) |
Definition at line 67 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(), FWProxyBuilderBase::context(), end, FWGeometry::getCorners(), fireworks::Context::getGeom(), mps_fire::i, triggerObjects_cff::id, edm::Ref< C, T, F >::isAvailable(), Pi, and theta().
Referenced by FWPhotonProxyBuilder::buildViewType(), and FWElectronProxyBuilder::buildViewType().
float fireworks::pixelLocalX | ( | const double | mpx, |
const float * | par | ||
) |
Definition at line 160 of file TrackUtils.cc.
References fireworks::Context::getInstance(), createfilelist::int, and MICRON.
Referenced by FWSiPixelDigiProxyBuilder::build(), FWSiPixelClusterProxyBuilder::build(), FWTrajectorySeedProxyBuilder::build(), fireworks::StateOrdering::operator()(), pushPixelCluster(), and ValidateGeometry::validatePixelTopology().
float fireworks::pixelLocalY | ( | const double | mpy, |
const float * | par | ||
) |
Definition at line 216 of file TrackUtils.cc.
References begin, constexpr, end, fireworks::Context::getInstance(), createfilelist::int, and MICRON.
Referenced by FWSiPixelDigiProxyBuilder::build(), FWSiPixelClusterProxyBuilder::build(), FWTrajectorySeedProxyBuilder::build(), fireworks::StateOrdering::operator()(), pushPixelCluster(), and ValidateGeometry::validatePixelTopology().
TEveTrack * fireworks::prepareCandidate | ( | const reco::Candidate & | track, |
TEveTrackPropagator * | propagator | ||
) |
Definition at line 10 of file CandidateUtils.cc.
References reco::Candidate::charge(), reco::Candidate::px(), reco::Candidate::py(), reco::Candidate::pz(), lumiQTWidget::t, and reco::Candidate::vertex().
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 63 of file TrackUtils.cc.
References reco::TrackBase::charge(), reco::Track::extra(), f, mps_fire::i, reco::Track::innerMomentum(), reco::Track::innerOk(), reco::Track::innerPosition(), edm::Ref< C, T, F >::isAvailable(), reco::Track::outerMomentum(), reco::Track::outerOk(), reco::Track::outerPosition(), AlCaHLTBitMon_ParallelJobs::p, point, position, reco::TrackBase::pt(), reco::TrackBase::px(), reco::TrackBase::py(), reco::TrackBase::pz(), lumiQTWidget::t, reco::btau::trackMomentum, findQualityFiles::v, reco::TrackBase::vx(), reco::TrackBase::vy(), and reco::TrackBase::vz().
Referenced by FWTauProxyBuilderBase::addConstituentTracks(), FWTauProxyBuilderBase::addLeadTrack(), DummyEvelyser::analyze(), FWElectronLegoProxyBuilder::build(), FWTrackProxyBuilder::build(), FWTrackHitsDetailView::build(), FWConvTrackHitsDetailView::build(), FWMuonBuilder::buildMuon(), fireworks::StateOrdering::operator()(), and FWElectronProxyBuilder::requestCommon().
void fireworks::pushNearbyPixelHits | ( | std::vector< TVector3 > & | pixelPoints, |
const FWEventItem & | iItem, | ||
const reco::Track & | t | ||
) |
Definition at line 519 of file TrackUtils.cc.
References edmNew::DetSet< T >::begin(), SiPixelRecHit::cluster(), FWGeometry::contains(), edmNew::DetSet< T >::end(), edmNew::DetSetVector< T >::end(), edmNew::DetSetVector< T >::find(), fwLog, relativeConstraints::geom, edm::EventBase::get(), FWEventItem::getEvent(), FWEventItem::getGeom(), FWGeometry::getParameters(), edm::Ref< C, T, F >::id(), createfilelist::int, edm::Ref< C, T, F >::isAvailable(), edm::Ref< C, T, F >::isNonnull(), fwlog::kError, digitizers_cfi::pixel, PixelSubdetector::PixelBarrel, PixelSubdetector::PixelEndcap, edm::Handle< T >::product(), pushPixelCluster(), reco::Track::recHitsBegin(), and reco::Track::recHitsEnd().
Referenced by FWTrackHitsDetailView::addHits(), FWConvTrackHitsDetailView::addHits(), and fireworks::StateOrdering::operator()().
void fireworks::pushPixelCluster | ( | std::vector< TVector3 > & | pixelPoints, |
const FWGeometry & | geom, | ||
DetId | id, | ||
const SiPixelCluster & | c, | ||
const float * | pars | ||
) |
Definition at line 625 of file TrackUtils.cc.
References cuy::col, fwLog, fwlog::kDebug, DTRecHitClients_cfi::local, FWGeometry::localToGlobal(), SiPixelCluster::minPixelCol(), SiPixelCluster::minPixelRow(), pixelLocalX(), pixelLocalY(), and AlCaHLTBitMon_QueryRunRegistry::string.
Referenced by fireworks::StateOrdering::operator()(), pushNearbyPixelHits(), and pushPixelHits().
void fireworks::pushPixelHits | ( | std::vector< TVector3 > & | pixelPoints, |
const FWEventItem & | iItem, | ||
const reco::Track & | t | ||
) |
Definition at line 578 of file TrackUtils.cc.
References EnergyCorrector::c, FWGeometry::contains(), PVValHelper::dz, reco::TrackBase::dz(), reco::TrackBase::eta(), fwLog, relativeConstraints::geom, FWEventItem::getGeom(), FWGeometry::getParameters(), createfilelist::int, fwlog::kDebug, fwlog::kError, digitizers_cfi::pixel, PixelSubdetector::PixelBarrel, PixelSubdetector::PixelEndcap, pushPixelCluster(), reco::Track::recHitsBegin(), reco::Track::recHitsEnd(), and reco::TrackBase::vz().
Referenced by FWTrackHitsDetailView::addHits(), FWConvTrackHitsDetailView::addHits(), FWTracksRecHitsProxyBuilder::build(), and fireworks::StateOrdering::operator()().
const TGGC & fireworks::redGC | ( | ) |
Definition at line 46 of file GlobalContexts.cc.
void fireworks::setPath | ( | TString & | v | ) |
Definition at line 15 of file fwPaths.cc.
References fwLog, and fwlog::kError.
Referenced by CmsShowHelpPopup::CmsShowHelpPopup(), main(), CmsShowMainBase::sendVersionInfo(), and CmsShowMainFrame::showFWorksInfo().
void fireworks::setTrackTypePF | ( | const reco::PFCandidate & | pfCand, |
TAttLine * | track | ||
) |
Definition at line 17 of file setTrackTypePF.cc.
Referenced by FWPFCandidateWithHitsProxyBuilder::build(), FWPFPatJetLegoProxyBuilder< T >::build(), FWPFPatJet3DProxyBuilder< T >::build(), FWPFCandidate3DProxyBuilder::build(), and FWPFCandidatesLegoProxyBuilder::build().
void fireworks::setupAddElement | ( | TEveElement * | el, |
TEveElement * | parent, | ||
const FWEventItem * | item, | ||
bool | master, | ||
bool | color | ||
) |
Definition at line 307 of file TrackUtils.cc.
References FWDisplayProperties::color(), FWEventItem::defaultDisplayProperties(), and FWDisplayProperties::transparency().
Referenced by addSiStripClusters(), FWDTRecHitProxyBuilder::buildViewType(), and FWProxyBuilderBase::getHaveWindow().
int * fireworks::supportedDataFormatsVersion | ( | ) |
Definition at line 43 of file fwPaths.cc.
References 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 48 of file thetaBins.cc.
References JetChargeProducer_cfi::exp, mps_fire::i, fw3dlego::xbins, and fw3dlego::xbins_n.
Referenced by FWCaloTauProxyBuilder::buildViewType().
|
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.
const TString fireworks::p2 = gSystem->Getenv("CMSSW_RELEASE_BASE") + datadir |
Definition at line 13 of file fwPaths.cc.
|
static |
Definition at line 42 of file fwPaletteClassic.cc.
Referenced by FWColorManager::initColorTable(), and FWColorManager::initialize().
|
static |
Definition at line 4 of file fwPaletteClassic.cc.
Referenced by FWColorManager::initColorTable().
|
static |
Definition at line 101 of file fwPaletteClassic.cc.
Referenced by FWColorManager::initColorTable(), and FWColorManager::initialize().
|
static |
Definition at line 60 of file TrackUtils.cc.
Referenced by MixCollectionValidation::bookHistograms(), edm::CFWriter::CFWriter(), HcalHitFilter< HcalForward >::HcalHitFilter(), edm::MixingModule::MixingModule(), and HcalFrontEndId::rbx().