From 1d6bc4dfb3f3eef3aa82854af7481fb8f7a6bec2 Mon Sep 17 00:00:00 2001 From: scott snyder <sss@karma> Date: Tue, 23 Mar 2021 15:14:40 -0400 Subject: [PATCH] CaloClusterCorrection: Remove CaloClusterLocalCalibCone. Remove obsolete/unused tool CaloClusterLocalCalibCone, which uses the obsolete CaloNoiseTool. --- .../CaloTopoLocalCalibCone_jobOptions.py | 68 ---- .../src/CaloClusterLocalCalibCone.cxx | 336 ------------------ .../src/CaloClusterLocalCalibCone.h | 158 -------- .../CaloClusterCorrection_entries.cxx | 2 - 4 files changed, 564 deletions(-) delete mode 100755 Calorimeter/CaloClusterCorrection/share/CaloTopoLocalCalibCone_jobOptions.py delete mode 100755 Calorimeter/CaloClusterCorrection/src/CaloClusterLocalCalibCone.cxx delete mode 100755 Calorimeter/CaloClusterCorrection/src/CaloClusterLocalCalibCone.h diff --git a/Calorimeter/CaloClusterCorrection/share/CaloTopoLocalCalibCone_jobOptions.py b/Calorimeter/CaloClusterCorrection/share/CaloTopoLocalCalibCone_jobOptions.py deleted file mode 100755 index 1c70bd96b18d..000000000000 --- a/Calorimeter/CaloClusterCorrection/share/CaloTopoLocalCalibCone_jobOptions.py +++ /dev/null @@ -1,68 +0,0 @@ - -include.block( "CaloClusterCorrection/CaloTopoLocalCalibCone_jobOptions.py" ) - -# -# jobOptions for the local calibration of CaloTopoClusters with the cone method -# - -theApp.Dlls += ["CaloClusterCorrection", "CaloUtils" ] - -CaloTopoClusterMaker.ClusterCorrectionTools += [ -"CaloClusterLocalCalib/Classification", -"CaloClusterLocalCalibCone/ConeCalibration" -] - -# use new name for calibrated clusters and old name for em-scale clusters - -CaloTopoClusterMaker.ClustersOutputName = "CaloCalTopoCluster" -CaloTopoClusterMaker.KeepCorrectionToolAndContainerNames += ["CaloClusterLocalCalib/Classification","CaloTopoCluster"] -CaloTopoClusterMaker.TopoMoments.MomentsNames += [ - "FIRST_ETA", - "CENTER_LAMBDA", - "FIRST_ENG_DENS" -] - -CaloTopoClusterMaker.Classification.ClusterClassificationToolName = "EMFracClusterClassificationTool/EMFrac" -if DetDescrVersion.startswith("Rome"): - CaloTopoClusterMaker.Classification.EMFrac.EMFractionFileName = "EMFrac_classify_20060603_RZG.root" - CaloTopoClusterMaker.Classification.EMFrac.EnergyBins = [ 0.0*GeV, 1.0*GeV, -4.0*GeV, 16.0*GeV, 64.0*GeV, 4.0*TeV ] - CaloTopoClusterMaker.ConeCalibration.HadWeightFileName = "H1ClusterCellWeights_20060705_RZG.root" - -else: - CaloTopoClusterMaker.Classification.EMFrac.EMFractionFileName = "EMFrac_classify_20061117_RZG.root" - CaloTopoClusterMaker.Classification.EMFrac.EnergyBins = [ 0.0*GeV, 1.0*GeV, -4.0*GeV, 16.0*GeV, 64.0*GeV, 264.0*GeV, 4.0*TeV ] - CaloTopoClusterMaker.ConeCalibration.HadWeightFileName = "/afs/cern.ch/user/m/menke/public/postbarcelona_12.0.3_weights_20061118_j0.2_1.0_2sigma_celleta.root" - -CaloTopoClusterMaker.Classification.EMFrac.EtaBins = [ 0.0, 0.2, 0.4, -0.6, 0.8, 1.0, 1.2, 1.4, 1.6, 1.8, 2.0, 2.2, 2.4, 2.6, 2.8, 3.0, 3.2, -3.4, 3.6, 3.8, 4.0, 4.2, 4.4, 4.6, 4.8, 5.0 ] -CaloTopoClusterMaker.Classification.EMFrac.UseEMFractionSpread = TRUE -CaloTopoClusterMaker.Classification.EMFrac.MaxEMFraction = 1.0 - -CaloTopoClusterMaker.ConeCalibration.ClusterRecoStatus = 2 # 0 = ANY, 1 = EM, 2 = HAD, 4 = MUON -CaloTopoClusterMaker.ConeCalibration.EtaBins = [ 0.0, 0.2, 0.4, -0.6, 0.8, 1.0, 1.2, 1.4, 1.6, 1.8, 2.0, 2.2, 2.4, 2.6, 2.8, 3.0, 3.2, -3.4, 3.6, 3.8, 4.0, 4.2, 4.4, 4.6, 4.8, 5.0 ] -CaloTopoClusterMaker.ConeCalibration.CaloIndices = [ - -1,0,0,0 - ,-1,1,1,1 - ,2,2,2,2 - ,4,4,4 - ,-1,-1,-1 - ,4,4,4 - ,3,3,3 ] -CaloTopoClusterMaker.ConeCalibration.SamplingIndices = [ - -1,1,2,3 - ,-1,1,2,3 - ,0,1,2,3 - ,0,1,2 - ,-1,-1,-1 - ,0,1,2 - ,1,2,3 ] -CaloTopoClusterMaker.ConeCalibration.SignalOverNoiseCut = 2.0 - - - - diff --git a/Calorimeter/CaloClusterCorrection/src/CaloClusterLocalCalibCone.cxx b/Calorimeter/CaloClusterCorrection/src/CaloClusterLocalCalibCone.cxx deleted file mode 100755 index 26fb106bac51..000000000000 --- a/Calorimeter/CaloClusterCorrection/src/CaloClusterLocalCalibCone.cxx +++ /dev/null @@ -1,336 +0,0 @@ -/* - Copyright (C) 2002-2020 CERN for the benefit of the ATLAS collaboration -*/ - -//----------------------------------------------------------------------- -// File and Version Information: -// $Id: CaloClusterLocalCalibCone.cxx,v 1.5 2009-04-22 17:26:23 ssnyder Exp $ -// -// Description: see CaloClusterLocalCalibCone.h -// -// Environment: -// Software developed for the ATLAS Detector at CERN LHC -// -// Author List: -// Sven Menke -// -//----------------------------------------------------------------------- - -//----------------------- -// This Class's Header -- -//----------------------- -#include "CaloClusterLocalCalibCone.h" - -#include "CaloDetDescr/CaloDetDescrManager.h" -#include "CaloIdentifier/CaloCell_ID.h" -#include "CaloInterface/ICalorimeterNoiseTool.h" -#include "CaloEvent/CaloClusterContainer.h" -#include "CaloEvent/CaloCluster.h" -#include "CaloEvent/CaloRecoStatus.h" -#include "GaudiKernel/ISvcLocator.h" -#include "GaudiKernel/IToolSvc.h" -#include "GaudiKernel/ListItem.h" -#include "PathResolver/PathResolver.h" -#include "TFile.h" -#include "TProfile2D.h" -//#include "CLHEP/Vector/LorentzVector.h" - -#include "xAODCaloEvent/CaloClusterKineHelper.h" - -//using CLHEP::HepLorentzVector; - -CaloClusterLocalCalibCone::CaloClusterLocalCalibCone(const std::string& type, - const std::string& name, - const IInterface* parent) - :AthAlgTool(type, name, parent), - m_coneSchemaName("Angle"), - m_coneSchema(Angle), - m_coneDistance(0.2), - m_recoStatus(CaloRecoStatus::UNKNOWNSTATUS), - m_hadWeightFileName(""), - m_signalOverNoiseCut(2), - m_hadWeightFile(nullptr), - m_noiseTool(nullptr) -{ - m_etaBins.resize(0); - m_caloIndices.resize(0); - m_samplingIndices.resize(0); - m_data.resize(0); - - // Combination Schema for the Cones - declareProperty("ConeSchema",m_coneSchemaName); - // Combination Distance - declareProperty("ConeDistance",m_coneDistance); - // Reco Status of Clusters to be considered for weighting - declareProperty("ClusterRecoStatus",m_recoStatus) ; - // Name of File containing the had weights - declareProperty("HadWeightFileName",m_hadWeightFileName); - // Eta Bins of the classification Data - declareProperty("EtaBins",m_etaBins); - // Calorimeter indices for each CaloCell_ID::CaloSample - declareProperty("CaloIndices",m_caloIndices); - // Sampling indices for each CaloCell_ID::CaloSample - declareProperty("SamplingIndices",m_samplingIndices); - // Minimal Signal Over Noise (|E|/sigma) level for cells - declareProperty("SignalOverNoiseCut",m_signalOverNoiseCut); - - declareProperty("UpdateSamplingVars",m_updateSamplingVars=false); -} - -StatusCode CaloClusterLocalCalibCone::initialize() -{ - msg(MSG::INFO) << "Initializing " << name() << endmsg; - - - - //---- retrieve the noise tool ---------------- - - IToolSvc* p_toolSvc = nullptr;// Pointer to Tool Service - StatusCode sc = service("ToolSvc", p_toolSvc); - if (sc.isFailure()) { - msg(MSG::FATAL) - << " Tool Service not found " - << endmsg; - return StatusCode::FAILURE; - } - - IAlgTool* algtool; - ListItem corr("CaloNoiseTool/calonoisetool"); - sc = p_toolSvc->retrieveTool(corr.type(), corr.name(), algtool); - if (sc.isFailure()) { - msg(MSG::INFO) - << "Unable to find noise tool" - << endmsg; - } - - m_noiseTool=dynamic_cast<ICalorimeterNoiseTool*>(algtool); - - // set cone schema - if ( m_coneSchemaName == "Angle" ) { - m_coneSchema = Angle; - msg( MSG::INFO) - << "Angle schema with Delta Angle = " << m_coneDistance << " is set!" - << endmsg; - } - else if ( m_coneSchemaName == "DeltaR" ) { - m_coneSchema = DeltaR; - msg( MSG::INFO) - << "DeltaR schema with Delta R = " << m_coneDistance << " is set!" - << endmsg; - } - else { - msg(MSG::ERROR) - << "Unknown cone schema <" << m_coneSchemaName << "> selected. " - << "Please specify Angle or DeltaR and try again!" - << endmsg; - return StatusCode::FAILURE; - } - - // do some sanity checks on the properties given - if ( m_hadWeightFileName.empty() ) { - msg( MSG::ERROR ) - << "You need to specify name of the file holding the data " - << "with the property HadWeightFileName in order to use this tool!" - << endmsg; - return StatusCode::FAILURE; - } - if ( m_etaBins.size() <= 1 ) { - msg( MSG::ERROR) - << "You need to specify the |eta| bins with the property " - << "EtaBins in order to use this tool!" - << endmsg; - return StatusCode::FAILURE; - } - if ( m_caloIndices.empty() ) { - msg(MSG::ERROR) - << "You need to specify the calorimeter indices with the property " - << "CaloIndices in order to use this tool!" - << endmsg; - return StatusCode::FAILURE; - } - if ( m_samplingIndices.empty() ) { - msg(MSG::ERROR) - << "You need to specify the sampling indices with the property " - << "SamplingIndices in order to use this tool!" - << endmsg; - return StatusCode::FAILURE; - } - if ( m_caloIndices.size() != m_samplingIndices.size() ) { - msg(MSG::ERROR) - << "You need to specify the same number of entries with the properties " - << "CaloIndices and SamplingIndices in order to use this tool!" - << endmsg; - return StatusCode::FAILURE; - } - sc = initDataFromFile(m_hadWeightFileName); - if ( sc.isFailure() ) { - msg(MSG::ERROR) - << "Unable to initialize hadronic weights from file <" - << m_hadWeightFileName << ">" << endmsg; - } - - return sc; -} - -StatusCode CaloClusterLocalCalibCone::initDataFromFile(const std::string& hadWeightFileName) -{ - - // Find the full path to filename: - std::string file = PathResolver::find_file (hadWeightFileName, "DATAPATH"); - msg(MSG::INFO) << "Reading file " << file << endmsg; - m_hadWeightFile = new TFile(file.c_str()); - if ( !m_hadWeightFile ) { - return StatusCode::FAILURE; - } - - int neta = m_etaBins.size()-1; - int nsamplings = m_samplingIndices.size(); - m_data.resize(nsamplings); - for(int isamp=0;isamp<nsamplings;isamp++) { - m_data[isamp].resize(neta); - for(int ieta=0;ieta<neta;ieta++) { - if ( m_caloIndices[isamp] >= 0 && m_samplingIndices[isamp] >= 0 ) { - std::ostringstream sname; - sname << "weight_ieta_" << ieta << "_icalo_" - << m_caloIndices[isamp] << "_isamp_" << m_samplingIndices[isamp]; - m_data[isamp][ieta]=(TProfile2D *)m_hadWeightFile->Get(sname.str().c_str()); - } - else - m_data[isamp][ieta] = nullptr; - } - } - - return StatusCode::SUCCESS; -} - -StatusCode -CaloClusterLocalCalibCone::execute(const EventContext& /*ctx*/, - xAOD::CaloClusterContainer* clusColl) const -{ - // make jets - std::vector<TLorentzVector *> jets; - std::vector<TLorentzVector *> pjet(clusColl->size(),nullptr); - // assume clusters are ordered in E_T - // loop over cluster collection and add each cluster to the map for - // each member cell - xAOD::CaloClusterContainer::iterator clusIter = clusColl->begin(); - xAOD::CaloClusterContainer::iterator clusIterEnd = clusColl->end(); - unsigned int iClus=0; - for (; clusIter != clusIterEnd; clusIter++, iClus++) { - xAOD::CaloCluster* thisCluster = *clusIter; - // check existing jets - for (unsigned int ijet = 0; ijet < jets.size(); ijet++) { - if ((m_coneSchema == Angle && jets[ijet]->Angle(thisCluster->p4().Vect()) < m_coneDistance) || - (m_coneSchema == DeltaR && jets[ijet]->DeltaR(thisCluster->p4()) < m_coneDistance)) { - if (thisCluster->e() + jets[ijet]->E() > 0) { - pjet[iClus] = jets[ijet]; - // add energy only - don't change jet direction - (*jets[ijet]) *= ((thisCluster->e() + jets[ijet]->E()) / jets[ijet]->E()); - - ATH_MSG_DEBUG("added cluster with E/eta/phi = " - << thisCluster->e() << "/" << thisCluster->eta() << "/" << thisCluster->phi() << " to jet " - << ijet << " which has now E/eta/phi/M = " << jets[ijet]->E() << "/" << jets[ijet]->Eta() << "/" - << jets[ijet]->Phi() << "/" << jets[ijet]->M() << endmsg); - } - break; - } - } - if (!pjet[iClus] && thisCluster->e() > 0) { - // make new jet - TLorentzVector* theJet = new TLorentzVector(thisCluster->p4()); - pjet[iClus] = theJet; - jets.push_back(theJet); - ATH_MSG_DEBUG("cluster with E/eta/phi = " - << thisCluster->e() << "/" << thisCluster->eta() << "/" << thisCluster->phi() << " started new jet " - << jets.size() - 1 << " which has now E/eta/phi/M = " << theJet->E() << "/" << theJet->Eta() << "/" - << theJet->Phi() << "/" << theJet->M() << endmsg); - } - } - const CaloDetDescrManager* calo_dd_man = nullptr; - ATH_CHECK( detStore()->retrieve(calo_dd_man,"CaloMgr") ); - - clusIter = clusColl->begin(); - iClus = 0; - for (; clusIter != clusIterEnd; clusIter++, iClus++) { - xAOD::CaloCluster* thisCluster = *clusIter; - if (pjet[iClus] && thisCluster->recoStatus().checkStatus(CaloRecoStatus::StatusIndicator(m_recoStatus))) { - TLorentzVector* thisJet = pjet[iClus]; - // weight all cells in selected cluster - xAOD::CaloCluster::cell_iterator itrCell = thisCluster->cell_begin(); - xAOD::CaloCluster::cell_iterator itrCell_e = thisCluster->cell_end(); - for (; itrCell != itrCell_e; ++itrCell) { - const CaloCell* thisCell = *itrCell; - double weight = itrCell.weight(); - // check calo and sampling index for current cell - Identifier myId = thisCell->ID(); - CaloCell_ID::CaloSample theSample = thisCell->caloDDE()->getSampling(); - if (theSample < (int)m_caloIndices.size() && m_caloIndices[theSample] >= 0 && - m_samplingIndices[theSample] >= 0) { - // check noise level and energy density of the current cell - double sigma = m_noiseTool->getNoise(thisCell, ICalorimeterNoiseTool::ELECTRONICNOISE); - double energy = fabs(thisCell->e()); - double ratio = 0; - if (finite(sigma) && sigma > 0) - ratio = energy / sigma; - if (ratio > m_signalOverNoiseCut) { - double volume = 0; - double density = 0; - const CaloDetDescrElement* myCDDE = calo_dd_man->get_element(myId); - if (myCDDE) { - volume = myCDDE->volume(); - } - if (volume > 0) - density = energy / volume; - if (density > 0) { - int neta = m_etaBins.size() - 1; - int ieta; - double abseta = fabs(thisCell->eta()); - for (ieta = 0; ieta < neta; ieta++) { - if (abseta >= m_etaBins[ieta] && abseta < m_etaBins[ieta + 1]) - break; - } - if (ieta < neta && m_data[theSample][ieta]) { - double log10edens = log10(density); - double log10conee = log10(thisJet->E()); - double lemax = m_data[theSample][ieta]->GetXaxis()->GetBinCenter(m_data[theSample][ieta]->GetNbinsX()); - if (log10conee > lemax) - log10conee = lemax; - int iBin = m_data[theSample][ieta]->FindBin(log10conee, log10edens); - double num = m_data[theSample][ieta]->GetBinEntries(iBin); - if (num > 10) { - weight *= m_data[theSample][ieta]->GetBinContent(iBin); - thisCluster->reweightCell(itrCell, weight); - ATH_MSG_VERBOSE("cell with E/eta/phi = " - << thisCell->e() << "/" << thisCell->eta() << "/" << thisCell->phi() - << " in jet with E/eta/phi/M = " << thisJet->E() << "/" << thisJet->Eta() << "/" - << thisJet->Phi() << "/" << thisJet->M() << " weighted with w = " << weight - << endmsg); - } - } - } // end if density >0 - } // end if noise cut - } - } // end loop over cells - CaloClusterKineHelper::calculateKine(thisCluster,true,m_updateSamplingVars); - - } // end if reco status - } // end loop over clusters - for(unsigned int ijet=0;ijet<jets.size();ijet++) { - delete jets[ijet]; - } - return StatusCode::SUCCESS; -} - -CaloClusterLocalCalibCone::~CaloClusterLocalCalibCone() -{ - if ( m_hadWeightFile ) { - m_hadWeightFile->Close(); - delete m_hadWeightFile; - m_hadWeightFile = nullptr; - } -} - - - - - diff --git a/Calorimeter/CaloClusterCorrection/src/CaloClusterLocalCalibCone.h b/Calorimeter/CaloClusterCorrection/src/CaloClusterLocalCalibCone.h deleted file mode 100755 index f0e8ac173cc9..000000000000 --- a/Calorimeter/CaloClusterCorrection/src/CaloClusterLocalCalibCone.h +++ /dev/null @@ -1,158 +0,0 @@ -/* - Copyright (C) 2002-2020 CERN for the benefit of the ATLAS collaboration -*/ - -#ifndef CALOCLUSTERCORRECTION_CALOCLUSTERLOCALCALIBCONE_H -#define CALOCLUSTERCORRECTION_CALOCLUSTERLOCALCALIBCONE_H -/** - * @class CaloClusterLocalCalibCone - * @version \$Id: CaloClusterLocalCalibCone.h,v 1.4 2009-04-22 17:26:21 ssnyder Exp $ - * @author Sven Menke <menke@mppmu.mpg.de> - * @date 23-November-2006 - * @brief cone method for local hadron calibration - * - * concrete class implementing a CaloClusterCollectionProcessor to - * form cones from all clusters in a cluster collection and weight the - * cells in the clusters according to cone and cell - * properties. Basically the energy of the cone and the eta and energy - * density of the cell are used to look up the weights. This tool - * assumes that classification of the clusters is already done. This - * tool reads its data from a root file containing TProfile2D - * histograms. */ - -#include "CaloRec/CaloClusterCollectionProcessor.h" -#include "AthenaKernel/IOVSvcDefs.h" -#include "AthenaBaseComps/AthAlgTool.h" - -class TProfile2D; -class TFile; -class CaloCell_ID; -class CaloDetDescrManager; -class ICalorimeterNoiseTool; - -class CaloClusterLocalCalibCone : public AthAlgTool, virtual public CaloClusterCollectionProcessor -{ - - public: - - enum ConeSchema {Angle,DeltaR}; - - // Constructor - CaloClusterLocalCalibCone(const std::string& type, - const std::string& name, - const IInterface* parent); - - virtual ~CaloClusterLocalCalibCone() override; - - virtual StatusCode initialize() override; - - using CaloClusterCollectionProcessor::execute; // xxx temporary - virtual StatusCode execute(const EventContext& ctx, - xAOD::CaloClusterContainer* clusColl) const override; - - private: - - CaloClusterLocalCalibCone(); - - StatusCode initDataFromFile(const std::string& hadWeightFileName); - - /** - * @brief name of the schema to use for making the cones ("Angle" or "DeltaR") - * - * The schema to use for cone making. If the schema is Angle the - * distance criterion is the angular distance in radians of the cone - * to the cluster in case of DeltaR it is the distance in eta-phi - * space. */ - std::string m_coneSchemaName; - - /** - * @brief actual schema enum - * - * The enum corresponding to the used schema. */ - ConeSchema m_coneSchema; - - /** - * @brief max distance to cone axis allowed for a cluster to be included - * - * Cones are made starting with the leading cluster in E_T. Clusters - * with distances from the cone below this value are adding their - * energy to the cone but the cone direction remains that of the - * leading cluster. */ - double m_coneDistance; - - /** - * @brief required reco status for the clusters in order to be calibrated - * - * Only clusters matching this reco status will be used in the calibration - * procedure. */ - int m_recoStatus; - - /** - * @brief name of the file containing the hadronic cell weights - * - * The H1-style hadronic cell weights are stored as function of - * cone energy and the cell energy density for each eta region - * (cell eta) and calorimeter sampling of the cell. The weights - * are stored as histograms in this file. */ - std::string m_hadWeightFileName; - - /** - * @brief vector with n+1 elements defining the n eta bins - * - * The i-th eta bin covers the region m_etaBins[i] <= |eta| < - * m_etaBins[i+1]. The definition given here has to match the one - * used in the data file containing the histograms. */ - std::vector<double> m_etaBins; - - /** - * @brief vector with nSample (=24) elements defining the calo index - * - * The i-th number corresponds to the i-th sampling as defined in - * CaloCell_ID::CaloSample. An entry of -1 means no data is defined - * for this sampling. Different samplings could point to the same - * index. The definition given here has to match the one used in - * the data file containing the histograms. */ - std::vector<int> m_caloIndices; - - /** - * @brief vector with nSample (=24) elements defining the sampling index - * - * The i-th number corresponds to the i-th sampling as defined in - * CaloCell_ID::CaloSample. An entry of -1 means no data is defined - * for this sampling. Different samplings could point to the same - * index. The definition given here has to match the one used in - * the data file containing the histograms. */ - std::vector<int> m_samplingIndices; - - /** - * @brief minimal signal/elec_noise ratio for a cell to be weighted - * - * Only cells with |energy| above this value times the RMS of the electronics - * noise are considered in weighting. */ - double m_signalOverNoiseCut; - - - /** - * @brief update also sampling variables */ - bool m_updateSamplingVars; - - /** - * @brief pointer to the TFile containing the TProfile2D histograms - * - * The file is opened in the initialization phase. */ - - TFile *m_hadWeightFile; - - /** - * @brief vector of vector of pointers to TProfile2D histograms - * - * This object contains the actual data used for calibration. The - * number of samplings and eta bins define the size of the - * vectors. */ - - std::vector<std::vector<TProfile2D *> > m_data; - - ICalorimeterNoiseTool * m_noiseTool; -}; - -#endif diff --git a/Calorimeter/CaloClusterCorrection/src/components/CaloClusterCorrection_entries.cxx b/Calorimeter/CaloClusterCorrection/src/components/CaloClusterCorrection_entries.cxx index 7daea0b61ea7..7d368a36db55 100644 --- a/Calorimeter/CaloClusterCorrection/src/components/CaloClusterCorrection_entries.cxx +++ b/Calorimeter/CaloClusterCorrection/src/components/CaloClusterCorrection_entries.cxx @@ -1,5 +1,4 @@ #include "CaloClusterCorrection/CaloClusterLocalCalib.h" -#include "../CaloClusterLocalCalibCone.h" #include "../CaloClusterLogPos.h" #include "CaloClusterCorrection/CaloFillRectangularCluster.h" #include "../CaloClusterUpdate.h" @@ -52,7 +51,6 @@ #include "../CaloDummyCorrection.h" -DECLARE_COMPONENT( CaloClusterLocalCalibCone ) DECLARE_COMPONENT( CaloClusterLocalCalib ) DECLARE_COMPONENT( CaloClusterLogPos ) DECLARE_COMPONENT( CaloFillRectangularCluster ) -- GitLab