From 5954cf2436a390c996083d27d0412c48ae4a2751 Mon Sep 17 00:00:00 2001
From: Sylvester Joosten <sjoosten@anl.gov>
Date: Mon, 26 Jul 2021 18:17:43 +0000
Subject: [PATCH] removed unnecessary includes of DataObjectHandleBase
---
.../deprecated/calorimeter_clustering.py | 121 ----------
.../options/deprecated/full_cal_clusters.py | 208 ------------------
.../options/deprecated/full_cal_digi.py | 193 ----------------
.../options/deprecated/hcal_clustering.py | 130 -----------
.../clustering/options/full_cal_reco.py | 1 -
.../options/full_trackpluscalo_reco.py | 1 -
benchmarks/ecal/options/barrel.py | 1 -
.../deprecated/crystal_calorimeter_reco.py | 86 --------
.../options/deprecated/emcal_barrel_reco.py | 126 -----------
.../options/deprecated/example_crystal.py | 42 ----
.../deprecated/full_em_calorimeter_reco.py | 111 ----------
benchmarks/ecal/options/endcap_e.py | 1 -
benchmarks/ecal/options/endcap_i.py | 1 -
.../full/options/full_reconstruction.py | 1 -
.../imaging_ecal/options/hybrid_cluster.py | 1 -
.../imaging_ecal/options/imaging_2dcluster.py | 1 -
.../options/imaging_topocluster.py | 1 -
.../imaging_ecal/options/scfi_cluster.py | 1 -
.../options/imaging_ml_data.py | 1 -
benchmarks/rich/options/rich_reco.py | 1 -
.../options/tracker_reconstruction.py | 3 +-
.../tracking/options/truth_seeded_tracking.py | 1 -
22 files changed, 1 insertion(+), 1032 deletions(-)
delete mode 100644 benchmarks/clustering/options/deprecated/calorimeter_clustering.py
delete mode 100644 benchmarks/clustering/options/deprecated/full_cal_clusters.py
delete mode 100644 benchmarks/clustering/options/deprecated/full_cal_digi.py
delete mode 100644 benchmarks/clustering/options/deprecated/hcal_clustering.py
delete mode 100644 benchmarks/ecal/options/deprecated/crystal_calorimeter_reco.py
delete mode 100644 benchmarks/ecal/options/deprecated/emcal_barrel_reco.py
delete mode 100644 benchmarks/ecal/options/deprecated/example_crystal.py
delete mode 100644 benchmarks/ecal/options/deprecated/full_em_calorimeter_reco.py
diff --git a/benchmarks/clustering/options/deprecated/calorimeter_clustering.py b/benchmarks/clustering/options/deprecated/calorimeter_clustering.py
deleted file mode 100644
index d4431f16..00000000
--- a/benchmarks/clustering/options/deprecated/calorimeter_clustering.py
+++ /dev/null
@@ -1,121 +0,0 @@
-from Gaudi.Configuration import *
-import os
-
-from GaudiKernel.DataObjectHandleBase import DataObjectHandleBase
-from Configurables import ApplicationMgr, EICDataSvc, PodioOutput, GeoSvc
-from GaudiKernel import SystemOfUnits as units
-
-detector_name = "topside"
-if "JUGGLER_DETECTOR" in os.environ :
- detector_name = str(os.environ["JUGGLER_DETECTOR"])
-
-if "JUGGLER_DETECTOR_PATH" in os.environ :
- detector_name = str(os.environ["JUGGLER_DETECTOR_PATH"]) + "/" + detector_name
-
-# get sampling fraction from system environment variable, 1.0 by default
-sf = 1.0
-if "CB_EMCAL_SAMP_FRAC" in os.environ :
- sf = str(os.environ["CB_EMCAL_SAMP_FRAC"])
-
-# todo add checks
-input_sim_file = str(os.environ["JUGGLER_SIM_FILE"])
-output_rec_file = str(os.environ["JUGGLER_REC_FILE"])
-n_events = str(os.environ["JUGGLER_N_EVENTS"])
-
-geo_service = GeoSvc("GeoSvc", detectors=["{}.xml".format(detector_name)], OutputLevel=INFO)
-podioevent = EICDataSvc("EventDataSvc", inputs=[input_sim_file])
-
-from Configurables import PodioInput
-from Configurables import Jug__Base__InputCopier_dd4pod__Geant4ParticleCollection_dd4pod__Geant4ParticleCollection_ as MCCopier
-from Configurables import Jug__Base__InputCopier_dd4pod__CalorimeterHitCollection_dd4pod__CalorimeterHitCollection_ as CalCopier
-
-from Configurables import Jug__Digi__HadronicCalDigi as HadCalorimeterDigi
-from Configurables import Jug__Digi__EMCalorimeterDigi as EMCalorimeterDigi
-from Configurables import Jug__Digi__CrystalEndcapsDigi as CrystalEndcapsDigi
-
-from Configurables import Jug__Reco__CrystalEndcapsReco as CrystalEndcapsReco
-from Configurables import Jug__Reco__EMCalReconstruction as EMCalReconstruction
-
-from Configurables import Jug__Reco__SimpleClustering as SimpleClustering
-from Configurables import Jug__Reco__CalorimeterIslandCluster as IslandCluster
-from Configurables import Jug__Reco__ClusterRecoCoG as RecoCoG
-
-podioinput = PodioInput("PodioReader", collections=["mcparticles","CrystalEcalHits","EcalBarrelHits"], OutputLevel=DEBUG)
-
-## copiers to get around input --> output copy bug. Note the "2" appended to the output collection.
-copier = MCCopier("MCCopier",
- inputCollection="mcparticles",
- outputCollection="mcparticles2")
-calcopier = CalCopier("CalCopier",
- inputCollection="CrystalEcalHits",
- outputCollection="CrystalEcalHits2")
-
-emcaldigi = CrystalEndcapsDigi("ecal_digi",
- inputHitCollection="CrystalEcalHits",
- outputHitCollection="RawDigiEcalHits")
-ecdigi = EMCalorimeterDigi("ec_barrel_digi",
- inputHitCollection="EcalBarrelHits",
- outputHitCollection="RawEcalBarrelHits")
-
-crystal_ec_reco = CrystalEndcapsReco("crystal_ec_reco",
- inputHitCollection="RawDigiEcalHits",
- outputHitCollection="RecoEcalHits",
- minModuleEdep=1.0*units.MeV)
-
-ecal_reco = EMCalReconstruction("ecal_reco",
- inputHitCollection="RawEcalBarrelHits",
- outputHitCollection="RecEcalBarrelHits",
- samplingFraction=0.25,
- minModuleEdep=0.0*units.MeV)
-
-ec_barrel_cluster = IslandCluster("ec_barrel_cluster",
- inputHitCollection="RecEcalBarrelHits",
- outputClusterCollection="EcalBarrelProtoClusters",
- splitHitCollection="splitEcalBarrelHitCollection",
- minClusterCenterEdep=1*units.MeV,
- groupRange=2.0,
- OutputLevel=DEBUG)
-
-crystal_ec_cluster = IslandCluster("crystal_ec_cluster",
- inputHitCollection="RecoEcalHits",
- outputClusterCollection="EcalProtoClusters",
- splitHitCollection="splitEcalHitCollection",
- minClusterCenterEdep=30*units.MeV,
- groupRange=2.0,
- OutputLevel=DEBUG)
-
-simple_cluster = SimpleClustering("simple_cluster",
- inputHitCollection="RecEcalBarrelHits",
- outputClusters="SimpleClusters",
- OutputLevel=DEBUG)
-
-ec_barrel_clusterreco = RecoCoG("ec_barrel_clusterreco",
- inputClusterCollection="EcalBarrelProtoClusters",
- outputClusterCollection="EcalBarrelClusters",
- logWeightBase=6.2,
- samplingFraction=sf)
-
-clusterreco = RecoCoG("cluster_reco",
- inputClusterCollection="EcalProtoClusters",
- outputClusterCollection="EcalClusters",
- logWeightBase=4.2,
- moduleDimZName="CrystalBox_z_length",
- samplingFraction=sf,
- OutputLevel=DEBUG)
-
-out = PodioOutput("out", filename=output_rec_file)
-
-out.outputCommands = ["keep *"]
-
-ApplicationMgr(
- TopAlg = [podioinput, copier, calcopier,
- ecdigi, emcaldigi,
- crystal_ec_reco, ecal_reco,
- ec_barrel_cluster, crystal_ec_cluster, ec_barrel_clusterreco, clusterreco,
- simple_cluster,
- out],
- EvtSel = 'NONE',
- EvtMax = n_events,
- ExtSvc = [podioevent],
- OutputLevel=DEBUG
- )
diff --git a/benchmarks/clustering/options/deprecated/full_cal_clusters.py b/benchmarks/clustering/options/deprecated/full_cal_clusters.py
deleted file mode 100644
index c0918e01..00000000
--- a/benchmarks/clustering/options/deprecated/full_cal_clusters.py
+++ /dev/null
@@ -1,208 +0,0 @@
-'''
- An example script to cluster reconstructed calorimeter hits
-'''
-
-from Gaudi.Configuration import *
-import os
-import ROOT
-
-from GaudiKernel.DataObjectHandleBase import DataObjectHandleBase
-from Configurables import ApplicationMgr, EICDataSvc, PodioInput, PodioOutput, GeoSvc
-from GaudiKernel.SystemOfUnits import MeV, GeV, mm, cm, mrad
-
-detector_name = str(os.environ.get("JUGGLER_DETECTOR", "athena"))
-detector_path = str(os.environ.get("JUGGLER_DETECTOR_PATH", "."))
-compact_path = os.path.join(detector_path, detector_name)
-
-# get sampling fractions from system environment variable, 1.0 by default
-ce_ecal_sf = float(os.environ.get("CE_ECAL_SAMP_FRAC", 0.253))
-cb_ecal_sf = float(os.environ.get("CB_ECAL_SAMP_FRAC", 0.01324))
-cb_hcal_sf = float(os.environ.get("CB_HCAL_SAMP_FRAC", 0.038))
-ci_hcal_sf = float(os.environ.get("CI_HCAL_SAMP_FRAC", 0.025))
-ce_hcal_sf = float(os.environ.get("CE_HCAL_SAMP_FRAC", 0.025))
-
-# input and output
-input_digis = [f.strip() for f in str.split(os.environ["JUGGLER_DIGI_FILE"], ",") if f.strip()]
-output_rec = str(os.environ["JUGGLER_REC_FILE"])
-n_events = int(os.environ["JUGGLER_N_EVENTS"])
-
-# geometry service
-geo_service = GeoSvc("GeoSvc", detectors=["{}.xml".format(compact_path)], OutputLevel=INFO)
-# data service
-podioevent = EICDataSvc("EventDataSvc", inputs=input_digis)
-
-
-# juggler components
-from Configurables import Jug__Base__InputCopier_dd4pod__Geant4ParticleCollection_dd4pod__Geant4ParticleCollection_ as MCCopier
-from Configurables import Jug__Digi__CalorimeterHitDigi as CalHitDigi
-from Configurables import Jug__Reco__CalorimeterHitReco as CalHitReco
-from Configurables import Jug__Reco__CalorimeterHitsMerger as CalHitsMerger
-from Configurables import Jug__Reco__CalorimeterIslandCluster as IslandCluster
-
-from Configurables import Jug__Reco__ImagingPixelReco as ImCalPixelReco
-from Configurables import Jug__Reco__ImagingTopoCluster as ImagingCluster
-
-from Configurables import Jug__Reco__ClusterRecoCoG as RecoCoG
-from Configurables import Jug__Reco__ImagingClusterReco as ImagingClusterReco
-
-# branches needed from simulation root file
-digi_coll = [
-# "mcparticles2",
- "EcalEndcapNHitsReco",
- "EcalEndcapPHitsReco",
- "EcalBarrelHitsReco",
- "HcalBarrelHitsReco",
- "HcalHadronEndcapHitsReco",
- "HcalElectronEndcapHitsReco",
-]
-
-# input and output
-podin = PodioInput("PodioReader", collections=digi_coll, OutputLevel=DEBUG)
-podout = PodioOutput("out", filename=output_rec)
-# copier needed to get around input --> output copy bug. So truth (mcparticles) can be saved in output file
-# copier = MCCopier("MCCopier", inputCollection="mcparticles2", outputCollection="mcparticles3")
-
-
-# Crystal Endcap Ecal
-ce_ecal_cl = IslandCluster("ce_ecal_cl",
- # OutputLevel=DEBUG,
- inputHitCollection="EcalEndcapNHitsReco",
- outputClusterCollection="EcalEndcapNProtoClusters",
- splitHitCollection="EcalEndcapNHitsSplit",
- splitCluster=False,
- minClusterCenterEdep=30*MeV,
- groupRanges=[2.2*cm, 2.2*cm])
-
-ce_ecal_clreco = RecoCoG("ce_ecal_clreco",
- inputClusterCollection="EcalEndcapNProtoClusters",
- outputClusterCollection="EcalEndcapNClusters",
- samplingFraction=0.998, # this accounts for a small fraction of leakage
- logWeightBase=4.6)
-
-
-# Endcap Sampling Ecal
-# merge hits in different layer (projection to local x-y plane)
-ci_ecal_merger = CalHitsMerger("ci_ecal_merger",
- inputHitCollection="EcalEndcapPHitsReco",
- outputHitCollection="EcalEndcapPHitsRecoXY",
- fields=["layer", "slice"],
- fieldRefNumbers=[1, 0],
- readoutClass="EcalEndcapPHits")
-
-ci_ecal_cl = IslandCluster("ci_ecal_cl",
- inputHitCollection="EcalEndcapPHitsRecoXY",
- outputClusterCollection="EcalEndcapPProtoClusters",
- splitHitCollection="EcalEndcapPHitsSplit",
- splitCluster=False,
- minClusterCenterEdep=30.*MeV,
- groupRanges=[5*mm, 5*mm])
-
-ci_ecal_clreco = RecoCoG("ci_ecal_clreco",
- inputClusterCollection="EcalEndcapPProtoClusters",
- outputClusterCollection="EcalEndcapPClusters",
- logWeightBase=6.2,
- samplingFraction=ce_ecal_sf)
-
-
-# Central Barrel Ecal (Imaging Cal.)
-cb_ecal_cl = ImagingCluster("cb_ecal_cl",
- inputHitCollection="EcalBarrelHitsReco",
- outputClusterCollection="EcalBarrelProtoClusters",
- outputHitCollection="EcalBarrelClusterHits",
- localRanges=[2.*mm, 2*mm], # same layer
- adjLayerRanges=[10*mrad, 10*mrad], # adjacent layer
- adjLayerDiff=2, # id diff for adjacent layer
- adjSectorDist=3.*cm) # different sector
-cb_ecal_clreco = ImagingClusterReco("cb_ecal_clreco",
- samplingFraction=cb_ecal_sf,
- inputClusterCollection="EcalBarrelProtoClusters",
- outputClusterCollection="EcalBarrelClusters",
- outputLayerCollection="EcalBarrelLayers")
-
-
-# Central Barrel Hcal
-# merge hits in different layer (projection to local x-y plane)
-cb_hcal_merger = CalHitsMerger("cb_hcal_merger",
- inputHitCollection="HcalBarrelHitsReco",
- outputHitCollection="HcalBarrelHitsRecoXY",
- readoutClass="HcalBarrelHits",
- fields=["layer", "slice"],
- fieldRefNumbers=[1, 0])
-
-cb_hcal_cl = IslandCluster("cb_hcal_cl",
- inputHitCollection="HcalBarrelHitsRecoXY",
- outputClusterCollection="HcalBarrelProtoClusters",
- splitHitCollection="HcalBarrelHitsSplit",
- splitCluster=False,
- minClusterCenterEdep=30.*MeV,
- groupRanges=[15.*cm, 15.*cm])
-
-cb_hcal_clreco = RecoCoG("cb_hcal_clreco",
- inputClusterCollection="HcalBarrelProtoClusters",
- outputClusterCollection="HcalBarrelClusters",
- logWeightBase=6.2,
- samplingFraction=cb_hcal_sf)
-
-
-# Hcal Hadron Endcap HCal
-ci_hcal_merger = CalHitsMerger("ci_hcal_merger",
- inputHitCollection="HcalHadronEndcapHitsReco",
- outputHitCollection="HcalHadronEndcapHitsRecoXY",
- readoutClass="HcalHadronEndcapHits",
- fields=["layer", "slice"],
- fieldRefNumbers=[1, 0])
-
-ci_hcal_cl = IslandCluster("ci_hcal_cl",
- inputHitCollection="HcalHadronEndcapHitsRecoXY",
- outputClusterCollection="HcalHadronEndcapProtoClusters",
- splitHitCollection="HcalHadronEndcapHitsSplit",
- splitCluster=False,
- minClusterCenterEdep=30.*MeV,
- groupRanges=[15.*cm, 15.*cm])
-
-ci_hcal_clreco = RecoCoG("ci_hcal_clreco",
- inputClusterCollection="HcalHadronEndcapProtoClusters",
- outputClusterCollection="HcalHadronEndcapClusters",
- logWeightBase=6.2,
- samplingFraction=ci_hcal_sf)
-
-# Hcal Electron Endcap
-ce_hcal_merger = CalHitsMerger("ce_hcal_merger",
- inputHitCollection="HcalElectronEndcapHitsReco",
- outputHitCollection="HcalElectronEndcapHitsRecoXY",
- readoutClass="HcalElectronEndcapHits",
- fields=["layer", "slice"],
- fieldRefNumbers=[1, 0])
-
-ce_hcal_cl = IslandCluster("ce_hcal_cl",
- inputHitCollection="HcalElectronEndcapHitsRecoXY",
- outputClusterCollection="HcalElectronEndcapProtoClusters",
- splitHitCollection="HcalElectronEndcapHitsSplit",
- splitCluster=False,
- minClusterCenterEdep=30.*MeV,
- groupRanges=[15.*cm, 15.*cm])
-
-ce_hcal_clreco = RecoCoG("ce_hcal_clreco",
- inputClusterCollection="HcalElectronEndcapProtoClusters",
- outputClusterCollection="HcalElectronEndcapClusters",
- logWeightBase=6.2,
- samplingFraction=ce_hcal_sf)
-
-
-podout.outputCommands = ["drop *", "keep mcparticles", "keep *Clusters", "keep *Layers"]
-
-ApplicationMgr(
- TopAlg = [podin, # copier,
- ce_ecal_cl, ce_ecal_clreco,
- ci_ecal_merger, ci_ecal_cl, ci_ecal_clreco,
- cb_ecal_cl, cb_ecal_clreco,
- cb_hcal_merger, cb_hcal_cl, cb_hcal_clreco,
- ce_hcal_merger, ce_hcal_cl, ce_hcal_clreco,
- ci_hcal_merger, ci_hcal_cl, ci_hcal_clreco,
- podout],
- EvtSel = 'NONE',
- EvtMax = n_events,
- ExtSvc = [podioevent],
- OutputLevel=DEBUG
-)
-
diff --git a/benchmarks/clustering/options/deprecated/full_cal_digi.py b/benchmarks/clustering/options/deprecated/full_cal_digi.py
deleted file mode 100644
index 347e14e2..00000000
--- a/benchmarks/clustering/options/deprecated/full_cal_digi.py
+++ /dev/null
@@ -1,193 +0,0 @@
-'''
- An example script to digitize/reconstruct calorimeter hits
-'''
-from Gaudi.Configuration import *
-import os
-import ROOT
-
-from GaudiKernel.DataObjectHandleBase import DataObjectHandleBase
-from Configurables import ApplicationMgr, EICDataSvc, PodioInput, PodioOutput, GeoSvc
-from GaudiKernel.SystemOfUnits import MeV, GeV, mm, cm, mrad
-
-detector_name = str(os.environ.get("JUGGLER_DETECTOR", "athena"))
-detector_path = str(os.environ.get("JUGGLER_DETECTOR_PATH", "."))
-compact_path = os.path.join(detector_path, detector_name)
-
-# input and output
-input_sims = [f.strip() for f in str.split(os.environ["JUGGLER_SIM_FILE"], ",") if f.strip()]
-output_rec = str(os.environ["JUGGLER_DIGI_FILE"])
-n_events = int(os.environ["JUGGLER_N_EVENTS"])
-
-# geometry service
-geo_service = GeoSvc("GeoSvc", detectors=["{}.xml".format(compact_path)], OutputLevel=INFO)
-# data service
-podioevent = EICDataSvc("EventDataSvc", inputs=input_sims)
-
-
-# juggler components
-from Configurables import Jug__Base__InputCopier_dd4pod__Geant4ParticleCollection_dd4pod__Geant4ParticleCollection_ as MCCopier
-from Configurables import Jug__Digi__CalorimeterHitDigi as CalHitDigi
-from Configurables import Jug__Reco__CalorimeterHitReco as CalHitReco
-from Configurables import Jug__Reco__CalorimeterHitsMerger as CalHitsMerger
-from Configurables import Jug__Reco__CalorimeterIslandCluster as IslandCluster
-
-from Configurables import Jug__Reco__ImagingPixelReco as ImCalPixelReco
-from Configurables import Jug__Reco__ImagingTopoCluster as ImagingCluster
-
-from Configurables import Jug__Reco__ClusterRecoCoG as RecoCoG
-from Configurables import Jug__Reco__ImagingClusterReco as ImagingClusterReco
-
-# branches needed from simulation root file
-sim_coll = [
- "mcparticles",
- "EcalEndcapNHits",
- "EcalEndcapPHits",
- "EcalBarrelHits",
- "HcalBarrelHits",
- "HcalHadronEndcapHits",
- "HcalElectronEndcapHits",
-]
-
-# input and output
-podin = PodioInput("PodioReader", collections=sim_coll)
-podout = PodioOutput("out", filename=output_rec)
-# copier needed to get around input --> output copy bug. So truth (mcparticles) can be saved in output file
-copier = MCCopier("MCCopier", inputCollection="mcparticles", outputCollection="mcparticles2")
-
-
-# Crystal Endcap Ecal
-ce_ecal_digi = CalHitDigi("ce_ecal_digi",
- inputHitCollection="EcalEndcapNHits",
- outputHitCollection="EcalEndcapNHitsDigi",
- energyResolutions=[0., 0.02, 0.],
- dynamicRangeADC=5.*GeV, # digi settings must match with reco
- capacityADC=32768,
- pedestalMean=400,
- pedestalSigma=3)
-
-ce_ecal_reco = CalHitReco("ce_ecal_reco",
- inputHitCollection="EcalEndcapNHitsDigi",
- outputHitCollection="EcalEndcapNHitsReco",
- dynamicRangeADC=5.*GeV,
- capacityADC=32768,
- pedestalMean=400,
- pedestalSigma=3,
- thresholdFactor=4, # 4 sigma
- minimumHitEdep=1.0*MeV, # discard low energy hits
- readoutClass="EcalEndcapNHits",
- sectorField="sector")
-
-# Endcap Sampling Ecal
-ci_ecal_digi = CalHitDigi("ci_ecal_digi",
- inputHitCollection="EcalEndcapPHits",
- outputHitCollection="EcalEndcapPHitsDigi",
- dynamicRangeADC=50.*MeV,
- capacityADC=32768,
- pedestalMean=400,
- pedestalSigma=10)
-
-ci_ecal_reco = CalHitReco("ci_ecal_reco",
- inputHitCollection="EcalEndcapPHitsDigi",
- outputHitCollection="EcalEndcapPHitsReco",
- dynamicRangeADC=50.*MeV,
- capacityADC=32768,
- pedestalMean=400,
- pedestalSigma=10,
- thresholdFactor=5.0)
-
-# Central Barrel Ecal (Imaging Cal.)
-cb_ecal_digi = CalHitDigi("cb_ecal_digi",
- inputHitCollection="EcalBarrelHits",
- outputHitCollection="EcalBarrelHitsDigi",
- energyResolutions=[0., 0.02, 0.], # 2% flat resolution
- dynamicRangeADC=3*MeV,
- capacityADC=8192,
- pedestalMean=400,
- pedestalSigma=20) # about 6 keV
-cb_ecal_reco = ImCalPixelReco("cb_ecal_reco",
- inputHitCollection="EcalBarrelHitsDigi",
- outputHitCollection="EcalBarrelHitsReco",
- dynamicRangeADC=3.*MeV,
- capacityADC=8192,
- pedestalMean=400,
- pedestalSigma=20,
- thresholdFactor=3, # about 20 keV
- readoutClass="EcalBarrelHits", # readout class
- layerField="layer", # field to get layer id
- sectorField="module") # field to get sector id
-
-# Central Barrel Hcal
-cb_hcal_digi = CalHitDigi("cb_hcal_digi",
- inputHitCollection="HcalBarrelHits",
- outputHitCollection="HcalBarrelHitsDigi",
- dynamicRangeADC=50.*MeV,
- capacityADC=32768,
- pedestalMean=400,
- pedestalSigma=10)
-
-cb_hcal_reco = CalHitReco("cb_hcal_reco",
- inputHitCollection="HcalBarrelHitsDigi",
- outputHitCollection="HcalBarrelHitsReco",
- dynamicRangeADC=50.*MeV,
- capacityADC=32768,
- pedestalMean=400,
- pedestalSigma=10,
- thresholdFactor=5.0,
- readoutClass="HcalBarrelHits",
- layerField="layer",
- sectorField="module")
-
-# Hcal Hadron Endcap
-ci_hcal_digi = CalHitDigi("ci_hcal_digi",
- inputHitCollection="HcalHadronEndcapHits",
- outputHitCollection="HcalHadronEndcapHitsDigi",
- dynamicRangeADC=50.*MeV,
- capacityADC=32768,
- pedestalMean=400,
- pedestalSigma=10)
-
-ci_hcal_reco = CalHitReco("ci_hcal_reco",
- inputHitCollection="HcalHadronEndcapHitsDigi",
- outputHitCollection="HcalHadronEndcapHitsReco",
- dynamicRangeADC=50.*MeV,
- capacityADC=32768,
- pedestalMean=400,
- pedestalSigma=10,
- thresholdFactor=5.0)
-
-# Hcal Electron Endcap
-ce_hcal_digi = CalHitDigi("ce_hcal_digi",
- inputHitCollection="HcalElectronEndcapHits",
- outputHitCollection="HcalElectronEndcapHitsDigi",
- dynamicRangeADC=50.*MeV,
- capacityADC=32768,
- pedestalMean=400,
- pedestalSigma=10)
-
-ce_hcal_reco = CalHitReco("ce_hcal_reco",
- inputHitCollection="HcalElectronEndcapHitsDigi",
- outputHitCollection="HcalElectronEndcapHitsReco",
- dynamicRangeADC=50.*MeV,
- capacityADC=32768,
- pedestalMean=400,
- pedestalSigma=10,
- thresholdFactor=5.0)
-
-
-podout.outputCommands = ['drop *', 'keep mcparticles2', 'keep *Reco', 'keep *Digi']
-
-ApplicationMgr(
- TopAlg = [podin, copier,
- ce_ecal_digi, ce_ecal_reco,
- ci_ecal_digi, ci_ecal_reco,
- cb_ecal_digi, cb_ecal_reco,
- cb_hcal_digi, cb_hcal_reco,
- ce_hcal_digi, ce_hcal_reco,
- ci_hcal_digi, ci_hcal_reco,
- podout],
- EvtSel = 'NONE',
- EvtMax = n_events,
- ExtSvc = [podioevent],
- OutputLevel=DEBUG
-)
-
diff --git a/benchmarks/clustering/options/deprecated/hcal_clustering.py b/benchmarks/clustering/options/deprecated/hcal_clustering.py
deleted file mode 100644
index 986c976a..00000000
--- a/benchmarks/clustering/options/deprecated/hcal_clustering.py
+++ /dev/null
@@ -1,130 +0,0 @@
-from Gaudi.Configuration import *
-import os
-
-from GaudiKernel.DataObjectHandleBase import DataObjectHandleBase
-from Configurables import ApplicationMgr, EICDataSvc, PodioOutput, GeoSvc
-from GaudiKernel import SystemOfUnits as units
-
-detector_name = "topside"
-if "JUGGLER_DETECTOR" in os.environ :
- detector_name = str(os.environ["JUGGLER_DETECTOR"])
-
-if "JUGGLER_DETECTOR_PATH" in os.environ :
- detector_name = str(os.environ["JUGGLER_DETECTOR_PATH"]) + "/" + detector_name
-
-# get sampling fraction from system environment variable, 1.0 by default
-sf = 1.0
-if "CB_EMCAL_SAMP_FRAC" in os.environ :
- sf = str(os.environ["CB_EMCAL_SAMP_FRAC"])
-
-# todo add checks
-input_sim_file = str(os.environ["JUGGLER_SIM_FILE"])
-output_rec_file = str(os.environ["JUGGLER_REC_FILE"])
-n_events = str(os.environ["JUGGLER_N_EVENTS"])
-
-geo_service = GeoSvc("GeoSvc", detectors=["{}.xml".format(detector_name)])
-podioevent = EICDataSvc("EventDataSvc", inputs=[input_sim_file])
-
-from Configurables import PodioInput
-from Configurables import Jug__Base__InputCopier_dd4pod__Geant4ParticleCollection_dd4pod__Geant4ParticleCollection_ as MCCopier
-from Configurables import Jug__Base__InputCopier_dd4pod__CalorimeterHitCollection_dd4pod__CalorimeterHitCollection_ as CalCopier
-
-# from Configurables import Jug__Digi__HadronicCalDigi as HadCalorimeterDigi
-from Configurables import Jug__Digi__CalorimeterHitDigi as HadCalorimeterDigi
-from Configurables import Jug__Digi__EMCalorimeterDigi as EMCalorimeterDigi
-from Configurables import Jug__Digi__CrystalEndcapsDigi as CrystalEndcapsDigi
-
-from Configurables import Jug__Reco__CrystalEndcapsReco as CrystalEndcapsReco
-from Configurables import Jug__Reco__EMCalReconstruction as EMCalReconstruction
-# from Configurables import Jug__Reco__HCalReconstruction as HCalReconstruction
-from Configurables import Jug__Reco__EcalTungstenSamplingReco as HCalReconstruction
-from Configurables import Jug__Reco__CalorimeterHitsMerger as CalorimeterHitsMerger
-
-# from Configurables import Jug__Reco__SimpleClustering as SimpleClustering
-from Configurables import Jug__Reco__TopologicalCellCluster as TopoCluster
-from Configurables import Jug__Reco__CalorimeterIslandCluster as IslandCluster
-from Configurables import Jug__Reco__ClusterRecoCoG as RecoCoG
-
-podioinput = PodioInput("PodioReader", collections=["mcparticles","HcalBarrelHits"], OutputLevel=DEBUG)
-
-## copiers to get around input --> output copy bug. Note the "2" appended to the output collection.
-copier = MCCopier("MCCopier",
- inputCollection="mcparticles",
- outputCollection="mcparticles2")
-
-##raw hits
-
-
-calcopier = CalCopier("CalCopier",
- inputCollection="HcalBarrelHits",
- outputCollection="HcalBarrelHits2")
-
-#digitized hits
-
-hcaldigi = HadCalorimeterDigi("hcal_barrel_digi",
- inputHitCollection="HcalBarrelHits",
- outputHitCollection="RawHcalBarrelHits",
- inputEnergyUnit=units.GeV,
- inputTimeUnit=units.ns,
- energyResolutions=[0.0, 0., 0.],
- dynamicRangeADC=50.*units.MeV,
- capacityADC=32768,
- pedestalMean=400,
- pedestalSigma=10,
- OutputLevel=DEBUG
- )
-
-#reconstructed hits
-
-hcal_reco = HCalReconstruction("hcal_reco",
- inputHitCollection="RawHcalBarrelHits",
- outputHitCollection="RecHcalBarrelHits",
- dynamicRangeADC=50.*units.MeV,
- capacityADC=32768,
- pedestalMean=400,
- pedestalSigma=10,
- thresholdFactor=5.0,
- OutputLevel=DEBUG)
-
-#clusters
-xymerger = CalorimeterHitsMerger("hcal_xy_merger", #
- fields=["layer", "slice"],
- fieldRefNumbers=[0,0],
- inputHitCollection="RecHcalBarrelHits",
- outputHitCollection="RecHcalBarrelHitsXY",
- OutputLevel=DEBUG)
-
-
-hcal_barrel_cluster = IslandCluster("hcal_barrel_cluster",
- inputHitCollection="RecHcalBarrelHits",
- outputClusterCollection="HcalBarrelClusters",
- minClusterCenterEdep=30*units.MeV,
- groupRange=2.0,
- OutputLevel=DEBUG)
-
-
-# finalizing clustering (center-of-gravity step)
-
-hcal_barrel_clusterreco = RecoCoG("hcal_barrel_clusterreco",
- clusterCollection="HcalBarrelClusters",
- logWeightBase=6.2,
- samplingFraction=sf,
- OutputLevel=DEBUG)
-
-out = PodioOutput("out", filename=output_rec_file)
-
-out.outputCommands = ["keep *"]
-
-ApplicationMgr(
- TopAlg = [podioinput, copier, calcopier,
- hcaldigi,
- hcal_reco,
- xymerger,
- hcal_barrel_cluster,
- hcal_barrel_clusterreco,
- out],
- EvtSel = 'NONE',
- EvtMax = n_events,
- ExtSvc = [podioevent],
- OutputLevel=DEBUG
- )
diff --git a/benchmarks/clustering/options/full_cal_reco.py b/benchmarks/clustering/options/full_cal_reco.py
index 6e1d3691..402bc11e 100644
--- a/benchmarks/clustering/options/full_cal_reco.py
+++ b/benchmarks/clustering/options/full_cal_reco.py
@@ -5,7 +5,6 @@ from Gaudi.Configuration import *
import os
import ROOT
-from GaudiKernel.DataObjectHandleBase import DataObjectHandleBase
from Configurables import ApplicationMgr, EICDataSvc, PodioInput, PodioOutput, GeoSvc
from GaudiKernel.SystemOfUnits import MeV, GeV, mm, cm, mrad
diff --git a/benchmarks/clustering/options/full_trackpluscalo_reco.py b/benchmarks/clustering/options/full_trackpluscalo_reco.py
index fc016724..1c1c77cf 100644
--- a/benchmarks/clustering/options/full_trackpluscalo_reco.py
+++ b/benchmarks/clustering/options/full_trackpluscalo_reco.py
@@ -5,7 +5,6 @@ from Gaudi.Configuration import *
import os
import ROOT
-from GaudiKernel.DataObjectHandleBase import DataObjectHandleBase
from Configurables import ApplicationMgr, EICDataSvc, PodioInput, PodioOutput, GeoSvc
from GaudiKernel.SystemOfUnits import MeV, GeV, mm, cm, mrad
diff --git a/benchmarks/ecal/options/barrel.py b/benchmarks/ecal/options/barrel.py
index c71d5775..e2df5b3b 100644
--- a/benchmarks/ecal/options/barrel.py
+++ b/benchmarks/ecal/options/barrel.py
@@ -5,7 +5,6 @@ from Gaudi.Configuration import *
import os
import ROOT
-from GaudiKernel.DataObjectHandleBase import DataObjectHandleBase
from Configurables import ApplicationMgr, EICDataSvc, PodioInput, PodioOutput, GeoSvc
from GaudiKernel.SystemOfUnits import MeV, GeV, mm, cm, mrad
diff --git a/benchmarks/ecal/options/deprecated/crystal_calorimeter_reco.py b/benchmarks/ecal/options/deprecated/crystal_calorimeter_reco.py
deleted file mode 100644
index 30b563d5..00000000
--- a/benchmarks/ecal/options/deprecated/crystal_calorimeter_reco.py
+++ /dev/null
@@ -1,86 +0,0 @@
-from Gaudi.Configuration import *
-import os
-
-from GaudiKernel.DataObjectHandleBase import DataObjectHandleBase
-from Configurables import ApplicationMgr, EICDataSvc, PodioOutput, GeoSvc
-from GaudiKernel import SystemOfUnits as units
-
-detector_name = "topside"
-if "JUGGLER_DETECTOR" in os.environ :
- detector_name = str(os.environ["JUGGLER_DETECTOR"])
-
-detector_path = "topside"
-if "JUGGLER_DETECTOR_PATH" in os.environ :
- detector_path = str(os.environ["JUGGLER_DETECTOR_PATH"])
-
-# todo add checks
-input_sim_file = "jug_input.root"
-if "JUGGLER_SIM_FILE" in os.environ :
- input_sim_file = str(os.environ["JUGGLER_SIM_FILE"])
-else :
- print(" ERROR : JUGGLER_SIM_FILE not set" )
-
-output_rec_file = "jug_rec.root"
-if "JUGGLER_REC_FILE" in os.environ :
- output_rec_file = str(os.environ["JUGGLER_REC_FILE"])
-else :
- print(" ERROR : JUGGLER_REC_FILE not set" )
-
-
-n_events = 100
-if "JUGGLER_N_EVENTS" in os.environ :
- n_events = str(os.environ["JUGGLER_N_EVENTS"])
-
-geo_service = GeoSvc("GeoSvc", detectors=["{}/{}.xml".format(detector_path,detector_name)], OutputLevel=INFO)
-podioevent = EICDataSvc("EventDataSvc", inputs=[input_sim_file], OutputLevel=INFO)
-
-from Configurables import PodioInput
-from Configurables import Jug__Base__InputCopier_dd4pod__Geant4ParticleCollection_dd4pod__Geant4ParticleCollection_ as MCCopier
-from Configurables import Jug__Base__InputCopier_dd4pod__CalorimeterHitCollection_dd4pod__CalorimeterHitCollection_ as CalCopier
-
-
-
-from Configurables import Jug__Digi__CrystalEndcapsDigi as CrystalEndcapsDigi
-from Configurables import Jug__Reco__CrystalEndcapsReco as CrystalEndcapsReco
-from Configurables import Jug__Reco__CalorimeterIslandCluster as IslandCluster
-from Configurables import Jug__Reco__ClusterRecoCoG as RecoCoG
-
-podioinput = PodioInput("PodioReader", collections=["mcparticles","EcalEndcapNHits"], OutputLevel=DEBUG)
-
-## copiers to get around input --> output copy bug. Note the "2" appended to the output collection.
-copier = MCCopier("MCCopier", inputCollection="mcparticles", outputCollection="mcparticles2",OutputLevel=INFO)
-calcopier = CalCopier("CalCopier", inputCollection="EcalEndcapNHits", outputCollection="EcalEndcapNHits2",OutputLevel=INFO)
-
-emcaldigi = CrystalEndcapsDigi("ecal_digi",
- inputHitCollection="EcalEndcapNHits",
- outputHitCollection="RawDigiEcalHits")
-
-emcalreco = CrystalEndcapsReco("ecal_reco",
- inputHitCollection="RawDigiEcalHits",
- outputHitCollection="RecoEcalHits",
- minModuleEdep=0.00001*units.MeV)
-
-emcalcluster = IslandCluster("emcal_cluster",
- inputHitCollection="RecoEcalHits",
- outputHitCollection="EcalClusterHits",
- minClusterCenterEdep=50.0*units.MeV,
- groupRange=2.0)
-
-clusterreco = RecoCoG("cluster_reco",
- inputHitCollection="EcalClusterHits",
- outputClusterCollection="EcalClusters",
- logWeightBase=4.2,
- moduleDimZName="CrystalModule_sz")
-
-out = PodioOutput("out", filename=output_rec_file)
-
-out.outputCommands = ["keep *"]
-
-ApplicationMgr(
- TopAlg = [podioinput, copier, calcopier,
- emcaldigi, emcalreco, emcalcluster, clusterreco, out],
- EvtSel = 'NONE',
- EvtMax = n_events,
- ExtSvc = [podioevent],
- OutputLevel=INFO
- )
diff --git a/benchmarks/ecal/options/deprecated/emcal_barrel_reco.py b/benchmarks/ecal/options/deprecated/emcal_barrel_reco.py
deleted file mode 100644
index 964e5c37..00000000
--- a/benchmarks/ecal/options/deprecated/emcal_barrel_reco.py
+++ /dev/null
@@ -1,126 +0,0 @@
-#######################################
-# EMCAL Barrel detector Reconstruction
-# J.KIM 04/02/2021
-#######################################
-
-from Gaudi.Configuration import *
-import os
-
-from GaudiKernel.DataObjectHandleBase import DataObjectHandleBase
-from Configurables import ApplicationMgr, EICDataSvc, PodioOutput, GeoSvc
-from GaudiKernel import SystemOfUnits as units
-
-detector_name = "topside"
-if "JUGGLER_DETECTOR" in os.environ :
- detector_name = str(os.environ["JUGGLER_DETECTOR"])
-
-if "JUGGLER_DETECTOR_PATH" in os.environ :
- detector_name = str(os.environ["JUGGLER_DETECTOR_PATH"])+"/"+detector_name
-
-input_sim_file = "jug_input.root"
-if "JUGGLER_SIM_FILE" in os.environ :
- input_sim_file = str(os.environ["JUGGLER_SIM_FILE"])
-else :
- print(" ERROR : JUGGLER_SIM_FILE not set" )
-
-output_rec_file = "jug_rec.root"
-if "JUGGLER_REC_FILE" in os.environ :
- output_rec_file = str(os.environ["JUGGLER_REC_FILE"])
-else :
- print(" ERROR : JUGGLER_REC_FILE not set" )
-
-n_events = 100
-if "JUGGLER_N_EVENTS" in os.environ :
- n_events = str(os.environ["JUGGLER_N_EVENTS"])
-
-# get sampling fraction from system environment variable, 1.0 by default
-sf = 1.0
-if "CB_EMCAL_SAMP_FRAC" in os.environ :
- sf = str(os.environ["CB_EMCAL_SAMP_FRAC"])
-
-geo_service = GeoSvc("GeoSvc", detectors=["{}.xml".format(detector_name)], OutputLevel=INFO)
-podioevent = EICDataSvc("EventDataSvc", inputs=[input_sim_file], OutputLevel=DEBUG)
-
-from Configurables import PodioInput
-from Configurables import Jug__Base__InputCopier_dd4pod__Geant4ParticleCollection_dd4pod__Geant4ParticleCollection_ as MCCopier
-from Configurables import Jug__Base__InputCopier_dd4pod__CalorimeterHitCollection_dd4pod__CalorimeterHitCollection_ as CalCopier
-
-from Configurables import Jug__Digi__EcalTungstenSamplingDigi as EcalTungstenSamplingDigi
-
-from Configurables import Jug__Reco__EcalTungstenSamplingReco as EcalTungstenSamplingReco
-from Configurables import Jug__Reco__CalorimeterHitsMerger as CalorimeterHitsMerger
-from Configurables import Jug__Reco__CalorimeterIslandCluster as IslandCluster
-from Configurables import Jug__Reco__ClusterRecoCoG as RecoCoG
-
-podioinput = PodioInput("PodioReader", collections=["mcparticles","EcalBarrelHits"], OutputLevel=DEBUG)
-
-# Thrown Information
-copier = MCCopier("MCCopier",
- inputCollection="mcparticles",
- outputCollection="mcparticles2",
- OutputLevel=DEBUG)
-# Geant4 Information
-embarrelcopier = CalCopier("CalBarrelCopier",
- inputCollection="EcalBarrelHits",
- outputCollection="EcalBarrelHits2",
- OutputLevel=DEBUG)
-# Digitization
-embarreldigi = EcalTungstenSamplingDigi("ecal_barrel_digi",
- inputHitCollection="EcalBarrelHits",
- outputHitCollection="RawEcalBarrelHits",
- inputEnergyUnit=units.GeV,
- inputTimeUnit=units.ns,
- dynamicRangeADC=700*units.keV,
- energyResolutions=[0., 0.02, 0.],
- pedestalSigma=40,
- OutputLevel=DEBUG)
-# Reconstruction
-embarrelreco = EcalTungstenSamplingReco("ecal_barrel_reco",
- inputHitCollection="RawEcalBarrelHits",
- outputHitCollection="RecoEcalBarrelHits",
- dynamicRangeADC=700*units.keV,
- pedestalSigma=40,
- OutputLevel=DEBUG)
-# 2D+1 Clusterings
-# readout id definition for barrel ecal
-# <id>system:8,barrel:3,module:4,layer:10,slice:5,x:32:-16,y:-16</id>
-# xy_merger sum layers/slices, masking (8+3+4, 8+3+4+5+10-1)
-embarrelxymerger = CalorimeterHitsMerger("ecal_barrel_xy_merger",
- readoutClass="EcalBarrelHits",
- fields=["layer", "slice"],
- inputHitCollection="RecoEcalBarrelHits",
- outputHitCollection="RecoEcalBarrelHitsXY")
-# xy_merger sum modules, masking (8+3+4+5+10, 8+3+4+5+10+32-1)
-embarrelzmerger = CalorimeterHitsMerger("ecal_barrel_z_merger",
- readoutClass="EcalBarrelHits",
- fields=["x", "y"],
- inputHitCollection="RecoEcalBarrelHits",
- outputHitCollection="RecoEcalBarrelHitsZ")
-# Clustering
-embarrelcluster = IslandCluster("ecal_barrel_cluster",
- inputHitCollection="RecoEcalBarrelHitsXY",
- outputHitCollection="EcalBarrelClusterHits",
- minClusterCenterEdep=0.5*units.MeV,
- splitCluster=False,
- groupRanges=[2.0*units.cm, 2.0*units.cm, 2.0*units.cm],
- OutputLevel=DEBUG)
-# Reconstruct the cluster with Center of Gravity method
-embarrelclusterreco = RecoCoG("ecal_barrel_clusterreco",
- inputHitCollection="EcalBarrelClusterHits",
- outputClusterCollection="EcalBarrelClusters",
- logWeightBase=6.2,
- samplingFraction=sf,
- OutputLevel=DEBUG)
-
-out = PodioOutput("out", filename=output_rec_file)
-
-out.outputCommands = ["keep *"]
-
-ApplicationMgr(
- TopAlg = [podioinput, copier, embarrelcopier, embarreldigi,
- embarrelreco, embarrelxymerger, embarrelzmerger, embarrelcluster, embarrelclusterreco, out],
- EvtSel = 'NONE',
- EvtMax = n_events,
- ExtSvc = [podioevent],
- OutputLevel=DEBUG
- )
diff --git a/benchmarks/ecal/options/deprecated/example_crystal.py b/benchmarks/ecal/options/deprecated/example_crystal.py
deleted file mode 100644
index 7f9e6ee4..00000000
--- a/benchmarks/ecal/options/deprecated/example_crystal.py
+++ /dev/null
@@ -1,42 +0,0 @@
-from Gaudi.Configuration import *
-import os
-
-from GaudiKernel.DataObjectHandleBase import DataObjectHandleBase
-from Configurables import ApplicationMgr, EICDataSvc, PodioOutput, GeoSvc
-from GaudiKernel import SystemOfUnits as units
-
-detector_name = "topside"
-if "JUGGLER_DETECTOR" in os.environ :
- detector_name = str(os.environ["JUGGLER_DETECTOR"])
-
-# todo add checks
-input_sim_file = str(os.environ["JUGGLER_SIM_FILE"])
-output_rec_file = str(os.environ["JUGGLER_REC_FILE"])
-n_events = str(os.environ["JUGGLER_N_EVENTS"])
-
-geo_service = GeoSvc("GeoSvc", detectors=["{}.xml".format(detector_name)])
-podioevent = EICDataSvc("EventDataSvc", inputs=[input_sim_file], OutputLevel=DEBUG)
-
-from Configurables import PodioInput
-from Configurables import Jug__Digi__CrystalEndcapsDigi as CrystalEndcapsDigi
-from Configurables import Jug__Reco__CrystalEndcapsReco as CrystalEndcapsReco
-from Configurables import Jug__Reco__CalorimeterIslandCluster as IslandCluster
-from Configurables import Jug__Reco__ClusterRecoCoG as RecoCoG
-
-podioinput = PodioInput("PodioReader", collections=["mcparticles","CrystalEcalHits"], OutputLevel=DEBUG)
-emcaldigi = CrystalEndcapsDigi("ecal_digi", inputHitCollection="CrystalEcalHits", outputHitCollection="RawDigiEcalHits")
-emcalreco = CrystalEndcapsReco("ecal_reco", inputHitCollection="RawDigiEcalHits", outputHitCollection="RecoEcalHits", minModuleEdep=1.0*units.MeV)
-emcalcluster = IslandCluster("emcal_cluster", inputHitCollection="RecoEcalHits", outputHitCollection="EcalClusterHits", minClusterCenterEdep=30*units.MeV, groupRange=2.0)
-clusterreco = RecoCoG("cluster_reco", inputGitCollection="EcalClusterHits", outputClusterCollection="EcalClusters", logWeightBase=4.2, moduleDimZName="CrystalModule_sz")
-
-out = PodioOutput("out", filename=output_rec_file)
-
-out.outputCommands = ["keep *"]
-
-ApplicationMgr(
- TopAlg = [podioinput, emcaldigi, emcalreco, emcalcluster, clusterreco, out],
- EvtSel = 'NONE',
- EvtMax = n_events,
- ExtSvc = [podioevent],
- OutputLevel=DEBUG
- )
diff --git a/benchmarks/ecal/options/deprecated/full_em_calorimeter_reco.py b/benchmarks/ecal/options/deprecated/full_em_calorimeter_reco.py
deleted file mode 100644
index 67c531fd..00000000
--- a/benchmarks/ecal/options/deprecated/full_em_calorimeter_reco.py
+++ /dev/null
@@ -1,111 +0,0 @@
-from Gaudi.Configuration import *
-import os
-
-from GaudiKernel.DataObjectHandleBase import DataObjectHandleBase
-from Configurables import ApplicationMgr, EICDataSvc, PodioOutput, GeoSvc
-from GaudiKernel import SystemOfUnits as units
-
-detector_name = "topside"
-if "JUGGLER_DETECTOR" in os.environ :
- detector_name = str(os.environ["JUGGLER_DETECTOR"])
-
-if "JUGGLER_DETECTOR_PATH" in os.environ :
- detector_name = str(os.environ["JUGGLER_DETECTOR_PATH"])+"/"+detector_name
-
-input_sim_file = "jug_input.root"
-if "JUGGLER_SIM_FILE" in os.environ :
- input_sim_file = str(os.environ["JUGGLER_SIM_FILE"])
-else :
- print(" ERROR : JUGGLER_SIM_FILE not set" )
-
-output_rec_file = "jug_rec.root"
-if "JUGGLER_REC_FILE" in os.environ :
- output_rec_file = str(os.environ["JUGGLER_REC_FILE"])
-else :
- print(" ERROR : JUGGLER_REC_FILE not set" )
-
-n_events = 100
-if "JUGGLER_N_EVENTS" in os.environ :
- n_events = str(os.environ["JUGGLER_N_EVENTS"])
-
-geo_service = GeoSvc("GeoSvc", detectors=["{}.xml".format(detector_name)], OutputLevel=INFO)
-podioevent = EICDataSvc("EventDataSvc", inputs=[input_sim_file], OutputLevel=DEBUG)
-
-from Configurables import PodioInput
-from Configurables import Jug__Base__InputCopier_dd4pod__Geant4ParticleCollection_dd4pod__Geant4ParticleCollection_ as MCCopier
-from Configurables import Jug__Base__InputCopier_dd4pod__CalorimeterHitCollection_dd4pod__CalorimeterHitCollection_ as CalCopier
-
-from Configurables import Jug__Digi__CrystalEndcapsDigi as CrystalEndcapsDigi
-from Configurables import Jug__Digi__EcalTungstenSamplingDigi as EcalTungstenSamplingDigi
-
-from Configurables import Jug__Reco__CrystalEndcapsReco as CrystalEndcapsReco
-from Configurables import Jug__Reco__CalorimeterIslandCluster as IslandCluster
-from Configurables import Jug__Reco__ClusterRecoCoG as RecoCoG
-
-podioinput = PodioInput("PodioReader", collections=["mcparticles","EcalEndcapNHits","EcalBarrelHits","EcalEndcapPHits"], OutputLevel=DEBUG)
-
-## copiers to get around input --> output copy bug. Note the "2" appended to the output collection.
-copier = MCCopier("MCCopier",
- inputCollection="mcparticles",
- outputCollection="mcparticles2",
- OutputLevel=DEBUG)
-
-calcopier = CalCopier("CalCopier",
- inputCollection="EcalEndcapNHits",
- outputCollection="EcalEndcapNHits2",
- OutputLevel=DEBUG)
-
-embarrelcopier = CalCopier("CalBarrelCopier",
- inputCollection="EcalBarrelHits",
- outputCollection="EcalBarrelHits2",
- OutputLevel=DEBUG)
-
-embarreldigi = EcalTungstenSamplingDigi("ecal_barrel_digi",
- inputHitCollection="EcalBarrelHits",
- outputHitCollection="RawEcalBarrelHits",
- inputEnergyUnit=units.GeV,
- inputTimeUnit=units.ns,
- dynamicRangeADC=700*units.keV,
- energyResolutions=[0., 0.02, 0.],
- pedestalSigma=40,
- OutputLevel=DEBUG)
-
-emendcapdigi = EcalTungstenSamplingDigi("ec_endcap_digi",
- inputHitCollection="EcalEndcapPHits",
- outputHitCollection="RawEcalEndcapPHits",
- energyResolution=0.07,
- OutputLevel=DEBUG)
-
-emcaldigi = CrystalEndcapsDigi("ecal_digi",
- inputHitCollection="EcalEndcapNHits",
- outputHitCollection="RawDigiEcalHits")
-
-emcalreco = CrystalEndcapsReco("ecal_reco",
- inputHitCollection="RawDigiEcalHits",
- outputHitCollection="RecoEcalHits",
- minModuleEdep=0.00001*units.MeV)
-
-emcalcluster = IslandCluster("emcal_cluster",
- inputHitCollection="RecoEcalHits",
- outputHitCollection="EcalClusterHits",
- minClusterCenterEdep=50.0*units.MeV,
- groupRange=2.0)
-
-clusterreco = RecoCoG("cluster_reco",
- inputHitCollection="EcalClusterHits",
- outputClusterCollection="EcalClusters",
- logWeightBase=4.2,
- moduleDimZName="CrystalModule_sz")
-
-out = PodioOutput("out", filename=output_rec_file)
-
-out.outputCommands = ["keep *"]
-
-ApplicationMgr(
- TopAlg = [podioinput, copier, calcopier, embarrelcopier,
- embarreldigi, emendcapdigi, emcaldigi, emcalreco, emcalcluster, clusterreco, out],
- EvtSel = 'NONE',
- EvtMax = n_events,
- ExtSvc = [podioevent],
- OutputLevel=DEBUG
- )
diff --git a/benchmarks/ecal/options/endcap_e.py b/benchmarks/ecal/options/endcap_e.py
index 609c83da..fc907180 100644
--- a/benchmarks/ecal/options/endcap_e.py
+++ b/benchmarks/ecal/options/endcap_e.py
@@ -5,7 +5,6 @@ from Gaudi.Configuration import *
import os
import ROOT
-from GaudiKernel.DataObjectHandleBase import DataObjectHandleBase
from Configurables import ApplicationMgr, EICDataSvc, PodioInput, PodioOutput, GeoSvc
from GaudiKernel.SystemOfUnits import MeV, GeV, mm, cm, mrad
diff --git a/benchmarks/ecal/options/endcap_i.py b/benchmarks/ecal/options/endcap_i.py
index e03f8ad9..48b6408e 100644
--- a/benchmarks/ecal/options/endcap_i.py
+++ b/benchmarks/ecal/options/endcap_i.py
@@ -6,7 +6,6 @@ from Gaudi.Configuration import *
import os
import ROOT
-from GaudiKernel.DataObjectHandleBase import DataObjectHandleBase
from Configurables import ApplicationMgr, EICDataSvc, PodioInput, PodioOutput, GeoSvc
from GaudiKernel.SystemOfUnits import MeV, GeV, mm, cm, mrad
diff --git a/benchmarks/full/options/full_reconstruction.py b/benchmarks/full/options/full_reconstruction.py
index 6195d49b..16694906 100644
--- a/benchmarks/full/options/full_reconstruction.py
+++ b/benchmarks/full/options/full_reconstruction.py
@@ -1,6 +1,5 @@
from Gaudi.Configuration import *
-from GaudiKernel.DataObjectHandleBase import DataObjectHandleBase
from Configurables import ApplicationMgr, EICDataSvc, PodioOutput, GeoSvc
from GaudiKernel import SystemOfUnits as units
from GaudiKernel.SystemOfUnits import MeV, GeV, mm, cm, mrad
diff --git a/benchmarks/imaging_ecal/options/hybrid_cluster.py b/benchmarks/imaging_ecal/options/hybrid_cluster.py
index 707247ab..e89cef98 100644
--- a/benchmarks/imaging_ecal/options/hybrid_cluster.py
+++ b/benchmarks/imaging_ecal/options/hybrid_cluster.py
@@ -3,7 +3,6 @@ import ROOT
from Gaudi.Configuration import *
from GaudiKernel.SystemOfUnits import MeV, mm, cm, mrad, rad, ns
-from GaudiKernel.DataObjectHandleBase import DataObjectHandleBase
from Configurables import ApplicationMgr, EICDataSvc, PodioOutput, GeoSvc
from Configurables import PodioInput
diff --git a/benchmarks/imaging_ecal/options/imaging_2dcluster.py b/benchmarks/imaging_ecal/options/imaging_2dcluster.py
index 73d3def1..e58e962f 100644
--- a/benchmarks/imaging_ecal/options/imaging_2dcluster.py
+++ b/benchmarks/imaging_ecal/options/imaging_2dcluster.py
@@ -2,7 +2,6 @@ import os
import ROOT
from Gaudi.Configuration import *
from GaudiKernel.SystemOfUnits import mm, MeV, rad, ns
-from GaudiKernel.DataObjectHandleBase import DataObjectHandleBase
from Configurables import ApplicationMgr, EICDataSvc, PodioOutput, GeoSvc
from Configurables import PodioInput
diff --git a/benchmarks/imaging_ecal/options/imaging_topocluster.py b/benchmarks/imaging_ecal/options/imaging_topocluster.py
index 72a983bb..572544ef 100644
--- a/benchmarks/imaging_ecal/options/imaging_topocluster.py
+++ b/benchmarks/imaging_ecal/options/imaging_topocluster.py
@@ -3,7 +3,6 @@ import ROOT
from Gaudi.Configuration import *
from GaudiKernel import SystemOfUnits as units
-from GaudiKernel.DataObjectHandleBase import DataObjectHandleBase
from Configurables import ApplicationMgr, EICDataSvc, PodioOutput, GeoSvc
from Configurables import PodioInput
diff --git a/benchmarks/imaging_ecal/options/scfi_cluster.py b/benchmarks/imaging_ecal/options/scfi_cluster.py
index 3ab0d5cc..873c3b89 100644
--- a/benchmarks/imaging_ecal/options/scfi_cluster.py
+++ b/benchmarks/imaging_ecal/options/scfi_cluster.py
@@ -2,7 +2,6 @@ import os
import ROOT
from Gaudi.Configuration import *
from GaudiKernel.SystemOfUnits import mm, MeV, rad, ns
-from GaudiKernel.DataObjectHandleBase import DataObjectHandleBase
from Configurables import ApplicationMgr, EICDataSvc, PodioOutput, GeoSvc
from Configurables import PodioInput
diff --git a/benchmarks/imaging_shower_ML/options/imaging_ml_data.py b/benchmarks/imaging_shower_ML/options/imaging_ml_data.py
index 4c46af45..1bdc3f2f 100644
--- a/benchmarks/imaging_shower_ML/options/imaging_ml_data.py
+++ b/benchmarks/imaging_shower_ML/options/imaging_ml_data.py
@@ -3,7 +3,6 @@ import ROOT
from Gaudi.Configuration import *
from GaudiKernel import SystemOfUnits as units
-from GaudiKernel.DataObjectHandleBase import DataObjectHandleBase
from Configurables import ApplicationMgr, EICDataSvc, PodioOutput, GeoSvc
from Configurables import PodioInput
diff --git a/benchmarks/rich/options/rich_reco.py b/benchmarks/rich/options/rich_reco.py
index 640fb8de..edf86520 100644
--- a/benchmarks/rich/options/rich_reco.py
+++ b/benchmarks/rich/options/rich_reco.py
@@ -1,7 +1,6 @@
from Gaudi.Configuration import *
from GaudiKernel import SystemOfUnits as units
-from GaudiKernel.DataObjectHandleBase import DataObjectHandleBase
from Configurables import ApplicationMgr, EICDataSvc, PodioOutput, GeoSvc
detector_name = "topside"
diff --git a/benchmarks/tracking/options/tracker_reconstruction.py b/benchmarks/tracking/options/tracker_reconstruction.py
index ba2cbf0b..733eb8cc 100644
--- a/benchmarks/tracking/options/tracker_reconstruction.py
+++ b/benchmarks/tracking/options/tracker_reconstruction.py
@@ -1,6 +1,5 @@
from Gaudi.Configuration import *
-from GaudiKernel.DataObjectHandleBase import DataObjectHandleBase
from Configurables import ApplicationMgr, EICDataSvc, PodioOutput, GeoSvc
from GaudiKernel import SystemOfUnits as units
@@ -196,7 +195,7 @@ parts_from_fit1 = ParticlesFromTrackFit("parts_from_fit1",
# props = configurable.getDefaultProperties()
# for propname, prop in sorted(props.items()):
# print(" prop name: {}".format(propname))
-# if isinstance(prop, DataObjectHandleBase):
+# if isinstance(prop, DataHandleBase):
# types.append(prop.type())
# print(" {}: \"{}\"".format(propname, prop.type()))
#print("---")
diff --git a/benchmarks/tracking/options/truth_seeded_tracking.py b/benchmarks/tracking/options/truth_seeded_tracking.py
index 00ea29ed..3c9ee9cb 100644
--- a/benchmarks/tracking/options/truth_seeded_tracking.py
+++ b/benchmarks/tracking/options/truth_seeded_tracking.py
@@ -1,6 +1,5 @@
from Gaudi.Configuration import *
-from GaudiKernel.DataObjectHandleBase import DataObjectHandleBase
from Configurables import ApplicationMgr, EICDataSvc, PodioOutput, GeoSvc
from GaudiKernel.SystemOfUnits import MeV, GeV, mm, cm, mrad
--
GitLab