ATLAS Offline Software
Classes | Public Types | Public Member Functions | Static Public Member Functions | Protected Member Functions | Private Types | Private Member Functions | Private Attributes | List of all members
CP::IsolationCloseByCorrectionTool Class Reference

#include <IsolationCloseByCorrectionTool.h>

Inheritance diagram for CP::IsolationCloseByCorrectionTool:
Collaboration diagram for CP::IsolationCloseByCorrectionTool:

Classes

struct  ObjectCache
 

Public Types

enum  TopoConeCorrectionModel { SubtractObjectsDirectly = -1, UseAveragedDecorators = 0 }
 
using caloDecorNames = std::array< std::string, 4 >
 
using IsoHelperMap = std::map< IsoType, std::unique_ptr< IsoVariableHelper > >
 
using PrimaryCollection = std::set< const xAOD::IParticle * >
 Helper struct to collect all relevant objects for the procedure. More...
 

Public Member Functions

 IsolationCloseByCorrectionTool (const std::string &name)
 
virtual StatusCode initialize () override
 Dummy implementation of the initialisation function. More...
 
virtual CorrectionCode getCloseByCorrection (std::vector< float > &corrections, const xAOD::IParticle &par, const std::vector< xAOD::Iso::IsolationType > &types, const xAOD::IParticleContainer &closePar) const override
 
virtual asg::AcceptData acceptCorrected (const xAOD::IParticle &x, const xAOD::IParticleContainer &closePar) const override
 
virtual CorrectionCode getCloseByIsoCorrection (const EventContext &ctx, const xAOD::ElectronContainer *Electrons, const xAOD::MuonContainer *Muons, const xAOD::PhotonContainer *Photons) const override
 
virtual float getOriginalIsolation (const xAOD::IParticle &P, IsoType type) const override
 
virtual float getOriginalIsolation (const xAOD::IParticle *particle, IsoType type) const override
 
TrackSet getTrackCandidates (const EventContext &ctx, const xAOD::IParticle *particle) const override
 Load all TrackParticles associated with the particles in the Container. The particles have to pass the selection decoration flag. More...
 
const xAOD::IParticleisoRefParticle (const xAOD::IParticle *particle) const override
 Retrieve the reference particle to define the cone axis in which the track particles contributing to the isolation have to be. More...
 
void associateCluster (const xAOD::IParticle *particle, float &eta, float &phi, float &energy) const override
 Retrieve the associated clusters from the Particle and calculate the average eta/phi/energy. More...
 
void associateFlowElement (const EventContext &ctx, const xAOD::IParticle *particle, float &eta, float &phi, float &energy) const override
 
void getExtrapEtaPhi (const xAOD::IParticle *particlear, float &eta, float &phi) const
 
void loadPrimaryParticles (const xAOD::IParticleContainer *container, ObjectCache &cache) const
 Filter all electrons/muons/photons from the collection which pass the selection decoration. More...
 
void loadAssociatedObjects (const EventContext &ctx, ObjectCache &cache) const
 Load all associated tracks / clusters / flow elements into the cache. More...
 
bool isSame (const xAOD::IParticle *particle, const xAOD::IParticle *particle1) const
 
bool overlap (const xAOD::IParticle *particle, const xAOD::IParticle *particle1, float dR) const
 
float deltaR2 (const xAOD::IParticle *particle, const xAOD::IParticle *particle1, bool AvgCalo=false) const
 
const xAOD::VertexretrieveIDBestPrimaryVertex (const EventContext &ctx) const
 
virtual void print () const
 Print the state of the tool. More...
 
ServiceHandle< StoreGateSvc > & evtStore ()
 The standard StoreGateSvc (event store) Returns (kind of) a pointer to the StoreGateSvc. More...
 
const ServiceHandle< StoreGateSvc > & evtStore () const
 The standard StoreGateSvc (event store) Returns (kind of) a pointer to the StoreGateSvc. More...
 
const ServiceHandle< StoreGateSvc > & detStore () const
 The standard StoreGateSvc/DetectorStore Returns (kind of) a pointer to the StoreGateSvc. More...
 
virtual StatusCode sysInitialize () override
 Perform system initialization for an algorithm. More...
 
virtual StatusCode sysStart () override
 Handle START transition. More...
 
virtual std::vector< Gaudi::DataHandle * > inputHandles () const override
 Return this algorithm's input handles. More...
 
virtual std::vector< Gaudi::DataHandle * > outputHandles () const override
 Return this algorithm's output handles. More...
 
Gaudi::Details::PropertyBase & declareProperty (Gaudi::Property< T > &t)
 
Gaudi::Details::PropertyBase * declareProperty (const std::string &name, SG::VarHandleKey &hndl, const std::string &doc, const SG::VarHandleKeyType &)
 Declare a new Gaudi property. More...
 
Gaudi::Details::PropertyBase * declareProperty (const std::string &name, SG::VarHandleBase &hndl, const std::string &doc, const SG::VarHandleType &)
 Declare a new Gaudi property. More...
 
Gaudi::Details::PropertyBase * declareProperty (const std::string &name, SG::VarHandleKeyArray &hndArr, const std::string &doc, const SG::VarHandleKeyArrayType &)
 
Gaudi::Details::PropertyBase * declareProperty (const std::string &name, T &property, const std::string &doc, const SG::NotHandleType &)
 Declare a new Gaudi property. More...
 
Gaudi::Details::PropertyBase * declareProperty (const std::string &name, T &property, const std::string &doc="none")
 Declare a new Gaudi property. More...
 
void updateVHKA (Gaudi::Details::PropertyBase &)
 
MsgStream & msg () const
 
MsgStream & msg (const MSG::Level lvl) const
 
bool msgLvl (const MSG::Level lvl) const
 

Static Public Member Functions

static caloDecorNames caloDecors ()
 Returns an array with the calo cluster decoration ames [0]-> eta, [1]->phi, [2]->energy. [3]->isDecorated. More...
 
static caloDecorNames pflowDecors ()
 
static bool isFixedTrackIso (xAOD::Iso::IsolationType type)
 
static bool isVarTrackIso (xAOD::Iso::IsolationType type)
 
static bool isFixedTrackIsoTTVA (xAOD::Iso::IsolationType type)
 
static bool isVarTrackIsoTTVA (xAOD::Iso::IsolationType Iso)
 
static bool isTrackIso (xAOD::Iso::IsolationType type)
 
static bool isTrackIsoTTVA (xAOD::Iso::IsolationType type)
 
static float trackPtCut (xAOD::Iso::IsolationType type)
 
static bool isTopoEtIso (xAOD::Iso::IsolationType type)
 
static bool isPFlowIso (xAOD::Iso::IsolationType type)
 
static bool isEgamma (const xAOD::IParticle *particle)
 
static float clusterEtMinusTile (const xAOD::CaloCluster *C)
 
static std::string particleName (const xAOD::IParticle *C)
 
static std::string particleName (xAOD::Type::ObjectType T)
 

Protected Member Functions

void renounceArray (SG::VarHandleKeyArray &handlesArray)
 remove all handles from I/O resolution More...
 
std::enable_if_t< std::is_void_v< std::result_of_t< decltype(&T::renounce)(T)> > &&!std::is_base_of_v< SG::VarHandleKeyArray, T > &&std::is_base_of_v< Gaudi::DataHandle, T >, void > renounce (T &h)
 
void extraDeps_update_handler (Gaudi::Details::PropertyBase &ExtraDeps)
 Add StoreName to extra input/output deps as needed. More...
 

Private Types

typedef ServiceHandle< StoreGateSvcStoreGateSvc_t
 

Private Member Functions

void isoTypesFromWP (const std::vector< std::unique_ptr< IsolationWP >> &WP, IsoVector &types)
 Helper function to load all Isolation types from the iso working points. More...
 
TrackSet getAssociatedTracks (const xAOD::IParticle *P) const
 Retrieve all Inner detector tracks associated with the primary particle. More...
 
TrackSet getAssociatedTracks (const xAOD::IParticle *P, const xAOD::Vertex *vtx) const
 Retrieve the subset of tracks passing the isolation selection. More...
 
void getAssocFlowElements (const EventContext &ctx, ObjectCache &cache) const
 Retrieve all Flow elements associated with the particles in the cache. More...
 
CorrectionCode performCloseByCorrection (const EventContext &ctx, ObjectCache &cache) const
 
const IsoVectorgetIsolationTypes (const xAOD::IParticle *particle) const
 
CorrectionCode subtractCloseByContribution (const EventContext &ctx, const xAOD::IParticle *P, const ObjectCache &cache) const
 
CorrectionCode getCloseByCorrectionTrackIso (const xAOD::IParticle *primary, const IsoType type, const ObjectCache &cache, float &isoValue) const
 
CorrectionCode getCloseByCorrectionTopoIso (const EventContext &ctx, const xAOD::IParticle *primary, const IsoType type, const ObjectCache &cache, float &isoValue) const
 
CorrectionCode getCloseByCorrectionPflowIso (const EventContext &ctx, const xAOD::IParticle *primary, const IsoType type, const ObjectCache &cache, float &isoValue) const
 
CorrectionCode copyIsoValuesForPartsNotSelected (const xAOD::IParticle *part) const
 
ClusterSet getAssociatedClusters (const EventContext &ctx, const xAOD::IParticle *particle) const
 Loads the topo clusters associated with the primary IParticle. More...
 
PflowSet getAssocFlowElements (const EventContext &ctx, const xAOD::IParticle *particle) const
 Loads the pflow elements associated with the primary IParticle. More...
 
bool getExtrapEtaPhi (const EventContext &ctx, const xAOD::TrackParticle *tp, float &eta, float &phi) const
 helper to get eta,phi of muon extrap More...
 
float coneSize (const xAOD::IParticle *particle, IsoType Cone) const
 
float unCalibPt (const xAOD::IParticle *particle) const
 
bool passSelectionQuality (const xAOD::IParticle *particle) const
 
bool passFirstStage (const xAOD::TrackParticle *trk, const xAOD::Vertex *vtx) const
 The Track particle has to pass the Track selection tool and the TTVA selection. More...
 
void printIsolationCones (const IsoVector &types, xAOD::Type::ObjectType T) const
 
void declareDependency (const std::vector< std::string > &containers, const IsoVector &types)
 Helper function to declare the data dependencies. More...
 
Gaudi::Details::PropertyBase & declareGaudiProperty (Gaudi::Property< T > &hndl, const SG::VarHandleKeyType &)
 specialization for handling Gaudi::Property<SG::VarHandleKey> More...
 
Gaudi::Details::PropertyBase & declareGaudiProperty (Gaudi::Property< T > &hndl, const SG::VarHandleKeyArrayType &)
 specialization for handling Gaudi::Property<SG::VarHandleKeyArray> More...
 
Gaudi::Details::PropertyBase & declareGaudiProperty (Gaudi::Property< T > &hndl, const SG::VarHandleType &)
 specialization for handling Gaudi::Property<SG::VarHandleBase> More...
 
Gaudi::Details::PropertyBase & declareGaudiProperty (Gaudi::Property< T > &t, const SG::NotHandleType &)
 specialization for handling everything that's not a Gaudi::Property<SG::VarHandleKey> or a <SG::VarHandleKeyArray> More...
 

Private Attributes

ToolHandle< InDet::IInDetTrackSelectionToolm_trkselTool
 
ToolHandle< CP::ITrackVertexAssociationToolm_ttvaTool
 
ToolHandle< CP::IIsolationSelectionToolm_selectorTool
 
Gaudi::Property< std::string > m_quality_name
 
Gaudi::Property< std::string > m_passOR_name
 
Gaudi::Property< std::string > m_isoSelection_name {this, "IsolationSelectionDecorator", "", "Name of the final isolation decorator."}
 
Gaudi::Property< std::string > m_backup_prefix
 
Gaudi::Property< std::string > m_isoDecSuffix
 
Gaudi::Property< int > m_caloModel {this, "CaloCorrectionModel", TopoConeCorrectionModel::SubtractObjectsDirectly}
 EXPERT PROPERTIES. More...
 
Gaudi::Property< float > m_coreConeEl
 
Gaudi::Property< float > m_coreConeMu {this, "CoreConeMuons", 0.05, "This is the size of the core cone for the topoetcone variables."}
 
Gaudi::Property< float > m_ptvarconeRadius {this, "PtvarconeRadius", 1.e4, "This is the kT parameter for the ptvarcone variables."}
 
Gaudi::Property< float > m_maxTopoPolution
 
Gaudi::Property< float > m_ConeSizeVariation
 
Gaudi::Property< bool > m_declareCaloDecors {this, "declareCaloDecors", false, "If set to true, the data dependency on the calo/pflow decors will be declared"}
 
Gaudi::Property< std::vector< std::string > > m_elecKeys
 Declare the data dependencies of the Input containers. More...
 
Gaudi::Property< std::vector< std::string > > m_muonKeys
 
Gaudi::Property< std::vector< std::string > > m_photKeys
 
SG::ReadDecorHandleKeyArray< xAOD::IParticleContainerm_isoVarKeys
 
SG::WriteDecorHandleKeyArray< xAOD::IParticleContainerm_isoWriteDecVarKeys
 
ToolHandle< Trk::IParticleCaloExtensionToolm_caloExtTool {this, "ParticleCaloExtensionTool", "Trk::ParticleCaloExtensionTool/ParticleCaloExtensionTool"}
 calo extension tool for muon track particle extrapolation to calo More...
 
SG::ReadHandleKey< xAOD::VertexContainerm_VtxKey
 
SG::ReadHandleKey< xAOD::CaloClusterContainerm_CaloClusterKey
 
SG::ReadHandleKey< xAOD::FlowElementContainerm_PflowKey
 
IsoVector m_muon_isoTypes {}
 Isolation variables used by the muon working point. More...
 
IsoVector m_electron_isoTypes {}
 Isolation variables used by the electron working point. More...
 
IsoVector m_photon_isoTypes {}
 Isolation variables used by the photon working point. More...
 
bool m_has_nonTTVA {false}
 Switch whether a pile-up non robust TTVA working point is defined. More...
 
bool m_hasPflowIso {false}
 Switch whether a pflow isolation working point is defined. More...
 
bool m_hasEtConeIso {false}
 Switch whether a topoetcone isolation working point is defined. More...
 
bool m_isInitialised {false}
 
SelectionAccessor m_acc_quality {nullptr}
 
SelectionAccessor m_acc_passOR {nullptr}
 
SelectionDecorator m_dec_isoselection {nullptr}
 
IsoHelperMap m_isohelpers ATLAS_THREAD_SAFE
 
std::mutex m_isoHelpersMutex ATLAS_THREAD_SAFE
 Mutex to protect the map if the method with signature getCloseByCorrection(std::vector<float>& corrections, const xAOD::IParticle& par, const std::vector<xAOD::Iso::IsolationType>& types, const xAOD::IParticleContainer& closePar) is called. More...
 
StoreGateSvc_t m_evtStore
 Pointer to StoreGate (event store by default) More...
 
StoreGateSvc_t m_detStore
 Pointer to StoreGate (detector store by default) More...
 
std::vector< SG::VarHandleKeyArray * > m_vhka
 
bool m_varHandleArraysDeclared
 

Detailed Description

Definition at line 37 of file IsolationCloseByCorrectionTool.h.

Member Typedef Documentation

◆ caloDecorNames

using CP::IsolationCloseByCorrectionTool::caloDecorNames = std::array<std::string, 4>

Definition at line 45 of file IsolationCloseByCorrectionTool.h.

◆ IsoHelperMap

Definition at line 50 of file IsolationCloseByCorrectionTool.h.

◆ PrimaryCollection

Helper struct to collect all relevant objects for the procedure.

Definition at line 84 of file IsolationCloseByCorrectionTool.h.

◆ StoreGateSvc_t

typedef ServiceHandle<StoreGateSvc> AthCommonDataStore< AthCommonMsg< AlgTool > >::StoreGateSvc_t
privateinherited

Definition at line 388 of file AthCommonDataStore.h.

Member Enumeration Documentation

◆ TopoConeCorrectionModel

Enumerator
SubtractObjectsDirectly 
UseAveragedDecorators 

Definition at line 39 of file IsolationCloseByCorrectionTool.h.

39  {
42 
43  };

Constructor & Destructor Documentation

◆ IsolationCloseByCorrectionTool()

CP::IsolationCloseByCorrectionTool::IsolationCloseByCorrectionTool ( const std::string &  name)

Definition at line 35 of file IsolationCloseByCorrectionTool.cxx.

35 : asg::AsgTool(toolName) {}

Member Function Documentation

◆ acceptCorrected()

asg::AcceptData CP::IsolationCloseByCorrectionTool::acceptCorrected ( const xAOD::IParticle x,
const xAOD::IParticleContainer closePar 
) const
overridevirtual

Implements CP::IIsolationCloseByCorrectionTool.

Definition at line 850 of file IsolationCloseByCorrectionTool.cxx.

851  {
852  if (!m_isInitialised) { ATH_MSG_WARNING("The IsolationCloseByCorrectionTool was not initialised!!!"); }
853  assert(!m_selectorTool.empty());
854  const IsoVector& iso_types = getIsolationTypes(&x);
855  if (iso_types.empty()) {
856  // TODO: figure out if this is actually a valid situation
857  // or if we should just fail at this point.
858  ATH_MSG_WARNING("Could not cast particle for acceptCorrected. Will return false.");
859  static const asg::AcceptInfo dummyAcceptInfo = []() {
861  info.addCut("castCut", "whether we managed to cast to a known type");
862  return info;
863  }();
864  if (m_dec_isoselection) (*m_dec_isoselection)(x) = false;
865  return asg::AcceptData(&dummyAcceptInfo);
866  }
867 
868  if (closePar.empty()) return m_selectorTool->accept(x);
869  strObj strPar;
870  strPar.isolationValues.resize(numIsolationTypes);
871  strPar.pt = x.pt();
872  strPar.eta = x.eta();
873  strPar.type = x.type();
874  std::vector<float> corrections;
875  if (getCloseByCorrection(corrections, x, iso_types, closePar) == CorrectionCode::Error) {
876  ATH_MSG_WARNING("Could not calculate the corrections. acceptCorrected(x) is done without the corrections.");
877  if (m_dec_isoselection) (*m_dec_isoselection)(x) = bool(m_selectorTool->accept(x));
878  return m_selectorTool->accept(x);
879  }
880  for (unsigned int i = 0; i < iso_types.size(); ++i) {
881  strPar.isolationValues[iso_types[i]] = corrections[i];
883  float old = (*acc)(x);
884  ATH_MSG_DEBUG("Correcting " << toString(iso_types.at(i)) << " from " << old << " to " << corrections[i]);
885  }
886  auto accept = m_selectorTool->accept(strPar);
887  if (m_dec_isoselection) (*m_dec_isoselection)(x) = bool(accept);
888  return accept;
889  }

◆ associateCluster()

void CP::IsolationCloseByCorrectionTool::associateCluster ( const xAOD::IParticle particle,
float &  eta,
float &  phi,
float &  energy 
) const
overridevirtual

Retrieve the associated clusters from the Particle and calculate the average eta/phi/energy.

Remove super low energy clusters

Implements CP::IIsolationCloseByCorrectionTool.

Definition at line 782 of file IsolationCloseByCorrectionTool.cxx.

782  {
783  phi = particle->phi();
784  eta = particle->eta();
785  energy = -1.;
786  if (particle->type() == xAOD::Type::ObjectType::Muon) {
787  const xAOD::Muon* mu = static_cast<const xAOD::Muon*>(particle);
788  const xAOD::CaloCluster* cluster = mu->cluster();
789  if (!cluster) return;
790  energy = cluster->e();
791  // At the moment no cluster associated with muons is in the derivations
792  int nSample{0};
793  float etaT{0.f}, phiT{0.f}, dphiT{0.f};
794 
795  for (unsigned int i = 0; i < CaloSampling::Unknown; ++i) {
797  if (cluster->hasSampling(s)) {
798  ATH_MSG_VERBOSE("Sampling: " << i << "eta-phi (" << cluster->etaSample(s) << ", " << cluster->phiSample(s) << ")");
799  etaT += cluster->etaSample(s);
800  if (!nSample)
801  phiT = cluster->phiSample(s);
802  else
803  dphiT += xAOD::P4Helpers::deltaPhi(cluster->phiSample(s), phiT);
804  ++nSample;
805  }
806  }
807  if (!nSample) return;
808  ATH_MSG_DEBUG("Eta, phi before sampling: " << eta << ", " << phi << " and after sampling: " << etaT / nSample << ", "
809  << phiT / nSample);
810  phi = xAOD::P4Helpers::deltaPhi(phiT + dphiT / nSample, 0);
811  eta = etaT / nSample;
812  ATH_MSG_VERBOSE("associateCluster: mu with pt: " << mu->pt() * MeVtoGeV << " GeV, eta: "
813  << mu->eta() << ", phi: " << mu->phi() << " energy, eta, phi " << energy << ", " << eta << ", " << phi
814  << ", et " << energy * mu->pt() / mu->e());
815  }
816  if (!isEgamma(particle)) return;
817  const xAOD::Egamma* egamm = static_cast<const xAOD::Egamma*>(particle);
818  eta = phi = energy = 0.;
819  for (unsigned int cl = 0; cl < egamm->nCaloClusters(); ++cl) {
820  const xAOD::CaloCluster* prim_cluster = egamm->caloCluster(cl);
821  if (!prim_cluster) {
822  ATH_MSG_DEBUG("Cluster " << cl << " is not defined " << egamm);
823  continue;
824  }
825  std::vector<const xAOD::CaloCluster*> constituents = xAOD::EgammaHelpers::getAssociatedTopoClusters(prim_cluster);
826  for (const xAOD::CaloCluster* cluster : constituents) {
827  if (!cluster) continue;
828  const float clus_e = clusterEtMinusTile(cluster);
830  if (clus_e < MinClusterEnergy) continue;
831  eta += cluster->eta() * clus_e;
832  phi += cluster->phi() * clus_e;
833  energy += clus_e;
834  ATH_MSG_VERBOSE("associateCluster: eg add in clus with e: " << clus_e * MeVtoGeV << " clus et " << cluster->pt() * MeVtoGeV << " GeV, eta: "
835  << cluster->eta() << ", phi: " << cluster->phi());
836  }
837  }
838  if (energy >= MinClusterEnergy) {
839  phi = xAOD::P4Helpers::deltaPhi(phi / energy, 0.);
840  eta /= energy;
841  ATH_MSG_VERBOSE("associateCluster: eg with pt: " << egamm->pt() * MeVtoGeV << " GeV, eta: "
842  << egamm->eta() << ", phi: " << egamm->phi() << " energy, eta, phi " << energy << ", " << eta << ", " << phi );
843  } else {
844  ATH_MSG_DEBUG("Average energy from the clusters is too low " << energy << " copy particle properties");
845  eta = egamm->eta();
846  phi = egamm->phi();
847  energy = egamm->e();
848  }
849  }

◆ associateFlowElement()

void CP::IsolationCloseByCorrectionTool::associateFlowElement ( const EventContext &  ctx,
const xAOD::IParticle particle,
float &  eta,
float &  phi,
float &  energy 
) const
overridevirtual

Implements CP::IIsolationCloseByCorrectionTool.

Definition at line 758 of file IsolationCloseByCorrectionTool.cxx.

759  {
760  phi = eta = energy = 0.;
761  PflowSet flowCollection = getAssocFlowElements(ctx, particle);
762  if (flowCollection.empty()) {
763  phi = particle->phi();
764  eta = particle->eta();
765  return;
766  }
767  for (const FlowElementPtr& ele : flowCollection) {
768  const float flow_energy = ele->e() * ele.weight;
769  if (flow_energy < MinClusterEnergy) continue;
770  phi += ele->phi() * flow_energy;
771  eta += ele->eta() * flow_energy;
772  energy += flow_energy;
773  }
774  if (energy < MinClusterEnergy) {
775  phi = particle->phi();
776  eta = particle->eta();
777  return;
778  }
779  phi = xAOD::P4Helpers::deltaPhi(phi / energy, 0.);
780  eta /= energy;
781  }

◆ caloDecors()

caloDecorNames CP::IsolationCloseByCorrectionTool::caloDecors ( )
static

Returns an array with the calo cluster decoration ames [0]-> eta, [1]->phi, [2]->energy. [3]->isDecorated.

Definition at line 24 of file IsolationCloseByCorrectionTool.cxx.

24  {
25  return {"IsoCloseByCorr_assocClustEta", "IsoCloseByCorr_assocClustPhi", "IsoCloseByCorr_assocClustEnergy",
26  "IsoCloseByCorr_assocClustDecor"};
27  }

◆ clusterEtMinusTile()

float CP::IsolationCloseByCorrectionTool::clusterEtMinusTile ( const xAOD::CaloCluster C)
static

Definition at line 975 of file IsolationCloseByCorrectionTool.cxx.

975  {
976  float Et{0.f};
977  if (cluster) {
978  try {
979  Et = cluster->p4(xAOD::CaloCluster::State::UNCALIBRATED).Et();
980  Et = Et - cluster->eSample(xAOD::CaloCluster::CaloSample::TileGap3) /
981  std::cosh(cluster->p4(xAOD::CaloCluster::State::UNCALIBRATED).Eta());
982  } catch (...) { Et = cluster->p4().Et(); }
983  }
984  return std::max(Et, 0.f);
985  }

◆ coneSize()

float CP::IsolationCloseByCorrectionTool::coneSize ( const xAOD::IParticle particle,
IsoType  Cone 
) const
private

Definition at line 902 of file IsolationCloseByCorrectionTool.cxx.

902  {
903  using xAOD::Iso::coneSize;
904  float ConeDR = coneSize(Cone);
905  if (isVarTrackIso(Cone) || isVarTrackIsoTTVA(Cone)) {
906  const xAOD::IParticle* Reference = isoRefParticle(P);
907  float MiniIso = m_ptvarconeRadius / unCalibPt(Reference);
908  if (MiniIso < ConeDR) return MiniIso;
909  }
910  return ConeDR;
911  }

◆ copyIsoValuesForPartsNotSelected()

CorrectionCode CP::IsolationCloseByCorrectionTool::copyIsoValuesForPartsNotSelected ( const xAOD::IParticle part) const
private

Definition at line 347 of file IsolationCloseByCorrectionTool.cxx.

347  {
349 
350  ATH_MSG_DEBUG("copyIsoValuesForPartsNotSelected " << part->type() << " " << part->pt() * MeVtoGeV << " GeV" << " eta: " << part->eta() << " phi: " << part->phi());
351 
352  if (types.empty()) {
353  ATH_MSG_WARNING("No isolation types are defiend for " << particleName(part));
355  }
356  for (const IsolationType iso_type : types) {
357  float iso_variable{0.f};
358  if (m_isohelpers.at(iso_type)->getIsolation(part, iso_variable) == CorrectionCode::Error) {
359  ATH_MSG_ERROR("Cannot get value for " << toString(iso_type));
360  return CorrectionCode::Error;
361  }
362  ATH_MSG_DEBUG("copyIsoValuesForPartsNotSelected: Set pt, eta " << part->pt() << ", " << part->eta() << ", " << part->phi() << " for " << toString(iso_type) << " to " << iso_variable);
363  if (m_isohelpers.at(iso_type)->setIsolation(part, iso_variable) == CorrectionCode::Error) {
364  ATH_MSG_ERROR("Cannot set " << toString(iso_type) << " to " << iso_variable);
365  return CorrectionCode::Error;
366  }
367  }
368  return CorrectionCode::Ok;
369  }

◆ declareDependency()

void CP::IsolationCloseByCorrectionTool::declareDependency ( const std::vector< std::string > &  containers,
const IsoVector types 
)
private

Helper function to declare the data dependencies.

Definition at line 118 of file IsolationCloseByCorrectionTool.cxx.

118  {
119  for (const std::string& cont : containers) {
120  for (const IsoType iso : types) {
121  // define read accessor iso variable keys
122  m_isoVarKeys.emplace_back(cont + "." + std::string(toString(iso)));
123  // define write decorator iso variable keys - needed for MT, but we do not use handles for writing the decorators in isoHelpers
124  m_isoWriteDecVarKeys.emplace_back(cont + "." + std::string(toString(iso) + (m_isoDecSuffix.empty() ? "" : "_") + m_isoDecSuffix));
125  }
126  if (!m_declareCaloDecors && m_caloModel == TopoConeCorrectionModel::SubtractObjectsDirectly) continue;
128  for (const std::string& decor : pflowDecors()) m_isoVarKeys.emplace_back(cont + "." + decor);
129  }
131  for (const std::string& decor : caloDecors()) m_isoVarKeys.emplace_back(cont + "." + decor);
132  }
133  }
134  }

◆ declareGaudiProperty() [1/4]

Gaudi::Details::PropertyBase& AthCommonDataStore< AthCommonMsg< AlgTool > >::declareGaudiProperty ( Gaudi::Property< T > &  hndl,
const SG::VarHandleKeyArrayType  
)
inlineprivateinherited

specialization for handling Gaudi::Property<SG::VarHandleKeyArray>

Definition at line 170 of file AthCommonDataStore.h.

172  {
173  return *AthCommonDataStore<PBASE>::declareProperty(hndl.name(),
174  hndl.value(),
175  hndl.documentation());
176 
177  }

◆ declareGaudiProperty() [2/4]

Gaudi::Details::PropertyBase& AthCommonDataStore< AthCommonMsg< AlgTool > >::declareGaudiProperty ( Gaudi::Property< T > &  hndl,
const SG::VarHandleKeyType  
)
inlineprivateinherited

specialization for handling Gaudi::Property<SG::VarHandleKey>

Definition at line 156 of file AthCommonDataStore.h.

158  {
159  return *AthCommonDataStore<PBASE>::declareProperty(hndl.name(),
160  hndl.value(),
161  hndl.documentation());
162 
163  }

◆ declareGaudiProperty() [3/4]

Gaudi::Details::PropertyBase& AthCommonDataStore< AthCommonMsg< AlgTool > >::declareGaudiProperty ( Gaudi::Property< T > &  hndl,
const SG::VarHandleType  
)
inlineprivateinherited

specialization for handling Gaudi::Property<SG::VarHandleBase>

Definition at line 184 of file AthCommonDataStore.h.

186  {
187  return *AthCommonDataStore<PBASE>::declareProperty(hndl.name(),
188  hndl.value(),
189  hndl.documentation());
190  }

◆ declareGaudiProperty() [4/4]

Gaudi::Details::PropertyBase& AthCommonDataStore< AthCommonMsg< AlgTool > >::declareGaudiProperty ( Gaudi::Property< T > &  t,
const SG::NotHandleType  
)
inlineprivateinherited

specialization for handling everything that's not a Gaudi::Property<SG::VarHandleKey> or a <SG::VarHandleKeyArray>

Definition at line 199 of file AthCommonDataStore.h.

200  {
201  return PBASE::declareProperty(t);
202  }

◆ declareProperty() [1/6]

Gaudi::Details::PropertyBase* AthCommonDataStore< AthCommonMsg< AlgTool > >::declareProperty ( const std::string &  name,
SG::VarHandleBase hndl,
const std::string &  doc,
const SG::VarHandleType  
)
inlineinherited

Declare a new Gaudi property.

Parameters
nameName of the property.
hndlObject holding the property value.
docDocumentation string for the property.

This is the version for types that derive from SG::VarHandleBase. The property value object is put on the input and output lists as appropriate; then we forward to the base class.

Definition at line 245 of file AthCommonDataStore.h.

249  {
250  this->declare(hndl.vhKey());
251  hndl.vhKey().setOwner(this);
252 
253  return PBASE::declareProperty(name,hndl,doc);
254  }

◆ declareProperty() [2/6]

Gaudi::Details::PropertyBase* AthCommonDataStore< AthCommonMsg< AlgTool > >::declareProperty ( const std::string &  name,
SG::VarHandleKey hndl,
const std::string &  doc,
const SG::VarHandleKeyType  
)
inlineinherited

Declare a new Gaudi property.

Parameters
nameName of the property.
hndlObject holding the property value.
docDocumentation string for the property.

This is the version for types that derive from SG::VarHandleKey. The property value object is put on the input and output lists as appropriate; then we forward to the base class.

Definition at line 221 of file AthCommonDataStore.h.

225  {
226  this->declare(hndl);
227  hndl.setOwner(this);
228 
229  return PBASE::declareProperty(name,hndl,doc);
230  }

◆ declareProperty() [3/6]

Gaudi::Details::PropertyBase* AthCommonDataStore< AthCommonMsg< AlgTool > >::declareProperty ( const std::string &  name,
SG::VarHandleKeyArray hndArr,
const std::string &  doc,
const SG::VarHandleKeyArrayType  
)
inlineinherited

Definition at line 259 of file AthCommonDataStore.h.

263  {
264 
265  // std::ostringstream ost;
266  // ost << Algorithm::name() << " VHKA declareProp: " << name
267  // << " size: " << hndArr.keys().size()
268  // << " mode: " << hndArr.mode()
269  // << " vhka size: " << m_vhka.size()
270  // << "\n";
271  // debug() << ost.str() << endmsg;
272 
273  hndArr.setOwner(this);
274  m_vhka.push_back(&hndArr);
275 
276  Gaudi::Details::PropertyBase* p = PBASE::declareProperty(name, hndArr, doc);
277  if (p != 0) {
278  p->declareUpdateHandler(&AthCommonDataStore<PBASE>::updateVHKA, this);
279  } else {
280  ATH_MSG_ERROR("unable to call declareProperty on VarHandleKeyArray "
281  << name);
282  }
283 
284  return p;
285 
286  }

◆ declareProperty() [4/6]

Gaudi::Details::PropertyBase* AthCommonDataStore< AthCommonMsg< AlgTool > >::declareProperty ( const std::string &  name,
T &  property,
const std::string &  doc,
const SG::NotHandleType  
)
inlineinherited

Declare a new Gaudi property.

Parameters
nameName of the property.
propertyObject holding the property value.
docDocumentation string for the property.

This is the generic version, for types that do not derive from SG::VarHandleKey. It just forwards to the base class version of declareProperty.

Definition at line 333 of file AthCommonDataStore.h.

337  {
338  return PBASE::declareProperty(name, property, doc);
339  }

◆ declareProperty() [5/6]

Gaudi::Details::PropertyBase* AthCommonDataStore< AthCommonMsg< AlgTool > >::declareProperty ( const std::string &  name,
T &  property,
const std::string &  doc = "none" 
)
inlineinherited

Declare a new Gaudi property.

Parameters
nameName of the property.
propertyObject holding the property value.
docDocumentation string for the property.

This dispatches to either the generic declareProperty or the one for VarHandle/Key/KeyArray.

Definition at line 352 of file AthCommonDataStore.h.

355  {
356  typedef typename SG::HandleClassifier<T>::type htype;
357  return declareProperty (name, property, doc, htype());
358  }

◆ declareProperty() [6/6]

Gaudi::Details::PropertyBase& AthCommonDataStore< AthCommonMsg< AlgTool > >::declareProperty ( Gaudi::Property< T > &  t)
inlineinherited

Definition at line 145 of file AthCommonDataStore.h.

145  {
146  typedef typename SG::HandleClassifier<T>::type htype;
148  }

◆ deltaR2()

float CP::IsolationCloseByCorrectionTool::deltaR2 ( const xAOD::IParticle particle,
const xAOD::IParticle particle1,
bool  AvgCalo = false 
) const

Definition at line 946 of file IsolationCloseByCorrectionTool.cxx.

946  {
947  if (isSame(P, P1)) return 0.;
948  // Check if one of the objects is a CaloCluster or the Averaging over the clusters is requested.
949  if (AvgCalo || (P->type() != P1->type() &&
951  float phi1{0.f}, eta1{0.f}, eta2{0.f}, phi2{0.f};
952  getExtrapEtaPhi(P, eta1, phi1);
953  getExtrapEtaPhi(P1, eta2, phi2);
954  return xAOD::P4Helpers::deltaR2(eta1, phi1, eta2, phi2);
955  }
956  float dPhi = xAOD::P4Helpers::deltaPhi(P, P1);
957  float dEta = P->eta() - P1->eta();
958  return dEta * dEta + dPhi * dPhi;
959  }

◆ detStore()

const ServiceHandle<StoreGateSvc>& AthCommonDataStore< AthCommonMsg< AlgTool > >::detStore ( ) const
inlineinherited

The standard StoreGateSvc/DetectorStore Returns (kind of) a pointer to the StoreGateSvc.

Definition at line 95 of file AthCommonDataStore.h.

95 { return m_detStore; }

◆ evtStore() [1/2]

ServiceHandle<StoreGateSvc>& AthCommonDataStore< AthCommonMsg< AlgTool > >::evtStore ( )
inlineinherited

The standard StoreGateSvc (event store) Returns (kind of) a pointer to the StoreGateSvc.

Definition at line 85 of file AthCommonDataStore.h.

85 { return m_evtStore; }

◆ evtStore() [2/2]

const ServiceHandle<StoreGateSvc>& AthCommonDataStore< AthCommonMsg< AlgTool > >::evtStore ( ) const
inlineinherited

The standard StoreGateSvc (event store) Returns (kind of) a pointer to the StoreGateSvc.

Definition at line 90 of file AthCommonDataStore.h.

90 { return m_evtStore; }

◆ extraDeps_update_handler()

void AthCommonDataStore< AthCommonMsg< AlgTool > >::extraDeps_update_handler ( Gaudi::Details::PropertyBase &  ExtraDeps)
protectedinherited

Add StoreName to extra input/output deps as needed.

use the logic of the VarHandleKey to parse the DataObjID keys supplied via the ExtraInputs and ExtraOuputs Properties to add the StoreName if it's not explicitly given

◆ getAssocFlowElements() [1/2]

PflowSet CP::IsolationCloseByCorrectionTool::getAssocFlowElements ( const EventContext &  ctx,
const xAOD::IParticle particle 
) const
private

Loads the pflow elements associated with the primary IParticle.

Definition at line 178 of file IsolationCloseByCorrectionTool.cxx.

178  {
179  ObjectCache cache{};
180  cache.prim_parts = {particle};
181  loadAssociatedObjects(ctx, cache);
182  return cache.flows;
183  }

◆ getAssocFlowElements() [2/2]

void CP::IsolationCloseByCorrectionTool::getAssocFlowElements ( const EventContext &  ctx,
ObjectCache cache 
) const
private

Retrieve all Flow elements associated with the particles in the cache.

Definition at line 185 of file IsolationCloseByCorrectionTool.cxx.

185  {
186  if (m_PflowKey.empty()) return;
188  if (!readHandle.isValid()) return;
189  std::set<const xAOD::IParticle*> tombola{};
190  for (const xAOD::IParticle* p : cache.prim_parts) tombola.insert(p);
191  for (const TrackPtr& p : cache.tracks) tombola.insert(p);
192  for (const CaloClusterPtr& p : cache.clusters) tombola.insert(p);
193 
194  for (const xAOD::FlowElement* flow : *readHandle) {
195  if (!flow) continue;
196  for (size_t ch = 0; ch < flow->nChargedObjects(); ++ch) {
197  const xAOD::IParticle* obj = flow->chargedObject(ch);
198  if (tombola.count(obj)) {
199  const std::vector<float>& weights = flow->chargedObjectWeights();
200  cache.flows.emplace(flow, ch < weights.size() ? weights[ch] : 1.f);
201  }
202  }
203  for (size_t ne = 0; ne < flow->nOtherObjects(); ++ne) {
204  const xAOD::IParticle* obj = flow->otherObject(ne);
205  if (tombola.count(obj)) {
206  const std::vector<float>& weights = flow->otherObjectWeights();
207  cache.flows.emplace(flow, ne < weights.size() ? weights[ne] : 1.f);
208  ATH_MSG_VERBOSE("getAssocFlowElements: neflow " << ne << ", " << obj->type() << ", " << obj->pt() << ", " << obj->eta() << ", " << obj->phi() << ", " << flow->pt() << ", " << flow->eta() << ", " << flow->phi());
209  }
210  }
211  }
212  }

◆ getAssociatedClusters()

ClusterSet CP::IsolationCloseByCorrectionTool::getAssociatedClusters ( const EventContext &  ctx,
const xAOD::IParticle particle 
) const
private

Loads the topo clusters associated with the primary IParticle.

Definition at line 466 of file IsolationCloseByCorrectionTool.cxx.

466  {
467  // Use accessor to mark topoclusters which are associated to an egamma object, electron or photon
468  // This will be used to avoid associating the same object to a muon during getCloseByCorrectionPflowIso or getCloseByCorrectionTopoIso
469  static const CharDecorator acc_isAssociatedToEG{"isAssociatedToEG"};
471  if (isEgamma(P)) {
472  const xAOD::Egamma* egamm = static_cast<const xAOD::Egamma*>(P);
473  for (size_t calo = 0; calo < egamm->nCaloClusters(); ++calo) {
474  const xAOD::CaloCluster* clust = egamm->caloCluster(calo);
475  if (!clust) continue;
476  std::vector<const xAOD::CaloCluster*> constituents = xAOD::EgammaHelpers::getAssociatedTopoClusters(clust);
477  for (const xAOD::CaloCluster* cluster : constituents) {
478  if (cluster && std::abs(cluster->eta()) < 7. && cluster->e() > MinClusterEnergy) {
479  clusters.emplace(cluster);
480  acc_isAssociatedToEG(*cluster) = true; // set flag that this cluster is associate to an electron or photon
481  ATH_MSG_VERBOSE("getAssociatedClusters: " << P->type() << " has topo cluster with pt: " << cluster->pt() * MeVtoGeV << " GeV, eta: "
482  << cluster->eta() << ", phi: " << cluster->phi()
483  << ", isAssociatedToEG: " << (int)acc_isAssociatedToEG(*cluster));
484  }
485  }
486  }
487  if (clusters.size()) return clusters;
488  }
489  if (m_CaloClusterKey.empty()) return clusters;
491  if (!topoClusters.isValid()) return clusters;
492 
493  if (P->type() == xAOD::Type::ObjectType::Muon) {
494  const xAOD::Muon* mu = static_cast<const xAOD::Muon*>(P);
495  const xAOD::CaloCluster* cl = mu->cluster();
496  bool foundMuonTopo = false;
497  if (cl) {
498  ATH_MSG_VERBOSE("getAssociatedClusters: muon has cluster with pt: " << cl->pt() * MeVtoGeV << " GeV, eta: "
499  << cl->eta() << ", phi: " << cl->phi());
500  std::vector<const xAOD::CaloCluster*> constituents = xAOD::EgammaHelpers::getAssociatedTopoClusters(cl);
501  for (const xAOD::CaloCluster* cluster : constituents) {
502  if (cluster && std::abs(cluster->eta()) < 7. && cluster->e() > MinClusterEnergy) {
503  // skip association if this cluster is already associated with an electron or photon - priority is given to egamma reco
504  if (!acc_isAssociatedToEG.isAvailable(*cluster) || !acc_isAssociatedToEG(*cluster)) {
505  clusters.emplace(cluster);
506  foundMuonTopo = true;
507  ATH_MSG_VERBOSE("getAssociatedClusters: muon has topo cluster with pt: " << cluster->pt() * MeVtoGeV << " GeV, eta: "
508  << cluster->eta() << ", phi: " << cluster->phi());
509  }
510  else {
511  ATH_MSG_VERBOSE("getAssociatedClusters: muon topo cluster already associated with an EG objet - cluster with pt: "
512  << cluster->pt() * MeVtoGeV << " GeV, eta: " << cluster->eta() << ", phi: " << cluster->phi());
513  }
514  }
515  }
516  }
517  if (!foundMuonTopo) {
518 #ifndef XAOD_ANALYSIS
519  // extraploate muon to calo and look for matching topo cluster
520  const xAOD::TrackParticle* tp = mu->trackParticle(xAOD::Muon::InnerDetectorTrackParticle);
521  if (tp) {
522  ATH_MSG_VERBOSE("getAssociatedClusters: found mu tp " << " with pt: " << tp->pt() * MeVtoGeV << " GeV, eta: " << tp->eta() << ", phi: " << tp->phi());
523  float tpEtaAtCalo;
524  float tpPhiAtCalo;
525  if (getExtrapEtaPhi(ctx, tp, tpEtaAtCalo, tpPhiAtCalo)) {
526  ATH_MSG_VERBOSE("getAssociatedClusters: tp extrapolated - tpEtaAtCalo " << tpEtaAtCalo << ", tpPhiAtCalo " << tpPhiAtCalo);
527  for (const xAOD::CaloCluster* cluster : *topoClusters) {
528  if (cluster && std::abs(cluster->eta()) < 7. && cluster->e() > MinClusterEnergy &&
529  xAOD::P4Helpers::deltaR(tpEtaAtCalo, tpPhiAtCalo, cluster->eta(), cluster->phi()) < m_coreConeMu) {
530  clusters.emplace(cluster);
531  ATH_MSG_VERBOSE("getAssociatedClusters: for mu trkPart save clus " << " with pt: " << cluster->pt() * MeVtoGeV << " GeV, eta: " << cluster->eta() << ", phi: " << cluster->phi() << ", tpEtaAtCalo " << tpEtaAtCalo << ", tpPhiAtCalo " << tpPhiAtCalo);
532  }
533  }
534  }
535  }
536 #endif
537  }
538  }
539 
540  return clusters;
541  }

◆ getAssociatedTracks() [1/2]

TrackSet CP::IsolationCloseByCorrectionTool::getAssociatedTracks ( const xAOD::IParticle P) const
private

Retrieve all Inner detector tracks associated with the primary particle.

Definition at line 427 of file IsolationCloseByCorrectionTool.cxx.

427  {
428  TrackSet to_return{};
429  if (P->type() == xAOD::Type::Muon) {
430  const xAOD::Muon* mu = static_cast<const xAOD::Muon*>(P);
431  if (mu->muonType() != xAOD::Muon::SiliconAssociatedForwardMuon)
432  to_return.emplace(mu->trackParticle(xAOD::Muon::TrackParticleType::InnerDetectorTrackParticle));
433  } else if (P->type() == xAOD::Type::TrackParticle) {
434  const xAOD::TrackParticle* trk = static_cast<const xAOD::TrackParticle*>(P);
435  to_return.emplace(trk);
436  } else if (isEgamma(P)) {
437  const xAOD::Egamma* EG = static_cast<const xAOD::Egamma*>(P);
438  std::set<const xAOD::TrackParticle*> trk_vec = xAOD::EgammaHelpers::getTrackParticles(EG, true, true);
439  for (const xAOD::TrackParticle* trk : trk_vec) {
440  ATH_MSG_VERBOSE("Adding egamma track with "
441  << trk->pt() * MeVtoGeV << " GeV, eta: " << trk->eta() << ", phi: " << trk->phi());
442  to_return.emplace(trk);
443  }
444  }
445  return to_return;
446  }

◆ getAssociatedTracks() [2/2]

TrackSet CP::IsolationCloseByCorrectionTool::getAssociatedTracks ( const xAOD::IParticle P,
const xAOD::Vertex vtx 
) const
private

Retrieve the subset of tracks passing the isolation selection.

Definition at line 447 of file IsolationCloseByCorrectionTool.cxx.

447  {
448  const TrackSet assoc_tracks = getAssociatedTracks(P);
449  TrackSet to_ret{};
450  for (const TrackPtr trk : assoc_tracks) {
451  if (passFirstStage(trk, vtx)) to_ret.insert(trk);
452  }
453  return to_ret;
454  }

◆ getCloseByCorrection()

CorrectionCode CP::IsolationCloseByCorrectionTool::getCloseByCorrection ( std::vector< float > &  corrections,
const xAOD::IParticle par,
const std::vector< xAOD::Iso::IsolationType > &  types,
const xAOD::IParticleContainer closePar 
) const
overridevirtual

Check first if all isolation types are known to the tool

Implements CP::IIsolationCloseByCorrectionTool.

Definition at line 372 of file IsolationCloseByCorrectionTool.cxx.

374  {
375  if (!m_isInitialised) {
376  ATH_MSG_ERROR("The IsolationCloseByCorrectionTool was not initialised!!!");
377  return CorrectionCode::Error;
378  }
380  {
381  std::lock_guard<std::mutex> guard{m_isoHelpersMutex};
382  for (const IsolationType& t : types) {
383  IsoHelperMap::const_iterator Itr = m_isohelpers.find(t);
384  if (Itr != m_isohelpers.end()) { continue; }
385  Itr = m_isohelpers.insert(std::make_pair(t, std::make_unique<IsoVariableHelper>(t, m_backup_prefix, m_isoDecSuffix))).first;
386  }
387  }
388  corrections.assign(types.size(), 0);
389  ObjectCache cache{};
390  loadPrimaryParticles(&closePar, cache);
391  const EventContext& ctx = Gaudi::Hive::currentContext();
392  loadAssociatedObjects(ctx, cache);
393  std::vector<float>::iterator Cone = corrections.begin();
394  for (const IsolationType& iso_type : types) {
395  IsoHelperMap::const_iterator Itr = m_isohelpers.find(iso_type);
396  if (Itr->second->backupIsolation(&par) == CP::CorrectionCode::Error) {
397  ATH_MSG_ERROR("Failed to backup isolation");
398  return CorrectionCode::Error;
399  }
400  if (isTrackIso(iso_type)) {
401  if (getCloseByCorrectionTrackIso(&par, iso_type, cache, (*Cone)) == CorrectionCode::Error) {
402  ATH_MSG_ERROR("Failed to apply track correction");
403  return CorrectionCode::Error;
404 
405  }
406  }
407  else if (isTopoEtIso(iso_type)) {
408  if (getCloseByCorrectionTopoIso(ctx, &par, iso_type, cache, (*Cone)) == CorrectionCode::Error) {
409  ATH_MSG_ERROR("Failed to apply topo cluster correction");
410  return CorrectionCode::Error;
411  }
412  }
413  else if (isPFlowIso(iso_type)) {
414  if (getCloseByCorrectionPflowIso(ctx, &par, iso_type, cache, (*Cone)) == CorrectionCode::Error) {
415  ATH_MSG_ERROR("Failed to apply pflow correction");
416  return CorrectionCode::Error;
417  }
418  }
419  ++Cone;
420  }
421  return CorrectionCode::Ok;
422  }

◆ getCloseByCorrectionPflowIso()

CorrectionCode CP::IsolationCloseByCorrectionTool::getCloseByCorrectionPflowIso ( const EventContext &  ctx,
const xAOD::IParticle primary,
const IsoType  type,
const ObjectCache cache,
float &  isoValue 
) const
private

Disable the correction of already isolated objects

Find the pflow elements associated with this primary

Definition at line 588 of file IsolationCloseByCorrectionTool.cxx.

590  {
591  if (!isPFlowIso(type)) {
592  ATH_MSG_ERROR("getCloseByCorrectionPflowIso() -- The isolation type is not a Pflow variable " << toString(type));
593  return CorrectionCode::Error;
594  }
595  if (m_isohelpers.at(type)->getOriginalIsolation(primary, isoValue) == CorrectionCode::Error) {
596  ATH_MSG_ERROR("getCloseByCorrectionPflowIso() -- Could not retrieve the isolation variable.");
597  return CorrectionCode::Error;
598  }
600  if (isoValue <= 0.) {
601  ATH_MSG_DEBUG("Pflow varible is already sufficiently isolated ");
602  return CorrectionCode::Ok;
603  }
604  const float coneDR = coneSize(primary, type);
605  float ref_eta{0.f}, ref_phi{0.f};
606  getExtrapEtaPhi(primary, ref_eta, ref_phi);
607  if (m_caloModel == TopoConeCorrectionModel::SubtractObjectsDirectly) {
609  ATH_MSG_VERBOSE("getCloseByCorrectionPflowIso: " << toString(type) << " of " << particleName(primary) << " with pt: "
610  << primary->pt() * MeVtoGeV << " GeV, eta: " << primary->eta()
611  << ", phi: " << primary->phi() << " before correction: " << isoValue * MeVtoGeV << " GeV. ");
612  PflowSet assoc_coll = getAssocFlowElements(ctx, primary);
613  for (const FlowElementPtr& flow : cache.flows) {
614  ATH_MSG_VERBOSE("Loop over pflow element: " << flow->pt() << " GeV, eta: " << flow->eta() << " phi: " << flow->phi());
615 
616  const float dR = xAOD::P4Helpers::deltaR(ref_eta,ref_phi, flow->eta(),flow->phi());
618  ATH_MSG_VERBOSE("Flow element is in core cone");
619  continue;
620  }
621  if (assoc_coll.count(flow)) {
622  ATH_MSG_VERBOSE("Flow element is directly associated with the object");
623  continue;
624  }
625  if (dR < coneDR) {
626  ATH_MSG_VERBOSE("Found overlapping pflow element: " << flow->pt() << " GeV, eta: " << flow->eta()
627  << " phi: " << flow->phi() << " dR: " << dR);
628  isoValue -= flow->pt() * flow.weight;
629  }
630  }
631  ATH_MSG_VERBOSE("getCloseByCorrectionPflowIso: " << toString(type) << " of " << particleName(primary) << " with pt: "
632  << primary->pt() * MeVtoGeV << " GeV, eta: " << primary->eta()
633  << ", phi: " << primary->phi() << " after correction: " << isoValue * MeVtoGeV << " GeV. ");
634  } else if (m_caloModel == TopoConeCorrectionModel::UseAveragedDecorators) {
635  static const FloatAccessor acc_eta{pflowDecors()[0]};
636  static const FloatAccessor acc_phi{pflowDecors()[1]};
637  static const FloatAccessor acc_ene{pflowDecors()[2]};
638  static const CharAccessor acc_isDecor{pflowDecors()[3]};
639  for (const xAOD::IParticle* others : cache.prim_parts) {
640  if (others == primary) continue;
641  if (!acc_isDecor.isAvailable(*others) || !acc_isDecor(*others)) {
642  ATH_MSG_ERROR("The variable energy averaged pflow decorations are not available for "<<particleName(others)<<". Please check");
643  return CorrectionCode::Error;
644  }
645  const float other_eta = acc_eta(*others);
646  const float other_phi = acc_phi(*others);
647  const float dR = xAOD::P4Helpers::deltaR(ref_eta,ref_phi,other_eta,other_phi);
648  if (dR > coneDR) continue;
649  if (dR< (primary->type() == xAOD::Type::ObjectType::Muon ? m_coreConeMu : m_coreConeEl)) continue;
650  isoValue -= acc_ene(*others);
651  }
652  } else {
653  ATH_MSG_ERROR("Unknown calo correction model "<<m_caloModel);
654  return CorrectionCode::Error;
655  }
656  isoValue = std::max(0.f, isoValue);
657  return CorrectionCode::Ok;
658  }

◆ getCloseByCorrectionTopoIso()

CorrectionCode CP::IsolationCloseByCorrectionTool::getCloseByCorrectionTopoIso ( const EventContext &  ctx,
const xAOD::IParticle primary,
const IsoType  type,
const ObjectCache cache,
float &  isoValue 
) const
private

Disable the correction of already isolated objects

Definition at line 660 of file IsolationCloseByCorrectionTool.cxx.

662  {
663  // check if the isolation can be loaded
664  if (!isTopoEtIso(type)) {
665  ATH_MSG_ERROR("getCloseByCorrectionTopoIso() -- The isolation type is not an et cone variable " << toString(type));
666  return CorrectionCode::Error;
667  }
668  if (m_isohelpers.at(type)->getOriginalIsolation(primary, isoValue) == CorrectionCode::Error) {
669  ATH_MSG_WARNING("Could not retrieve the isolation variable.");
670  return CorrectionCode::Error;
671  }
673  if (isoValue <= 0.) {
674  ATH_MSG_DEBUG("Topo et cone variable is already sufficiently isolated");
675  return CorrectionCode::Ok;
676  }
677  float ref_eta{0.f}, ref_phi{0.f};
678  getExtrapEtaPhi(primary, ref_eta, ref_phi);
679  ATH_MSG_VERBOSE("getCloseByCorrectionTopoIso: " << toString(type) << " of " << particleName(primary) << " with ref eta: " << ref_eta << ", ref phi " << ref_phi);
680 
681  float MaxDR = coneSize(primary, type) * (primary->type() != xAOD::Type::ObjectType::Muon ? 1. : m_ConeSizeVariation.value());
682  if (m_caloModel == TopoConeCorrectionModel::SubtractObjectsDirectly) {
683  ATH_MSG_VERBOSE("getCloseByCorrectionTopoIso: " << toString(type) << " of " << particleName(primary) << " with pt: "
684  << primary->pt() * MeVtoGeV << " GeV, eta: " << primary->eta()
685  << ", phi: " << primary->phi() << " before correction: " << isoValue * MeVtoGeV << " GeV. ");
687  for (const CaloClusterPtr& calo : cache.clusters) {
688  const float dR = xAOD::P4Helpers::deltaR(ref_eta, ref_phi, calo->eta(), calo->phi());
689  ATH_MSG_VERBOSE("getCloseByCorrectionTopoIso: Loop over cluster: " << calo->pt() * MeVtoGeV << " GeV, eta: " << calo->eta() << " phi: " << calo->phi() << " dR: " << dR);
690  if (dR > MaxDR) continue;
691  // REMOVED CORE CUT SINCE TOPOCLUSTERS SHOULD BE ASSOCIATED TO THE ELECTRONS AND MUONS AND WILL BE CUT BY ASSOC CUT BELOW
692  if (assoc.count(calo)) {
693  ATH_MSG_VERBOSE("getCloseByCorrectionTopoIso: skip due to assoc " << assoc.count(calo));
694  continue;
695  }
696  float Polution = clusterEtMinusTile(calo) / (isoValue != 0 ? isoValue : 1.);
697  if (Polution < 0. || Polution > m_maxTopoPolution) {
698  ATH_MSG_VERBOSE("getCloseByCorrectionTopoIso: skip due to polution " << Polution << ", clus noTile " << clusterEtMinusTile(calo) * MeVtoGeV << " GeV");
699  continue;
700  }
701  ATH_MSG_VERBOSE("getCloseByCorrectionTopoIso: Found overlapping topocluster: " << calo->pt() * MeVtoGeV << " GeV, lessTile " << clusterEtMinusTile(calo) * MeVtoGeV << " GeV, eta: " << calo->eta()
702  << " phi: " << calo->phi() << " dR: " << dR);
703  isoValue -= clusterEtMinusTile(calo);
704  }
705  ATH_MSG_VERBOSE("getCloseByCorrectionTopoIso: " << toString(type) << " of " << particleName(primary) << " with pt: "
706  << primary->pt() * MeVtoGeV << " GeV, eta: " << primary->eta()
707  << ", phi: " << primary->phi() << " after correction: " << isoValue * MeVtoGeV << " GeV. ");
708  } else if (m_caloModel == TopoConeCorrectionModel::UseAveragedDecorators) {
709  static const FloatAccessor acc_eta{caloDecors()[0]};
710  static const FloatAccessor acc_phi{caloDecors()[1]};
711  static const FloatAccessor acc_ene{caloDecors()[2]};
712  static const CharAccessor acc_isDecor{caloDecors()[3]};
713  for (const xAOD::IParticle* others : cache.prim_parts) {
714  if (others == primary) continue;
715  if (!acc_isDecor.isAvailable(*others) || !acc_isDecor(*others)) {
716  ATH_MSG_ERROR("The averaged calo cluster decorations are not available for "<<particleName(others)<<". Please check");
717  return CorrectionCode::Error;
718  }
719  const float other_eta = acc_eta(*others);
720  const float other_phi = acc_phi(*others);
721  const float dR = xAOD::P4Helpers::deltaR(ref_eta,ref_phi,other_eta,other_phi);
722  if (dR > MaxDR) continue;
723  if (dR< (primary->type() == xAOD::Type::ObjectType::Muon ? m_coreConeMu : m_coreConeEl)) continue;
724  isoValue -= acc_ene(*others);
725  }
726  }
727  isoValue = std::max(0.f, isoValue);
728  return CorrectionCode::Ok;
729  }

◆ getCloseByCorrectionTrackIso()

CorrectionCode CP::IsolationCloseByCorrectionTool::getCloseByCorrectionTrackIso ( const xAOD::IParticle primary,
const IsoType  type,
const ObjectCache cache,
float &  isoValue 
) const
private

Only check the TTVA working point again if the tool has non-TTVA working points

Definition at line 548 of file IsolationCloseByCorrectionTool.cxx.

549  {
550  if (!isTrackIso(type)) {
551  ATH_MSG_ERROR("Invalid isolation type " << toString(type));
552  return CorrectionCode::Error;
553  }
554  IsoHelperMap::const_iterator Itr = m_isohelpers.find(type);
555  if (Itr == m_isohelpers.end() || Itr->second->getOriginalIsolation(par, isoValue) == CorrectionCode::Error) {
556  ATH_MSG_WARNING(__func__<<"() -- "<<__LINE__<<" Could not retrieve the isolation variable " << toString(type));
557  return CorrectionCode::Error;
558  } else if (cache.tracks.empty())
559  return CorrectionCode::Ok;
560 
561  float MaxDR = coneSize(par, type);
562  const TrackSet ToExclude = getAssociatedTracks(par);
563 
564  const xAOD::IParticle* Ref = isoRefParticle(par);
565  ATH_MSG_VERBOSE(toString(type) << " of " << particleName(par) << " with pt: " << par->pt() * MeVtoGeV << " GeV, eta: " << par->eta()
566  << ", phi: " << par->phi() << " before correction: " << isoValue * MeVtoGeV << " GeV. "
567  << ToExclude.size() << " tracks will be excluded.");
568 
569  for (const TrackPtr& poluting_trk : cache.tracks) {
570  // Checks for the Pile-up robust isolation WP's
571  if (poluting_trk->pt() < trackPtCut(type)) continue;
573  if (isTrackIsoTTVA(type) && m_has_nonTTVA && !m_ttvaTool->isCompatible(*poluting_trk, *cache.prim_vtx)) continue;
574 
575  if (overlap(Ref, poluting_trk, MaxDR) && !ToExclude.count(poluting_trk)) {
576  ATH_MSG_VERBOSE("Subtract track with "
577  << poluting_trk->pt() * MeVtoGeV << " GeV, eta: " << poluting_trk->eta() << ", phi: " << poluting_trk->phi()
578  << " with dR: " << std::sqrt(deltaR2(Ref, poluting_trk)) << " from the isolation cone " << toString(type)
579  << " " << (isoValue * MeVtoGeV) << " GeV.");
580  isoValue -= poluting_trk->pt();
581  }
582  }
583  isoValue = std::max(0.f, isoValue);
584  ATH_MSG_VERBOSE(toString(type) << " of " << particleName(par) << " with pt: " << par->pt() * MeVtoGeV << " GeV, eta: " << par->eta()
585  << ", phi: " << par->phi() << " after correction: " << isoValue * MeVtoGeV << " GeV");
586  return CorrectionCode::Ok;
587  }

◆ getCloseByIsoCorrection()

CorrectionCode CP::IsolationCloseByCorrectionTool::getCloseByIsoCorrection ( const EventContext &  ctx,
const xAOD::ElectronContainer Electrons,
const xAOD::MuonContainer Muons,
const xAOD::PhotonContainer Photons 
) const
overridevirtual

Pick up first all objects that a considerable for the close-by correction

Implements CP::IIsolationCloseByCorrectionTool.

Definition at line 247 of file IsolationCloseByCorrectionTool.cxx.

251  {
252  if (!m_isInitialised) {
253  ATH_MSG_ERROR("The IsolationCloseByCorrectionTool was not initialised!!!");
254  return CorrectionCode::Error;
255  }
256  ObjectCache cache{};
259  loadPrimaryParticles(muons, cache);
260  loadPrimaryParticles(photons, cache);
261 
262  loadAssociatedObjects(ctx, cache);
263  return performCloseByCorrection(ctx, cache);
264  }

◆ getExtrapEtaPhi() [1/2]

bool CP::IsolationCloseByCorrectionTool::getExtrapEtaPhi ( const EventContext &  ctx,
const xAOD::TrackParticle tp,
float &  eta,
float &  phi 
) const
private

helper to get eta,phi of muon extrap

try the extention in athena if it's not obtained from muon yet.

if still not got the updated eta & phi

Definition at line 215 of file IsolationCloseByCorrectionTool.cxx.

215  {
217  ATH_MSG_DEBUG("Geting calo extension caloExtension tool.");
218  // If we have an extension cache then it owns the extension, otherwise we own it
219  // Therefore we have to prepare both an owning and a non-owning pointer
220  std::unique_ptr<Trk::CaloExtension> caloExtension;
221  caloExtension = m_caloExtTool->caloExtension(ctx, *tp);
222  if(!caloExtension){
223  ATH_MSG_WARNING("Can not get caloExtension.");
224  return false;
225  };
226 
227  const std::vector<Trk::CurvilinearParameters>& intersections = caloExtension->caloLayerIntersections();
228  if(!intersections.empty()){
229  Amg::Vector3D avePoint(0,0,0);
230  for (unsigned int i = 0; i < intersections.size(); ++i){
231  const Amg::Vector3D& point = intersections[i].position();
232  avePoint += point;
233  }
234  avePoint = (1./intersections.size())*avePoint;
235  eta = avePoint.eta();
236  phi = avePoint.phi();
237  return true;
238  } else {
239  ATH_MSG_WARNING("Muon Calo extension got no intersection!!!");
240  }
242  ATH_MSG_WARNING("Calo extension can not be obtained!!!");
243  return false;
244  }

◆ getExtrapEtaPhi() [2/2]

void CP::IsolationCloseByCorrectionTool::getExtrapEtaPhi ( const xAOD::IParticle particlear,
float &  eta,
float &  phi 
) const

Definition at line 730 of file IsolationCloseByCorrectionTool.cxx.

730  {
731  static const FloatAccessor acc_assocEta{IsolationCloseByCorrectionTool::caloDecors()[0]};
732  static const FloatAccessor acc_assocPhi{IsolationCloseByCorrectionTool::caloDecors()[1]};
733  static const CharAccessor acc_isDecor{caloDecors()[3]};
734  if (par->type() != xAOD::Type::ObjectType::Muon) {
735  const xAOD::Egamma* egam = dynamic_cast<const xAOD::Egamma*>(par);
736  if( egam ) {
737  eta = egam->caloCluster()->eta();
738  phi = egam->caloCluster()->phi();
739  }
740  else {
741  eta = par->eta();
742  phi = par->phi();
743  }
744  } else if (acc_isDecor.isAvailable(*par) && acc_isDecor(*par)) {
745  eta = acc_assocEta(*par);
746  phi = acc_assocPhi(*par);
747  } else {
748  float assoc_ene{0.f};
749  static const FloatDecorator dec_assocEta{IsolationCloseByCorrectionTool::caloDecors()[0]};
750  static const FloatDecorator dec_assocPhi{IsolationCloseByCorrectionTool::caloDecors()[1]};
751  static const CharDecorator dec_isDecor{caloDecors()[3]};
752  associateCluster(par,eta, phi, assoc_ene);
753  dec_assocEta(*par) = eta;
754  dec_assocPhi(*par) = phi;
755  dec_isDecor(*par) = true;
756  }
757  }

◆ getIsolationTypes()

const IsoVector & CP::IsolationCloseByCorrectionTool::getIsolationTypes ( const xAOD::IParticle particle) const
private

Definition at line 300 of file IsolationCloseByCorrectionTool.cxx.

300  {
301  static const IsoVector dummy{};
302  if (!particle) return dummy;
304  return m_electron_isoTypes;
305  else if (particle->type() == xAOD::Type::ObjectType::Muon)
306  return m_muon_isoTypes;
307  else if (particle->type() == xAOD::Type::ObjectType::Photon)
308  return m_photon_isoTypes;
309  return dummy;
310  }

◆ getKey()

SG::sgkey_t asg::AsgTool::getKey ( const void *  ptr) const
inherited

Get the (hashed) key of an object that is in the event store.

This is a bit of a special one. StoreGateSvc and xAOD::TEvent both provide ways for getting the SG::sgkey_t key for an object that is in the store, based on a bare pointer. But they provide different interfaces for doing so.

In order to allow tools to efficiently perform this operation, they can use this helper function.

See also
asg::AsgTool::getName
Parameters
ptrThe bare pointer to the object that the event store should know about
Returns
The hashed key of the object in the store. If not found, an invalid (zero) key.

Definition at line 119 of file AsgTool.cxx.

119  {
120 
121 #ifdef XAOD_STANDALONE
122  // In case we use @c xAOD::TEvent, we have a direct function call
123  // for this.
124  return evtStore()->event()->getKey( ptr );
125 #else
126  const SG::DataProxy* proxy = evtStore()->proxy( ptr );
127  return ( proxy == nullptr ? 0 : proxy->sgkey() );
128 #endif // XAOD_STANDALONE
129  }

◆ getName()

const std::string & asg::AsgTool::getName ( const void *  ptr) const
inherited

Get the name of an object that is / should be in the event store.

This is a bit of a special one. StoreGateSvc and xAOD::TEvent both provide ways for getting the std::string name for an object that is in the store, based on a bare pointer. But they provide different interfaces for doing so.

In order to allow tools to efficiently perform this operation, they can use this helper function.

See also
asg::AsgTool::getKey
Parameters
ptrThe bare pointer to the object that the event store should know about
Returns
The string name of the object in the store. If not found, an empty string.

Definition at line 106 of file AsgTool.cxx.

106  {
107 
108 #ifdef XAOD_STANDALONE
109  // In case we use @c xAOD::TEvent, we have a direct function call
110  // for this.
111  return evtStore()->event()->getName( ptr );
112 #else
113  const SG::DataProxy* proxy = evtStore()->proxy( ptr );
114  static const std::string dummy = "";
115  return ( proxy == nullptr ? dummy : proxy->name() );
116 #endif // XAOD_STANDALONE
117  }

◆ getOriginalIsolation() [1/2]

float CP::IsolationCloseByCorrectionTool::getOriginalIsolation ( const xAOD::IParticle P,
IsoType  type 
) const
overridevirtual

Implements CP::IIsolationCloseByCorrectionTool.

Definition at line 972 of file IsolationCloseByCorrectionTool.cxx.

972  {
974  }

◆ getOriginalIsolation() [2/2]

float CP::IsolationCloseByCorrectionTool::getOriginalIsolation ( const xAOD::IParticle particle,
IsoType  type 
) const
overridevirtual

Implements CP::IIsolationCloseByCorrectionTool.

Definition at line 963 of file IsolationCloseByCorrectionTool.cxx.

963  {
964  IsoHelperMap::const_iterator itr = m_isohelpers.find(isoVariable);
965  float isovalue = 0;
966  if (itr == m_isohelpers.end() || itr->second->getOriginalIsolation(particle, isovalue) == CorrectionCode::Error) {
967  ATH_MSG_ERROR("Failed to retrive the original isolation cone ");
968  isovalue = FLT_MAX;
969  }
970  return isovalue;
971  }

◆ getProperty()

template<class T >
const T* asg::AsgTool::getProperty ( const std::string &  name) const
inherited

Get one of the tool's properties.

◆ getTrackCandidates()

TrackSet CP::IsolationCloseByCorrectionTool::getTrackCandidates ( const EventContext &  ctx,
const xAOD::IParticle particle 
) const
overridevirtual

Load all TrackParticles associated with the particles in the Container. The particles have to pass the selection decoration flag.

Implements CP::IIsolationCloseByCorrectionTool.

Definition at line 455 of file IsolationCloseByCorrectionTool.cxx.

455  {
457  }

◆ initialize()

StatusCode CP::IsolationCloseByCorrectionTool::initialize ( )
overridevirtual

Dummy implementation of the initialisation function.

It's here to allow the dual-use tools to skip defining an initialisation function. Since many are doing so...

Retrieve the isolation tool and load the isolation cones

Setup the data dependency

Same holds for the TTVA selection tool

Reimplemented from asg::AsgTool.

Definition at line 37 of file IsolationCloseByCorrectionTool.cxx.

37  {
39  ATH_CHECK(m_selectorTool.retrieve());
43 
47  if (!m_isoDecSuffix.empty()) ATH_MSG_INFO("IsoDecSuffix set to " << m_isoDecSuffix);
48  if (!m_quality_name.empty()) ATH_MSG_INFO("SelectionDecorator set to " << m_quality_name);
49 
50 
51 #ifndef XAOD_ANALYSIS
56  ATH_CHECK(m_isoVarKeys.initialize());
57  ATH_CHECK(m_isoWriteDecVarKeys.initialize());
58  if (!m_caloExtTool.empty()) ATH_CHECK(m_caloExtTool.retrieve());
59  else {
60  ATH_MSG_WARNING("The ParticleCaloExtensionTool was not configured. Pleease include it!!!");
61  }
62 #endif
63 
64  ATH_CHECK(m_VtxKey.initialize());
65  ATH_CHECK(m_CaloClusterKey.initialize(m_caloModel == TopoConeCorrectionModel::SubtractObjectsDirectly));
66  ATH_CHECK(m_PflowKey.initialize(m_caloModel == TopoConeCorrectionModel::SubtractObjectsDirectly));
67 
68  // set default properties of track selection tool, if the user hasn't configured it
69  if (m_trkselTool.empty()) {
70  asg::AsgToolConfig config{"InDet::InDetTrackSelectionTool/TrackParticleSelectionTool"};
71  ATH_MSG_INFO("No TrackSelectionTool provided, so I will create and configure my own, called: " << config.name());
72  // The z0 cut is checked in any case either by the
73  // track to vertex association tool or by the tracking tool
74  ATH_CHECK(config.setProperty("maxZ0SinTheta", 3.));
75  // The minimum Pt requirement is lowered to 500 MeV because
76  // the Loose ttva cone variables accept very low-pt tracks
77  // https://gitlab.cern.ch/atlas/athena/blob/21.2/Reconstruction/RecoAlgs/IsolationAlgs/python/IsoUpdatedTrackCones.py#L21
78  ATH_CHECK(config.setProperty("minPt", 500.));
79  ATH_CHECK(config.setProperty("CutLevel", "Loose"));
80  ATH_CHECK(config.makePrivateTool(m_trkselTool));
81  }
83  if (m_ttvaTool.empty()) {
84  asg::AsgToolConfig config{"CP::TrackVertexAssociationTool/ttva_selection_tool"};
85  ATH_CHECK(config.setProperty("WorkingPoint", "Nonprompt_All_MaxWeight"));
86  ATH_CHECK(config.makePrivateTool(m_ttvaTool));
87  }
88  ATH_CHECK(m_trkselTool.retrieve());
89  ATH_CHECK(m_ttvaTool.retrieve());
90 
91  if (!m_quality_name.empty()) m_acc_quality = std::make_unique<CharAccessor>(m_quality_name);
92  if (!m_passOR_name.empty()) m_acc_passOR = std::make_unique<CharAccessor>(m_passOR_name);
93  if (!m_isoSelection_name.empty()) m_dec_isoselection = std::make_unique<CharDecorator>(m_isoSelection_name);
94  m_isInitialised = true;
95  return StatusCode::SUCCESS;
96  }

◆ inputHandles()

virtual std::vector<Gaudi::DataHandle*> AthCommonDataStore< AthCommonMsg< AlgTool > >::inputHandles ( ) const
overridevirtualinherited

Return this algorithm's input handles.

We override this to include handle instances from key arrays if they have not yet been declared. See comments on updateVHKA.

◆ isEgamma()

bool CP::IsolationCloseByCorrectionTool::isEgamma ( const xAOD::IParticle particle)
static

Definition at line 458 of file IsolationCloseByCorrectionTool.cxx.

458  {
459  return P && (P->type() == xAOD::Type::ObjectType::Electron || P->type() == xAOD::Type::ObjectType::Photon);
460  }

◆ isFixedTrackIso()

bool CP::IsolationCloseByCorrectionTool::isFixedTrackIso ( xAOD::Iso::IsolationType  type)
static

Definition at line 995 of file IsolationCloseByCorrectionTool.cxx.

◆ isFixedTrackIsoTTVA()

bool CP::IsolationCloseByCorrectionTool::isFixedTrackIsoTTVA ( xAOD::Iso::IsolationType  type)
static

◆ isoRefParticle()

const xAOD::IParticle * CP::IsolationCloseByCorrectionTool::isoRefParticle ( const xAOD::IParticle particle) const
overridevirtual

Retrieve the reference particle to define the cone axis in which the track particles contributing to the isolation have to be.

Implements CP::IIsolationCloseByCorrectionTool.

Definition at line 925 of file IsolationCloseByCorrectionTool.cxx.

925  {
926  if (!P) {
927  ATH_MSG_ERROR("Nullptr given");
928  return nullptr;
929  }
930  // Use for muons the associated ID track. Else the particle itself
931  if (P->type() == xAOD::Type::ObjectType::Muon) {
932  const xAOD::Muon* muon = static_cast<const xAOD::Muon*>(P);
933  const xAOD::TrackParticle* idTrk = muon->trackParticle(xAOD::Muon::TrackParticleType::InnerDetectorTrackParticle);
934  return idTrk ? idTrk : muon->primaryTrackParticle();
935  }
936  return P;
937  }

◆ isoTypesFromWP()

void CP::IsolationCloseByCorrectionTool::isoTypesFromWP ( const std::vector< std::unique_ptr< IsolationWP >> &  WP,
IsoVector types 
)
private

Helper function to load all Isolation types from the iso working points.

Definition at line 97 of file IsolationCloseByCorrectionTool.cxx.

97  {
98  types.clear();
99  for (const std::unique_ptr<IsolationWP>& W : WPs) {
100  for (const std::unique_ptr<IsolationCondition>& C : W->conditions()) {
101  for (unsigned int t = 0; t < C->num_types(); ++t) {
102  const IsoType iso_type = C->type(t);
103  if (std::find(types.begin(), types.end(), iso_type) == types.end()) types.emplace_back(iso_type);
104  if (m_isohelpers.find(iso_type) == m_isohelpers.end()) {
105  m_isohelpers.insert(std::make_pair(iso_type, std::make_unique<IsoVariableHelper>(iso_type, m_backup_prefix, m_isoDecSuffix)));
106  }
107  }
108  }
109  }
110  m_has_nonTTVA |= std::find_if(types.begin(), types.end(),
111  [](const IsolationType& t) { return isTrackIso(t) && !isTrackIsoTTVA(t); }) != types.end();
112  m_hasPflowIso |= std::find_if(types.begin(), types.end(),
113  [](const IsolationType& t) { return isPFlowIso(t); }) != types.end();
114  m_hasEtConeIso |= std::find_if(types.begin(), types.end(),
115  [](const IsolationType& t) { return isTopoEtIso(t); }) != types.end();
116  }

◆ isPFlowIso()

bool CP::IsolationCloseByCorrectionTool::isPFlowIso ( xAOD::Iso::IsolationType  type)
static

◆ isSame()

bool CP::IsolationCloseByCorrectionTool::isSame ( const xAOD::IParticle particle,
const xAOD::IParticle particle1 
) const

Definition at line 938 of file IsolationCloseByCorrectionTool.cxx.

938  {
939  if (!P || !P1) {
940  ATH_MSG_WARNING("Nullptr were given");
941  return true;
942  }
943  return (P == P1);
944  }

◆ isTopoEtIso()

bool CP::IsolationCloseByCorrectionTool::isTopoEtIso ( xAOD::Iso::IsolationType  type)
static

◆ isTrackIso()

bool CP::IsolationCloseByCorrectionTool::isTrackIso ( xAOD::Iso::IsolationType  type)
static

Definition at line 997 of file IsolationCloseByCorrectionTool.cxx.

997  {
999  }

◆ isTrackIsoTTVA()

bool CP::IsolationCloseByCorrectionTool::isTrackIsoTTVA ( xAOD::Iso::IsolationType  type)
static

Definition at line 1017 of file IsolationCloseByCorrectionTool.cxx.

◆ isVarTrackIso()

bool CP::IsolationCloseByCorrectionTool::isVarTrackIso ( xAOD::Iso::IsolationType  type)
static

◆ isVarTrackIsoTTVA()

bool CP::IsolationCloseByCorrectionTool::isVarTrackIsoTTVA ( xAOD::Iso::IsolationType  Iso)
static

◆ loadAssociatedObjects()

void CP::IsolationCloseByCorrectionTool::loadAssociatedObjects ( const EventContext &  ctx,
ObjectCache cache 
) const

Load all associated tracks / clusters / flow elements into the cache.

Definition at line 161 of file IsolationCloseByCorrectionTool.cxx.

161  {
162 
163  // Use isLRT decoration for LLP particles to avoid looking for tracks from the primary vertex
164  const CharAccessor isLRT("isLRT");
165 
166  cache.prim_vtx = retrieveIDBestPrimaryVertex(ctx);
167  for (const xAOD::IParticle* prim : cache.prim_parts) {
168  // skip LRT leptons
169  if (!isLRT.isAvailable(*prim) || !isLRT(*prim) ) {
170  const TrackSet tracks = getAssociatedTracks(prim, cache.prim_vtx);
171  cache.tracks.insert(tracks.begin(), tracks.end());
172  }
173  const ClusterSet clusters = getAssociatedClusters(ctx, prim);
174  cache.clusters.insert(clusters.begin(), clusters.end());
175  }
176  getAssocFlowElements(ctx, cache);
177  }

◆ loadPrimaryParticles()

void CP::IsolationCloseByCorrectionTool::loadPrimaryParticles ( const xAOD::IParticleContainer container,
ObjectCache cache 
) const

Filter all electrons/muons/photons from the collection which pass the selection decoration.

Definition at line 136 of file IsolationCloseByCorrectionTool.cxx.

136  {
137  if (!container) return;
138  for (const xAOD::IParticle* particle : *container) {
139  if (m_dec_isoselection) (*m_dec_isoselection)(*particle) = true && m_selectorTool->accept(*particle);
140  const IsoVector& iso_types = getIsolationTypes(particle);
141  if (iso_types.empty()) { ATH_MSG_DEBUG("No isolation types have been defined for particle type " << particleName(particle)); }
142  for (const IsoType type : iso_types) {
143  IsoHelperMap::const_iterator Itr = m_isohelpers.find(type);
144  if (Itr == m_isohelpers.end() || Itr->second->backupIsolation(particle) == CorrectionCode::Error) {
145  ATH_MSG_WARNING("Failed to properly access the vanilla isolation variable "
146  << toString(type) << "for particle " << particleName(particle) << " with pT: "
147  << particle->pt() * MeVtoGeV << " GeV, eta: " << particle->eta() << ", phi: " << particle->phi());
148  }
149  }
150  // Save all particles to be sure to output the new iso decorated values
151  // They either pass or not the selection.
152  // The selected ones participate in the CloseBy and may have their isolation corrected.
154  cache.not_sel_parts.insert(particle);
155  }
156  else {
157  cache.prim_parts.insert(particle);
158  }
159  }
160  }

◆ msg() [1/2]

MsgStream& AthCommonMsg< AlgTool >::msg ( ) const
inlineinherited

Definition at line 24 of file AthCommonMsg.h.

24  {
25  return this->msgStream();
26  }

◆ msg() [2/2]

MsgStream& AthCommonMsg< AlgTool >::msg ( const MSG::Level  lvl) const
inlineinherited

Definition at line 27 of file AthCommonMsg.h.

27  {
28  return this->msgStream(lvl);
29  }

◆ msg_level_name()

const std::string & asg::AsgTool::msg_level_name ( ) const
inherited

A deprecated function for getting the message level's name.

Instead of using this, weirdly named function, user code should get the string name of the current minimum message level (in case they really need it...), with:

MSG::name( msg().level() )

This function's name doesn't follow the ATLAS coding rules, and as such will be removed in the not too distant future.

Returns
The string name of the current minimum message level that's printed

Definition at line 101 of file AsgTool.cxx.

101  {
102 
103  return MSG::name( msg().level() );
104  }

◆ msgLvl()

bool AthCommonMsg< AlgTool >::msgLvl ( const MSG::Level  lvl) const
inlineinherited

Definition at line 30 of file AthCommonMsg.h.

30  {
31  return this->msgLevel(lvl);
32  }

◆ outputHandles()

virtual std::vector<Gaudi::DataHandle*> AthCommonDataStore< AthCommonMsg< AlgTool > >::outputHandles ( ) const
overridevirtualinherited

Return this algorithm's output handles.

We override this to include handle instances from key arrays if they have not yet been declared. See comments on updateVHKA.

◆ overlap()

bool CP::IsolationCloseByCorrectionTool::overlap ( const xAOD::IParticle particle,
const xAOD::IParticle particle1,
float  dR 
) const

Definition at line 960 of file IsolationCloseByCorrectionTool.cxx.

960  {
961  return (!isSame(P, P1) && deltaR2(P, P1) < (dR * dR));
962  }

◆ particleName() [1/2]

std::string CP::IsolationCloseByCorrectionTool::particleName ( const xAOD::IParticle C)
static

Definition at line 986 of file IsolationCloseByCorrectionTool.cxx.

986 { return particleName(C->type()); }

◆ particleName() [2/2]

std::string CP::IsolationCloseByCorrectionTool::particleName ( xAOD::Type::ObjectType  T)
static

Definition at line 987 of file IsolationCloseByCorrectionTool.cxx.

987  {
988  if (T == xAOD::Type::ObjectType::Electron) return "Electron";
989  if (T == xAOD::Type::ObjectType::Photon) return "Photon";
990  if (T == xAOD::Type::ObjectType::Muon) return "Muon";
991  if (T == xAOD::Type::ObjectType::TrackParticle) return "Track";
992  if (T == xAOD::Type::ObjectType::CaloCluster) return "Cluster";
993  return "Unknown";
994  }

◆ passFirstStage()

bool CP::IsolationCloseByCorrectionTool::passFirstStage ( const xAOD::TrackParticle trk,
const xAOD::Vertex vtx 
) const
private

The Track particle has to pass the Track selection tool and the TTVA selection.

The latter only applies if there's no WP floating around using the legacy ptcone variables

Definition at line 424 of file IsolationCloseByCorrectionTool.cxx.

424  {
425  return trk && vtx && m_trkselTool->accept(*trk, vtx) && (!m_has_nonTTVA || m_ttvaTool->isCompatible(*trk, *vtx));
426  }

◆ passSelectionQuality()

bool CP::IsolationCloseByCorrectionTool::passSelectionQuality ( const xAOD::IParticle particle) const
private

Definition at line 542 of file IsolationCloseByCorrectionTool.cxx.

542  {
543  if (!P) return false;
544  if (m_acc_quality && (!m_acc_quality->isAvailable(*P) || !(*m_acc_quality)(*P))) return false;
545  if (m_acc_passOR && (!m_acc_passOR->isAvailable(*P) || !(*m_acc_passOR)(*P))) return false;
546  return true;
547  }

◆ performCloseByCorrection()

CorrectionCode CP::IsolationCloseByCorrectionTool::performCloseByCorrection ( const EventContext &  ctx,
ObjectCache cache 
) const
private

Definition at line 265 of file IsolationCloseByCorrectionTool.cxx.

265  {
266  if (cache.prim_vtx) {
267  // require a primary vertex for isolation correction - expect that if there is not primary vertex, then we only need to assure that the cache.not_sel_parts are treated correctly below
268  for (const xAOD::IParticle* particle : cache.prim_parts) {
269  ATH_MSG_DEBUG("Correct the isolation of particle "<<particleName(particle)<< " with pt: " << particle->pt() * MeVtoGeV << " GeV"
270  << " eta: " << particle->eta()
271  << " phi: " << particle->phi());
272 
274  ATH_MSG_ERROR("Failed to correct the isolation of particle with pt: " << particle->pt() * MeVtoGeV << " GeV"
275  << " eta: " << particle->eta()
276  << " phi: " << particle->phi());
277  return CorrectionCode::Error;
278  }
279  if (m_dec_isoselection) (*m_dec_isoselection)(*particle) = bool(m_selectorTool->accept(*particle));
280  ATH_MSG_DEBUG("Corrected the isolation of particle with pt: " << particle->pt() * MeVtoGeV << " GeV"
281  << " eta: " << particle->eta()
282  << " phi: " << particle->phi());
283 
284  }
285  }
286  // Only need to copy the uncorrected iso values
287  for (const xAOD::IParticle* particle : cache.not_sel_parts) {
288  ATH_MSG_DEBUG("Copy isolation values of particle with pt: " << particle->pt() * MeVtoGeV << " GeV"
289  << " eta: " << particle->eta()
290  << " phi: " << particle->phi());
292  ATH_MSG_ERROR("Failed to copy the isolation of particle with pt: " << particle->pt() * MeVtoGeV << " GeV"
293  << " eta: " << particle->eta()
294  << " phi: " << particle->phi());
295  return CorrectionCode::Error;
296  }
297  }
298  return CorrectionCode::Ok;
299  }

◆ pflowDecors()

caloDecorNames CP::IsolationCloseByCorrectionTool::pflowDecors ( )
static

Definition at line 28 of file IsolationCloseByCorrectionTool.cxx.

28  {
29  return {"IsoCloseByCorr_assocPflowEta", "IsoCloseByCorr_assocPflowPhi", "IsoCloseByCorr_assocPflowEnergy",
30  "IsoCloseByCorr_assocPflowDecor"};
31  }

◆ print()

void asg::AsgTool::print ( ) const
virtualinherited

◆ printIsolationCones()

void CP::IsolationCloseByCorrectionTool::printIsolationCones ( const IsoVector types,
xAOD::Type::ObjectType  T 
) const
private

Definition at line 1018 of file IsolationCloseByCorrectionTool.cxx.

1018  {
1019  ATH_MSG_INFO("The following isolation cones are considered for " << particleName(T));
1020  for (const IsoType& cone : types) { ATH_MSG_INFO(" --- " << toString(cone)); }
1021  }

◆ renounce()

std::enable_if_t<std::is_void_v<std::result_of_t<decltype(&T::renounce)(T)> > && !std::is_base_of_v<SG::VarHandleKeyArray, T> && std::is_base_of_v<Gaudi::DataHandle, T>, void> AthCommonDataStore< AthCommonMsg< AlgTool > >::renounce ( T &  h)
inlineprotectedinherited

Definition at line 380 of file AthCommonDataStore.h.

381  {
382  h.renounce();
383  PBASE::renounce (h);
384  }

◆ renounceArray()

void AthCommonDataStore< AthCommonMsg< AlgTool > >::renounceArray ( SG::VarHandleKeyArray handlesArray)
inlineprotectedinherited

remove all handles from I/O resolution

Definition at line 364 of file AthCommonDataStore.h.

364  {
365  handlesArray.renounce();
366  }

◆ retrieveIDBestPrimaryVertex()

const xAOD::Vertex * CP::IsolationCloseByCorrectionTool::retrieveIDBestPrimaryVertex ( const EventContext &  ctx) const

Definition at line 890 of file IsolationCloseByCorrectionTool.cxx.

890  {
892  if (!Verticies.isValid() || !Verticies->size()) {
893  ATH_MSG_WARNING("Failed to load vertex collection " << m_VtxKey.key());
894  return nullptr;
895  }
896  for (const xAOD::Vertex* V : *Verticies) {
897  if (V->vertexType() == xAOD::VxType::VertexType::PriVtx) return V;
898  }
899  return nullptr;
900  }

◆ subtractCloseByContribution()

CorrectionCode CP::IsolationCloseByCorrectionTool::subtractCloseByContribution ( const EventContext &  ctx,
const xAOD::IParticle P,
const ObjectCache cache 
) const
private

Definition at line 312 of file IsolationCloseByCorrectionTool.cxx.

314  {
316  if (types.empty()) {
317  ATH_MSG_WARNING("No isolation types are defiend for " << particleName(par));
319  }
320  for (const IsolationType iso_type : types) {
321  float iso_variable{0.f};
322  if (isTrackIso(iso_type)) {
323  if (getCloseByCorrectionTrackIso(par, iso_type, cache, iso_variable) == CorrectionCode::Error) {
324  ATH_MSG_ERROR("Failed to apply track correction");
325  return CorrectionCode::Error;
326  }
327  } else if (isTopoEtIso(iso_type)) {
328  if (getCloseByCorrectionTopoIso(ctx, par, iso_type, cache, iso_variable) == CorrectionCode::Error) {
329  ATH_MSG_ERROR("Failed to apply topo cluster correction");
330  return CorrectionCode::Error;
331  }
332  } else if (isPFlowIso(iso_type)) {
333  if (getCloseByCorrectionPflowIso(ctx, par, iso_type, cache, iso_variable) == CorrectionCode::Error) {
334  ATH_MSG_ERROR("Failed to apply pflow correction");
335  return CorrectionCode::Error;
336  }
337  }
338  ATH_MSG_DEBUG("subtractCloseByContribution: Set pt, eta, phi " << par->pt() << ", " << par->eta() << ", " << par->phi() << " for " << toString(iso_type) << " to " << iso_variable);
339  if (m_isohelpers.at(iso_type)->setIsolation(par, iso_variable) == CorrectionCode::Error) {
340  ATH_MSG_ERROR("Cannot set " << toString(iso_type) << " to " << iso_variable);
341  return CorrectionCode::Error;
342  }
343  }
344  return CorrectionCode::Ok;
345  }

◆ sysInitialize()

virtual StatusCode AthCommonDataStore< AthCommonMsg< AlgTool > >::sysInitialize ( )
overridevirtualinherited

Perform system initialization for an algorithm.

We override this to declare all the elements of handle key arrays at the end of initialization. See comments on updateVHKA.

Reimplemented in DerivationFramework::CfAthAlgTool, AthCheckedComponent< AthAlgTool >, AthCheckedComponent<::AthAlgTool >, and asg::AsgMetadataTool.

◆ sysStart()

virtual StatusCode AthCommonDataStore< AthCommonMsg< AlgTool > >::sysStart ( )
overridevirtualinherited

Handle START transition.

We override this in order to make sure that conditions handle keys can cache a pointer to the conditions container.

◆ trackPtCut()

float CP::IsolationCloseByCorrectionTool::trackPtCut ( xAOD::Iso::IsolationType  type)
static

Definition at line 1022 of file IsolationCloseByCorrectionTool.cxx.

1022  {
1023  if (!isTrackIso(type)) return -1;
1025  static const std::set<IsolationFlavour> Pt1000_Flavours{IsolationFlavour::ptcone_Nonprompt_All_MaxWeightTTVA_pt1000,
1029  if (Pt1000_Flavours.count(flavour)) return 1000;
1030  return 500;
1031  }

◆ unCalibPt()

float CP::IsolationCloseByCorrectionTool::unCalibPt ( const xAOD::IParticle particle) const
private

Definition at line 912 of file IsolationCloseByCorrectionTool.cxx.

912  {
913  if (!P) {
914  ATH_MSG_WARNING("No partcile given. Return stupidly big number. ");
915  return 1.e25;
916  }
918  if (!OR) {
919  ATH_MSG_VERBOSE("No reference from the shallow copy container of " << particleName(P) << " could be found");
920  return P->pt();
921  }
922  return OR->pt();
923  }

◆ updateVHKA()

void AthCommonDataStore< AthCommonMsg< AlgTool > >::updateVHKA ( Gaudi::Details::PropertyBase &  )
inlineinherited

Definition at line 308 of file AthCommonDataStore.h.

308  {
309  // debug() << "updateVHKA for property " << p.name() << " " << p.toString()
310  // << " size: " << m_vhka.size() << endmsg;
311  for (auto &a : m_vhka) {
312  std::vector<SG::VarHandleKey*> keys = a->keys();
313  for (auto k : keys) {
314  k->setOwner(this);
315  }
316  }
317  }

Member Data Documentation

◆ ATLAS_THREAD_SAFE [1/2]

IsoHelperMap m_isohelpers CP::IsolationCloseByCorrectionTool::ATLAS_THREAD_SAFE
mutableprivate

Definition at line 299 of file IsolationCloseByCorrectionTool.h.

◆ ATLAS_THREAD_SAFE [2/2]

std::mutex m_isoHelpersMutex CP::IsolationCloseByCorrectionTool::ATLAS_THREAD_SAFE
mutableprivate

Mutex to protect the map if the method with signature getCloseByCorrection(std::vector<float>& corrections, const xAOD::IParticle& par, const std::vector<xAOD::Iso::IsolationType>& types, const xAOD::IParticleContainer& closePar) is called.

Definition at line 304 of file IsolationCloseByCorrectionTool.h.

◆ m_acc_passOR

SelectionAccessor CP::IsolationCloseByCorrectionTool::m_acc_passOR {nullptr}
private

Definition at line 295 of file IsolationCloseByCorrectionTool.h.

◆ m_acc_quality

SelectionAccessor CP::IsolationCloseByCorrectionTool::m_acc_quality {nullptr}
private

Definition at line 294 of file IsolationCloseByCorrectionTool.h.

◆ m_backup_prefix

Gaudi::Property<std::string> CP::IsolationCloseByCorrectionTool::m_backup_prefix
private
Initial value:
{
this, "BackupPrefix", "", "Prefix in front of the isolation variables, if the original cone values need to be backuped"}

Definition at line 214 of file IsolationCloseByCorrectionTool.h.

◆ m_CaloClusterKey

SG::ReadHandleKey<xAOD::CaloClusterContainer> CP::IsolationCloseByCorrectionTool::m_CaloClusterKey
private
Initial value:
{this, "CaloClusterContainer", "CaloCalTopoClusters",
"Name of the primary calo cluster container"}

Definition at line 274 of file IsolationCloseByCorrectionTool.h.

◆ m_caloExtTool

ToolHandle<Trk::IParticleCaloExtensionTool> CP::IsolationCloseByCorrectionTool::m_caloExtTool {this, "ParticleCaloExtensionTool", "Trk::ParticleCaloExtensionTool/ParticleCaloExtensionTool"}
private

calo extension tool for muon track particle extrapolation to calo

Definition at line 266 of file IsolationCloseByCorrectionTool.h.

◆ m_caloModel

Gaudi::Property<int> CP::IsolationCloseByCorrectionTool::m_caloModel {this, "CaloCorrectionModel", TopoConeCorrectionModel::SubtractObjectsDirectly}
private

EXPERT PROPERTIES.

Definition at line 221 of file IsolationCloseByCorrectionTool.h.

◆ m_ConeSizeVariation

Gaudi::Property<float> CP::IsolationCloseByCorrectionTool::m_ConeSizeVariation
private
Initial value:
{
this, "ExtrapolationConeSize", 1.2,
"Constant factor to be multiplied on top of the topo-etcone size if the reference particle is not a calorimeter particle in "
"order to account for extrapolation effects"}

Definition at line 244 of file IsolationCloseByCorrectionTool.h.

◆ m_coreConeEl

Gaudi::Property<float> CP::IsolationCloseByCorrectionTool::m_coreConeEl
private
Initial value:
{this, "CoreConeElectrons", 0.1,
"This is the size of the core cone for the topoetcone variables."}

Definition at line 224 of file IsolationCloseByCorrectionTool.h.

◆ m_coreConeMu

Gaudi::Property<float> CP::IsolationCloseByCorrectionTool::m_coreConeMu {this, "CoreConeMuons", 0.05, "This is the size of the core cone for the topoetcone variables."}
private

Definition at line 229 of file IsolationCloseByCorrectionTool.h.

◆ m_dec_isoselection

SelectionDecorator CP::IsolationCloseByCorrectionTool::m_dec_isoselection {nullptr}
private

Definition at line 296 of file IsolationCloseByCorrectionTool.h.

◆ m_declareCaloDecors

Gaudi::Property<bool> CP::IsolationCloseByCorrectionTool::m_declareCaloDecors {this, "declareCaloDecors", false, "If set to true, the data dependency on the calo/pflow decors will be declared"}
private

Definition at line 249 of file IsolationCloseByCorrectionTool.h.

◆ m_detStore

StoreGateSvc_t AthCommonDataStore< AthCommonMsg< AlgTool > >::m_detStore
privateinherited

Pointer to StoreGate (detector store by default)

Definition at line 393 of file AthCommonDataStore.h.

◆ m_elecKeys

Gaudi::Property<std::vector<std::string> > CP::IsolationCloseByCorrectionTool::m_elecKeys
private
Initial value:
{
this, "EleContainers", {}, "Pipe the list of electron containers given later to the tool"}

Declare the data dependencies of the Input containers.

The isolation variables used in the working point calculation are declared to the avalanche scheduler. This is not needed for the AthAnalysis nor AnalysisBase releases.

Definition at line 254 of file IsolationCloseByCorrectionTool.h.

◆ m_electron_isoTypes

IsoVector CP::IsolationCloseByCorrectionTool::m_electron_isoTypes {}
private

Isolation variables used by the electron working point.

Definition at line 281 of file IsolationCloseByCorrectionTool.h.

◆ m_evtStore

StoreGateSvc_t AthCommonDataStore< AthCommonMsg< AlgTool > >::m_evtStore
privateinherited

Pointer to StoreGate (event store by default)

Definition at line 390 of file AthCommonDataStore.h.

◆ m_has_nonTTVA

bool CP::IsolationCloseByCorrectionTool::m_has_nonTTVA {false}
private

Switch whether a pile-up non robust TTVA working point is defined.

Definition at line 285 of file IsolationCloseByCorrectionTool.h.

◆ m_hasEtConeIso

bool CP::IsolationCloseByCorrectionTool::m_hasEtConeIso {false}
private

Switch whether a topoetcone isolation working point is defined.

Definition at line 289 of file IsolationCloseByCorrectionTool.h.

◆ m_hasPflowIso

bool CP::IsolationCloseByCorrectionTool::m_hasPflowIso {false}
private

Switch whether a pflow isolation working point is defined.

Definition at line 287 of file IsolationCloseByCorrectionTool.h.

◆ m_isInitialised

bool CP::IsolationCloseByCorrectionTool::m_isInitialised {false}
private

Definition at line 292 of file IsolationCloseByCorrectionTool.h.

◆ m_isoDecSuffix

Gaudi::Property<std::string> CP::IsolationCloseByCorrectionTool::m_isoDecSuffix
private
Initial value:
{
this, "IsoDecSuffix", "", "Suffix added to output isolation variable nanes for close by corrections"}

Definition at line 217 of file IsolationCloseByCorrectionTool.h.

◆ m_isoSelection_name

Gaudi::Property<std::string> CP::IsolationCloseByCorrectionTool::m_isoSelection_name {this, "IsolationSelectionDecorator", "", "Name of the final isolation decorator."}
private

Definition at line 212 of file IsolationCloseByCorrectionTool.h.

◆ m_isoVarKeys

SG::ReadDecorHandleKeyArray<xAOD::IParticleContainer> CP::IsolationCloseByCorrectionTool::m_isoVarKeys
private
Initial value:
{
this, "IsoVarKeys", {}, "The list is filled during the initialization"}

Definition at line 260 of file IsolationCloseByCorrectionTool.h.

◆ m_isoWriteDecVarKeys

SG::WriteDecorHandleKeyArray<xAOD::IParticleContainer> CP::IsolationCloseByCorrectionTool::m_isoWriteDecVarKeys
private
Initial value:
{
this, "IsoWriteDecVarKeys", {}, "The list is filled during the initialization"}

Definition at line 262 of file IsolationCloseByCorrectionTool.h.

◆ m_maxTopoPolution

Gaudi::Property<float> CP::IsolationCloseByCorrectionTool::m_maxTopoPolution
private
Initial value:
{
this, "MaxClusterFrac", 1.1,
"Maximum energy fraction a single cluster can make up to be considered as contributed to the isolation"}

Definition at line 240 of file IsolationCloseByCorrectionTool.h.

◆ m_muon_isoTypes

IsoVector CP::IsolationCloseByCorrectionTool::m_muon_isoTypes {}
private

Isolation variables used by the muon working point.

Definition at line 279 of file IsolationCloseByCorrectionTool.h.

◆ m_muonKeys

Gaudi::Property<std::vector<std::string> > CP::IsolationCloseByCorrectionTool::m_muonKeys
private
Initial value:
{
this, "MuoContainers", {}, "Pipe the list of muon containers given later to the tool"}

Definition at line 256 of file IsolationCloseByCorrectionTool.h.

◆ m_passOR_name

Gaudi::Property<std::string> CP::IsolationCloseByCorrectionTool::m_passOR_name
private
Initial value:
{this, "PassoverlapDecorator", "",
"Does the particle also need to pass the overlap removal?"}

Definition at line 210 of file IsolationCloseByCorrectionTool.h.

◆ m_PflowKey

SG::ReadHandleKey<xAOD::FlowElementContainer> CP::IsolationCloseByCorrectionTool::m_PflowKey
private
Initial value:
{this, "PflowContainer", "CHSNeutralParticleFlowObjects",
"Name of the neutral pflow elements"}

Definition at line 276 of file IsolationCloseByCorrectionTool.h.

◆ m_photKeys

Gaudi::Property<std::vector<std::string> > CP::IsolationCloseByCorrectionTool::m_photKeys
private
Initial value:
{
this, "PhoContainers", {}, "Pipe the list of photon containers given later to the tool"}

Definition at line 258 of file IsolationCloseByCorrectionTool.h.

◆ m_photon_isoTypes

IsoVector CP::IsolationCloseByCorrectionTool::m_photon_isoTypes {}
private

Isolation variables used by the photon working point.

Definition at line 283 of file IsolationCloseByCorrectionTool.h.

◆ m_ptvarconeRadius

Gaudi::Property<float> CP::IsolationCloseByCorrectionTool::m_ptvarconeRadius {this, "PtvarconeRadius", 1.e4, "This is the kT parameter for the ptvarcone variables."}
private

Definition at line 233 of file IsolationCloseByCorrectionTool.h.

◆ m_quality_name

Gaudi::Property<std::string> CP::IsolationCloseByCorrectionTool::m_quality_name
private
Initial value:
{
this, "SelectionDecorator", "",
"Name of the char auxdata defining whether the particle shall be considered for iso correction"}

Definition at line 207 of file IsolationCloseByCorrectionTool.h.

◆ m_selectorTool

ToolHandle<CP::IIsolationSelectionTool> CP::IsolationCloseByCorrectionTool::m_selectorTool
private
Initial value:
{this, "IsolationSelectionTool", "",
"Please give me your configured IsolationSelectionTool!"}

Definition at line 202 of file IsolationCloseByCorrectionTool.h.

◆ m_trkselTool

ToolHandle<InDet::IInDetTrackSelectionTool> CP::IsolationCloseByCorrectionTool::m_trkselTool
private
Initial value:
{
this, "TrackSelectionTool", "", "TrackSelectionTool to select tracks which made it actually into the isolation"}

Definition at line 198 of file IsolationCloseByCorrectionTool.h.

◆ m_ttvaTool

ToolHandle<CP::ITrackVertexAssociationTool> CP::IsolationCloseByCorrectionTool::m_ttvaTool
private
Initial value:
{this, "TTVASelectionTool", "",
"TTVASelectionTool to correct for the pile-up robust WPs"}

Definition at line 200 of file IsolationCloseByCorrectionTool.h.

◆ m_varHandleArraysDeclared

bool AthCommonDataStore< AthCommonMsg< AlgTool > >::m_varHandleArraysDeclared
privateinherited

Definition at line 399 of file AthCommonDataStore.h.

◆ m_vhka

std::vector<SG::VarHandleKeyArray*> AthCommonDataStore< AthCommonMsg< AlgTool > >::m_vhka
privateinherited

Definition at line 398 of file AthCommonDataStore.h.

◆ m_VtxKey

SG::ReadHandleKey<xAOD::VertexContainer> CP::IsolationCloseByCorrectionTool::m_VtxKey
private
Initial value:
{this, "VertexContainer", "PrimaryVertices",
"Name of the primary vertex container"}

Definition at line 272 of file IsolationCloseByCorrectionTool.h.


The documentation for this class was generated from the following files:
grepfile.info
info
Definition: grepfile.py:38
CP::IsolationCloseByCorrectionTool::copyIsoValuesForPartsNotSelected
CorrectionCode copyIsoValuesForPartsNotSelected(const xAOD::IParticle *part) const
Definition: IsolationCloseByCorrectionTool.cxx:347
CP::IsolationCloseByCorrectionTool::m_hasEtConeIso
bool m_hasEtConeIso
Switch whether a topoetcone isolation working point is defined.
Definition: IsolationCloseByCorrectionTool.h:289
LArG4FSStartPointFilter.part
part
Definition: LArG4FSStartPointFilter.py:21
xAOD::iterator
JetConstituentVector::iterator iterator
Definition: JetConstituentVector.cxx:68
xAOD::CaloCluster_v1::phi
virtual double phi() const
The azimuthal angle ( ) of the particle.
Definition: CaloCluster_v1.cxx:256
CP::IsolationCloseByCorrectionTool::m_backup_prefix
Gaudi::Property< std::string > m_backup_prefix
Definition: IsolationCloseByCorrectionTool.h:214
xAOD::TrackParticle_v1::pt
virtual double pt() const override final
The transverse momentum ( ) of the particle.
Definition: TrackParticle_v1.cxx:73
xAOD::Iso::topoetcone
@ topoetcone
Topo-cluster ET-sum.
Definition: IsolationFlavour.h:25
GetLCDefs::Unknown
@ Unknown
Definition: GetLCDefs.h:21
CP::IsolationCloseByCorrectionTool::m_maxTopoPolution
Gaudi::Property< float > m_maxTopoPolution
Definition: IsolationCloseByCorrectionTool.h:240
test_pyathena.eta
eta
Definition: test_pyathena.py:10
xAOD::muon
@ muon
Definition: TrackingPrimitives.h:195
asg::AsgTool
Base class for the dual-use tool implementation classes.
Definition: AsgTool.h:47
sendEI_SPB.ch
ch
Definition: sendEI_SPB.py:35
Trk::ParticleSwitcher::particle
constexpr ParticleHypothesis particle[PARTICLEHYPOTHESES]
the array of masses
Definition: ParticleHypothesis.h:76
python.SystemOfUnits.s
int s
Definition: SystemOfUnits.py:131
xAOD::Electron
Electron_v1 Electron
Definition of the current "egamma version".
Definition: Event/xAOD/xAODEgamma/xAODEgamma/Electron.h:17
CP::IsolationCloseByCorrectionTool::m_ttvaTool
ToolHandle< CP::ITrackVertexAssociationTool > m_ttvaTool
Definition: IsolationCloseByCorrectionTool.h:200
xAOD::EgammaHelpers::getAssociatedTopoClusters
std::vector< const xAOD::CaloCluster * > getAssociatedTopoClusters(const xAOD::CaloCluster *cluster)
Return a vector of all the topo clusters associated with the egamma cluster.
Definition: EgammaxAODHelpers.cxx:65
CP::IsolationCloseByCorrectionTool::m_isoWriteDecVarKeys
SG::WriteDecorHandleKeyArray< xAOD::IParticleContainer > m_isoWriteDecVarKeys
Definition: IsolationCloseByCorrectionTool.h:262
StateLessPT_NewConfig.proxy
proxy
Definition: StateLessPT_NewConfig.py:392
max
#define max(a, b)
Definition: cfImp.cxx:41
CP::IsolationCloseByCorrectionTool::isTrackIsoTTVA
static bool isTrackIsoTTVA(xAOD::Iso::IsolationType type)
Definition: IsolationCloseByCorrectionTool.cxx:1017
ParticleGun_SamplingFraction.eta2
eta2
Definition: ParticleGun_SamplingFraction.py:96
CP::IsolationCloseByCorrectionTool::isVarTrackIsoTTVA
static bool isVarTrackIsoTTVA(xAOD::Iso::IsolationType Iso)
Definition: IsolationCloseByCorrectionTool.cxx:1009
ATH_MSG_INFO
#define ATH_MSG_INFO(x)
Definition: AthMsgStreamMacros.h:31
CP::IsolationCloseByCorrectionTool::isFixedTrackIso
static bool isFixedTrackIso(xAOD::Iso::IsolationType type)
Definition: IsolationCloseByCorrectionTool.cxx:995
find
std::string find(const std::string &s)
return a remapped string
Definition: hcg.cxx:135
CP::IsolationCloseByCorrectionTool::m_acc_quality
SelectionAccessor m_acc_quality
Definition: IsolationCloseByCorrectionTool.h:294
SG::Accessor
Helper class to provide type-safe access to aux data.
Definition: Control/AthContainers/AthContainers/Accessor.h:68
CP::IsolationCloseByCorrectionTool::m_declareCaloDecors
Gaudi::Property< bool > m_declareCaloDecors
Definition: IsolationCloseByCorrectionTool.h:249
CP::IsolationCloseByCorrectionTool::m_passOR_name
Gaudi::Property< std::string > m_passOR_name
Definition: IsolationCloseByCorrectionTool.h:210
SG::ReadHandle
Definition: StoreGate/StoreGate/ReadHandle.h:70
JetTiledMap::W
@ W
Definition: TiledEtaPhiMap.h:44
xAOD::Iso::IsolationFlavour
IsolationFlavour
Enumeration for different ways of calculating isolation in xAOD files.
Definition: IsolationFlavour.h:17
AthCommonDataStore::declareProperty
Gaudi::Details::PropertyBase & declareProperty(Gaudi::Property< T > &t)
Definition: AthCommonDataStore.h:145
CP::IsolationCloseByCorrectionTool::m_PflowKey
SG::ReadHandleKey< xAOD::FlowElementContainer > m_PflowKey
Definition: IsolationCloseByCorrectionTool.h:276
xAOD::Egamma_v1::e
virtual double e() const override final
The total energy of the particle.
Definition: Egamma_v1.cxx:90
xAOD::TrackParticle_v1::eta
virtual double eta() const override final
The pseudorapidity ( ) of the particle.
Definition: TrackParticle_v1.cxx:77
DMTest::P
P_v1 P
Definition: P.h:23
CP::IsolationCloseByCorrectionTool::UseAveragedDecorators
@ UseAveragedDecorators
Definition: IsolationCloseByCorrectionTool.h:41
CutsMETMaker::accept
StatusCode accept(const xAOD::Muon *mu)
Definition: CutsMETMaker.cxx:18
CP::PflowSet
std::set< FlowElementPtr > PflowSet
Definition: PhysicsAnalysis/AnalysisCommon/IsolationSelection/IsolationSelection/Defs.h:74
CP::IsolationCloseByCorrectionTool::passSelectionQuality
bool passSelectionQuality(const xAOD::IParticle *particle) const
Definition: IsolationCloseByCorrectionTool.cxx:542
DMTest::C
C_v1 C
Definition: C.h:26
CP::IsolationCloseByCorrectionTool::m_muonKeys
Gaudi::Property< std::vector< std::string > > m_muonKeys
Definition: IsolationCloseByCorrectionTool.h:256
CP::MeVtoGeV
constexpr float MeVtoGeV
Definition: IsolationCloseByCorrectionTool.cxx:33
CP::IsolationCloseByCorrectionTool::isTopoEtIso
static bool isTopoEtIso(xAOD::Iso::IsolationType type)
Definition: IsolationCloseByCorrectionTool.cxx:1000
CP::IsolationCloseByCorrectionTool::clusterEtMinusTile
static float clusterEtMinusTile(const xAOD::CaloCluster *C)
Definition: IsolationCloseByCorrectionTool.cxx:975
CP::IsolationCloseByCorrectionTool::m_electron_isoTypes
IsoVector m_electron_isoTypes
Isolation variables used by the electron working point.
Definition: IsolationCloseByCorrectionTool.h:281
AthCommonDataStore< AthCommonMsg< AlgTool > >::m_evtStore
StoreGateSvc_t m_evtStore
Pointer to StoreGate (event store by default)
Definition: AthCommonDataStore.h:390
CP::TrackSet
std::set< TrackPtr > TrackSet
Definition: PhysicsAnalysis/AnalysisCommon/IsolationSelection/IsolationSelection/Defs.h:72
AthCommonDataStore< AthCommonMsg< AlgTool > >::m_vhka
std::vector< SG::VarHandleKeyArray * > m_vhka
Definition: AthCommonDataStore.h:398
ParticleTest.tp
tp
Definition: ParticleTest.py:25
CP::IsolationCloseByCorrectionTool::m_elecKeys
Gaudi::Property< std::vector< std::string > > m_elecKeys
Declare the data dependencies of the Input containers.
Definition: IsolationCloseByCorrectionTool.h:254
CP::IsolationCloseByCorrectionTool::pflowDecors
static caloDecorNames pflowDecors()
Definition: IsolationCloseByCorrectionTool.cxx:28
xAOD::P4Helpers::deltaPhi
double deltaPhi(double phiA, double phiB)
delta Phi in range [-pi,pi[
Definition: xAODP4Helpers.h:69
xAOD::eta1
setEt setPhi setE277 setWeta2 eta1
Definition: TrigEMCluster_v1.cxx:41
CP::IsolationCloseByCorrectionTool::associateCluster
void associateCluster(const xAOD::IParticle *particle, float &eta, float &phi, float &energy) const override
Retrieve the associated clusters from the Particle and calculate the average eta/phi/energy.
Definition: IsolationCloseByCorrectionTool.cxx:782
xAOD::EgammaHelpers::getTrackParticles
std::set< const xAOD::TrackParticle * > getTrackParticles(const xAOD::Egamma *eg, bool useBremAssoc=true, bool allParticles=true)
Return a list of all or only the best TrackParticle associated to the object.
Definition: EgammaxAODHelpers.cxx:120
xAOD::Egamma_v1
Definition: Egamma_v1.h:56
CP::CharDecorator
SG::AuxElement::Decorator< char > CharDecorator
Definition: PhysicsAnalysis/AnalysisCommon/IsolationSelection/IsolationSelection/Defs.h:19
CP::IsolationCloseByCorrectionTool::loadAssociatedObjects
void loadAssociatedObjects(const EventContext &ctx, ObjectCache &cache) const
Load all associated tracks / clusters / flow elements into the cache.
Definition: IsolationCloseByCorrectionTool.cxx:161
xAOD::Iso::neflowisol
@ neflowisol
neutral eflow
Definition: IsolationFlavour.h:31
read_hist_ntuple.t
t
Definition: read_hist_ntuple.py:5
ATH_MSG_VERBOSE
#define ATH_MSG_VERBOSE(x)
Definition: AthMsgStreamMacros.h:28
dbg::ptr
void * ptr(T *p)
Definition: SGImplSvc.cxx:74
xAOD::P4Helpers::deltaR2
double deltaR2(double rapidity1, double phi1, double rapidity2, double phi2)
from bare rapidity,phi
Definition: xAODP4Helpers.h:111
CP::IsolationCloseByCorrectionTool::m_caloModel
Gaudi::Property< int > m_caloModel
EXPERT PROPERTIES.
Definition: IsolationCloseByCorrectionTool.h:221
SG::VarHandleKey::empty
bool empty() const
Test if the key is blank.
Definition: AthToolSupport/AsgDataHandles/Root/VarHandleKey.cxx:150
CP::IsolationCloseByCorrectionTool::isSame
bool isSame(const xAOD::IParticle *particle, const xAOD::IParticle *particle1) const
Definition: IsolationCloseByCorrectionTool.cxx:938
CP::IsoType
xAOD::Iso::IsolationType IsoType
Definition: PhysicsAnalysis/AnalysisCommon/IsolationSelection/IsolationSelection/Defs.h:36
xAOD::IParticle
Class providing the definition of the 4-vector interface.
Definition: Event/xAOD/xAODBase/xAODBase/IParticle.h:41
CP::CaloClusterPtr
SortedObjPtr< xAOD::CaloCluster > CaloClusterPtr
Definition: PhysicsAnalysis/AnalysisCommon/IsolationSelection/IsolationSelection/Defs.h:69
x
#define x
CP::IsolationCloseByCorrectionTool::performCloseByCorrection
CorrectionCode performCloseByCorrection(const EventContext &ctx, ObjectCache &cache) const
Definition: IsolationCloseByCorrectionTool.cxx:265
xAOD::Egamma_v1::nCaloClusters
size_t nCaloClusters() const
Return the number of xAOD::CaloClusters that define the electron candidate.
Definition: Egamma_v1.cxx:377
CaloCell_ID_FCS::TileGap3
@ TileGap3
Definition: FastCaloSim_CaloCell_ID.h:36
xAOD::Muon_v1
Class describing a Muon.
Definition: Muon_v1.h:38
CP::FloatDecorator
SG::AuxElement::Decorator< float > FloatDecorator
Definition: PhysicsAnalysis/AnalysisCommon/IsolationSelection/IsolationSelection/Defs.h:22
xAOD::CaloCluster
CaloCluster_v1 CaloCluster
Define the latest version of the calorimeter cluster class.
Definition: Event/xAOD/xAODCaloEvent/xAODCaloEvent/CaloCluster.h:19
CP::IsolationCloseByCorrectionTool::SubtractObjectsDirectly
@ SubtractObjectsDirectly
Definition: IsolationCloseByCorrectionTool.h:40
config
Definition: PhysicsAnalysis/AnalysisCommon/AssociationUtils/python/config.py:1
CP::IsolationCloseByCorrectionTool::m_coreConeMu
Gaudi::Property< float > m_coreConeMu
Definition: IsolationCloseByCorrectionTool.h:229
python.iconfTool.models.loaders.level
level
Definition: loaders.py:20
SG::VarHandleKeyArray::setOwner
virtual void setOwner(IDataHandleHolder *o)=0
CP::IsolationCloseByCorrectionTool::m_isoSelection_name
Gaudi::Property< std::string > m_isoSelection_name
Definition: IsolationCloseByCorrectionTool.h:212
IDTPMcnv.htype
htype
Definition: IDTPMcnv.py:27
CP::IsolationCloseByCorrectionTool::m_photon_isoTypes
IsoVector m_photon_isoTypes
Isolation variables used by the photon working point.
Definition: IsolationCloseByCorrectionTool.h:283
xAOD::CaloCluster_v1::etaSample
float etaSample(const CaloSample sampling) const
Retrieve barycenter in a given sample.
Definition: CaloCluster_v1.cxx:532
xAOD::TrackParticle
TrackParticle_v1 TrackParticle
Reference the current persistent version:
Definition: Event/xAOD/xAODTracking/xAODTracking/TrackParticle.h:13
xAOD::phi
setEt phi
Definition: TrigEMCluster_v1.cxx:29
CP::IsolationCloseByCorrectionTool::m_has_nonTTVA
bool m_has_nonTTVA
Switch whether a pile-up non robust TTVA working point is defined.
Definition: IsolationCloseByCorrectionTool.h:285
CP::IsolationCloseByCorrectionTool::retrieveIDBestPrimaryVertex
const xAOD::Vertex * retrieveIDBestPrimaryVertex(const EventContext &ctx) const
Definition: IsolationCloseByCorrectionTool.cxx:890
xAOD::Cone
@ Cone
Definition: TrackingPrimitives.h:552
CP::IsolationCloseByCorrectionTool::m_ConeSizeVariation
Gaudi::Property< float > m_ConeSizeVariation
Definition: IsolationCloseByCorrectionTool.h:244
CP::IsolationCloseByCorrectionTool::getAssocFlowElements
void getAssocFlowElements(const EventContext &ctx, ObjectCache &cache) const
Retrieve all Flow elements associated with the particles in the cache.
Definition: IsolationCloseByCorrectionTool.cxx:185
AthCommonDataStore< AthCommonMsg< AlgTool > >::evtStore
ServiceHandle< StoreGateSvc > & evtStore()
The standard StoreGateSvc (event store) Returns (kind of) a pointer to the StoreGateSvc.
Definition: AthCommonDataStore.h:85
CP::IsolationCloseByCorrectionTool::m_muon_isoTypes
IsoVector m_muon_isoTypes
Isolation variables used by the muon working point.
Definition: IsolationCloseByCorrectionTool.h:279
CP::CorrectionCode::OutOfValidityRange
@ OutOfValidityRange
Input object is out of validity range.
Definition: CorrectionCode.h:37
CP::IsolationCloseByCorrectionTool::m_CaloClusterKey
SG::ReadHandleKey< xAOD::CaloClusterContainer > m_CaloClusterKey
Definition: IsolationCloseByCorrectionTool.h:274
CP::CorrectionCode::Error
@ Error
Some error happened during the object correction.
Definition: CorrectionCode.h:36
xAOD::CaloCluster_v1
Description of a calorimeter cluster.
Definition: CaloCluster_v1.h:59
xAOD::Iso::ptvarcone
@ ptvarcone
mini isolation
Definition: IsolationFlavour.h:28
CP::IsolationCloseByCorrectionTool::isEgamma
static bool isEgamma(const xAOD::IParticle *particle)
Definition: IsolationCloseByCorrectionTool.cxx:458
CP::IsolationCloseByCorrectionTool::loadPrimaryParticles
void loadPrimaryParticles(const xAOD::IParticleContainer *container, ObjectCache &cache) const
Filter all electrons/muons/photons from the collection which pass the selection decoration.
Definition: IsolationCloseByCorrectionTool.cxx:136
python.utils.AtlRunQueryDQUtils.p
p
Definition: AtlRunQueryDQUtils.py:210
AthCommonDataStore
Definition: AthCommonDataStore.h:52
Amg::toString
std::string toString(const Translation3D &translation, int precision=4)
GeoPrimitvesToStringConverter.
Definition: GeoPrimitivesToStringConverter.h:40
StateLessPT_NewConfig.primary
primary
Definition: StateLessPT_NewConfig.py:228
xAOD::Iso::ptvarcone_Nonprompt_All_MaxWeightTTVALooseCone_pt1000
@ ptvarcone_Nonprompt_All_MaxWeightTTVALooseCone_pt1000
Definition: IsolationFlavour.h:42
ATH_MSG_ERROR
#define ATH_MSG_ERROR(x)
Definition: AthMsgStreamMacros.h:33
CP::IsolationCloseByCorrectionTool::deltaR2
float deltaR2(const xAOD::IParticle *particle, const xAOD::IParticle *particle1, bool AvgCalo=false) const
Definition: IsolationCloseByCorrectionTool.cxx:946
asg::AsgToolConfig
an object that can create a AsgTool
Definition: AsgToolConfig.h:22
ParticleGun_FastCalo_ChargeFlip_Config.energy
energy
Definition: ParticleGun_FastCalo_ChargeFlip_Config.py:78
asg::AcceptInfo
Definition: AcceptInfo.h:28
CP::IsolationCloseByCorrectionTool::m_coreConeEl
Gaudi::Property< float > m_coreConeEl
Definition: IsolationCloseByCorrectionTool.h:224
HepMC::flow
int flow(const T &a, int i)
Definition: Flow.h:51
CP::IsolationCloseByCorrectionTool::coneSize
float coneSize(const xAOD::IParticle *particle, IsoType Cone) const
Definition: IsolationCloseByCorrectionTool.cxx:902
IsoCloseByCorrectionTest.containers
containers
Associate the close-by pflow objects and the calorimeter clusters.
Definition: IsoCloseByCorrectionTest.py:82
xAOD::CaloCluster_v1::eta
virtual double eta() const
The pseudorapidity ( ) of the particle.
Definition: CaloCluster_v1.cxx:251
lumiFormat.i
int i
Definition: lumiFormat.py:85
CaloSampling::CaloSample
CaloSample
Definition: Calorimeter/CaloGeoHelpers/CaloGeoHelpers/CaloSampling.h:22
xAOD::P4Helpers::deltaR
double deltaR(double rapidity1, double phi1, double rapidity2, double phi2)
from bare bare rapidity,phi
Definition: xAODP4Helpers.h:150
CP::IsolationCloseByCorrectionTool::particleName
static std::string particleName(const xAOD::IParticle *C)
Definition: IsolationCloseByCorrectionTool.cxx:986
CP::IsolationCloseByCorrectionTool::getCloseByCorrectionPflowIso
CorrectionCode getCloseByCorrectionPflowIso(const EventContext &ctx, const xAOD::IParticle *primary, const IsoType type, const ObjectCache &cache, float &isoValue) const
Definition: IsolationCloseByCorrectionTool.cxx:588
ATH_MSG_DEBUG
#define ATH_MSG_DEBUG(x)
Definition: AthMsgStreamMacros.h:29
CP::IsolationCloseByCorrectionTool::passFirstStage
bool passFirstStage(const xAOD::TrackParticle *trk, const xAOD::Vertex *vtx) const
The Track particle has to pass the Track selection tool and the TTVA selection.
Definition: IsolationCloseByCorrectionTool.cxx:424
xAOD::Iso::IsolationType
IsolationType
Overall enumeration for isolation types in xAOD files.
Definition: IsolationType.h:26
CP::IsolationCloseByCorrectionTool::printIsolationCones
void printIsolationCones(const IsoVector &types, xAOD::Type::ObjectType T) const
Definition: IsolationCloseByCorrectionTool.cxx:1018
TauGNNUtils::Variables::Track::dPhi
bool dPhi(const xAOD::TauJet &tau, const xAOD::TauTrack &track, double &out)
Definition: TauGNNUtils.cxx:538
xAOD::Iso::ptcone_Nonprompt_All_MaxWeightTTVALooseCone_pt500
@ ptcone_Nonprompt_All_MaxWeightTTVALooseCone_pt500
ptcone for high mu
Definition: IsolationFlavour.h:45
CP::IsolationCloseByCorrectionTool::isFixedTrackIsoTTVA
static bool isFixedTrackIsoTTVA(xAOD::Iso::IsolationType type)
Definition: IsolationCloseByCorrectionTool.cxx:1001
xAOD::Egamma_v1::caloCluster
const xAOD::CaloCluster * caloCluster(size_t index=0) const
Pointer to the xAOD::CaloCluster/s that define the electron candidate.
Definition: Egamma_v1.cxx:388
xAOD::Iso::ptcone_Nonprompt_All_MaxWeightTTVA_pt500
@ ptcone_Nonprompt_All_MaxWeightTTVA_pt500
ptcone for high mu
Definition: IsolationFlavour.h:38
xAOD::VxType::PriVtx
@ PriVtx
Primary vertex.
Definition: TrackingPrimitives.h:571
CP::IsolationCloseByCorrectionTool::isPFlowIso
static bool isPFlowIso(xAOD::Iso::IsolationType type)
Definition: IsolationCloseByCorrectionTool.cxx:1032
CP::IsolationCloseByCorrectionTool::m_photKeys
Gaudi::Property< std::vector< std::string > > m_photKeys
Definition: IsolationCloseByCorrectionTool.h:258
AthenaPoolTestRead.acc
acc
Definition: AthenaPoolTestRead.py:16
python.xAODType.dummy
dummy
Definition: xAODType.py:4
CP::IsolationCloseByCorrectionTool::m_caloExtTool
ToolHandle< Trk::IParticleCaloExtensionTool > m_caloExtTool
calo extension tool for muon track particle extrapolation to calo
Definition: IsolationCloseByCorrectionTool.h:266
ATH_CHECK
#define ATH_CHECK
Definition: AthCheckMacros.h:40
MSG::name
const std::string & name(Level lvl)
Convenience function for translating message levels to strings.
Definition: MsgLevel.cxx:19
hist_file_dump.f
f
Definition: hist_file_dump.py:135
xAOD::Iso::ptvarcone_Nonprompt_All_MaxWeightTTVALooseCone_pt500
@ ptvarcone_Nonprompt_All_MaxWeightTTVALooseCone_pt500
Definition: IsolationFlavour.h:41
xAOD::Iso::ptcone
@ ptcone
Track isolation.
Definition: IsolationFlavour.h:22
xAOD::Egamma_v1::phi
virtual double phi() const override final
The azimuthal angle ( ) of the particle.
Definition: Egamma_v1.cxx:75
xAOD::CaloCluster_v1::phiSample
float phiSample(const CaloSample sampling) const
Retrieve barycenter in a given sample.
Definition: CaloCluster_v1.cxx:547
CP::IsolationCloseByCorrectionTool::unCalibPt
float unCalibPt(const xAOD::IParticle *particle) const
Definition: IsolationCloseByCorrectionTool.cxx:912
CP::IsolationCloseByCorrectionTool::getAssociatedTracks
TrackSet getAssociatedTracks(const xAOD::IParticle *P) const
Retrieve all Inner detector tracks associated with the primary particle.
Definition: IsolationCloseByCorrectionTool.cxx:427
AthCommonDataStore< AthCommonMsg< AlgTool > >::m_detStore
StoreGateSvc_t m_detStore
Pointer to StoreGate (detector store by default)
Definition: AthCommonDataStore.h:393
SG::VarHandleKey::initialize
StatusCode initialize(bool used=true)
If this object is used as a property, then this should be called during the initialize phase.
Definition: AthToolSupport/AsgDataHandles/Root/VarHandleKey.cxx:103
xAOD::getIsolationAccessor
const SG::AuxElement::Accessor< float > * getIsolationAccessor(Iso::IsolationType type)
Get the Accessor object for a given isolation type.
Definition: getIsolationAccessor.cxx:24
CP::IsolationCloseByCorrectionTool::m_hasPflowIso
bool m_hasPflowIso
Switch whether a pflow isolation working point is defined.
Definition: IsolationCloseByCorrectionTool.h:287
CP::IsolationCloseByCorrectionTool::m_selectorTool
ToolHandle< CP::IIsolationSelectionTool > m_selectorTool
Definition: IsolationCloseByCorrectionTool.h:202
CP::IsolationCloseByCorrectionTool::m_isInitialised
bool m_isInitialised
Definition: IsolationCloseByCorrectionTool.h:292
SG::VarHandleKeyArray::renounce
virtual void renounce()=0
xAOD::Iso::isolationFlavour
IsolationFlavour isolationFlavour(IsolationType type)
convert Isolation Type into Isolation Flavour
Definition: IsolationHelpers.h:47
SG::HandleClassifier::type
std::conditional< std::is_base_of< SG::VarHandleKeyArray, T >::value, VarHandleKeyArrayType, type2 >::type type
Definition: HandleClassifier.h:54
CP::IsolationCloseByCorrectionTool::m_acc_passOR
SelectionAccessor m_acc_passOR
Definition: IsolationCloseByCorrectionTool.h:295
CP::IsolationCloseByCorrectionTool::getExtrapEtaPhi
bool getExtrapEtaPhi(const EventContext &ctx, const xAOD::TrackParticle *tp, float &eta, float &phi) const
helper to get eta,phi of muon extrap
Definition: IsolationCloseByCorrectionTool.cxx:215
CP::IsolationCloseByCorrectionTool::getIsolationTypes
const IsoVector & getIsolationTypes(const xAOD::IParticle *particle) const
Definition: IsolationCloseByCorrectionTool.cxx:300
xAOD::Iso::ptvarcone_Nonprompt_All_MaxWeightTTVA_pt1000
@ ptvarcone_Nonprompt_All_MaxWeightTTVA_pt1000
Definition: IsolationFlavour.h:35
CP::IsolationCloseByCorrectionTool::getCloseByCorrectionTopoIso
CorrectionCode getCloseByCorrectionTopoIso(const EventContext &ctx, const xAOD::IParticle *primary, const IsoType type, const ObjectCache &cache, float &isoValue) const
Definition: IsolationCloseByCorrectionTool.cxx:660
CP::IsolationCloseByCorrectionTool::m_isoDecSuffix
Gaudi::Property< std::string > m_isoDecSuffix
Definition: IsolationCloseByCorrectionTool.h:217
xAOD::CaloCluster_v1::pt
virtual double pt() const
The transverse momentum ( ) of the particle (negative for negative-energy clusters)
Definition: CaloCluster_v1.cxx:247
python.root_lsr_rank.types
types
Definition: root_lsr_rank.py:35
merge_scale_histograms.doc
string doc
Definition: merge_scale_histograms.py:9
CP::IsolationCloseByCorrectionTool::m_trkselTool
ToolHandle< InDet::IInDetTrackSelectionTool > m_trkselTool
Definition: IsolationCloseByCorrectionTool.h:198
name
std::string name
Definition: Control/AthContainers/Root/debug.cxx:221
createCoolChannelIdFile.par
par
Definition: createCoolChannelIdFile.py:29
CP::IsolationCloseByCorrectionTool::caloDecors
static caloDecorNames caloDecors()
Returns an array with the calo cluster decoration ames [0]-> eta, [1]->phi, [2]->energy....
Definition: IsolationCloseByCorrectionTool.cxx:24
weights
Definition: herwig7_interface.h:44
Amg::Vector3D
Eigen::Matrix< double, 3, 1 > Vector3D
Definition: GeoPrimitives.h:47
CP::IsolationCloseByCorrectionTool::getCloseByCorrectionTrackIso
CorrectionCode getCloseByCorrectionTrackIso(const xAOD::IParticle *primary, const IsoType type, const ObjectCache &cache, float &isoValue) const
Definition: IsolationCloseByCorrectionTool.cxx:548
xAOD::Iso::ptcone_Nonprompt_All_MaxWeightTTVALooseCone_pt1000
@ ptcone_Nonprompt_All_MaxWeightTTVALooseCone_pt1000
Definition: IsolationFlavour.h:46
CP::IsolationCloseByCorrectionTool::m_ptvarconeRadius
Gaudi::Property< float > m_ptvarconeRadius
Definition: IsolationCloseByCorrectionTool.h:233
xAOD::Photon
Photon_v1 Photon
Definition of the current "egamma version".
Definition: Event/xAOD/xAODEgamma/xAODEgamma/Photon.h:17
CP::ClusterSet
std::set< CaloClusterPtr > ClusterSet
Definition: PhysicsAnalysis/AnalysisCommon/IsolationSelection/IsolationSelection/Defs.h:73
Muon
struct TBPatternUnitContext Muon
CP::CorrectionCode::Ok
@ Ok
The correction was done successfully.
Definition: CorrectionCode.h:38
a
TList * a
Definition: liststreamerinfos.cxx:10
h
xAOD::Vertex_v1
Class describing a Vertex.
Definition: Vertex_v1.h:42
python.HLT.Muon.MuonRecoSequences.isLRT
def isLRT(name)
Definition: MuonRecoSequences.py:65
CSV_InDetExporter.old
old
Definition: CSV_InDetExporter.py:145
CP::IsolationCloseByCorrectionTool::m_VtxKey
SG::ReadHandleKey< xAOD::VertexContainer > m_VtxKey
Definition: IsolationCloseByCorrectionTool.h:272
ATH_MSG_WARNING
#define ATH_MSG_WARNING(x)
Definition: AthMsgStreamMacros.h:32
python.CaloScaleNoiseConfig.type
type
Definition: CaloScaleNoiseConfig.py:78
CP::IsolationCloseByCorrectionTool::subtractCloseByContribution
CorrectionCode subtractCloseByContribution(const EventContext &ctx, const xAOD::IParticle *P, const ObjectCache &cache) const
Definition: IsolationCloseByCorrectionTool.cxx:312
AthCommonMsg< AlgTool >::msg
MsgStream & msg() const
Definition: AthCommonMsg.h:24
CP::IsolationCloseByCorrectionTool::getOriginalIsolation
virtual float getOriginalIsolation(const xAOD::IParticle &P, IsoType type) const override
Definition: IsolationCloseByCorrectionTool.cxx:972
RunTileMonitoring.clusters
clusters
Definition: RunTileMonitoring.py:133
Root::OR
@ OR
Definition: TGRLCollection.h:32
CP::IsolationCloseByCorrectionTool::m_quality_name
Gaudi::Property< std::string > m_quality_name
Definition: IsolationCloseByCorrectionTool.h:207
CP::IsolationCloseByCorrectionTool::isTrackIso
static bool isTrackIso(xAOD::Iso::IsolationType type)
Definition: IsolationCloseByCorrectionTool.cxx:997
SG::VarHandleBase::vhKey
SG::VarHandleKey & vhKey()
Return a non-const reference to the HandleKey.
Definition: StoreGate/src/VarHandleBase.cxx:623
xAOD::Egamma_v1::pt
virtual double pt() const override final
The transverse momentum ( ) of the particle.
Definition: Egamma_v1.cxx:65
xAOD::Iso::numIsolationTypes
@ numIsolationTypes
Definition: IsolationType.h:118
CP::FloatAccessor
SG::AuxElement::ConstAccessor< float > FloatAccessor
Definition: PhysicsAnalysis/AnalysisCommon/IsolationSelection/IsolationSelection/Defs.h:21
CP::IsolationCloseByCorrectionTool::getAssociatedClusters
ClusterSet getAssociatedClusters(const EventContext &ctx, const xAOD::IParticle *particle) const
Loads the topo clusters associated with the primary IParticle.
Definition: IsolationCloseByCorrectionTool.cxx:466
xAOD::Egamma_v1::eta
virtual double eta() const override final
The pseudorapidity ( ) of the particle.
Definition: Egamma_v1.cxx:70
CP::IsolationCloseByCorrectionTool::overlap
bool overlap(const xAOD::IParticle *particle, const xAOD::IParticle *particle1, float dR) const
Definition: IsolationCloseByCorrectionTool.cxx:960
CP::MinClusterEnergy
constexpr float MinClusterEnergy
Definition: IsolationCloseByCorrectionTool.cxx:32
python.Bindings.keys
keys
Definition: Control/AthenaPython/python/Bindings.py:798
CP::IsolationCloseByCorrectionTool::m_dec_isoselection
SelectionDecorator m_dec_isoselection
Definition: IsolationCloseByCorrectionTool.h:296
xAOD::TrackParticle_v1
Class describing a TrackParticle.
Definition: TrackParticle_v1.h:43
xAOD::getOriginalObject
const IParticle * getOriginalObject(const IParticle &copy)
This function can be used to conveniently get a pointer back to the original object from which a copy...
Definition: IParticleHelpers.cxx:140
Trk::CaloExtension::caloLayerIntersections
const std::vector< CurvilinearParameters > & caloLayerIntersections() const
access to the intersections with the calorimeter layers.
Definition: CaloExtension.h:76
xAOD::CaloCluster_v1::type
virtual Type::ObjectType type() const
The type of the object as a simple enumeration.
Definition: CaloCluster_v1.cxx:489
xAOD::CaloCluster_v1::hasSampling
bool hasSampling(const CaloSample s) const
Checks if certain smapling contributes to cluster.
Definition: CaloCluster_v1.h:890
CheckAppliedSFs.WPs
WPs
Definition: CheckAppliedSFs.py:206
asg::AcceptData
Definition: AcceptData.h:30
TauGNNUtils::Variables::Track::dEta
bool dEta(const xAOD::TauJet &tau, const xAOD::TauTrack &track, double &out)
Definition: TauGNNUtils.cxx:527
python.PyAthena.obj
obj
Definition: PyAthena.py:132
CP::IsolationCloseByCorrectionTool::isoRefParticle
const xAOD::IParticle * isoRefParticle(const xAOD::IParticle *particle) const override
Retrieve the reference particle to define the cone axis in which the track particles contributing to ...
Definition: IsolationCloseByCorrectionTool.cxx:925
CP::IsolationCloseByCorrectionTool::getCloseByCorrection
virtual CorrectionCode getCloseByCorrection(std::vector< float > &corrections, const xAOD::IParticle &par, const std::vector< xAOD::Iso::IsolationType > &types, const xAOD::IParticleContainer &closePar) const override
Definition: IsolationCloseByCorrectionTool.cxx:372
SG::DataProxy
Definition: DataProxy.h:44
CaloNoise_fillDB.mu
mu
Definition: CaloNoise_fillDB.py:53
xAOD::bool
setBGCode setTAP setLVL2ErrorBits bool
Definition: TrigDecision_v1.cxx:60
xAOD::Iso::coneSize
float coneSize(IsolationConeSize type)
convert Isolation Size into cone size
Definition: IsolationHelpers.h:27
CP::IsolationCloseByCorrectionTool::isVarTrackIso
static bool isVarTrackIso(xAOD::Iso::IsolationType type)
Definition: IsolationCloseByCorrectionTool.cxx:996
dq_make_web_display.cl
cl
print [x.__class__ for x in toList(dqregion.getSubRegions()) ]
Definition: dq_make_web_display.py:26
CP::IsolationCloseByCorrectionTool::declareDependency
void declareDependency(const std::vector< std::string > &containers, const IsoVector &types)
Helper function to declare the data dependencies.
Definition: IsolationCloseByCorrectionTool.cxx:118
xAOD::Iso::ptcone_Nonprompt_All_MaxWeightTTVA_pt1000
@ ptcone_Nonprompt_All_MaxWeightTTVA_pt1000
Definition: IsolationFlavour.h:39
CP::IsolationCloseByCorrectionTool::isoTypesFromWP
void isoTypesFromWP(const std::vector< std::unique_ptr< IsolationWP >> &WP, IsoVector &types)
Helper function to load all Isolation types from the iso working points.
Definition: IsolationCloseByCorrectionTool.cxx:97
CP::IsolationCloseByCorrectionTool::trackPtCut
static float trackPtCut(xAOD::Iso::IsolationType type)
Definition: IsolationCloseByCorrectionTool.cxx:1022
AthCommonDataStore::declareGaudiProperty
Gaudi::Details::PropertyBase & declareGaudiProperty(Gaudi::Property< T > &hndl, const SG::VarHandleKeyType &)
specialization for handling Gaudi::Property<SG::VarHandleKey>
Definition: AthCommonDataStore.h:156
xAOD::CaloCluster_v1::e
virtual double e() const
The total energy of the particle.
Definition: CaloCluster_v1.cxx:265
xAOD::Iso::ptvarcone_Nonprompt_All_MaxWeightTTVA_pt500
@ ptvarcone_Nonprompt_All_MaxWeightTTVA_pt500
ptvarcone for high mu
Definition: IsolationFlavour.h:34
CP::IsoVector
std::vector< IsoType > IsoVector
Definition: PhysicsAnalysis/AnalysisCommon/IsolationSelection/IsolationSelection/Defs.h:37
CP::IsolationCloseByCorrectionTool::m_isoVarKeys
SG::ReadDecorHandleKeyArray< xAOD::IParticleContainer > m_isoVarKeys
Definition: IsolationCloseByCorrectionTool.h:260
DataVector::empty
bool empty() const noexcept
Returns true if the collection is empty.
InDetDD::electrons
@ electrons
Definition: InDetDD_Defs.h:17
CP::TrackPtr
SortedObjPtr< xAOD::TrackParticle > TrackPtr
Definition: PhysicsAnalysis/AnalysisCommon/IsolationSelection/IsolationSelection/Defs.h:70
xAOD::TrackParticle_v1::phi
virtual double phi() const override final
The azimuthal angle ( ) of the particle (has range to .)
fitman.k
k
Definition: fitman.py:528
CP::CharAccessor
SG::AuxElement::ConstAccessor< char > CharAccessor
Definition: PhysicsAnalysis/AnalysisCommon/IsolationSelection/IsolationSelection/Defs.h:18
xAOD::FlowElement_v1
A detector object made of other lower level object(s)
Definition: FlowElement_v1.h:25