diff --git a/DataFormats/L1THGCal/interface/HGCalTower.h b/DataFormats/L1THGCal/interface/HGCalTower.h index 3d202721d2e09..74c392ee0ee07 100644 --- a/DataFormats/L1THGCal/interface/HGCalTower.h +++ b/DataFormats/L1THGCal/interface/HGCalTower.h @@ -18,7 +18,7 @@ namespace l1t { double etHad, double eta, double phi, - unsigned short id, + uint32_t id, int hwpt = 0, int hweta = 0, int hwphi = 0, diff --git a/DataFormats/L1THGCal/interface/HGCalTowerID.h b/DataFormats/L1THGCal/interface/HGCalTowerID.h index 85a8f88fb024b..674180adb96bb 100644 --- a/DataFormats/L1THGCal/interface/HGCalTowerID.h +++ b/DataFormats/L1THGCal/interface/HGCalTowerID.h @@ -1,5 +1,7 @@ -#ifndef DataFormats_L1TCalorimeter_HGCalTowerID_h -#define DataFormats_L1TCalorimeter_HGCalTowerID_h +#ifndef DataFormats_L1THGCal_HGCalTowerID_h +#define DataFormats_L1THGCal_HGCalTowerID_h + +#include // NOTE: in the current implementation HGCalTowerID can only // accomodate 127 bins per coordinate x2 zsides @@ -9,13 +11,15 @@ namespace l1t { public: HGCalTowerID() : HGCalTowerID(0) {} - HGCalTowerID(unsigned short rawId) : rawId_(rawId) {} + HGCalTowerID(uint32_t rawId) : rawId_(rawId) {} - HGCalTowerID(short zside, unsigned short coord1, unsigned short coord2) { - rawId_ = ((coord1 & coordMask) << coord1Shift) | ((coord2 & coordMask) << coord2Shift) | - (((zside > 0) & zsideMask) << zsideShift); + HGCalTowerID(short subdetIsNode, short zside, unsigned short coord1, unsigned short coord2) { + rawId_ = (((subdetIsNode & subDetMask) << subDetShift) | ((coord1 & coordMask) << coord1Shift) | + ((coord2 & coordMask) << coord2Shift) | ((zside > 0) & zsideMask) << zsideShift); } + short subdet() const { return (rawId_ >> subDetShift) & subDetMask; } + short zside() const { return ((rawId_ >> zsideShift) & zsideMask) ? 1 : -1; } unsigned short iEta() const { return (rawId_ >> coord1Shift) & coordMask; } @@ -25,7 +29,9 @@ namespace l1t { unsigned short rawId() const { return rawId_; } private: - unsigned short rawId_; + uint32_t rawId_; + static const int subDetMask = 0x1; // two for now 0 is HGC and 1 is HFNose + static const int subDetShift = 16; static const int zsideMask = 0x1; static const int zsideShift = 15; static const int coordMask = 0x007F; @@ -34,9 +40,9 @@ namespace l1t { }; struct HGCalTowerCoord { - HGCalTowerCoord(unsigned short rawId, float eta, float phi) : rawId(rawId), eta(eta), phi(phi) {} + HGCalTowerCoord(uint32_t rawId, float eta, float phi) : rawId(rawId), eta(eta), phi(phi) {} - const unsigned short rawId; + const uint32_t rawId; const float eta; const float phi; }; diff --git a/DataFormats/L1THGCal/src/HGCalTower.cc b/DataFormats/L1THGCal/src/HGCalTower.cc index 59a61e49a962b..0aab6e6ee2161 100644 --- a/DataFormats/L1THGCal/src/HGCalTower.cc +++ b/DataFormats/L1THGCal/src/HGCalTower.cc @@ -8,7 +8,7 @@ HGCalTower::HGCalTower(double etEm, double etHad, double eta, double phi, - unsigned short id, + uint32_t id, int hwpt, int hweta, int hwphi, diff --git a/L1Trigger/L1THGCal/interface/HGCalTriggerTools.h b/L1Trigger/L1THGCal/interface/HGCalTriggerTools.h index 474f66cfaec1a..ceb9c1a9b354d 100644 --- a/L1Trigger/L1THGCal/interface/HGCalTriggerTools.h +++ b/L1Trigger/L1THGCal/interface/HGCalTriggerTools.h @@ -51,10 +51,11 @@ class HGCalTriggerTools { // in the v8 geometry detid scheme int thicknessIndex(const DetId&, bool tc = false) const; - unsigned lastLayerEE() const { return eeLayers_; } + unsigned lastLayerEE(bool nose = false) const { return (nose ? HFNoseDetId::HFNoseLayerEEmax : eeLayers_); } unsigned lastLayerFH() const { return eeLayers_ + fhLayers_; } unsigned lastLayerBH() const { return totalLayers_; } unsigned lastLayerNose() const { return noseLayers_; } + unsigned lastLayer(bool nose = false) const { return nose ? noseLayers_ : totalLayers_; } // 4-vector helper functions using GlobalPoint float getEta(const GlobalPoint& position, const float& vertex_z = 0.) const; diff --git a/L1Trigger/L1THGCal/interface/HGCalTriggerTowerGeometryHelper.h b/L1Trigger/L1THGCal/interface/HGCalTriggerTowerGeometryHelper.h index b9764df18286a..e5ac5b9f0d0e3 100644 --- a/L1Trigger/L1THGCal/interface/HGCalTriggerTowerGeometryHelper.h +++ b/L1Trigger/L1THGCal/interface/HGCalTriggerTowerGeometryHelper.h @@ -38,10 +38,13 @@ class HGCalTriggerTowerGeometryHelper { unsigned short getTriggerTower(const l1t::HGCalTriggerCell&) const; unsigned short getTriggerTower(const l1t::HGCalTriggerSums&) const; + const bool isNose() { return doNose_; } + private: std::vector tower_coords_; std::unordered_map cells_to_trigger_towers_; + bool doNose_; double minEta_; double maxEta_; double minPhi_; diff --git a/L1Trigger/L1THGCal/interface/backend/HGCalTowerMap2DImpl.h b/L1Trigger/L1THGCal/interface/backend/HGCalTowerMap2DImpl.h index 7136c032e3693..89aee5cb9def8 100644 --- a/L1Trigger/L1THGCal/interface/backend/HGCalTowerMap2DImpl.h +++ b/L1Trigger/L1THGCal/interface/backend/HGCalTowerMap2DImpl.h @@ -22,9 +22,9 @@ class HGCalTowerMap2DImpl { std::unordered_map towerMapsTmp = newTowerMaps(); for (const auto& ptr : ptrs) { - if (triggerTools_.isNose(ptr->detId())) - continue; + bool isNose = triggerTools_.isNose(ptr->detId()); unsigned layer = triggerTools_.layerWithOffset(ptr->detId()); + if (towerMapsTmp.find(layer) == towerMapsTmp.end()) { throw cms::Exception("Out of range") << "HGCalTowerMap2dImpl: Found trigger sum in layer " << layer << " for which there is no tower map\n"; @@ -34,8 +34,8 @@ class HGCalTowerMap2DImpl { if (useLayerWeights_) calibPt = layerWeights_[layer] * ptr->mipPt(); - double etEm = layer <= triggerTools_.lastLayerEE() ? calibPt : 0; - double etHad = layer > triggerTools_.lastLayerEE() ? calibPt : 0; + double etEm = layer <= triggerTools_.lastLayerEE(isNose) ? calibPt : 0; + double etHad = layer > triggerTools_.lastLayerEE(isNose) ? calibPt : 0; towerMapsTmp[layer].addEt(towerGeometryHelper_.getTriggerTower(*ptr), etEm, etHad); } diff --git a/L1Trigger/L1THGCal/interface/concentrator/HGCalConcentratorProcessorSelection.h b/L1Trigger/L1THGCal/interface/concentrator/HGCalConcentratorProcessorSelection.h index 40a67b0f903f5..57f14d61add2e 100644 --- a/L1Trigger/L1THGCal/interface/concentrator/HGCalConcentratorProcessorSelection.h +++ b/L1Trigger/L1THGCal/interface/concentrator/HGCalConcentratorProcessorSelection.h @@ -32,6 +32,7 @@ class HGCalConcentratorProcessorSelection : public HGCalConcentratorProcessorBas private: bool fixedDataSizePerHGCROC_; + bool allTrigCellsInTrigSums_; std::vector coarsenTriggerCells_; static constexpr int kHighDensityThickness_ = 0; static constexpr int kNSubDetectors_ = 3; diff --git a/L1Trigger/L1THGCal/plugins/backend/HGCalTowerProcessor.cc b/L1Trigger/L1THGCal/plugins/backend/HGCalTowerProcessor.cc index e17fa8ec27e5d..fc0b107a785e8 100644 --- a/L1Trigger/L1THGCal/plugins/backend/HGCalTowerProcessor.cc +++ b/L1Trigger/L1THGCal/plugins/backend/HGCalTowerProcessor.cc @@ -12,6 +12,7 @@ class HGCalTowerProcessor : public HGCalTowerProcessorBase { public: HGCalTowerProcessor(const edm::ParameterSet& conf) : HGCalTowerProcessorBase(conf) { + includeTrigCells_ = conf.getParameter("includeTrigCells"), towermap2D_ = std::make_unique(conf.getParameterSet("towermap_parameters")); towermap3D_ = std::make_unique(); } @@ -33,33 +34,39 @@ class HGCalTowerProcessor : public HGCalTowerProcessorBase { towerMapsPtrs.emplace_back(towerMapCollHandle, i); } - /* create additional TowerMaps from the unclustered TCs */ + if (includeTrigCells_) { + /* create additional TowerMaps from the unclustered TCs */ - // translate our HGCalClusters into HGCalTriggerCells - std::vector> trigCellVec; - for (unsigned i = 0; i < unclTCsCollHandle->size(); ++i) { - edm::Ptr ptr(unclTCsCollHandle, i); - for (const auto& itTC : ptr->constituents()) { - trigCellVec.push_back(itTC.second); + // translate our HGCalClusters into HGCalTriggerCells + std::vector> trigCellVec; + for (unsigned i = 0; i < unclTCsCollHandle->size(); ++i) { + edm::Ptr ptr(unclTCsCollHandle, i); + for (const auto& itTC : ptr->constituents()) { + trigCellVec.push_back(itTC.second); + } } - } - // fill the TowerMaps with the HGCalTriggersCells - l1t::HGCalTowerMapBxCollection towerMapsFromUnclTCs; - towermap2D_->buildTowerMap2D(trigCellVec, towerMapsFromUnclTCs); + // fill the TowerMaps with the HGCalTriggersCells + l1t::HGCalTowerMapBxCollection towerMapsFromUnclTCs; + towermap2D_->buildTowerMap2D(trigCellVec, towerMapsFromUnclTCs); - /* merge the two sets of TowerMaps */ - unsigned int towerMapsPtrsSize = towerMapsPtrs.size(); - for (unsigned int i = 0; i < towerMapsFromUnclTCs.size(); ++i) { - towerMapsPtrs.emplace_back(&(towerMapsFromUnclTCs[i]), i + towerMapsPtrsSize); - } + /* merge the two sets of TowerMaps */ + unsigned int towerMapsPtrsSize = towerMapsPtrs.size(); + for (unsigned int i = 0; i < towerMapsFromUnclTCs.size(); ++i) { + towerMapsPtrs.emplace_back(&(towerMapsFromUnclTCs[i]), i + towerMapsPtrsSize); + } - /* call to towerMap3D clustering */ - towermap3D_->buildTowerMap3D(towerMapsPtrs, collTowers); + /* call to towerMap3D clustering */ + towermap3D_->buildTowerMap3D(towerMapsPtrs, collTowers); + } else { + /* call to towerMap3D clustering */ + towermap3D_->buildTowerMap3D(towerMapsPtrs, collTowers); + } } private: edm::ESHandle triggerGeometry_; + bool includeTrigCells_; /* algorithms instances */ std::unique_ptr towermap2D_; diff --git a/L1Trigger/L1THGCal/plugins/concentrator/HGCalConcentratorProcessorSelection.cc b/L1Trigger/L1THGCal/plugins/concentrator/HGCalConcentratorProcessorSelection.cc index 6818e6852e642..60a3a6b0fcf5e 100644 --- a/L1Trigger/L1THGCal/plugins/concentrator/HGCalConcentratorProcessorSelection.cc +++ b/L1Trigger/L1THGCal/plugins/concentrator/HGCalConcentratorProcessorSelection.cc @@ -8,6 +8,7 @@ DEFINE_EDM_PLUGIN(HGCalConcentratorFactory, HGCalConcentratorProcessorSelection, HGCalConcentratorProcessorSelection::HGCalConcentratorProcessorSelection(const edm::ParameterSet& conf) : HGCalConcentratorProcessorBase(conf), fixedDataSizePerHGCROC_(conf.getParameter("fixedDataSizePerHGCROC")), + allTrigCellsInTrigSums_(conf.getParameter("allTrigCellsInTrigSums")), coarsenTriggerCells_(conf.getParameter>("coarsenTriggerCells")), selectionType_(kNSubDetectors_) { std::vector selectionType(conf.getParameter>("Method")); @@ -164,7 +165,11 @@ void HGCalConcentratorProcessorSelection::run(const edm::HandledoSum(module_trigcell.first, trigCellVecNotSelected, trigSumsVecOutput); + if (allTrigCellsInTrigSums_) { // using all TCs + trigSumImpl_->doSum(module_trigcell.first, module_trigcell.second, trigSumsVecOutput); + } else { // using only unselected TCs + trigSumImpl_->doSum(module_trigcell.first, trigCellVecNotSelected, trigSumsVecOutput); + } } for (const auto& trigCell : trigCellVecOutput) { diff --git a/L1Trigger/L1THGCal/python/customTriggerSums.py b/L1Trigger/L1THGCal/python/customTriggerSums.py new file mode 100644 index 0000000000000..52945d1e9e2c7 --- /dev/null +++ b/L1Trigger/L1THGCal/python/customTriggerSums.py @@ -0,0 +1,31 @@ +import FWCore.ParameterSet.Config as cms + +def custom_partial_trigger_sums(process): + process.tower.includeTrigCells = cms.bool(True) + process.hgcalTowerProducer.ProcessorParameters.includeTrigCells = cms.bool(True) + process.hgcalTowerProducerHFNose.ProcessorParameters.includeTrigCells = cms.bool(True) + process.threshold_conc_proc.allTrigCellsInTrigSums = cms.bool(False) + process.best_conc_proc.allTrigCellsInTrigSums = cms.bool(False) + process.supertc_conc_proc.allTrigCellsInTrigSums = cms.bool(False) + process.custom_conc_proc.allTrigCellsInTrigSums = cms.bool(False) + process.coarsetc_onebitfraction_proc.allTrigCellsInTrigSums = cms.bool(False) + process.coarsetc_equalshare_proc.allTrigCellsInTrigSums = cms.bool(False) + process.autoEncoder_conc_proc.allTrigCellsInTrigSums = cms.bool(False) + process.hgcalConcentratorProducer.ProcessorParameters.allTrigCellsInTrigSums = cms.bool(False) + process.hgcalConcentratorProducerHFNose.ProcessorParameters.allTrigCellsInTrigSums = cms.bool(False) + return process + +def custom_full_trigger_sums(process): + process.tower.includeTrigCells = cms.bool(False) + process.hgcalTowerProducer.ProcessorParameters.includeTrigCells = cms.bool(False) + process.hgcalTowerProducerHFNose.ProcessorParameters.includeTrigCells = cms.bool(False) + process.threshold_conc_proc.allTrigCellsInTrigSums = cms.bool(True) + process.best_conc_proc.allTrigCellsInTrigSums = cms.bool(True) + process.supertc_conc_proc.allTrigCellsInTrigSums = cms.bool(True) + process.custom_conc_proc.allTrigCellsInTrigSums = cms.bool(True) + process.coarsetc_onebitfraction_proc.allTrigCellsInTrigSums = cms.bool(True) + process.coarsetc_equalshare_proc.allTrigCellsInTrigSums = cms.bool(True) + process.autoEncoder_conc_proc.allTrigCellsInTrigSums = cms.bool(True) + process.hgcalConcentratorProducer.ProcessorParameters.allTrigCellsInTrigSums = cms.bool(True) + process.hgcalConcentratorProducerHFNose.ProcessorParameters.allTrigCellsInTrigSums = cms.bool(True) + return process diff --git a/L1Trigger/L1THGCal/python/hgcalConcentratorProducer_cfi.py b/L1Trigger/L1THGCal/python/hgcalConcentratorProducer_cfi.py index 0f06060ced83c..a61d98160cf7f 100644 --- a/L1Trigger/L1THGCal/python/hgcalConcentratorProducer_cfi.py +++ b/L1Trigger/L1THGCal/python/hgcalConcentratorProducer_cfi.py @@ -32,6 +32,7 @@ threshold_scintillator = cms.double(2.), # MipT coarsenTriggerCells = cms.vuint32(0,0,0), fixedDataSizePerHGCROC = cms.bool(False), + allTrigCellsInTrigSums = cms.bool(True), ctcSize = cms.vuint32(CTC_SIZE), ) @@ -81,6 +82,7 @@ NData = cms.vuint32(bestchoice_ndata_decentralized), coarsenTriggerCells = cms.vuint32(0,0,0), fixedDataSizePerHGCROC = cms.bool(False), + allTrigCellsInTrigSums = cms.bool(False), coarseTCCompression = coarseTCCompression_proc.clone(), superTCCalibration_ee = vfe_proc.calibrationCfg_ee.clone(), superTCCalibration_hesi = vfe_proc.calibrationCfg_hesi.clone(), @@ -95,6 +97,7 @@ stcSize = cms.vuint32(STC_SIZE), ctcSize = cms.vuint32(CTC_SIZE), fixedDataSizePerHGCROC = cms.bool(False), + allTrigCellsInTrigSums = cms.bool(False), coarsenTriggerCells = cms.vuint32(0,0,0), superTCCompression = superTCCompression_proc.clone(), coarseTCCompression = coarseTCCompression_proc.clone(), @@ -111,6 +114,7 @@ threshold_scintillator = cms.double(2.), # MipT coarsenTriggerCells = cms.vuint32(0,0,0), fixedDataSizePerHGCROC = cms.bool(False), + allTrigCellsInTrigSums = cms.bool(False), type_energy_division = cms.string('superTriggerCell'),# superTriggerCell,oneBitFraction,equalShare stcSize = cms.vuint32(STC_SIZE), ctcSize = cms.vuint32(CTC_SIZE), @@ -129,6 +133,7 @@ stcSize = cms.vuint32([4]*(MAX_LAYERS+1)+ [8]*(MAX_LAYERS+1)*3), ctcSize = cms.vuint32(CTC_SIZE), fixedDataSizePerHGCROC = cms.bool(True), + allTrigCellsInTrigSums = cms.bool(False), coarsenTriggerCells = cms.vuint32(0,0,0), oneBitFractionThreshold = cms.double(0.125), oneBitFractionLowValue = cms.double(0.0625), @@ -148,6 +153,7 @@ stcSize = cms.vuint32([4]*(MAX_LAYERS+1)+ [8]*(MAX_LAYERS+1)*3), ctcSize = cms.vuint32(CTC_SIZE), fixedDataSizePerHGCROC = cms.bool(True), + allTrigCellsInTrigSums = cms.bool(False), coarsenTriggerCells = cms.vuint32(0,0,0), superTCCompression = superTCCompression_proc.clone(), coarseTCCompression = coarseTCCompression_proc.clone(), @@ -212,6 +218,7 @@ stcSize = supertc_conc_proc.stcSize, ctcSize = supertc_conc_proc.ctcSize, fixedDataSizePerHGCROC = supertc_conc_proc.fixedDataSizePerHGCROC, + allTrigCellsInTrigSums = supertc_conc_proc.allTrigCellsInTrigSums, coarsenTriggerCells = supertc_conc_proc.coarsenTriggerCells, superTCCompression = superTCCompression_proc.clone(), coarseTCCompression = coarseTCCompression_proc.clone(), diff --git a/L1Trigger/L1THGCal/python/hgcalTowerMapProducer_cfi.py b/L1Trigger/L1THGCal/python/hgcalTowerMapProducer_cfi.py index 968fa3ddd0e40..d46fe04576a76 100644 --- a/L1Trigger/L1THGCal/python/hgcalTowerMapProducer_cfi.py +++ b/L1Trigger/L1THGCal/python/hgcalTowerMapProducer_cfi.py @@ -2,6 +2,7 @@ import math L1TTriggerTowerConfig_etaphi = cms.PSet(readMappingFile=cms.bool(False), + doNose=cms.bool(False), minEta=cms.double(1.479), maxEta=cms.double(3.0), minPhi=cms.double(-1*math.pi), @@ -26,6 +27,21 @@ ProcessorParameters = tower_map.clone() ) +L1TTriggerTowerConfigHFNose_etaphi = L1TTriggerTowerConfig_etaphi.clone( + doNose = True , + minEta = 3.0 , + maxEta = 4.2 +) + +towerMap2DHFNose_parValues = towerMap2D_parValues.clone( + L1TTriggerTowerConfig = L1TTriggerTowerConfigHFNose_etaphi +) + +towerHFNose_map = cms.PSet( ProcessorName = cms.string('HGCalTowerMapProcessor'), + towermap_parameters = towerMap2DHFNose_parValues.clone() + ) + hgcalTowerMapProducerHFNose = hgcalTowerMapProducer.clone( - InputTriggerSums = cms.InputTag('hgcalConcentratorProducerHFNose:HGCalConcentratorProcessorSelection') + InputTriggerSums = cms.InputTag('hgcalConcentratorProducerHFNose:HGCalConcentratorProcessorSelection'), + ProcessorParameters = towerHFNose_map.clone() ) diff --git a/L1Trigger/L1THGCal/python/hgcalTowerProducer_cfi.py b/L1Trigger/L1THGCal/python/hgcalTowerProducer_cfi.py index 3782cfec31a9b..d4503936c4d87 100644 --- a/L1Trigger/L1THGCal/python/hgcalTowerProducer_cfi.py +++ b/L1Trigger/L1THGCal/python/hgcalTowerProducer_cfi.py @@ -2,6 +2,7 @@ import L1Trigger.L1THGCal.hgcalTowerMapProducer_cfi as hgcalTowerMapProducer_cfi tower = cms.PSet( ProcessorName = cms.string('HGCalTowerProcessor'), + includeTrigCells = cms.bool(False), towermap_parameters = hgcalTowerMapProducer_cfi.towerMap2D_parValues.clone() ) @@ -12,9 +13,13 @@ ProcessorParameters = tower.clone(), ) +towerHFNose = tower.clone( + towermap_parameters = hgcalTowerMapProducer_cfi.towerMap2DHFNose_parValues.clone() +) hgcalTowerProducerHFNose = hgcalTowerProducer.clone( InputTowerMaps = cms.InputTag('hgcalTowerMapProducerHFNose:HGCalTowerMapProcessor'), InputTriggerCells = cms.InputTag('hgcalBackEndLayer1ProducerHFNose:HGCalBackendLayer1Processor2DClustering'), + ProcessorParameters = towerHFNose.clone(), ) diff --git a/L1Trigger/L1THGCal/src/HGCalTriggerTowerGeometryHelper.cc b/L1Trigger/L1THGCal/src/HGCalTriggerTowerGeometryHelper.cc index c56c336fb6114..24d221f94482e 100644 --- a/L1Trigger/L1THGCal/src/HGCalTriggerTowerGeometryHelper.cc +++ b/L1Trigger/L1THGCal/src/HGCalTriggerTowerGeometryHelper.cc @@ -11,7 +11,8 @@ #include HGCalTriggerTowerGeometryHelper::HGCalTriggerTowerGeometryHelper(const edm::ParameterSet& conf) - : minEta_(conf.getParameter("minEta")), + : doNose_(conf.getParameter("doNose")), + minEta_(conf.getParameter("minEta")), maxEta_(conf.getParameter("maxEta")), minPhi_(conf.getParameter("minPhi")), maxPhi_(conf.getParameter("maxPhi")), @@ -46,7 +47,7 @@ HGCalTriggerTowerGeometryHelper::HGCalTriggerTowerGeometryHelper(const edm::Para for (int zside = -1; zside <= 1; zside += 2) { for (unsigned int bin1 = 0; bin1 != nBinsEta_; bin1++) { for (unsigned int bin2 = 0; bin2 != nBinsPhi_; bin2++) { - l1t::HGCalTowerID towerId(zside, bin1, bin2); + l1t::HGCalTowerID towerId(doNose_, zside, bin1, bin2); tower_coords_.emplace_back(towerId.rawId(), zside * ((binsEta_[bin1 + 1] + binsEta_[bin1]) / 2), (binsPhi_[bin2 + 1] + binsPhi_[bin2]) / 2); @@ -73,7 +74,7 @@ HGCalTriggerTowerGeometryHelper::HGCalTriggerTowerGeometryHelper(const edm::Para << " to TT iEta: " << iEta << " iPhi: " << iPhi << " when max #bins eta: " << nBinsEta_ << " phi: " << nBinsPhi_ << std::endl; } - l1t::HGCalTowerID towerId(triggerTools_.zside(DetId(trigger_cell_id)), iEta, iPhi); + l1t::HGCalTowerID towerId(doNose_, triggerTools_.zside(DetId(trigger_cell_id)), iEta, iPhi); cells_to_trigger_towers_[trigger_cell_id] = towerId.rawId(); } l1tTriggerTowerMappingStream.close(); @@ -116,7 +117,7 @@ unsigned short HGCalTriggerTowerGeometryHelper::getTriggerTowerFromEtaPhi(const bin_phi = bin_phi_l - binsPhi_.begin() - 1; } int zside = eta < 0 ? -1 : 1; - return l1t::HGCalTowerID(zside, bin_eta, bin_phi).rawId(); + return l1t::HGCalTowerID(doNose_, zside, bin_eta, bin_phi).rawId(); } unsigned short HGCalTriggerTowerGeometryHelper::getTriggerTower(const l1t::HGCalTriggerCell& thecell) const { diff --git a/L1Trigger/L1THGCal/src/backend/HGCalTowerMap2DImpl.cc b/L1Trigger/L1THGCal/src/backend/HGCalTowerMap2DImpl.cc index f1633de896fb8..fc9fcc36db917 100644 --- a/L1Trigger/L1THGCal/src/backend/HGCalTowerMap2DImpl.cc +++ b/L1Trigger/L1THGCal/src/backend/HGCalTowerMap2DImpl.cc @@ -16,11 +16,14 @@ HGCalTowerMap2DImpl::HGCalTowerMap2DImpl(const edm::ParameterSet& conf) towerGeometryHelper_(conf.getParameter("L1TTriggerTowerConfig")) {} std::unordered_map HGCalTowerMap2DImpl::newTowerMaps() { + bool isNose = towerGeometryHelper_.isNose(); + std::unordered_map towerMaps; - for (unsigned layer = 1; layer <= triggerTools_.lastLayerBH(); layer++) { + for (unsigned layer = 1; layer <= triggerTools_.lastLayer(isNose); layer++) { // FIXME: this is hardcoded...quite ugly - if (layer <= triggerTools_.lastLayerEE() && layer % 2 == 0) + if (!isNose && layer <= triggerTools_.lastLayerEE(isNose) && layer % 2 == 0) continue; + towerMaps[layer] = l1t::HGCalTowerMap(towerGeometryHelper_.getTowerCoordinates(), layer); } diff --git a/L1Trigger/L1THGCal/test/testHGCalL1TGeometryV10Imp1_cfg.py b/L1Trigger/L1THGCal/test/testHGCalL1TGeometryV10Imp1_cfg.py deleted file mode 100644 index b322c98b3b342..0000000000000 --- a/L1Trigger/L1THGCal/test/testHGCalL1TGeometryV10Imp1_cfg.py +++ /dev/null @@ -1,122 +0,0 @@ -import FWCore.ParameterSet.Config as cms - -from Configuration.StandardSequences.Eras import eras - -process = cms.Process('DIGI',eras.Phase2C8) - -# import of standard configurations -process.load('Configuration.StandardSequences.Services_cff') -process.load('SimGeneral.HepPDTESSource.pythiapdt_cfi') -process.load('FWCore.MessageService.MessageLogger_cfi') -process.load('Configuration.EventContent.EventContent_cff') -process.load('SimGeneral.MixingModule.mixNoPU_cfi') -process.load('Configuration.Geometry.GeometryExtended2026D41Reco_cff') -process.load('Configuration.Geometry.GeometryExtended2026D41_cff') -process.load('Configuration.StandardSequences.MagneticField_cff') -process.load('Configuration.StandardSequences.Generator_cff') -process.load('IOMC.EventVertexGenerators.VtxSmearedHLLHC14TeV_cfi') -process.load('GeneratorInterface.Core.genFilterSummary_cff') -process.load('Configuration.StandardSequences.SimIdeal_cff') -process.load('Configuration.StandardSequences.Digi_cff') -process.load('Configuration.StandardSequences.SimL1Emulator_cff') -process.load('Configuration.StandardSequences.DigiToRaw_cff') -process.load('Configuration.StandardSequences.EndOfProcess_cff') -process.load('Configuration.StandardSequences.FrontierConditions_GlobalTag_cff') - - -process.maxEvents = cms.untracked.PSet( - input = cms.untracked.int32(1) -) - -# Input source -process.source = cms.Source("EmptySource") - -process.options = cms.untracked.PSet( - -) - -# Production Info -process.configurationMetadata = cms.untracked.PSet( - version = cms.untracked.string('$Revision: 1.20 $'), - annotation = cms.untracked.string('SingleElectronPt10_cfi nevts:10'), - name = cms.untracked.string('Applications') -) - -# Output definition - -process.FEVTDEBUGoutput = cms.OutputModule("PoolOutputModule", - splitLevel = cms.untracked.int32(0), - eventAutoFlushCompressedSize = cms.untracked.int32(5242880), - outputCommands = process.FEVTDEBUGHLTEventContent.outputCommands, - fileName = cms.untracked.string('file:junk.root'), - dataset = cms.untracked.PSet( - filterName = cms.untracked.string(''), - dataTier = cms.untracked.string('GEN-SIM-DIGI-RAW') - ), - SelectEvents = cms.untracked.PSet( - SelectEvents = cms.vstring('generation_step') - ) -) - -# Additional output definition -process.TFileService = cms.Service( - "TFileService", - fileName = cms.string("test_triggergeom.root") - ) - - - -# Other statements -process.genstepfilter.triggerConditions=cms.vstring("generation_step") -from Configuration.AlCa.GlobalTag import GlobalTag -process.GlobalTag = GlobalTag(process.GlobalTag, 'auto:phase2_realistic', '') - -process.generator = cms.EDProducer("FlatRandomPtGunProducer", - PGunParameters = cms.PSet( - MaxPt = cms.double(10.01), - MinPt = cms.double(9.99), - PartID = cms.vint32(13), - MaxEta = cms.double(2.5), - MaxPhi = cms.double(3.14159265359), - MinEta = cms.double(-2.5), - MinPhi = cms.double(-3.14159265359) - ), - Verbosity = cms.untracked.int32(0), - psethack = cms.string('single electron pt 10'), - AddAntiParticle = cms.bool(True), - firstRun = cms.untracked.uint32(1) -) - -process.mix.digitizers = cms.PSet(process.theDigitizersValid) - - -# Path and EndPath definitions -process.generation_step = cms.Path(process.pgen) -process.simulation_step = cms.Path(process.psim) -process.genfiltersummary_step = cms.EndPath(process.genFilterSummary) -process.digitisation_step = cms.Path(process.pdigi_valid) -process.L1simulation_step = cms.Path(process.SimL1Emulator) -process.digi2raw_step = cms.Path(process.DigiToRaw) -process.endjob_step = cms.EndPath(process.endOfProcess) -process.FEVTDEBUGoutput_step = cms.EndPath(process.FEVTDEBUGoutput) - -process.load('L1Trigger.L1THGCal.hgcalTriggerPrimitives_cff') -# Eventually modify default geometry parameters -from L1Trigger.L1THGCal.customTriggerGeometry import custom_geometry_V9 -process = custom_geometry_V9(process, 1) - -process.hgcaltriggergeomtester = cms.EDAnalyzer( - "HGCalTriggerGeomTesterV9" - ) -process.test_step = cms.Path(process.hgcaltriggergeomtester) - -# Schedule definition -process.schedule = cms.Schedule(process.generation_step,process.genfiltersummary_step,process.simulation_step,process.digitisation_step,process.L1simulation_step,process.digi2raw_step,process.test_step,process.endjob_step,process.FEVTDEBUGoutput_step) -#process.schedule = cms.Schedule(process.generation_step,process.genfiltersummary_step,process.simulation_step,process.digitisation_step,process.L1simulation_step,process.digi2raw_step,process.endjob_step,process.FEVTDEBUGoutput_step) -# filter all path with the production filter sequence -for path in process.paths: - getattr(process,path)._seq = process.generator * getattr(process,path)._seq - -# Add early deletion of temporary data products to reduce peak memory need -from Configuration.StandardSequences.earlyDeleteSettings_cff import customiseEarlyDelete -process = customiseEarlyDelete(process) diff --git a/L1Trigger/L1THGCal/test/testHGCalL1TGeometryV10Imp2_cfg.py b/L1Trigger/L1THGCal/test/testHGCalL1TGeometryV10Imp2_cfg.py deleted file mode 100644 index 8bdafbe73ce6c..0000000000000 --- a/L1Trigger/L1THGCal/test/testHGCalL1TGeometryV10Imp2_cfg.py +++ /dev/null @@ -1,122 +0,0 @@ -import FWCore.ParameterSet.Config as cms - -from Configuration.StandardSequences.Eras import eras - -process = cms.Process('DIGI',eras.Phase2C8) - -# import of standard configurations -process.load('Configuration.StandardSequences.Services_cff') -process.load('SimGeneral.HepPDTESSource.pythiapdt_cfi') -process.load('FWCore.MessageService.MessageLogger_cfi') -process.load('Configuration.EventContent.EventContent_cff') -process.load('SimGeneral.MixingModule.mixNoPU_cfi') -process.load('Configuration.Geometry.GeometryExtended2026D41Reco_cff') -process.load('Configuration.Geometry.GeometryExtended2026D41_cff') -process.load('Configuration.StandardSequences.MagneticField_cff') -process.load('Configuration.StandardSequences.Generator_cff') -process.load('IOMC.EventVertexGenerators.VtxSmearedHLLHC14TeV_cfi') -process.load('GeneratorInterface.Core.genFilterSummary_cff') -process.load('Configuration.StandardSequences.SimIdeal_cff') -process.load('Configuration.StandardSequences.Digi_cff') -process.load('Configuration.StandardSequences.SimL1Emulator_cff') -process.load('Configuration.StandardSequences.DigiToRaw_cff') -process.load('Configuration.StandardSequences.EndOfProcess_cff') -process.load('Configuration.StandardSequences.FrontierConditions_GlobalTag_cff') - - -process.maxEvents = cms.untracked.PSet( - input = cms.untracked.int32(1) -) - -# Input source -process.source = cms.Source("EmptySource") - -process.options = cms.untracked.PSet( - -) - -# Production Info -process.configurationMetadata = cms.untracked.PSet( - version = cms.untracked.string('$Revision: 1.20 $'), - annotation = cms.untracked.string('SingleElectronPt10_cfi nevts:10'), - name = cms.untracked.string('Applications') -) - -# Output definition - -process.FEVTDEBUGoutput = cms.OutputModule("PoolOutputModule", - splitLevel = cms.untracked.int32(0), - eventAutoFlushCompressedSize = cms.untracked.int32(5242880), - outputCommands = process.FEVTDEBUGHLTEventContent.outputCommands, - fileName = cms.untracked.string('file:junk.root'), - dataset = cms.untracked.PSet( - filterName = cms.untracked.string(''), - dataTier = cms.untracked.string('GEN-SIM-DIGI-RAW') - ), - SelectEvents = cms.untracked.PSet( - SelectEvents = cms.vstring('generation_step') - ) -) - -# Additional output definition -process.TFileService = cms.Service( - "TFileService", - fileName = cms.string("test_triggergeom.root") - ) - - - -# Other statements -process.genstepfilter.triggerConditions=cms.vstring("generation_step") -from Configuration.AlCa.GlobalTag import GlobalTag -process.GlobalTag = GlobalTag(process.GlobalTag, 'auto:phase2_realistic', '') - -process.generator = cms.EDProducer("FlatRandomPtGunProducer", - PGunParameters = cms.PSet( - MaxPt = cms.double(10.01), - MinPt = cms.double(9.99), - PartID = cms.vint32(13), - MaxEta = cms.double(2.5), - MaxPhi = cms.double(3.14159265359), - MinEta = cms.double(-2.5), - MinPhi = cms.double(-3.14159265359) - ), - Verbosity = cms.untracked.int32(0), - psethack = cms.string('single electron pt 10'), - AddAntiParticle = cms.bool(True), - firstRun = cms.untracked.uint32(1) -) - -process.mix.digitizers = cms.PSet(process.theDigitizersValid) - - -# Path and EndPath definitions -process.generation_step = cms.Path(process.pgen) -process.simulation_step = cms.Path(process.psim) -process.genfiltersummary_step = cms.EndPath(process.genFilterSummary) -process.digitisation_step = cms.Path(process.pdigi_valid) -process.L1simulation_step = cms.Path(process.SimL1Emulator) -process.digi2raw_step = cms.Path(process.DigiToRaw) -process.endjob_step = cms.EndPath(process.endOfProcess) -process.FEVTDEBUGoutput_step = cms.EndPath(process.FEVTDEBUGoutput) - -process.load('L1Trigger.L1THGCal.hgcalTriggerPrimitives_cff') -# Eventually modify default geometry parameters -from L1Trigger.L1THGCal.customTriggerGeometry import custom_geometry_V9 -process = custom_geometry_V9(process, 2) - -process.hgcaltriggergeomtester = cms.EDAnalyzer( - "HGCalTriggerGeomTesterV9Imp2" - ) -process.test_step = cms.Path(process.hgcaltriggergeomtester) - -# Schedule definition -process.schedule = cms.Schedule(process.generation_step,process.genfiltersummary_step,process.simulation_step,process.digitisation_step,process.L1simulation_step,process.digi2raw_step,process.test_step,process.endjob_step,process.FEVTDEBUGoutput_step) -#process.schedule = cms.Schedule(process.generation_step,process.genfiltersummary_step,process.simulation_step,process.digitisation_step,process.L1simulation_step,process.digi2raw_step,process.endjob_step,process.FEVTDEBUGoutput_step) -# filter all path with the production filter sequence -for path in process.paths: - getattr(process,path)._seq = process.generator * getattr(process,path)._seq - -# Add early deletion of temporary data products to reduce peak memory need -from Configuration.StandardSequences.earlyDeleteSettings_cff import customiseEarlyDelete -process = customiseEarlyDelete(process) diff --git a/L1Trigger/L1THGCal/test/testHGCalL1TGeometryV11Imp2_cfg.py b/L1Trigger/L1THGCal/test/testHGCalL1TGeometryV11Imp2_cfg.py index 1f1820e675cc7..7d0c20f6e4928 100644 --- a/L1Trigger/L1THGCal/test/testHGCalL1TGeometryV11Imp2_cfg.py +++ b/L1Trigger/L1THGCal/test/testHGCalL1TGeometryV11Imp2_cfg.py @@ -68,7 +68,7 @@ # Other statements process.genstepfilter.triggerConditions=cms.vstring("generation_step") from Configuration.AlCa.GlobalTag import GlobalTag -process.GlobalTag = GlobalTag(process.GlobalTag, 'auto:phase2_realistic', '') +process.GlobalTag = GlobalTag(process.GlobalTag, 'auto:phase2_realistic_T15', '') process.generator = cms.EDProducer("FlatRandomPtGunProducer", PGunParameters = cms.PSet( @@ -90,14 +90,7 @@ # Path and EndPath definitions -process.generation_step = cms.Path(process.pgen) -process.simulation_step = cms.Path(process.psim) -process.genfiltersummary_step = cms.EndPath(process.genFilterSummary) -process.digitisation_step = cms.Path(process.pdigi_valid) -process.L1simulation_step = cms.Path(process.SimL1Emulator) -process.digi2raw_step = cms.Path(process.DigiToRaw) process.endjob_step = cms.EndPath(process.endOfProcess) -process.FEVTDEBUGoutput_step = cms.EndPath(process.FEVTDEBUGoutput) process.load('L1Trigger.L1THGCal.hgcalTriggerPrimitives_cff') # Eventually modify default geometry parameters @@ -110,8 +103,7 @@ process.test_step = cms.Path(process.hgcaltriggergeomtester) # Schedule definition -process.schedule = cms.Schedule(process.generation_step,process.genfiltersummary_step,process.simulation_step,process.digitisation_step,process.L1simulation_step,process.digi2raw_step,process.test_step,process.endjob_step,process.FEVTDEBUGoutput_step) -#process.schedule = cms.Schedule(process.generation_step,process.genfiltersummary_step,process.simulation_step,process.digitisation_step,process.L1simulation_step,process.digi2raw_step,process.endjob_step,process.FEVTDEBUGoutput_step) +process.schedule = cms.Schedule(process.test_step,process.endjob_step) # filter all path with the production filter sequence for path in process.paths: getattr(process,path)._seq = process.generator * getattr(process,path)._seq diff --git a/L1Trigger/L1THGCal/test/testHGCalL1TGeometryV9Imp1_cfg.py b/L1Trigger/L1THGCal/test/testHGCalL1TGeometryV9Imp1_cfg.py deleted file mode 100644 index e52dc40e17fa9..0000000000000 --- a/L1Trigger/L1THGCal/test/testHGCalL1TGeometryV9Imp1_cfg.py +++ /dev/null @@ -1,122 +0,0 @@ -import FWCore.ParameterSet.Config as cms - - -from Configuration.Eras.Era_Phase2C4_cff import Phase2C4 -process = cms.Process('DIGI',Phase2C4) - -# import of standard configurations -process.load('Configuration.StandardSequences.Services_cff') -process.load('SimGeneral.HepPDTESSource.pythiapdt_cfi') -process.load('FWCore.MessageService.MessageLogger_cfi') -process.load('Configuration.EventContent.EventContent_cff') -process.load('SimGeneral.MixingModule.mixNoPU_cfi') -process.load('Configuration.Geometry.GeometryExtended2026D35Reco_cff') -process.load('Configuration.Geometry.GeometryExtended2026D35_cff') -process.load('Configuration.StandardSequences.MagneticField_cff') -process.load('Configuration.StandardSequences.Generator_cff') -process.load('IOMC.EventVertexGenerators.VtxSmearedHLLHC14TeV_cfi') -process.load('GeneratorInterface.Core.genFilterSummary_cff') -process.load('Configuration.StandardSequences.SimIdeal_cff') -process.load('Configuration.StandardSequences.Digi_cff') -process.load('Configuration.StandardSequences.SimL1Emulator_cff') -process.load('Configuration.StandardSequences.DigiToRaw_cff') -process.load('Configuration.StandardSequences.EndOfProcess_cff') -process.load('Configuration.StandardSequences.FrontierConditions_GlobalTag_cff') - - -process.maxEvents = cms.untracked.PSet( - input = cms.untracked.int32(1) -) - -# Input source -process.source = cms.Source("EmptySource") - -process.options = cms.untracked.PSet( - -) - -# Production Info -process.configurationMetadata = cms.untracked.PSet( - version = cms.untracked.string('$Revision: 1.20 $'), - annotation = cms.untracked.string('SingleElectronPt10_cfi nevts:10'), - name = cms.untracked.string('Applications') -) - -# Output definition - -process.FEVTDEBUGoutput = cms.OutputModule("PoolOutputModule", - splitLevel = cms.untracked.int32(0), - eventAutoFlushCompressedSize = cms.untracked.int32(5242880), - outputCommands = process.FEVTDEBUGHLTEventContent.outputCommands, - fileName = cms.untracked.string('file:junk.root'), - dataset = cms.untracked.PSet( - filterName = cms.untracked.string(''), - dataTier = cms.untracked.string('GEN-SIM-DIGI-RAW') - ), - SelectEvents = cms.untracked.PSet( - SelectEvents = cms.vstring('generation_step') - ) -) - -# Additional output definition -process.TFileService = cms.Service( - "TFileService", - fileName = cms.string("test_triggergeom.root") - ) - - - -# Other statements -process.genstepfilter.triggerConditions=cms.vstring("generation_step") -from Configuration.AlCa.GlobalTag import GlobalTag -process.GlobalTag = GlobalTag(process.GlobalTag, 'auto:phase2_realistic', '') - -process.generator = cms.EDProducer("FlatRandomPtGunProducer", - PGunParameters = cms.PSet( - MaxPt = cms.double(10.01), - MinPt = cms.double(9.99), - PartID = cms.vint32(13), - MaxEta = cms.double(2.5), - MaxPhi = cms.double(3.14159265359), - MinEta = cms.double(-2.5), - MinPhi = cms.double(-3.14159265359) - ), - Verbosity = cms.untracked.int32(0), - psethack = cms.string('single electron pt 10'), - AddAntiParticle = cms.bool(True), - firstRun = cms.untracked.uint32(1) -) - -process.mix.digitizers = cms.PSet(process.theDigitizersValid) - - -# Path and EndPath definitions -process.generation_step = cms.Path(process.pgen) -process.simulation_step = cms.Path(process.psim) -process.genfiltersummary_step = cms.EndPath(process.genFilterSummary) -process.digitisation_step = cms.Path(process.pdigi_valid) -process.L1simulation_step = cms.Path(process.SimL1Emulator) -process.digi2raw_step = cms.Path(process.DigiToRaw) -process.endjob_step = cms.EndPath(process.endOfProcess) -process.FEVTDEBUGoutput_step = cms.EndPath(process.FEVTDEBUGoutput) - -process.load('L1Trigger.L1THGCal.hgcalTriggerPrimitives_cff') -# Eventually modify default geometry parameters -from L1Trigger.L1THGCal.customTriggerGeometry import custom_geometry_V9 -process = custom_geometry_V9(process, 1) - -process.hgcaltriggergeomtester = cms.EDAnalyzer( - "HGCalTriggerGeomTesterV9" - ) -process.test_step = cms.Path(process.hgcaltriggergeomtester) - -# Schedule definition -process.schedule = cms.Schedule(process.generation_step,process.genfiltersummary_step,process.simulation_step,process.digitisation_step,process.L1simulation_step,process.digi2raw_step,process.test_step,process.endjob_step,process.FEVTDEBUGoutput_step) -#process.schedule = cms.Schedule(process.generation_step,process.genfiltersummary_step,process.simulation_step,process.digitisation_step,process.L1simulation_step,process.digi2raw_step,process.endjob_step,process.FEVTDEBUGoutput_step) -# filter all path with the production filter sequence -for path in process.paths: - getattr(process,path)._seq = process.generator * getattr(process,path)._seq - -# Add early deletion of temporary data products to reduce peak memory need -from Configuration.StandardSequences.earlyDeleteSettings_cff import customiseEarlyDelete -process = customiseEarlyDelete(process) diff --git a/L1Trigger/L1THGCal/test/testHGCalL1TGeometryV9Imp2_Nose_cfg.py b/L1Trigger/L1THGCal/test/testHGCalL1TGeometryV9Imp2_Nose_cfg.py index 5c3c4f97819f8..fe10ad953aaa5 100644 --- a/L1Trigger/L1THGCal/test/testHGCalL1TGeometryV9Imp2_Nose_cfg.py +++ b/L1Trigger/L1THGCal/test/testHGCalL1TGeometryV9Imp2_Nose_cfg.py @@ -1,8 +1,7 @@ import FWCore.ParameterSet.Config as cms - -from Configuration.Eras.Era_Phase2C6_cff import Phase2C6 -process = cms.Process('DIGI',Phase2C6) +from Configuration.Eras.Era_Phase2C10_cff import Phase2C10 +process = cms.Process('REDOL1',Phase2C10) # import of standard configurations process.load('Configuration.StandardSequences.Services_cff') @@ -10,8 +9,8 @@ process.load('FWCore.MessageService.MessageLogger_cfi') process.load('Configuration.EventContent.EventContent_cff') process.load('SimGeneral.MixingModule.mixNoPU_cfi') -process.load('Configuration.Geometry.GeometryExtended2026D44Reco_cff') -process.load('Configuration.Geometry.GeometryExtended2026D44_cff') +process.load('Configuration.Geometry.GeometryExtended2026D60Reco_cff') +process.load('Configuration.Geometry.GeometryExtended2026D60_cff') process.load('Configuration.StandardSequences.MagneticField_cff') process.load('Configuration.StandardSequences.Generator_cff') process.load('IOMC.EventVertexGenerators.VtxSmearedHLLHC14TeV_cfi') @@ -68,10 +67,13 @@ eventAutoFlushCompressedSize = cms.untracked.int32(5242880), outputCommands = cms.untracked.vstring( 'keep *_genParticles_*_*', + 'keep *_caloParticles_*_*', 'keep *_*hgcalBackEndLayer1Producer*_*_*', 'keep *_*hgcalBackEndLayer2Producer*_*_*', - 'keep *_hgcalTowerProducer_*_*', + 'keep *_*hgcalTowerMapProducer*_*_*', + 'keep *_*hgcalTowerProducer*_*_*' ), + fileName = cms.untracked.string('file:/tmp/dalfonso/test.root') ) @@ -87,7 +89,7 @@ # Other statements process.genstepfilter.triggerConditions=cms.vstring("generation_step") from Configuration.AlCa.GlobalTag import GlobalTag -process.GlobalTag = GlobalTag(process.GlobalTag, 'auto:phase2_realistic', '') +process.GlobalTag = GlobalTag(process.GlobalTag, 'auto:phase2_realistic_T15', '') process.generator = cms.EDFilter("Pythia8PtGun", @@ -127,8 +129,9 @@ process.load('L1Trigger.L1THGCal.hgcalTriggerPrimitives_cff') # Eventually modify default geometry parameters -from L1Trigger.L1THGCal.customTriggerGeometry import custom_geometry_V9 -process = custom_geometry_V9(process, 2) +##from L1Trigger.L1THGCal.customTriggerGeometry import custom_geometry_V9 +from L1Trigger.L1THGCal.customTriggerGeometry import custom_geometry_decentralized_V11 +process = custom_geometry_decentralized_V11(process) process.hgcaltriggergeomtester = cms.EDAnalyzer( "HGCalTriggerGeomTesterV9Imp2" diff --git a/L1Trigger/L1THGCal/test/testHGCalL1TGeometryV9Imp2_cfg.py b/L1Trigger/L1THGCal/test/testHGCalL1TGeometryV9Imp2_cfg.py deleted file mode 100644 index 66c4013f64a4c..0000000000000 --- a/L1Trigger/L1THGCal/test/testHGCalL1TGeometryV9Imp2_cfg.py +++ /dev/null @@ -1,122 +0,0 @@ -import FWCore.ParameterSet.Config as cms - - -from Configuration.Eras.Era_Phase2C4_cff import Phase2C4 -process = cms.Process('DIGI',Phase2C4) - -# import of standard configurations -process.load('Configuration.StandardSequences.Services_cff') -process.load('SimGeneral.HepPDTESSource.pythiapdt_cfi') -process.load('FWCore.MessageService.MessageLogger_cfi') -process.load('Configuration.EventContent.EventContent_cff') -process.load('SimGeneral.MixingModule.mixNoPU_cfi') -process.load('Configuration.Geometry.GeometryExtended2026D35Reco_cff') -process.load('Configuration.Geometry.GeometryExtended2026D35_cff') -process.load('Configuration.StandardSequences.MagneticField_cff') -process.load('Configuration.StandardSequences.Generator_cff') -process.load('IOMC.EventVertexGenerators.VtxSmearedHLLHC14TeV_cfi') -process.load('GeneratorInterface.Core.genFilterSummary_cff') -process.load('Configuration.StandardSequences.SimIdeal_cff') -process.load('Configuration.StandardSequences.Digi_cff') -process.load('Configuration.StandardSequences.SimL1Emulator_cff') -process.load('Configuration.StandardSequences.DigiToRaw_cff') -process.load('Configuration.StandardSequences.EndOfProcess_cff') -process.load('Configuration.StandardSequences.FrontierConditions_GlobalTag_cff') - - -process.maxEvents = cms.untracked.PSet( - input = cms.untracked.int32(1) -) - -# Input source -process.source = cms.Source("EmptySource") - -process.options = cms.untracked.PSet( - -) - -# Production Info -process.configurationMetadata = cms.untracked.PSet( - version = cms.untracked.string('$Revision: 1.20 $'), - annotation = cms.untracked.string('SingleElectronPt10_cfi nevts:10'), - name = cms.untracked.string('Applications') -) - -# Output definition - -process.FEVTDEBUGoutput = cms.OutputModule("PoolOutputModule", - splitLevel = cms.untracked.int32(0), - eventAutoFlushCompressedSize = cms.untracked.int32(5242880), - outputCommands = process.FEVTDEBUGHLTEventContent.outputCommands, - fileName = cms.untracked.string('file:junk.root'), - dataset = cms.untracked.PSet( - filterName = cms.untracked.string(''), - dataTier = cms.untracked.string('GEN-SIM-DIGI-RAW') - ), - SelectEvents = cms.untracked.PSet( - SelectEvents = cms.vstring('generation_step') - ) -) - -# Additional output definition -process.TFileService = cms.Service( - "TFileService", - fileName = cms.string("test_triggergeom.root") - ) - - - -# Other statements -process.genstepfilter.triggerConditions=cms.vstring("generation_step") -from Configuration.AlCa.GlobalTag import GlobalTag -process.GlobalTag = GlobalTag(process.GlobalTag, 'auto:phase2_realistic', '') - -process.generator = cms.EDProducer("FlatRandomPtGunProducer", - PGunParameters = cms.PSet( - MaxPt = cms.double(10.01), - MinPt = cms.double(9.99), - PartID = cms.vint32(13), - MaxEta = cms.double(2.5), - MaxPhi = cms.double(3.14159265359), - MinEta = cms.double(-2.5), - MinPhi = cms.double(-3.14159265359) - ), - Verbosity = cms.untracked.int32(0), - psethack = cms.string('single electron pt 10'), - AddAntiParticle = cms.bool(True), - firstRun = cms.untracked.uint32(1) -) - -process.mix.digitizers = cms.PSet(process.theDigitizersValid) - - -# Path and EndPath definitions -process.generation_step = cms.Path(process.pgen) -process.simulation_step = cms.Path(process.psim) -process.genfiltersummary_step = cms.EndPath(process.genFilterSummary) -process.digitisation_step = cms.Path(process.pdigi_valid) -process.L1simulation_step = cms.Path(process.SimL1Emulator) -process.digi2raw_step = cms.Path(process.DigiToRaw) -process.endjob_step = cms.EndPath(process.endOfProcess) -process.FEVTDEBUGoutput_step = cms.EndPath(process.FEVTDEBUGoutput) - -process.load('L1Trigger.L1THGCal.hgcalTriggerPrimitives_cff') -# Eventually modify default geometry parameters -from L1Trigger.L1THGCal.customTriggerGeometry import custom_geometry_V9 -process = custom_geometry_V9(process, 2) - -process.hgcaltriggergeomtester = cms.EDAnalyzer( - "HGCalTriggerGeomTesterV9Imp2" - ) -process.test_step = cms.Path(process.hgcaltriggergeomtester) - -# Schedule definition -process.schedule = cms.Schedule(process.generation_step,process.genfiltersummary_step,process.simulation_step,process.digitisation_step,process.L1simulation_step,process.digi2raw_step,process.test_step,process.endjob_step,process.FEVTDEBUGoutput_step) -#process.schedule = cms.Schedule(process.generation_step,process.genfiltersummary_step,process.simulation_step,process.digitisation_step,process.L1simulation_step,process.digi2raw_step,process.endjob_step,process.FEVTDEBUGoutput_step) -# filter all path with the production filter sequence -for path in process.paths: - getattr(process,path)._seq = process.generator * getattr(process,path)._seq - -# Add early deletion of temporary data products to reduce peak memory need -from Configuration.StandardSequences.earlyDeleteSettings_cff import customiseEarlyDelete -process = customiseEarlyDelete(process) diff --git a/L1Trigger/L1THGCal/test/testHGCalL1TGeometry_cfg.py b/L1Trigger/L1THGCal/test/testHGCalL1TGeometry_cfg.py deleted file mode 100644 index ab2d13e4bc7e2..0000000000000 --- a/L1Trigger/L1THGCal/test/testHGCalL1TGeometry_cfg.py +++ /dev/null @@ -1,120 +0,0 @@ -import FWCore.ParameterSet.Config as cms - - -from Configuration.Eras.Era_Phase2_cff import Phase2 -process = cms.Process('DIGI',Phase2) - -# import of standard configurations -process.load('Configuration.StandardSequences.Services_cff') -process.load('SimGeneral.HepPDTESSource.pythiapdt_cfi') -process.load('FWCore.MessageService.MessageLogger_cfi') -process.load('Configuration.EventContent.EventContent_cff') -process.load('SimGeneral.MixingModule.mixNoPU_cfi') -process.load('Configuration.Geometry.GeometryExtended2023D17Reco_cff') -process.load('Configuration.Geometry.GeometryExtended2023D17_cff') -process.load('Configuration.StandardSequences.MagneticField_cff') -process.load('Configuration.StandardSequences.Generator_cff') -process.load('IOMC.EventVertexGenerators.VtxSmearedHLLHC14TeV_cfi') -process.load('GeneratorInterface.Core.genFilterSummary_cff') -process.load('Configuration.StandardSequences.SimIdeal_cff') -process.load('Configuration.StandardSequences.Digi_cff') -process.load('Configuration.StandardSequences.SimL1Emulator_cff') -process.load('Configuration.StandardSequences.DigiToRaw_cff') -process.load('Configuration.StandardSequences.EndOfProcess_cff') -process.load('Configuration.StandardSequences.FrontierConditions_GlobalTag_cff') - - -process.maxEvents = cms.untracked.PSet( - input = cms.untracked.int32(1) -) - -# Input source -process.source = cms.Source("EmptySource") - -process.options = cms.untracked.PSet( - -) - -# Production Info -process.configurationMetadata = cms.untracked.PSet( - version = cms.untracked.string('$Revision: 1.20 $'), - annotation = cms.untracked.string('SingleElectronPt10_cfi nevts:10'), - name = cms.untracked.string('Applications') -) - -# Output definition - -process.FEVTDEBUGoutput = cms.OutputModule("PoolOutputModule", - splitLevel = cms.untracked.int32(0), - eventAutoFlushCompressedSize = cms.untracked.int32(5242880), - outputCommands = process.FEVTDEBUGHLTEventContent.outputCommands, - fileName = cms.untracked.string('file:junk.root'), - dataset = cms.untracked.PSet( - filterName = cms.untracked.string(''), - dataTier = cms.untracked.string('GEN-SIM-DIGI-RAW') - ), - SelectEvents = cms.untracked.PSet( - SelectEvents = cms.vstring('generation_step') - ) -) - -# Additional output definition -process.TFileService = cms.Service( - "TFileService", - fileName = cms.string("test_triggergeom.root") - ) - - - -# Other statements -process.genstepfilter.triggerConditions=cms.vstring("generation_step") -from Configuration.AlCa.GlobalTag import GlobalTag -process.GlobalTag = GlobalTag(process.GlobalTag, 'auto:phase2_realistic', '') - -process.generator = cms.EDProducer("FlatRandomPtGunProducer", - PGunParameters = cms.PSet( - MaxPt = cms.double(10.01), - MinPt = cms.double(9.99), - PartID = cms.vint32(13), - MaxEta = cms.double(2.5), - MaxPhi = cms.double(3.14159265359), - MinEta = cms.double(-2.5), - MinPhi = cms.double(-3.14159265359) - ), - Verbosity = cms.untracked.int32(0), - psethack = cms.string('single electron pt 10'), - AddAntiParticle = cms.bool(True), - firstRun = cms.untracked.uint32(1) -) - -process.mix.digitizers = cms.PSet(process.theDigitizersValid) - - -# Path and EndPath definitions -process.generation_step = cms.Path(process.pgen) -process.simulation_step = cms.Path(process.psim) -process.genfiltersummary_step = cms.EndPath(process.genFilterSummary) -process.digitisation_step = cms.Path(process.pdigi_valid) -process.L1simulation_step = cms.Path(process.SimL1Emulator) -process.digi2raw_step = cms.Path(process.DigiToRaw) -process.endjob_step = cms.EndPath(process.endOfProcess) -process.FEVTDEBUGoutput_step = cms.EndPath(process.FEVTDEBUGoutput) - -process.load('L1Trigger.L1THGCal.hgcalTriggerPrimitives_cff') -# Eventually modify default geometry parameters - -process.hgcaltriggergeomtester = cms.EDAnalyzer( - "HGCalTriggerGeomTester" - ) -process.test_step = cms.Path(process.hgcaltriggergeomtester) - -# Schedule definition -process.schedule = cms.Schedule(process.generation_step,process.genfiltersummary_step,process.simulation_step,process.digitisation_step,process.L1simulation_step,process.digi2raw_step,process.test_step,process.endjob_step,process.FEVTDEBUGoutput_step) -#process.schedule = cms.Schedule(process.generation_step,process.genfiltersummary_step,process.simulation_step,process.digitisation_step,process.L1simulation_step,process.digi2raw_step,process.endjob_step,process.FEVTDEBUGoutput_step) -# filter all path with the production filter sequence -for path in process.paths: - getattr(process,path)._seq = process.generator * getattr(process,path)._seq - -# Add early deletion of temporary data products to reduce peak memory need -from Configuration.StandardSequences.earlyDeleteSettings_cff import customiseEarlyDelete -process = customiseEarlyDelete(process) diff --git a/L1Trigger/L1THGCal/test/testHGCalL1T_RelValV9_cfg.py b/L1Trigger/L1THGCal/test/testHGCalL1T_RelValV9_cfg.py deleted file mode 100644 index e0a719ebc4e6e..0000000000000 --- a/L1Trigger/L1THGCal/test/testHGCalL1T_RelValV9_cfg.py +++ /dev/null @@ -1,89 +0,0 @@ -import FWCore.ParameterSet.Config as cms - -from Configuration.Eras.Era_Phase2C4_cff import Phase2C4 -process = cms.Process('DIGI',Phase2C4) - -# import of standard configurations -process.load('Configuration.StandardSequences.Services_cff') -process.load('SimGeneral.HepPDTESSource.pythiapdt_cfi') -process.load('FWCore.MessageService.MessageLogger_cfi') -process.load('Configuration.EventContent.EventContent_cff') -process.load('SimGeneral.MixingModule.mixNoPU_cfi') -process.load('Configuration.Geometry.GeometryExtended2023D35Reco_cff') -process.load('Configuration.Geometry.GeometryExtended2023D35_cff') -process.load('Configuration.StandardSequences.MagneticField_cff') -process.load('Configuration.StandardSequences.Generator_cff') -process.load('IOMC.EventVertexGenerators.VtxSmearedHLLHC14TeV_cfi') -process.load('GeneratorInterface.Core.genFilterSummary_cff') -process.load('Configuration.StandardSequences.SimIdeal_cff') -process.load('Configuration.StandardSequences.Digi_cff') -process.load('Configuration.StandardSequences.SimL1Emulator_cff') -process.load('Configuration.StandardSequences.DigiToRaw_cff') -process.load('Configuration.StandardSequences.EndOfProcess_cff') -process.load('Configuration.StandardSequences.FrontierConditions_GlobalTag_cff') - - -process.maxEvents = cms.untracked.PSet( - input = cms.untracked.int32(50) -) - -# Input source -process.source = cms.Source("PoolSource", - fileNames = cms.untracked.vstring('/store/relval/CMSSW_10_4_0_pre2/RelValSinglePiFlatPt_0p7to10_pythia8_cfi/GEN-SIM-DIGI-RAW/103X_upgrade2023_realistic_v2_2023D35noPU-v1/10000/CE7F0A8C-F917-F14D-9BC4-CD46CFA8B7FD.root'), - inputCommands=cms.untracked.vstring( - 'keep *', - 'drop l1tEMTFHit2016Extras_simEmtfDigis_CSC_HLT', - 'drop l1tEMTFHit2016Extras_simEmtfDigis_RPC_HLT', - 'drop l1tEMTFHit2016s_simEmtfDigis__HLT', - 'drop l1tEMTFTrack2016Extras_simEmtfDigis__HLT', - 'drop l1tEMTFTrack2016s_simEmtfDigis__HLT', - 'drop FTLClusteredmNewDetSetVector_mtdClusters_FTLBarrel_RECO', - 'drop FTLClusteredmNewDetSetVector_mtdClusters_FTLEndcap_RECO', - 'drop MTDTrackingRecHitedmNewDetSetVector_mtdTrackingRecHits__RECO', - 'drop BTLDetIdBTLSampleFTLDataFrameTsSorted_mix_FTLBarrel_HLT', - 'drop ETLDetIdETLSampleFTLDataFrameTsSorted_mix_FTLEndcap_HLT', - ) - ) - -process.options = cms.untracked.PSet( - -) - -# Production Info -process.configurationMetadata = cms.untracked.PSet( - version = cms.untracked.string('$Revision: 1.20 $'), - annotation = cms.untracked.string('SingleElectronPt10_cfi nevts:10'), - name = cms.untracked.string('Applications') -) - -process.FEVTDEBUGoutput = cms.OutputModule("PoolOutputModule", - splitLevel = cms.untracked.int32(0), - eventAutoFlushCompressedSize = cms.untracked.int32(5242880), - outputCommands = cms.untracked.vstring( - 'keep *_hgcalBackEndLayer2Producer_*_*', - 'keep *_hgcalTowerProducer_*_*', - ), - fileName = cms.untracked.string('file:test.root') -) - - -# Other statements -from Configuration.AlCa.GlobalTag import GlobalTag -process.GlobalTag = GlobalTag(process.GlobalTag, 'auto:phase2_realistic', '') - -# load HGCAL TPG simulation -process.load('L1Trigger.L1THGCal.hgcalTriggerPrimitives_cff') -process.hgcl1tpg_step = cms.Path(process.hgcalTriggerPrimitives) - - -process.FEVTDEBUGoutput_step = cms.EndPath(process.FEVTDEBUGoutput) - -# Schedule definition -process.schedule = cms.Schedule(process.hgcl1tpg_step, process.FEVTDEBUGoutput_step) - - -# Add early deletion of temporary data products to reduce peak memory need -from Configuration.StandardSequences.earlyDeleteSettings_cff import customiseEarlyDelete -process = customiseEarlyDelete(process) -# End adding early deletion - diff --git a/L1Trigger/L1THGCal/test/testHGCalL1T_RelVal_cfg.py b/L1Trigger/L1THGCal/test/testHGCalL1T_RelVal_cfg.py deleted file mode 100644 index 3e858057c6380..0000000000000 --- a/L1Trigger/L1THGCal/test/testHGCalL1T_RelVal_cfg.py +++ /dev/null @@ -1,88 +0,0 @@ -import FWCore.ParameterSet.Config as cms -from Configuration.ProcessModifiers.convertHGCalDigisSim_cff import convertHGCalDigisSim - -# For old samples use the digi converter -from Configuration.Eras.Era_Phase2_cff import Phase2 -#process = cms.Process('DIGI',Phase2,convertHGCalDigisSim) -process = cms.Process('DIGI',Phase2) - -# import of standard configurations -process.load('Configuration.StandardSequences.Services_cff') -process.load('SimGeneral.HepPDTESSource.pythiapdt_cfi') -process.load('FWCore.MessageService.MessageLogger_cfi') -process.load('Configuration.EventContent.EventContent_cff') -process.load('SimGeneral.MixingModule.mixNoPU_cfi') -process.load('Configuration.Geometry.GeometryExtended2023D17Reco_cff') -process.load('Configuration.Geometry.GeometryExtended2023D17_cff') -process.load('Configuration.StandardSequences.MagneticField_cff') -process.load('Configuration.StandardSequences.Generator_cff') -process.load('IOMC.EventVertexGenerators.VtxSmearedHLLHC14TeV_cfi') -process.load('GeneratorInterface.Core.genFilterSummary_cff') -process.load('Configuration.StandardSequences.SimIdeal_cff') -process.load('Configuration.StandardSequences.Digi_cff') -process.load('Configuration.StandardSequences.SimL1Emulator_cff') -process.load('Configuration.StandardSequences.DigiToRaw_cff') -process.load('Configuration.StandardSequences.EndOfProcess_cff') -process.load('Configuration.StandardSequences.FrontierConditions_GlobalTag_cff') - - -process.maxEvents = cms.untracked.PSet( - input = cms.untracked.int32(50) -) - -# Input source -process.source = cms.Source("PoolSource", - fileNames = cms.untracked.vstring('/store/relval/CMSSW_10_4_0_pre2/RelValTTbar_14TeV/GEN-SIM-DIGI-RAW/103X_upgrade2023_realistic_v2_2023D21noPU-v1/20000/F4344045-AEDE-4240-B7B1-27D2CF96C34E.root'), - inputCommands=cms.untracked.vstring( - 'keep *', - 'drop l1tEMTFHit2016Extras_simEmtfDigis_CSC_HLT', - 'drop l1tEMTFHit2016Extras_simEmtfDigis_RPC_HLT', - 'drop l1tEMTFHit2016s_simEmtfDigis__HLT', - 'drop l1tEMTFTrack2016Extras_simEmtfDigis__HLT', - 'drop l1tEMTFTrack2016s_simEmtfDigis__HLT', - ) - ) - -process.options = cms.untracked.PSet( - -) - -# Production Info -process.configurationMetadata = cms.untracked.PSet( - version = cms.untracked.string('$Revision: 1.20 $'), - annotation = cms.untracked.string('SingleElectronPt10_cfi nevts:10'), - name = cms.untracked.string('Applications') -) - -process.FEVTDEBUGoutput = cms.OutputModule("PoolOutputModule", - splitLevel = cms.untracked.int32(0), - eventAutoFlushCompressedSize = cms.untracked.int32(5242880), - outputCommands = cms.untracked.vstring( - 'keep *_hgcalBackEndLayer2Producer_*_*', - 'keep *_hgcalTowerProducer_*_*', - ), - fileName = cms.untracked.string('file:test.root') -) - -# Other statements -from Configuration.AlCa.GlobalTag import GlobalTag -process.GlobalTag = GlobalTag(process.GlobalTag, 'auto:phase2_realistic', '') - -# load HGCAL TPG simulation -process.load('L1Trigger.L1THGCal.hgcalTriggerPrimitives_cff') -process.hgcl1tpg_step = cms.Path(process.hgcalTriggerPrimitives) -# Change to V7 trigger geometry for older samples -# from L1Trigger.L1THGCal.customTriggerGeometry import custom_geometry_ZoltanSplit_V7 -# process = custom_geometry_ZoltanSplit_V7(process) - - -process.FEVTDEBUGoutput_step = cms.EndPath(process.FEVTDEBUGoutput) - -# Schedule definition -process.schedule = cms.Schedule(process.hgcl1tpg_step, process.FEVTDEBUGoutput_step) - -# Add early deletion of temporary data products to reduce peak memory need -from Configuration.StandardSequences.earlyDeleteSettings_cff import customiseEarlyDelete -process = customiseEarlyDelete(process) -# End adding early deletion - diff --git a/L1Trigger/L1THGCal/test/testHGCalL1T_cfg.py b/L1Trigger/L1THGCal/test/testHGCalL1T_cfg.py deleted file mode 100644 index 3ad0b2b72e41e..0000000000000 --- a/L1Trigger/L1THGCal/test/testHGCalL1T_cfg.py +++ /dev/null @@ -1,129 +0,0 @@ -import FWCore.ParameterSet.Config as cms - -from Configuration.Eras.Era_Phase2_cff import Phase2 -process = cms.Process('DIGI',Phase2) - -# import of standard configurations -process.load('Configuration.StandardSequences.Services_cff') -process.load('SimGeneral.HepPDTESSource.pythiapdt_cfi') -process.load('FWCore.MessageService.MessageLogger_cfi') -process.load('Configuration.EventContent.EventContent_cff') -process.load('SimGeneral.MixingModule.mixNoPU_cfi') -process.load('Configuration.Geometry.GeometryExtended2023D17Reco_cff') -process.load('Configuration.Geometry.GeometryExtended2023D17_cff') -process.load('Configuration.StandardSequences.MagneticField_cff') -process.load('Configuration.StandardSequences.Generator_cff') -process.load('IOMC.EventVertexGenerators.VtxSmearedHLLHC14TeV_cfi') -process.load('GeneratorInterface.Core.genFilterSummary_cff') -process.load('Configuration.StandardSequences.SimIdeal_cff') -process.load('Configuration.StandardSequences.Digi_cff') -process.load('Configuration.StandardSequences.SimL1Emulator_cff') -process.load('Configuration.StandardSequences.DigiToRaw_cff') -process.load('Configuration.StandardSequences.EndOfProcess_cff') -process.load('Configuration.StandardSequences.FrontierConditions_GlobalTag_cff') - - -process.maxEvents = cms.untracked.PSet( - input = cms.untracked.int32(1) -) - -# Input source -process.source = cms.Source("EmptySource") - -process.options = cms.untracked.PSet( - -) - -# Production Info -process.configurationMetadata = cms.untracked.PSet( - version = cms.untracked.string('$Revision: 1.20 $'), - annotation = cms.untracked.string('SingleElectronPt10_cfi nevts:10'), - name = cms.untracked.string('Applications') -) - -# Output definition - -process.FEVTDEBUGoutput = cms.OutputModule("PoolOutputModule", - splitLevel = cms.untracked.int32(0), - eventAutoFlushCompressedSize = cms.untracked.int32(5242880), - #outputCommands = process.FEVTDEBUGEventContent.outputCommands, - outputCommands = cms.untracked.vstring( - 'keep *_*_HGCHitsEE_*', - 'keep *_*_HGCHitsHEback_*', - 'keep *_*_HGCHitsHEfront_*', - 'keep *_mix_*_*', - 'keep *_genParticles_*_*', - 'keep *_hgcalTriggerPrimitiveDigiProducer_*_*' - ), - fileName = cms.untracked.string('file:test.root'), - dataset = cms.untracked.PSet( - filterName = cms.untracked.string(''), - dataTier = cms.untracked.string('GEN-SIM-DIGI-RAW') - ), - SelectEvents = cms.untracked.PSet( - SelectEvents = cms.vstring('generation_step') - ) -) - -# Additional output definition -process.TFileService = cms.Service( - "TFileService", - fileName = cms.string("ntuple.root") - ) - -# Other statements -process.genstepfilter.triggerConditions=cms.vstring("generation_step") -from Configuration.AlCa.GlobalTag import GlobalTag -process.GlobalTag = GlobalTag(process.GlobalTag, 'auto:phase2_realistic', '') - -process.generator = cms.EDProducer("FlatRandomPtGunProducer", - PGunParameters = cms.PSet( - MaxPt = cms.double(50.01), - MinPt = cms.double(49.99), - PartID = cms.vint32(11), - MaxEta = cms.double(3.0), - MaxPhi = cms.double(3.14159265359), - MinEta = cms.double(1.5), - MinPhi = cms.double(-3.14159265359) - ), - Verbosity = cms.untracked.int32(0), - psethack = cms.string('single electron pt 50'), - AddAntiParticle = cms.bool(True), - firstRun = cms.untracked.uint32(1) -) - -process.mix.digitizers = cms.PSet(process.theDigitizersValid) - - - -# Path and EndPath definitions -process.generation_step = cms.Path(process.pgen) -process.simulation_step = cms.Path(process.psim) -process.genfiltersummary_step = cms.EndPath(process.genFilterSummary) -process.digitisation_step = cms.Path(process.pdigi_valid) -process.L1simulation_step = cms.Path(process.SimL1Emulator) - -process.load('L1Trigger.L1THGCal.hgcalTriggerPrimitives_cff') -process.hgcl1tpg_step = cms.Path(process.hgcalTriggerPrimitives) - - -process.digi2raw_step = cms.Path(process.DigiToRaw) -process.endjob_step = cms.EndPath(process.endOfProcess) -process.FEVTDEBUGoutput_step = cms.EndPath(process.FEVTDEBUGoutput) - -# load ntuplizer -process.load('L1Trigger.L1THGCal.hgcalTriggerNtuples_cff') -process.ntuple_step = cms.Path(process.hgcalTriggerNtuples) - -# Schedule definition -process.schedule = cms.Schedule(process.generation_step,process.genfiltersummary_step,process.simulation_step,process.digitisation_step,process.L1simulation_step,process.hgcl1tpg_step,process.digi2raw_step, process.ntuple_step, process.endjob_step, process.FEVTDEBUGoutput_step) - -# filter all path with the production filter sequence -for path in process.paths: - getattr(process,path)._seq = process.generator * getattr(process,path)._seq - -# Add early deletion of temporary data products to reduce peak memory need -from Configuration.StandardSequences.earlyDeleteSettings_cff import customiseEarlyDelete -process = customiseEarlyDelete(process) -# End adding early deletion - diff --git a/L1Trigger/L1THGCalUtilities/test/testCustomHGCalL1T_RelValV11_cfg.py b/L1Trigger/L1THGCalUtilities/test/testCustomHGCalL1T_RelValV11_cfg.py index b119b7d1bcb42..3d27f3c8ee44f 100644 --- a/L1Trigger/L1THGCalUtilities/test/testCustomHGCalL1T_RelValV11_cfg.py +++ b/L1Trigger/L1THGCalUtilities/test/testCustomHGCalL1T_RelValV11_cfg.py @@ -29,7 +29,7 @@ # Input source process.source = cms.Source("PoolSource", - fileNames = cms.untracked.vstring('/store/mc/Phase2HLTTDRWinter20DIGI/TT_TuneCP5_14TeV-powheg-pythia8/GEN-SIM-DIGI-RAW/PU200_110X_mcRun4_realistic_v3-v2/240000/2D0339A5-751F-3543-BA5B-456EA6E5E294.root'), + fileNames = cms.untracked.vstring('/store/mc/Phase2HLTTDRWinter20DIGI/SingleElectron_PT2to200/GEN-SIM-DIGI-RAW/PU200_110X_mcRun4_realistic_v3_ext2-v2/40000/00582F93-5A2A-5847-8162-D81EE503500F.root'), inputCommands=cms.untracked.vstring( 'keep *', 'drop l1tEMTFHit2016Extras_simEmtfDigis_CSC_HLT', @@ -64,7 +64,7 @@ # Other statements from Configuration.AlCa.GlobalTag import GlobalTag -process.GlobalTag = GlobalTag(process.GlobalTag, 'auto:phase2_realistic', '') +process.GlobalTag = GlobalTag(process.GlobalTag, 'auto:phase2_realistic_T15', '') # load HGCAL TPG simulation process.load('L1Trigger.L1THGCal.hgcalTriggerPrimitives_cff') diff --git a/L1Trigger/L1THGCalUtilities/test/testHGCalL1T_RelValV10_cfg.py b/L1Trigger/L1THGCalUtilities/test/testHGCalL1T_RelValV10_cfg.py deleted file mode 100644 index 1255782b2cb15..0000000000000 --- a/L1Trigger/L1THGCalUtilities/test/testHGCalL1T_RelValV10_cfg.py +++ /dev/null @@ -1,91 +0,0 @@ -import FWCore.ParameterSet.Config as cms - -from Configuration.Eras.Era_Phase2C8_cff import Phase2C8 -process = cms.Process('DIGI',Phase2C8) - -# import of standard configurations -process.load('Configuration.StandardSequences.Services_cff') -process.load('SimGeneral.HepPDTESSource.pythiapdt_cfi') -process.load('FWCore.MessageService.MessageLogger_cfi') -process.load('Configuration.EventContent.EventContent_cff') -process.load('SimGeneral.MixingModule.mixNoPU_cfi') -process.load('Configuration.Geometry.GeometryExtended2026D41Reco_cff') -process.load('Configuration.Geometry.GeometryExtended2026D41_cff') -process.load('Configuration.StandardSequences.MagneticField_cff') -process.load('Configuration.StandardSequences.Generator_cff') -process.load('IOMC.EventVertexGenerators.VtxSmearedHLLHC14TeV_cfi') -process.load('GeneratorInterface.Core.genFilterSummary_cff') -process.load('Configuration.StandardSequences.SimIdeal_cff') -process.load('Configuration.StandardSequences.Digi_cff') -process.load('Configuration.StandardSequences.SimL1Emulator_cff') -process.load('Configuration.StandardSequences.DigiToRaw_cff') -process.load('Configuration.StandardSequences.EndOfProcess_cff') -process.load('Configuration.StandardSequences.FrontierConditions_GlobalTag_cff') - - -process.maxEvents = cms.untracked.PSet( - input = cms.untracked.int32(50) -) - -# Input source -process.source = cms.Source("PoolSource", - fileNames = cms.untracked.vstring('/store/mc/PhaseIITDRSpring19DR/TTbar_14TeV_TuneCP5_Pythia8/GEN-SIM-DIGI-RAW/PU200_106X_upgrade2023_realistic_v3_ext1-v3/60000/FFB5D0CA-208F-6040-A9BF-3F5354D0AA59.root'), - inputCommands=cms.untracked.vstring( - 'keep *', - 'drop l1tEMTFHit2016Extras_simEmtfDigis_CSC_HLT', - 'drop l1tEMTFHit2016Extras_simEmtfDigis_RPC_HLT', - 'drop l1tEMTFHit2016s_simEmtfDigis__HLT', - 'drop l1tEMTFTrack2016Extras_simEmtfDigis__HLT', - 'drop l1tEMTFTrack2016s_simEmtfDigis__HLT', - 'drop FTLClusteredmNewDetSetVector_mtdClusters_FTLBarrel_RECO', - 'drop FTLClusteredmNewDetSetVector_mtdClusters_FTLEndcap_RECO', - 'drop MTDTrackingRecHitedmNewDetSetVector_mtdTrackingRecHits__RECO', - 'drop BTLDetIdBTLSampleFTLDataFrameTsSorted_mix_FTLBarrel_HLT', - 'drop ETLDetIdETLSampleFTLDataFrameTsSorted_mix_FTLEndcap_HLT', - ) - ) - -process.options = cms.untracked.PSet( - -) - -# Production Info -process.configurationMetadata = cms.untracked.PSet( - version = cms.untracked.string('$Revision: 1.20 $'), - annotation = cms.untracked.string('SingleElectronPt10_cfi nevts:10'), - name = cms.untracked.string('Applications') -) - -# Output definition -process.TFileService = cms.Service( - "TFileService", - fileName = cms.string("ntuple.root") - ) - -# Other statements -from Configuration.AlCa.GlobalTag import GlobalTag -process.GlobalTag = GlobalTag(process.GlobalTag, 'auto:phase2_realistic', '') - -# load HGCAL TPG simulation -process.load('L1Trigger.L1THGCal.hgcalTriggerPrimitives_cff') - -# To add truth-matched calo cells and downstream objects -#process.load('L1Trigger.L1THGCalUtilities.caloTruthCells_cff') -#process.hgcalTriggerPrimitives += process.caloTruthCells -#process.load('L1Trigger.L1THGCalUtilities.caloTruthCellsNtuples_cff') - -process.hgcl1tpg_step = cms.Path(process.hgcalTriggerPrimitives) - - -# load ntuplizer -process.load('L1Trigger.L1THGCalUtilities.hgcalTriggerNtuples_cff') -process.ntuple_step = cms.Path(process.hgcalTriggerNtuples) - -# Schedule definition -process.schedule = cms.Schedule(process.hgcl1tpg_step, process.ntuple_step) - -# Add early deletion of temporary data products to reduce peak memory need -from Configuration.StandardSequences.earlyDeleteSettings_cff import customiseEarlyDelete -process = customiseEarlyDelete(process) -# End adding early deletion - diff --git a/L1Trigger/L1THGCalUtilities/test/testHGCalL1T_RelValV11_cfg.py b/L1Trigger/L1THGCalUtilities/test/testHGCalL1T_RelValV11_cfg.py index 1f5aef1629c6a..47b11ee07ab06 100644 --- a/L1Trigger/L1THGCalUtilities/test/testHGCalL1T_RelValV11_cfg.py +++ b/L1Trigger/L1THGCalUtilities/test/testHGCalL1T_RelValV11_cfg.py @@ -29,7 +29,7 @@ # Input source process.source = cms.Source("PoolSource", - fileNames = cms.untracked.vstring('/store/mc/Phase2HLTTDRWinter20DIGI/TT_TuneCP5_14TeV-powheg-pythia8/GEN-SIM-DIGI-RAW/PU200_110X_mcRun4_realistic_v3-v2/240000/2D0339A5-751F-3543-BA5B-456EA6E5E294.root'), + fileNames = cms.untracked.vstring('/store/mc/Phase2HLTTDRWinter20DIGI/SingleElectron_PT2to200/GEN-SIM-DIGI-RAW/PU200_110X_mcRun4_realistic_v3_ext2-v2/40000/00582F93-5A2A-5847-8162-D81EE503500F.root'), inputCommands=cms.untracked.vstring( 'keep *', 'drop l1tEMTFHit2016Extras_simEmtfDigis_CSC_HLT', @@ -64,7 +64,7 @@ # Other statements from Configuration.AlCa.GlobalTag import GlobalTag -process.GlobalTag = GlobalTag(process.GlobalTag, 'auto:phase2_realistic', '') +process.GlobalTag = GlobalTag(process.GlobalTag, 'auto:phase2_realistic_T15', '') # load HGCAL TPG simulation process.load('L1Trigger.L1THGCal.hgcalTriggerPrimitives_cff') diff --git a/L1Trigger/L1THGCalUtilities/test/testHGCalL1T_RelValV9_cfg.py b/L1Trigger/L1THGCalUtilities/test/testHGCalL1T_RelValV9_cfg.py deleted file mode 100644 index b4df425ec18a9..0000000000000 --- a/L1Trigger/L1THGCalUtilities/test/testHGCalL1T_RelValV9_cfg.py +++ /dev/null @@ -1,91 +0,0 @@ -import FWCore.ParameterSet.Config as cms - -from Configuration.Eras.Era_Phase2C4_cff import Phase2C4 -process = cms.Process('DIGI',Phase2C4) - -# import of standard configurations -process.load('Configuration.StandardSequences.Services_cff') -process.load('SimGeneral.HepPDTESSource.pythiapdt_cfi') -process.load('FWCore.MessageService.MessageLogger_cfi') -process.load('Configuration.EventContent.EventContent_cff') -process.load('SimGeneral.MixingModule.mixNoPU_cfi') -process.load('Configuration.Geometry.GeometryExtended2026D35Reco_cff') -process.load('Configuration.Geometry.GeometryExtended2026D35_cff') -process.load('Configuration.StandardSequences.MagneticField_cff') -process.load('Configuration.StandardSequences.Generator_cff') -process.load('IOMC.EventVertexGenerators.VtxSmearedHLLHC14TeV_cfi') -process.load('GeneratorInterface.Core.genFilterSummary_cff') -process.load('Configuration.StandardSequences.SimIdeal_cff') -process.load('Configuration.StandardSequences.Digi_cff') -process.load('Configuration.StandardSequences.SimL1Emulator_cff') -process.load('Configuration.StandardSequences.DigiToRaw_cff') -process.load('Configuration.StandardSequences.EndOfProcess_cff') -process.load('Configuration.StandardSequences.FrontierConditions_GlobalTag_cff') - - -process.maxEvents = cms.untracked.PSet( - input = cms.untracked.int32(50) -) - -# Input source -process.source = cms.Source("PoolSource", - fileNames = cms.untracked.vstring('/store/mc/PhaseIIMTDTDRAutumn18DR/SinglePion_FlatPt-2to100/FEVT/PU200_103X_upgrade2023_realistic_v2-v1/70000/FFA969EE-22E0-E447-86AA-46A6CBF6407D.root'), - inputCommands=cms.untracked.vstring( - 'keep *', - 'drop l1tEMTFHit2016Extras_simEmtfDigis_CSC_HLT', - 'drop l1tEMTFHit2016Extras_simEmtfDigis_RPC_HLT', - 'drop l1tEMTFHit2016s_simEmtfDigis__HLT', - 'drop l1tEMTFTrack2016Extras_simEmtfDigis__HLT', - 'drop l1tEMTFTrack2016s_simEmtfDigis__HLT', - 'drop FTLClusteredmNewDetSetVector_mtdClusters_FTLBarrel_RECO', - 'drop FTLClusteredmNewDetSetVector_mtdClusters_FTLEndcap_RECO', - 'drop MTDTrackingRecHitedmNewDetSetVector_mtdTrackingRecHits__RECO', - 'drop BTLDetIdBTLSampleFTLDataFrameTsSorted_mix_FTLBarrel_HLT', - 'drop ETLDetIdETLSampleFTLDataFrameTsSorted_mix_FTLEndcap_HLT', - ) - ) - -process.options = cms.untracked.PSet( - -) - -# Production Info -process.configurationMetadata = cms.untracked.PSet( - version = cms.untracked.string('$Revision: 1.20 $'), - annotation = cms.untracked.string('SingleElectronPt10_cfi nevts:10'), - name = cms.untracked.string('Applications') -) - -# Output definition -process.TFileService = cms.Service( - "TFileService", - fileName = cms.string("ntuple.root") - ) - -# Other statements -from Configuration.AlCa.GlobalTag import GlobalTag -process.GlobalTag = GlobalTag(process.GlobalTag, 'auto:phase2_realistic', '') - -# load HGCAL TPG simulation -process.load('L1Trigger.L1THGCal.hgcalTriggerPrimitives_cff') - -# To add truth-matched calo cells and downstream objects -#process.load('L1Trigger.L1THGCalUtilities.caloTruthCells_cff') -#process.hgcalTriggerPrimitives += process.caloTruthCells -#process.load('L1Trigger.L1THGCalUtilities.caloTruthCellsNtuples_cff') - -process.hgcl1tpg_step = cms.Path(process.hgcalTriggerPrimitives) - - -# load ntuplizer -process.load('L1Trigger.L1THGCalUtilities.hgcalTriggerNtuples_cff') -process.ntuple_step = cms.Path(process.hgcalTriggerNtuples) - -# Schedule definition -process.schedule = cms.Schedule(process.hgcl1tpg_step, process.ntuple_step) - -# Add early deletion of temporary data products to reduce peak memory need -from Configuration.StandardSequences.earlyDeleteSettings_cff import customiseEarlyDelete -process = customiseEarlyDelete(process) -# End adding early deletion - diff --git a/L1Trigger/L1THGCalUtilities/test/testHGCalL1T_RelVal_cfg.py b/L1Trigger/L1THGCalUtilities/test/testHGCalL1T_RelVal_cfg.py deleted file mode 100644 index 841e69398a5b4..0000000000000 --- a/L1Trigger/L1THGCalUtilities/test/testHGCalL1T_RelVal_cfg.py +++ /dev/null @@ -1,82 +0,0 @@ -import FWCore.ParameterSet.Config as cms -from Configuration.ProcessModifiers.convertHGCalDigisSim_cff import convertHGCalDigisSim - -# For old samples use the digi converter -from Configuration.Eras.Era_Phase2_cff import Phase2 -#process = cms.Process('DIGI',Phase2,convertHGCalDigisSim) -process = cms.Process('DIGI',Phase2) - -# import of standard configurations -process.load('Configuration.StandardSequences.Services_cff') -process.load('SimGeneral.HepPDTESSource.pythiapdt_cfi') -process.load('FWCore.MessageService.MessageLogger_cfi') -process.load('Configuration.EventContent.EventContent_cff') -process.load('SimGeneral.MixingModule.mixNoPU_cfi') -process.load('Configuration.Geometry.GeometryExtended2023D17Reco_cff') -process.load('Configuration.Geometry.GeometryExtended2023D17_cff') -process.load('Configuration.StandardSequences.MagneticField_cff') -process.load('Configuration.StandardSequences.Generator_cff') -process.load('IOMC.EventVertexGenerators.VtxSmearedHLLHC14TeV_cfi') -process.load('GeneratorInterface.Core.genFilterSummary_cff') -process.load('Configuration.StandardSequences.SimIdeal_cff') -process.load('Configuration.StandardSequences.Digi_cff') -process.load('Configuration.StandardSequences.SimL1Emulator_cff') -process.load('Configuration.StandardSequences.DigiToRaw_cff') -process.load('Configuration.StandardSequences.EndOfProcess_cff') -process.load('Configuration.StandardSequences.FrontierConditions_GlobalTag_cff') - - -process.maxEvents = cms.untracked.PSet( - input = cms.untracked.int32(50) -) - -# Input source -process.source = cms.Source("PoolSource", - fileNames = cms.untracked.vstring('/store/relval/CMSSW_10_4_0_pre2/RelValTTbar_14TeV/GEN-SIM-DIGI-RAW/103X_upgrade2023_realistic_v2_2023D21noPU-v1/20000/F4344045-AEDE-4240-B7B1-27D2CF96C34E.root'), - inputCommands=cms.untracked.vstring( - 'keep *', - 'drop l1tEMTFHit2016Extras_simEmtfDigis_CSC_HLT', - 'drop l1tEMTFHit2016Extras_simEmtfDigis_RPC_HLT', - 'drop l1tEMTFHit2016s_simEmtfDigis__HLT', - 'drop l1tEMTFTrack2016Extras_simEmtfDigis__HLT', - 'drop l1tEMTFTrack2016s_simEmtfDigis__HLT', - ) - ) - -process.options = cms.untracked.PSet( - -) - -# Production Info -process.configurationMetadata = cms.untracked.PSet( - version = cms.untracked.string('$Revision: 1.20 $'), - annotation = cms.untracked.string('SingleElectronPt10_cfi nevts:10'), - name = cms.untracked.string('Applications') -) - -# Output definition -process.TFileService = cms.Service( - "TFileService", - fileName = cms.string("ntuple.root") - ) - -# Other statements -from Configuration.AlCa.GlobalTag import GlobalTag -process.GlobalTag = GlobalTag(process.GlobalTag, 'auto:phase2_realistic', '') - -# load HGCAL TPG simulation -process.load('L1Trigger.L1THGCal.hgcalTriggerPrimitives_cff') -process.hgcl1tpg_step = cms.Path(process.hgcalTriggerPrimitives) - -# load ntuplizer -process.load('L1Trigger.L1THGCalUtilities.hgcalTriggerNtuples_cff') -process.ntuple_step = cms.Path(process.hgcalTriggerNtuples) - -# Schedule definition -process.schedule = cms.Schedule(process.hgcl1tpg_step, process.ntuple_step) - -# Add early deletion of temporary data products to reduce peak memory need -from Configuration.StandardSequences.earlyDeleteSettings_cff import customiseEarlyDelete -process = customiseEarlyDelete(process) -# End adding early deletion - diff --git a/L1Trigger/L1THGCalUtilities/test/testHGCalL1T_multialgo_with_truth_cfg.py b/L1Trigger/L1THGCalUtilities/test/testHGCalL1T_multialgo_with_truth_cfg.py index 3344749f5dbec..6fc232cdf2ad1 100644 --- a/L1Trigger/L1THGCalUtilities/test/testHGCalL1T_multialgo_with_truth_cfg.py +++ b/L1Trigger/L1THGCalUtilities/test/testHGCalL1T_multialgo_with_truth_cfg.py @@ -1,9 +1,7 @@ import FWCore.ParameterSet.Config as cms -from Configuration.StandardSequences.Eras import eras -from Configuration.ProcessModifiers.convertHGCalDigisSim_cff import convertHGCalDigisSim -# For old samples use the digi converter -process = cms.Process('DIGI',eras.Phase2C4) +from Configuration.Eras.Era_Phase2C9_cff import Phase2C9 +process = cms.Process('DIGI',Phase2C9) # import of standard configurations process.load('Configuration.StandardSequences.Services_cff') @@ -11,8 +9,8 @@ process.load('FWCore.MessageService.MessageLogger_cfi') process.load('Configuration.EventContent.EventContent_cff') process.load('SimGeneral.MixingModule.mixNoPU_cfi') -process.load('Configuration.Geometry.GeometryExtended2026D35Reco_cff') -process.load('Configuration.Geometry.GeometryExtended2026D35_cff') +process.load('Configuration.Geometry.GeometryExtended2026D49Reco_cff') +process.load('Configuration.Geometry.GeometryExtended2026D49_cff') process.load('Configuration.StandardSequences.MagneticField_cff') process.load('Configuration.StandardSequences.Generator_cff') process.load('IOMC.EventVertexGenerators.VtxSmearedHLLHC14TeV_cfi') @@ -26,12 +24,12 @@ process.maxEvents = cms.untracked.PSet( - input = cms.untracked.int32(50) + input = cms.untracked.int32(5) ) # Input source process.source = cms.Source("PoolSource", - fileNames = cms.untracked.vstring('/store/mc/PhaseIIMTDTDRAutumn18DR/SinglePion_FlatPt-2to100/FEVT/NoPU_103X_upgrade2023_realistic_v2-v1/70000/60B619EA-9EC7-A744-B3E5-5369820F26CB.root'), + fileNames = cms.untracked.vstring('/store/mc/Phase2HLTTDRWinter20DIGI/SingleElectron_PT2to200/GEN-SIM-DIGI-RAW/PU200_110X_mcRun4_realistic_v3_ext2-v2/40000/00582F93-5A2A-5847-8162-D81EE503500F.root'), inputCommands=cms.untracked.vstring( 'keep *', 'drop l1tEMTFHit2016Extras_simEmtfDigis_CSC_HLT', @@ -61,11 +59,10 @@ # Other statements from Configuration.AlCa.GlobalTag import GlobalTag -process.GlobalTag = GlobalTag(process.GlobalTag, 'auto:phase2_realistic', '') +process.GlobalTag = GlobalTag(process.GlobalTag, 'auto:phase2_realistic_T15', '') # load HGCAL TPG simulation process.load('L1Trigger.L1THGCal.hgcalTriggerPrimitives_cff') - process.load('L1Trigger.L1THGCalUtilities.HGC3DClusterGenMatchSelector_cff') process.load('L1Trigger.L1THGCalUtilities.hgcalTriggerNtuples_cff') from L1Trigger.L1THGCalUtilities.hgcalTriggerChains import HGCalTriggerChains @@ -80,16 +77,13 @@ chains = HGCalTriggerChains() # Register algorithms ## VFE -chains.register_vfe("Floatingpoint8", lambda p : vfe.create_compression(p, 4, 4, True)) +chains.register_vfe("Floatingpoint", vfe.create_vfe) ## TRUTH PRODUCER chains.register_truth_prod("TruthProd", truth_prod.create_truth_prod) ## BE1 chains.register_backend1("TruthDummy", clustering2d.create_truth_dummy) ## BE2 chains.register_backend2("Histomax", clustering3d.create_histoMax) -chains.register_backend2("Histomaxvardrth0", lambda p,i : clustering3d.create_histoMax_variableDr(p,i,seed_threshold=0.)) -chains.register_backend2("Histomaxvardrth10", lambda p,i : clustering3d.create_histoMax_variableDr(p,i,seed_threshold=10.)) -chains.register_backend2("Histomaxvardrth20", lambda p,i : clustering3d.create_histoMax_variableDr(p,i,seed_threshold=20.)) # Register selector chains.register_selector("Genmatch", selectors.create_genmatch) # Register ntuples @@ -97,11 +91,11 @@ chains.register_ntuple("Genclustersntuple", lambda p,i : ntuple.create_ntuple(p,i, ntuple_list)) # Register trigger chains -backend_algos = ['Histomax', 'Histomaxvardrth0', 'Histomaxvardrth10', 'Histomaxvardrth20'] +backend_algos = ['Histomax'] -chains.register_truth_chain('Floatingpoint8', 'TruthProd', '', '', '', 'Genclustersntuple') +chains.register_truth_chain('Floatingpoint', 'TruthProd', '', '', '', 'Genclustersntuple') for be in backend_algos: - chains.register_truth_chain('Floatingpoint8', 'TruthProd', 'TruthDummy', be, 'Genmatch', 'Genclustersntuple') + chains.register_truth_chain('Floatingpoint', 'TruthProd', 'TruthDummy', be, 'Genmatch', 'Genclustersntuple') process = chains.create_truth_sequences(process)