Public Documentation
Documentation for EDM4hep.jl
public interface.
Index - Types
EDM4hep.CaloHitContribution
EDM4hep.CalorimeterHit
EDM4hep.Cluster
EDM4hep.EventHeader
EDM4hep.HitLevelData
EDM4hep.Hypothesis
EDM4hep.MCParticle
EDM4hep.MCRecoCaloAssociation
EDM4hep.MCRecoCaloParticleAssociation
EDM4hep.MCRecoClusterParticleAssociation
EDM4hep.MCRecoParticleAssociation
EDM4hep.MCRecoTrackParticleAssociation
EDM4hep.MCRecoTrackerAssociation
EDM4hep.MCRecoTrackerHitPlaneAssociation
EDM4hep.ParticleID
EDM4hep.Quantity
EDM4hep.RawCalorimeterHit
EDM4hep.RawTimeSeries
EDM4hep.RecDqdx
EDM4hep.RecIonizationCluster
EDM4hep.RecoParticleVertexAssociation
EDM4hep.ReconstructedParticle
EDM4hep.SimCalorimeterHit
EDM4hep.SimPrimaryIonizationCluster
EDM4hep.SimTrackerHit
EDM4hep.TimeSeries
EDM4hep.Track
EDM4hep.TrackState
EDM4hep.TrackerHit
EDM4hep.TrackerHitPlane
EDM4hep.TrackerPulse
EDM4hep.Vector2f
EDM4hep.Vector2i
EDM4hep.Vector3d
EDM4hep.Vector3f
EDM4hep.Vector4f
EDM4hep.Vertex
EDM4hep.RootIO.Reader
Index - Functions
Modules
EDM4hep.EDM4hep
— ModuleMain module for EDM4hep.jl
– Key4hep Event Data Model for Julia.
All data model types are exported from this module for public use
Exports
EDM4hep.RootIO
— ModuleROOT I/O module for EDM4hep.jl
It supports both formats: TTree and RNTuple
Types
This is the list of all types defined for EDM4hep using the PODIO yaml file.
EDM4hep.CaloHitContribution
— TypeMonte Carlo contribution to SimCalorimeterHit
- Author: F.Gaede, DESY
Fields
PDG::Int32
: PDG code of the shower particle that caused this contribution.energy::Float32
: energy in [GeV] of the this contributiontime::Float32
: time in [ns] of this contributionstepPosition::Vector3f
: position of this energy deposition (step) [mm]
Relations
particle::MCParticle
: primary MCParticle that caused the shower responsible for this contribution to the hit.
EDM4hep.CalorimeterHit
— TypeCalorimeter hit
- Author: F.Gaede, DESY
Fields
cellID::UInt64
: detector specific (geometrical) cell id.energy::Float32
: energy of the hit in [GeV].energyError::Float32
: error of the hit energy in [GeV].time::Float32
: time of the hit in [ns].position::Vector3f
: position of the hit in world coordinates in [mm].type::Int32
: type of hit. Mapping of integer types to names via collection parameters "CalorimeterHitTypeNames" and "CalorimeterHitTypeValues".
EDM4hep.Cluster
— TypeCalorimeter Hit Cluster
- Author: F.Gaede, DESY
Fields
type::Int32
: flagword that defines the type of cluster. Bits 16-31 are used internally.energy::Float32
: energy of the cluster [GeV]energyError::Float32
: error on the energyposition::Vector3f
: position of the cluster [mm]positionError::SVector{6,Float32}
: covariance matrix of the position (6 Parameters)iTheta::Float32
: intrinsic direction of cluster at position Theta. Not to be confused with direction cluster is seen from IP.phi::Float32
: intrinsic direction of cluster at position - Phi. Not to be confused with direction cluster is seen from IP.directionError::Vector3f
: covariance matrix of the direction (3 Parameters) [mm^2]shapeParameters::Float32
: shape parameters - check/set collection parameter ClusterShapeParameters for size and names of parameters.subdetectorEnergies::Float32
: energy observed in a particular subdetector. Check/set collection parameter ClusterSubdetectorNames for decoding the indices of the array.
Relations
clusters::Cluster
: clusters that have been combined to this cluster.hits::CalorimeterHit
: hits that have been combined to this cluster.particleIDs::ParticleID
: particle IDs (sorted by their likelihood)
EDM4hep.EventHeader
— TypeEvent Header. Additional parameters are assumed to go into the metadata tree.
- Author: F.Gaede
Fields
eventNumber::Int32
: event numberrunNumber::Int32
: run numbertimeStamp::UInt64
: time stampweight::Float32
: event weight
EDM4hep.HitLevelData
— TypeHitLevelData
Fields
cellID::UInt64
: cell idN::UInt32
: number of reconstructed ionization cluster.eDep::Float32
: reconstructed energy deposit [GeV].pathLength::Float32
: track path length [mm].
EDM4hep.Hypothesis
— TypeHypothesis
Fields
chi2::Float32
: chi2expected::Float32
: expected valuesigma::Float32
: sigma value
EDM4hep.MCParticle
— TypeThe Monte Carlo particle - based on the lcio::MCParticle.
- Author: F.Gaede, DESY
Fields
PDG::Int32
: PDG code of the particlegeneratorStatus::Int32
: status of the particle as defined by the generatorsimulatorStatus::Int32
: status of the particle from the simulation program - use BIT constants belowcharge::Float32
: particle chargetime::Float32
: creation time of the particle in [ns] wrt. the event, e.g. for preassigned decays or decays in flight from the simulator.mass::Float64
: mass of the particle in [GeV]vertex::Vector3d
: production vertex of the particle in [mm].endpoint::Vector3d
: endpoint of the particle in [mm]momentum::Vector3d
: particle 3-momentum at the production vertex in [GeV]momentumAtEndpoint::Vector3d
: particle 3-momentum at the endpoint in [GeV]spin::Vector3f
: spin (helicity) vector of the particle.colorFlow::Vector2i
: color flow as defined by the generator
Relations
parents::MCParticle
: The parents of this particle.daughters::MCParticle
: The daughters this particle.
EDM4hep.MCRecoCaloAssociation
— TypeAssociation between a CaloHit and the corresponding simulated CaloHit
- Author: C. Bernet, B. Hegner
Fields
weight::Float32
: weight of this association
Relations
rec::CalorimeterHit
: reference to the reconstructed hitsim::SimCalorimeterHit
: reference to the simulated hit
EDM4hep.MCRecoCaloParticleAssociation
— TypeAssociation between a CalorimeterHit and a MCParticle
- Author: Placido Fernandez Declara
Fields
weight::Float32
: weight of this association
Relations
rec::CalorimeterHit
: reference to the reconstructed hitsim::MCParticle
: reference to the Monte-Carlo particle
EDM4hep.MCRecoClusterParticleAssociation
— TypeAssociation between a Cluster and a MCParticle
- Author: Placido Fernandez Declara
Fields
weight::Float32
: weight of this association
Relations
rec::Cluster
: reference to the clustersim::MCParticle
: reference to the Monte-Carlo particle
EDM4hep.MCRecoParticleAssociation
— TypeUsed to keep track of the correspondence between MC and reconstructed particles
- Author: C. Bernet, B. Hegner
Fields
weight::Float32
: weight of this association
Relations
rec::ReconstructedParticle
: reference to the reconstructed particlesim::MCParticle
: reference to the Monte-Carlo particle
EDM4hep.MCRecoTrackParticleAssociation
— TypeAssociation between a Track and a MCParticle
- Author: Placido Fernandez Declara
Fields
weight::Float32
: weight of this association
Relations
rec::Track
: reference to the tracksim::MCParticle
: reference to the Monte-Carlo particle
EDM4hep.MCRecoTrackerAssociation
— TypeAssociation between a TrackerHit and the corresponding simulated TrackerHit
- Author: C. Bernet, B. Hegner
Fields
weight::Float32
: weight of this association
Relations
rec::TrackerHit
: reference to the reconstructed hitsim::SimTrackerHit
: reference to the simulated hit
EDM4hep.MCRecoTrackerHitPlaneAssociation
— TypeAssociation between a TrackerHitPlane and the corresponding simulated TrackerHit
- Author: Placido Fernandez Declara
Fields
weight::Float32
: weight of this association
Relations
rec::TrackerHitPlane
: reference to the reconstructed hitsim::SimTrackerHit
: reference to the simulated hit
EDM4hep.ParticleID
— TypeParticleID
- Author: F.Gaede, DESY
Fields
type::Int32
: userdefined typePDG::Int32
: PDG code of this id - ( 999999 ) if unknown.algorithmType::Int32
: type of the algorithm/module that created this hypothesislikelihood::Float32
: likelihood of this hypothesis - in a user defined normalization.parameters::Float32
: parameters associated with this hypothesis. Check/set collection parameters ParameterNames_PIDAlgorithmTypeName for decoding the indices.
EDM4hep.Quantity
— TypeQuantity
Fields
type::Int16
: flag identifying how to interpret the quantityvalue::Float32
: value of the quantityerror::Float32
: error on the value of the quantity
EDM4hep.RawCalorimeterHit
— TypeRaw calorimeter hit
- Author: F.Gaede, DESY
Fields
cellID::UInt64
: detector specific (geometrical) cell id.amplitude::Int32
: amplitude of the hit in ADC counts.timeStamp::Int32
: time stamp for the hit.
EDM4hep.RawTimeSeries
— TypeRaw data of a detector readout
- Author: F.Gaede, DESY
Fields
cellID::UInt64
: detector specific cell id.quality::Int32
: quality flag for the hit.time::Float32
: time of the hit [ns].charge::Float32
: integrated charge of the hit [fC].interval::Float32
: interval of each sampling [ns].adcCounts::Int32
: raw data (32-bit) word at i.
EDM4hep.RecDqdx
— TypedN/dx or dE/dx info of Track.
- Author: Wenxing Fang, IHEP
Fields
dQdx::Quantity
: the reconstructed dEdx or dNdx and its errorparticleType::Int16
: particle type, e(0),mu(1),pi(2),K(3),p(4).type::Int16
: type.hypotheses::SVector{5,Hypothesis}
: 5 particle hypothesishitData::HitLevelData
: hit level data
Relations
track::Track
: the corresponding track.
EDM4hep.RecIonizationCluster
— TypeReconstructed Ionization Cluster
- Author: Wenxing Fang, IHEP
Fields
cellID::UInt64
: cell id.significance::Float32
: significance.type::Int16
: type.
Relations
trackerPulse::TrackerPulse
: the TrackerPulse used to create the ionization cluster.
EDM4hep.RecoParticleVertexAssociation
— TypeAssociation between a Reconstructed Particle and a Vertex
- Author: Placido Fernandez Declara
Fields
weight::Float32
: weight of this association
Relations
rec::ReconstructedParticle
: reference to the reconstructed particlevertex::Vertex
: reference to the vertex
EDM4hep.ReconstructedParticle
— TypeReconstructed Particle
- Author: F.Gaede, DESY
Fields
type::Int32
: type of reconstructed particle. Check/set collection parameters ReconstructedParticleTypeNames and ReconstructedParticleTypeValues.energy::Float32
: [GeV] energy of the reconstructed particle. Four momentum state is not kept consistent internally.momentum::Vector3f
: [GeV] particle momentum. Four momentum state is not kept consistent internally.referencePoint::Vector3f
: [mm] reference, i.e. where the particle has been measuredcharge::Float32
: charge of the reconstructed particle.mass::Float32
: [GeV] mass of the reconstructed particle, set independently from four vector. Four momentum state is not kept consistent internally.goodnessOfPID::Float32
: overall goodness of the PID on a scale of [0;1]covMatrix::SVector{10,Float32}
: cvariance matrix of the reconstructed particle 4vector (10 parameters). Stored as lower triangle matrix of the four momentum (px,py,pz,E), i.e. cov(px,px), cov(py,##
Relations
startVertex::Vertex
: start vertex associated to this particleparticleIDUsed::ParticleID
: particle Id used for the kinematics of this particleclusters::Cluster
: clusters that have been used for this particle.tracks::Track
: tracks that have been used for this particle.particles::ReconstructedParticle
: reconstructed particles that have been combined to this particle.particleIDs::ParticleID
: particle Ids (not sorted by their likelihood)
EDM4hep.SimCalorimeterHit
— TypeSimulated calorimeter hit
- Author: F.Gaede, DESY
Fields
cellID::UInt64
: ID of the sensor that created this hitenergy::Float32
: energy of the hit in [GeV].position::Vector3f
: position of the hit in world coordinates in [mm].
Relations
contributions::CaloHitContribution
: Monte Carlo step contribution - parallel to particle
EDM4hep.SimPrimaryIonizationCluster
— TypeSimulated Primary Ionization
- Author: Wenxing Fang, IHEP
Fields
cellID::UInt64
: cell id.time::Float32
: the primary ionization's time in the lab frame [ns].position::Vector3d
: the primary ionization's position [mm].type::Int16
: type.electronCellID::UInt64
: cell id.electronTime::Float32
: the time in the lab frame [ns].electronPosition::Vector3d
: the position in the lab frame [mm].pulseTime::Float32
: the pulse's time in the lab frame [ns].pulseAmplitude::Float32
: the pulse's amplitude [fC].
Relations
mcparticle::MCParticle
: the particle that caused the ionizing collisions.
EDM4hep.SimTrackerHit
— TypeSimulated tracker hit
- Author: F.Gaede, DESY
Fields
cellID::UInt64
: ID of the sensor that created this hitEDep::Float32
: energy deposited in the hit [GeV].time::Float32
: proper time of the hit in the lab frame in [ns].pathLength::Float32
: path length of the particle in the sensitive material that resulted in this hit.quality::Int32
: quality bit flag.position::Vector3d
: the hit position in [mm].momentum::Vector3f
: the 3-momentum of the particle at the hits position in [GeV]
Relations
mcparticle::MCParticle
: MCParticle that caused the hit.
EDM4hep.TimeSeries
— TypeCalibrated Detector Data
- Author: Wenxing Fang, IHEP
Fields
cellID::UInt64
: cell id.time::Float32
: begin time [ns].interval::Float32
: interval of each sampling [ns].amplitude::Float32
: calibrated detector data.
EDM4hep.Track
— TypeReconstructed track
- Author: F.Gaede, DESY
Fields
type::Int32
: flagword that defines the type of track.Bits 16-31 are used internallychi2::Float32
: Chi^2 of the track fitndf::Int32
: number of degrees of freedom of the track fitdEdx::Float32
: dEdx of the track.dEdxError::Float32
: error of dEdx.radiusOfInnermostHit::Float32
: radius of the innermost hit that has been used in the track fitsubdetectorHitNumbers::Int32
: number of hits in particular subdetectors.Check/set collection variable TrackSubdetectorNames for decoding the indicestrackStates::TrackState
: track statesdxQuantities::Quantity
: different measurements of dx quantities
Relations
trackerHits::TrackerHit
: hits that have been used to create this tracktracks::Track
: tracks (segments) that have been combined to create this track
EDM4hep.TrackState
— TypeTrackState
Fields
location::Int32
: for use with At{Other|IP|FirstHit|LastHit|Calorimeter|Vertex}|LastLocationD0::Float32
: transverse impact parameterphi::Float32
: azimuthal angleomega::Float32
: is the signed curvature of the track in [1/mm].Z0::Float32
: longitudinal impact parametertanLambda::Float32
: lambda is the dip angle of the track in r-ztime::Float32
: time of the track at this trackstatereferencePoint::Vector3f
: Reference point of the track parameters, e.g. the origin at the IP, or the position of the first/last hits or the entry point into the calorimeter. [mm]covMatrix::SVector{21,Float32}
: lower triangular covariance matrix of the track parameters. the order of parameters is d0, phi, omega, z0, tan(lambda), time. the array is a row-major flattening of the matrix.
EDM4hep.TrackerHit
— TypeTracker hit
- Author: F.Gaede, DESY
Fields
cellID::UInt64
: ID of the sensor that created this hittype::Int32
: type of raw data hit, either one of edm4hep::RawTimeSeries, edm4hep::SIMTRACKERHIT - see collection parameters "TrackerHitTypeNames" and "TrackerHitTypeValues".quality::Int32
: quality bit flag of the hit.time::Float32
: time of the hit [ns].eDep::Float32
: energy deposited on the hit [GeV].eDepError::Float32
: error measured on EDep [GeV].position::Vector3d
: hit position in [mm].covMatrix::SVector{6,Float32}
: covariance of the position (x,y,z), stored as lower triangle matrix. i.e. cov(x,x) , cov(y,x) , cov(y,y) , cov(z,x) , cov(z,y) , cov(z,z)rawHits::ObjectID
: raw data hits. Check getType to get actual data type.
EDM4hep.TrackerHitPlane
— TypeTracker hit plane
- Author: Placido Fernandez Declara, CERN
Fields
cellID::UInt64
: ID of the sensor that created this hittype::Int32
: type of raw data hit, either one of edm4hep::RawTimeSeries, edm4hep::SIMTRACKERHIT - see collection parameters "TrackerHitTypeNames" and "TrackerHitTypeValues".quality::Int32
: quality bit flag of the hit.time::Float32
: time of the hit [ns].eDep::Float32
: energy deposited on the hit [GeV].eDepError::Float32
: error measured on EDep [GeV].u::Vector2f
: measurement direction vector, u lies in the x-y planev::Vector2f
: measurement direction vector, v is along zdu::Float32
: measurement error along the directiondv::Float32
: measurement error along the directionposition::Vector3d
: hit position in [mm].covMatrix::SVector{6,Float32}
: covariance of the position (x,y,z), stored as lower triangle matrix. i.e. cov(x,x) , cov(y,x) , cov(y,y) , cov(z,x) , cov(z,y) , cov(z,z)rawHits::ObjectID
: raw data hits. Check getType to get actual data type.
EDM4hep.TrackerPulse
— TypeReconstructed Tracker Pulse
- Author: Wenxing Fang, IHEP
Fields
cellID::UInt64
: cell id.time::Float32
: time [ns].charge::Float32
: charge [fC].quality::Int16
: quality.covMatrix::SVector{3,Float32}
: lower triangle covariance matrix of the charge(c) and time(t) measurements.
Relations
timeSeries::TimeSeries
: Optionally, the timeSeries that has been used to create the pulse can be stored with the pulse.
EDM4hep.Vector2f
— TypeVector2f
Fields
a::Float32
:b::Float32
:
EDM4hep.Vector2i
— TypeVector2i
Fields
a::Int32
:b::Int32
:
EDM4hep.Vector3d
— TypeVector3d
Fields
x::Float64
:y::Float64
:z::Float64
:
EDM4hep.Vector3f
— TypeVector3f
Fields
x::Float32
:y::Float32
:z::Float32
:
EDM4hep.Vector4f
— TypeGeneric vector for storing classical 4D coordinates in memory. Four momentum helper functions are in edm4hep::utils
Fields
x::Float32
:y::Float32
:z::Float32
:t::Float32
:
EDM4hep.Vertex
— TypeVertex
- Author: F.Gaede, DESY
Fields
primary::Int32
: boolean flag, if vertex is the primary vertex of the eventchi2::Float32
: chi-squared of the vertex fitprobability::Float32
: probability of the vertex fitposition::Vector3f
: [mm] position of the vertex.covMatrix::SVector{6,Float32}
: covariance matrix of the position (stored as lower triangle matrix, i.e. cov(xx),cov(y,x),cov(z,x),cov(y,y),... )algorithmType::Int32
: type code for the algorithm that has been used to create the vertex - check/set the collection parameters AlgorithmName and AlgorithmType.parameters::Float32
: additional parameters related to this vertex - check/set the collection parameter "VertexParameterNames" for the parameters meaning.
Relations
associatedParticle::POD
: reconstructed particle associated to this vertex.
EDM4hep.RootIO.Reader
— TypeThe Reader struture keeps a reference to the UnROOT LazyTree and caches already built 'layouts' of the EDM4hep types. The layouts maps a set of columns in the LazyTree into an object.
Functions
EDM4hep.RootIO.get
— Methodget(reader::Reader, treename::String)
Opens a 'TTree' in the ROOT file (typically the events tree). It returns a 'LazyTree' that allows the user to iterate over events.
EDM4hep.RootIO.get
— Methodget(reader::Reader, evt::UnROOT.LazyEvent, bname::String; btype::Type=Any, register=true)
Gets an object collection by its name, with the possibility to overwrite the mapping Julia type or use the type known in the ROOT file (C++ class name). The optonal key parameter register
indicates is the collection needs to be registered to the EDStore
.