C __group< T >
► C _HelpAction
C FullHelpAction
C _nt_compare< T1, T_rest >
C AAFHInterface Class to interface AAFH/DIAG36 Generator written in Fortran
► C ABC
► C CalibrationCheckerBase
C PXDHotPixelMaskCalibrationChecker
► C ConditionCheckerBase
C PXDDeadPixelsChecker
C PXDGainMapChecker
C PXDMaskedPixelsChecker
C PXDOccupancyInfoChecker
► C ABinaryOp
C BinaryJoin< ABinaryOp, AFunctor1, AFunctor2 > Functor factory turning a binary functor and two functors into a new functor which executes the binary operation with input from the two given functors
► C AbsBField
C GFGeant4Field Interface of the Belle II B-field with GenFit
► C AbsFinitePlane
C SensorPlane A Finite plane of one VXD Sensor
► C AbsHMatrix
C HMatrixQP AbsHMatrix implementation for one-dimensional MeasurementOnPlane and RKTrackRep parameterization
► C AbsMaterialInterface
C Geant4MaterialInterface AbsMaterialInterface implementation for use with Geant4's navigator
► C AbsMeasurement
► C CDCRecoHit This class is used to transfer CDC information to the track fit
C AlignableCDCRecoHit This class is used to transfer CDC information to the track fit and Millepede
► C AbstractBooleanNode< AVariableManager > A parsed cut-string naturally has a tree shape which incorporates the information of operator precedence and evaluation order of the statements
C BinaryBooleanNode< AVariableManager > Nodeclass with two AbstractBooleanNode as children and a Boolean Operator (AND, OR) Check() method evaluates the child nodes and returns the result of the boolean operation
C BinaryRelationalNode< AVariableManager > BooleanNode which has two AbstractExpressionNodes nodes and a ComparisonOperator
C TernaryRelationalNode< AVariableManager > BooleanNode which has three AbstractExpressionNodes nodes and two ComparisonOperator
C UnaryBooleanNode< AVariableManager > Nodeclass with a single AbstractBooleanNode as child
C UnaryRelationalNode< AVariableManager > Nodeclass with a single AbstractExpressioNode as child
► C AbstractExpressionNode< AVariableManager > AbstractExpressionNode Superclass for all nodes which host expressions
C BinaryExpressionNode< AVariableManager > BinaryExpressionNode Node which connects two expression nodes with an arithmetic operation
C DataNode< AVariableManager, T > Template class for storing the Constants (int, double, bool) of the Cutstring
C FunctionNode< AVariableManager > FunctionNode Node class for handling MetaVariables in cuts
C IdentifierNode< AVariableManager > Class which stores the name of a variable
C UnaryExpressionNode< AVariableManager > UnaryExpressionNode Node class with a single expression node as child
► C AbstractInterface Abstract Interface to third-party MVA libraries
C Interface< TemplateOptions, TemplateTeacher, TemplateExpert > Template class to easily construct a interface for an MVA library using a library-specific Options , Teacher and Expert class
C CountContainer::AcceptRejectPair Simple struct for counting accepted and rejected cases
► C AConnectionClass
C ZMQHistogramOutput< AConnectionClass > Add the common functionality to the histogram output classes
C ActiveSector< StaticSectorType, HitType > The ActiveSector Class
C adc_search Functions to search in the sorted list of tuples
C adcAsicTuple Tuple to store ADC,Channel -> 8 asicChannels
C adcChannelPair Pair ADC, channel
C EclConfiguration::adccounts_t Struct for the ADC count
C EclConfigurationPure::adccountspure_t Struct for the fit parameters for the pure CsI calorimeter
► C ADCCountTranslatorBase Abstract Base class for the ADC count translator
C LinearGlobalADCCountTranslator This class simply assumes a linear translation through (0,0)
► C AFilter
C AllFilter< AFilter > Filter adapter type that accepts all items (just for reference)
C AndFilter< AFilter > Filter adapter type that joins two filter results in an and like fashion
► C Chooseable< AFilter > Filter can delegate to a filter chosen and set up at run time by parameters
C ChooseableFilter< PXDResultFilterFactory >
C ChooseableFilter< SVDResultFilterFactory >
C ChooseableFilter< AxialSegmentPairFilterFactory >
C ChooseableFilter< ClusterFilterFactory >
C ChooseableFilter< FacetFilterFactory >
C ChooseableFilter< FacetRelationFilterFactory >
C ChooseableFilter< SegmentPairFilterFactory >
C ChooseableFilter< SegmentPairRelationFilterFactory >
C ChooseableFilter< SegmentRelationFilterFactory >
C ChooseableFilter< SegmentTripleFilterFactory >
C ChooseableFilter< SegmentTripleRelationFilterFactory >
C ChooseableFilter< TrackRelationFilterFactory >
C ChooseableFilter< WireHitFilterFactory >
C ChooseableFilter< TrackletFilterFactory >
C MCSymmetric< AFilter > Mixin for filters that use Monte Carlo information
C NegativeFilter< AFilter > Filter adapter type that negates the acceptance criterion for cross checks
C NoneFilter< AFilter > Filter adapter type that rejects all items
C NotFilter< AFilter > Filter adapter type that inverts the acceptance criterion for cross checks
C ObserverFilter< AFilter > Observer listening to the number of yes and no answers from the filter
► C OnVarSet< AFilter > Filter adapter to make a filter work on a set of variables
C ChoosableFromVarSet< Filter< typename ATruthVarSet::Object > >
► C FilterOnVarSet< SkimmedHitGapSegmentPairVarSet >
C FitlessSegmentPairFilter Filter for the construction of segment pairs based on simple criteria without the common fit
► C MVA< BaseAxialSegmentPairFilter >
C MVAFeasibleAxialSegmentPairFilter Filter for the construction of segment pairs based on simple criteria without the common fit
C MVARealisticAxialSegmentPairFilter Final filter for the construction of segment pairs
► C MVA< BaseFacetFilter >
C MVAFacetFilter Background facet detection based on MVA
► C MVA< BaseFacetRelationFilter >
C MVAFacetRelationFilter Background facetRelation detection based on MVA
► C MVA< BaseSegmentPairRelationFilter >
C MVARealisticSegmentPairRelationFilter Final filter for the construction of segment pairs
► C MVA< BaseSegmentRelationFilter >
C MVAFeasibleSegmentRelationFilter Filter for the construction of segment pairs based on simple criteria without the common fit
C MVARealisticSegmentRelationFilter Final filter for the construction of segment pairs
► C MVA< BaseTrackRelationFilter >
C MVAFeasibleTrackRelationFilter Filter for the construction of track pairs based on simple criteria without the common fit
C MVARealisticTrackRelationFilter Final filter for the construction of segment pairs
C ChoosableFromVarSet< AFilter > Filter adapter to make a filter work on a set of variables and return on variable as the result of the filter
► C MVA< AFilter > Filter based on a mva method
► C MVAFilter< BasicClusterVarSet >
C MVABackgroundClusterFilter Background cluster detection based on MVA package
► C MVAFilter< MVAFeasibleSegmentPairVarSet >
C MVAFeasibleSegmentPairFilter Filter for the construction of segment pairs based on simple criteria without the common fit
► C MVAFilter< MVARealisticSegmentPairVarSet >
C MVARealisticSegmentPairFilter Final filter for the construction of segment pairs
► C Recording< AFilter > Filter adapter to make a filter work on a set of variables and record the observed instances on invocation
C UnionRecording< typename AFilterFactory::CreatedFilter >
► C UnionRecording< AFilter > A filter that records variables form given objects
► C UnionRecordingFilter< AxialSegmentPairFilterFactory >
C UnionRecordingAxialSegmentPairFilter Filter to record multiple chooseable variable sets for axial segment pairs
► C UnionRecordingFilter< ClusterFilterFactory >
C UnionRecordingClusterFilter Filter to record multiple chooseable variable sets for wire hit clusters
► C UnionRecordingFilter< FacetFilterFactory >
C UnionRecordingFacetFilter Filter to record multiple chooseable variable sets for facets
► C UnionRecordingFilter< FacetRelationFilterFactory >
C UnionRecordingFacetRelationFilter Filter to record multiple chooseable variable sets for facet relations
► C UnionRecordingFilter< SegmentPairFilterFactory >
C UnionRecordingSegmentPairFilter Filter to record multiple chooseable variable sets for segment pairs
► C UnionRecordingFilter< SegmentPairRelationFilterFactory >
C UnionRecordingSegmentPairRelationFilter Filter to record multiple chooseable variable sets for segment pair relations
► C UnionRecordingFilter< SegmentRelationFilterFactory >
C UnionRecordingSegmentRelationFilter Filter to record multiple chooseable variable sets for segment relations
► C UnionRecordingFilter< TrackRelationFilterFactory >
C UnionRecordingTrackRelationFilter Filter to record multiple chooseable variable sets for track relations
C PassThroughFilter< AFilter > Filter adapter type that passes the weight of a weighted relation as a result
C RandomFilter< AFilter > Random filter resulting in a random weight between 0 and 1
C Sloppy< AFilter > A filter that accepts every "sloppinessFactor"th candidate on average (random selection)
► C AFitMethod
C CDCFitter2D< AFitMethod > Class implementing a fit for two dimensional trajectory circle using a generic fitting backend
► C AInBox
C StereoHitContained< AInBox > Predicate class to check for the containment of axial and stereo hits in some hough space part
C EclConfiguration::algoparams_t Struct for the parameters of the algorithm
► C AlgorithmStrategy
C KLMChannelStatus
C KLMStripEfficiency
C AlgoritmType Small class for classifying types of analyzing algorithms
C TOPAlignmentAlgorithm::AlignData Data structure
C AlignmentChecker Class for EKLM alignment checking
C AlignmentGeneratorConfig Basf2 (Belle II Analysis Software Framework) # Author: The Belle II Collaboration # # See git log for contributors and copyright holders
► C AllStateFilter
C NonIPCrossingStateFilter< AllStateFilter > Reusable filter for checking the direction of a new state if it is in the correct orientation (forwards or backwards) by their arc length
C Alternation< AFunctor1, AFunctor2 > Generic functor to try to functors and choose the first to be applicable
C AlwaysPassFilter
C AnalizerTCInfo Simple class storing infos relevant for a TC for analyzing it
C AnalysisConfiguration Singleton class keeping configurables of analysis components
► C AnalyzingAlgorithmBase< DataType, TCInfoType, VectorType > Base class for storing an algorithm determining the data one wants to have
C AnalyzingAlgorithmLostUClusters< DataType, TCInfoType, VectorType > Class for storing an algorithm to find out how many u-type-clusters the testTC lost compared to the refTC
C AnalyzingAlgorithmLostUEDep< DataType, TCInfoType, VectorType > Class for storing an algorithm to find out the energy deposit of u-type-clusters the testTC lost compared to the refTC
C AnalyzingAlgorithmLostVClusters< DataType, TCInfoType, VectorType > Class for storing an algorithm to find out how many v-type-clusters the testTC lost compared to the refTC
C AnalyzingAlgorithmLostVEDep< DataType, TCInfoType, VectorType > Class for storing an algorithm to find out the energy deposit of v-type-clusters the testTC lost compared to the refTC
C AnalyzingAlgorithmResidualP< DataType, TCInfoType, VectorType > Class for storing an algorithm determining the residual (ref-test) of momentum in |p|
C AnalyzingAlgorithmResidualPAngle< DataType, TCInfoType, VectorType > Class for storing an algorithm determining the residual (ref-test) of momentum in its angle (direction residual in degrees)
C AnalyzingAlgorithmResidualPPhi< DataType, TCInfoType, VectorType > Class for storing an algorithm determining the residual (ref-test) of momentum in phi (in degrees)
C AnalyzingAlgorithmResidualPT< DataType, TCInfoType, VectorType > Class for storing an algorithm determining the residual (ref-test) of momentum in pT
C AnalyzingAlgorithmResidualPTAngle< DataType, TCInfoType, VectorType > Class for storing an algorithm determining the residual (ref-test) of pT in angle (transverse direction residual in degrees)
C AnalyzingAlgorithmResidualPTheta< DataType, TCInfoType, VectorType > Class for storing an algorithm determining the residual (ref-test) of momentum in theta (in degrees)
C AnalyzingAlgorithmResidualPX< DataType, TCInfoType, VectorType > INFO This file contains all the algorithms calculating residuals of something
C AnalyzingAlgorithmResidualPY< DataType, TCInfoType, VectorType > Class for storing an algorithm determining the residual (ref-test) of momentum in Y
C AnalyzingAlgorithmResidualPZ< DataType, TCInfoType, VectorType > Class for storing an algorithm determining the residual (ref-test) of momentum in Z
C AnalyzingAlgorithmResidualPosition< DataType, TCInfoType, VectorType > Class for storing an algorithm determining the residual (ref-test) of the seed position in 3D
C AnalyzingAlgorithmResidualPositionXY< DataType, TCInfoType, VectorType > Class for storing an algorithm determining the residual (ref-test) of the seed position in XY (=r)
C AnalyzingAlgorithmTotalUClusters< DataType, TCInfoType, VectorType > Class for storing an algorithm to find out how many u-type-clusters the given TC had
C AnalyzingAlgorithmTotalUEDep< DataType, TCInfoType, VectorType > Class for storing an algorithm to find out the energy deposit of u-type-clusters the given TC had
C AnalyzingAlgorithmTotalVClusters< DataType, TCInfoType, VectorType > Class for storing an algorithm to find out how many v-type-clusters the given TC had
C AnalyzingAlgorithmTotalVEDep< DataType, TCInfoType, VectorType > Class for storing an algorithm to find out the energy deposit of v-type-clusters the given TC had
C AnalyzingAlgorithmValueDistSeed2IP< DataType, TCInfoType, VectorType > Class for storing an algorithm determining the the distance seedHit to IP in 3D
C AnalyzingAlgorithmValueDistSeed2IPXY< DataType, TCInfoType, VectorType > Class for storing an algorithm determining the distance seedHit to IP in XY (=r)
C AnalyzingAlgorithmValueDistSeed2IPZ< DataType, TCInfoType, VectorType > Class for storing an algorithm determining the distance seedHit to IP in XY (=r)
C AnalyzingAlgorithmValueP< DataType, TCInfoType, VectorType > Class for storing an algorithm determining the momentum in |p|
C AnalyzingAlgorithmValuePPhi< DataType, TCInfoType, VectorType > Class for storing an algorithm determining the momentum in phi (in degrees)
C AnalyzingAlgorithmValuePT< DataType, TCInfoType, VectorType > Class for storing an algorithm determining the momentum in pT
C AnalyzingAlgorithmValuePTheta< DataType, TCInfoType, VectorType > Class for storing an algorithm determining the momentum in theta (in degrees)
C AnalyzingAlgorithmValuePX< DataType, TCInfoType, VectorType > INFO This file contains all the algorithms calculating a certain value of something
C AnalyzingAlgorithmValuePY< DataType, TCInfoType, VectorType > Class for storing an algorithm determining the momentum in Y
C AnalyzingAlgorithmValuePZ< DataType, TCInfoType, VectorType > Class for storing an algorithm determining the momentum in Z
C AnalyzingAlgorithmValueQI< DataType, TCInfoType, VectorType > Class for storing an algorithm determining the quality indicator of the TC
C AngleUtil Utility functions to be used with angular quantities
C BFieldComponentQuad::ApertPoint Aperture data structure
► C AProperties
C DynTree< AProperties, ASubPropertiesFactory >::Node Class for a node in the tree
C SVDPackerModule::APVHeader Implementation of APV Header
C SVDUnpackerModule::APVHeader Implementation of APV Header
► C ArgumentParser
C ArgumentParser
C DefaultHelpArgumentParser
C ARICHBtestGeometryPar The Class for ARICH Beamtest Geometry Parameters
C ARICHCalibrationChecker ARICH calibration checker
C ARICHDatabaseImporter ARICH database importer
C ARICHGeometryPar The Class for ARICH Geometry Parameters
C ARICHRawHeader ARICH raw-data header
C ARICHReconstruction Internal ARICH track reconstruction
C ARICHTracking Beamtest ARICH Geometry Tracking Class
C ARICHTree Structure of a flat ntuple
C array< T > STL class
C ArrayIterator< ArrayType, ValueType > Generic iterator class for arrays, allowing use of STL algorithms, range-based for etc
C DisplayData::Arrow Stores data associated with an arrow
C asicChannel Record to be used to store ASIC info
C VarSet< AVarNames >::AssignFinite< AFloat > Helper construct to assign a finite value to float variables
C TOPTrack::AssumedEmission Assumed photon emission point in local frame
C Atom Very small (few mins) calibration interval which cannot be further divided : Atom
C AttrDict
► C AuthBase
C BearerAuth
C AutomatonCell Cell used by the cellular automata
► C ax_name_container_base_const
C ax_name_container_base< T2 >
C AxialLegendreLeafProcessor< ANode > Predicate class that is feed the nodes in a WeightedHoughTree walk It decides if a node should be further expanded and extracts items from nodes that are considered as leafs to build tracks
C AxialTrackUtil Utility structure gathering heuristic functions used during the axial track finding
C Axis This class unites some parameters for Factory which describe one axis of histogram
C CDCTriggerNeuroConfig::B2FormatLine
C B2LDataField
C B2LDataField_DNN
C B2Vector3< DataType > A fast and root compatible alternative to TVector3
C BabayagaNLO C++ Interface for the Fortran Bhabha and exclusive two photon generator BABAYAGA.NLO
C BackgroundInfo::BackgroundDescr Structure for background description
C BackgroundPDF Parametrization of background PDF in pixels of single module
C RaytracerBase::BarSegment Bar segment data in module local frame
► C BASE
C RelationsInterface< BASE > Defines interface for accessing relations of objects in StoreArray
C base_maker< T, data_T >
► C base_maker_t
C dataframe< _Remove_cvref_t< T >... >
C dataframe< Ts >
► C BaseAngle Class to compare if two angles are compatible within a given error range
C PhiAngle
C ThetaAngle
► C BaseCandidateReceiver Base class that receives candidates found by quadtree
C OffOriginExtension Class performs extension (adding new hits) of given candidate using conformal transformation w.r.t point on the trajectory
► C BaseConstraint Abstract base class for constraints of kinematic fits
► C BaseHardConstraint Abstract base class for constraints of kinematic fits
► C ParticleConstraint Abstract base class for constraints of kinematic fits
C MassConstraint Implements constraint 0 = mass1 - mass2 - m
C MomentumConstraint Implements a constraint of the form efact*sum(E )+pxfact*sum(px)+pyfact*sum(py)+pzfact*sum(pz)=value
C RecoilMassConstraint
► C BaseSoftConstraint Abstract base class for soft constraints of kinematic fits
► C SoftGaussParticleConstraint Abstract base class for constraints of kinematic fits
C SoftGaussMassConstraint Implements constraint 0 = mass1 - mass2 - m
C SoftGaussMomentumConstraint Implements a soft constraint with chi^2=((efact*sum(E_i) + pxfact*sum(p_x,i)+pyfact*sum(p_y,i)+pzfact*sum(p_z,i)-value)/sigma)^2
C TrackConstraint Abstract base class for constraints of kinematic fits
C BaseDefs
C BaseEvent
► C BaseFitObject
► C ParticleFitObject
C ISRPhotonFitObject
C JetFitObject Class for jets with (E , eta, phi) in kinematic fits
C NeutrinoFitObject
C PxPyPzMFitObject
► C BaseFitter Abstract base class for fitting engines of kinematic fits
C NewFitterGSL A kinematic fitter using the Newton-Raphson method to solve the equations
C NewtonFitterGSL
C OPALFitterGSL Description of the fit algorithm and interface:
C BaseJetPairing Abstract base class for jet pairings
► C BaseMeasurementCreator Base class for all measurement creators
C BaseMeasurementCreatorFromHit< RecoHitInformation::UsedCDCHit, Const::CDC >
C BaseMeasurementCreatorFromHit< RecoHitInformation::UsedSVDHit, Const::SVD >
C BaseMeasurementCreatorFromHit< RecoHitInformation::UsedPXDHit, Const::PXD >
C BaseMeasurementCreatorFromHit< RecoHitInformation::UsedBKLMHit, Const::BKLM >
C BaseMeasurementCreatorFromHit< RecoHitInformation::UsedEKLMHit, Const::EKLM >
► C BaseMeasurementCreatorFromHit< HitType, detector > Base Class to create measurements based on a given hit related to the RecoTrack
C CoordinateMeasurementCreator< RecoHitInformation::UsedCDCHit, Const::CDC >
C CoordinateMeasurementCreator< RecoHitInformation::UsedSVDHit, Const::SVD >
C CoordinateMeasurementCreator< RecoHitInformation::UsedPXDHit, Const::PXD >
C CoordinateMeasurementCreator< RecoHitInformation::UsedBKLMHit, Const::BKLM >
C CoordinateMeasurementCreator< RecoHitInformation::UsedEKLMHit, Const::EKLM >
► C BaseMeasurementCreatorFromCoordinateMeasurement< HitType, detector > Baseclass to create measurement track points based on the coordinate measurements
C VXDMomentumEstimationMeasurementCreator< RecoHitInformation::UsedSVDHit, Const::SVD >
C VXDMomentumEstimationMeasurementCreator< RecoHitInformation::UsedPXDHit, Const::PXD >
C VXDMomentumEstimationMeasurementCreator< HitType, detector > Creator for VXDMeasurements with momentum estimation based on the dEdX information
C CoordinateMeasurementCreator< HitType, detector > A measurement creator for normal coordinate measurements out of cdc/svd/pxd hits
► C BaseTracer Abstract base class for trace objects of kinematic fits
C TextTracer
C Basf2ModulesInformation
► C Basf2PathTask
C GenerateSimTask
C ResultRecordingTask
C ValidationAndOptimisationTask
C GenerateSimTask
C ResultRecordingTask
C StateRecordingTask
C ValidationAndOptimisationTask
C GenerateSimTask
C ResultRecordingTask
C StateRecordingTask
C ValidationAndOptimisationTask
C BASF2StateRecorder
► C Basf2Task
C CKFResultFilterTeacherTask
C SplitNMergeSimTask
C CKFResultFilterTeacherTask
C CKFStateFilterTeacherTask
C SplitNMergeSimTask
C CKFResultFilterTeacherTask
C CKFStateFilterTeacherTask
C SplitNMergeSimTask
C batch_generator
C BBBrem Generator for low scattering angle radiative Bhabha events (Beam-Beam Bremsstrahlung)
C BeamBGTypes Class to define BG types and to convert between BG types and tags or v.v
C BeamlineFieldMapInterpolation The BeamlineFieldMapInterpolation class
C BeamParametersFitter Fitter calculating BeamParameters from CollisionBoostVector and CollisionInvariantMass
C BEASTTree_v5 Structure for the input of the data BEAST (TTree "Data_BEAST")
C BeginRec Begin record structure for the beamtest data
C ReaderSAD::bendingElement Sensitive Element
C BestMatchContainer< TItem, TEstimator > Multiple entries can be added, but only the one will be kept, which has the best quality estimator
► C BFieldComponentAbs The BFieldComponentAbs class
C BFieldComponent3d The BFieldComponent3d class
C BFieldComponentBeamline The BFieldComponentBeamline class
C BFieldComponentConstant The BFieldComponentConstant class
C BFieldComponentKlm1 The Bfieldcomponentklm1 class
C BFieldComponentQuad The BFieldComponentQuad class
C BFieldComponentRadial The BFieldComponentRadial class
C BFieldManager Bfield manager to obtain the magnetic field at any point
C BFieldMap This class represents the magnetic field of the Belle II detector
C BFieldComponentKlm1::BFieldPoint Trivial struct representing rz coordinate
C BFieldComponentRadial::BFieldPoint Magnetic field data structure
C BHWide C++ Interface for the Fortran Bhabha scattering generator BHWide
► C BinData
C ONSENBinData
C BinHeader
C Binning Binning of a data distribution Provides PDF and CDF values of the distribution per bin
C BinTrailer
C bitset< Bits > STL class
C BitStream Bit stream struct
C BeamBkgMixerModule::BkgFiles Structure to hold samples of a particular background type
C BeamBkgMixerModule::BkgHits An input event buffer definition for background SimHits
C BkgNeutronWeight The class to get the weighting factor for a 1-MeV-equivalent neutron flux on silicon
C BKLMDatabaseImporter This module writes BKLM data to database
C BKLMElementNumbers BKLM element numbers
C BKLMStatus BKLM hit status
C BKLMTrackFinder Track finding procedure
C BKLMTrackFitter Track fitting procedure
C BoostPythonModuleProxy Proxy class to register python modules (the things you can 'import')
C BoundingBox A two dimensional rectangle that keeps track of the extend of a drawing
C Box< ATypes > The base class for all boxes
C ARICHGeoSupport::box Struct to hold parameters of box volumes (examples, scintilators for cosmic test)
► C Box< DiscreteP, DiscreteQ >
C PQBox A rectangular domain for the hough space over p and q
► C Box< DiscreteZ0, DiscreteTanL >
C Z0TanLambdaBox A rectangular domain for the hough space over phi0 and two dimensional curvature
C Box<> Box Base class specification without any template arguments
► C BoxDivisionHoughTree< AItemPtr, AHoughBox, divisions > A fast hough algorithm with rectangular boxes, which are split linearly by a fixed number of divisions in each coordinate up to a maximal level
C SimpleHitBasedHoughTree< CDCRLWireHit, AInBox, divisions ... >
C SimpleHitBasedHoughTree< const CDCSegment2D *, AInBox, divisions ... >
► C BoxDivisionHoughTree< AHitPointerType, AHitDecisionAlgorithm::HoughBox, divisionX, divisionY >
► C SimpleBoxDivisionHoughTree< AHitPointerType, AHitDecisionAlgorithm, divisionX, divisionY >
C DebugableSimpleBoxDivisionHoughTree< AHitPointerType, AHitDecisionAlgorithm, pDivisions, qDivisions >
C DebugableSimpleBoxDivisionHoughTree< AHitPointerType, AHitDecisionAlgorithm, z0Divisions, tanLambdaDivisions >
► C DebugableSimpleBoxDivisionHoughTree< AHitPointerType, AHitDecisionAlgorithm, 3, 3 >
C QuadraticLegendre< AHitPointerType, AHitDecisionAlgorithm, pDivisions, qDivisions > Hough Tree for finding StereoHits with using CDCRecoHit3D as the item type
► C DebugableSimpleBoxDivisionHoughTree< AHitPointerType, AHitDecisionAlgorithm, 2, 2 >
C Z0TanLambdaLegendre< AHitPointerType, AHitDecisionAlgorithm, z0Divisions, tanLambdaDivisions > Hough Tree for finding StereoHits using a templated class as the item type
► C BoxDivisionHoughTree< AHitPointerType, AHitDecisionAlgorithm::HoughBox, divisionX, divisionY, divisionZ >
C SimpleBoxDivisionHoughTree3D< AHitPointerType, AHitDecisionAlgorithm, qDivisions, pDivisions, muDivisions >
► C SimpleBoxDivisionHoughTree3D< AHitPointerType, AHitDecisionAlgorithm, 2, 2, 2 >
C HyperHough< AHitPointerType, AHitDecisionAlgorithm, qDivisions, pDivisions, muDivisions > Hough Tree for finding StereoHits with using CDCRecoHit3D as the item type
► C BoxDivisionHoughTree< AHitPtr, AInBoxAlgorithm::HoughBox, divisionX, divisionY >
► C SimpleBoxDivisionHoughTree< AHitPtr, AInBoxAlgorithm, divisionX, divisionY > Convenience class for the typical usage-case: A box divisioned hough tree with maximum and minimum values in both directions
► C DebugableSimpleBoxDivisionHoughTree< AHitPtr, AInBoxAlgorithm, divisionX, divisionY > A convenience class for adding debug information to a Simple Hough Tree
C QuadraticLegendre< std::pair< CDCRecoHit3D, const CDCRLWireHit * >, FirstOfPairInBox< HitInQuadraticBox >, 2, 2 >
C Z0TanLambdaLegendre< std::pair< CDCRecoHit3D, const CDCRLWireHit * >, FirstOfPairInBox< HitInZ0TanLambdaBox >, 2, 2 >
C Z0TanLambdaLegendre< std::pair< CDCRecoHit3D, const CDCRLWireHit * >, FirstOfPairInBox< HitInZ0TanLambdaBoxUsingZ >, 2, 2 >
C Z0TanLambdaLegendre< std::pair< std::pair< CDCSegment3D, CDCTrajectorySZ >, const CDCSegment2D * >, SegmentInZ0TanLambdaAlgorithm, 2, 2 >
► C BoxDivisionHoughTree< AHitPtr, AInBoxAlgorithm::HoughBox, divisionX, divisionY, divisionZ >
► C SimpleBoxDivisionHoughTree3D< AHitPtr, AInBoxAlgorithm, divisionX, divisionY, divisionZ > Convenience class for the typical usage-case: A box divisioned hough tree with maximum and minimum values in both directions
C HyperHough< std::pair< CDCRecoHit3D, const CDCRLWireHit * >, FirstOfPairInBox< HitInHyperBox >, 4, 3, 2 >
► C BoxDivisionHoughTree< AHitPtr, InBox::HoughBox, divisions... >
C SimpleHitBasedHoughTree< AHitPtr, InBox, divisions > A convenience class based on a BoxDivisionHoughTree for "hit-like" classes
C BranchInterface< ValueType > Simple struct for interfacing the Branch
C BremFindingMatchCompute Module to compute if an extrapolation to the ECL matches the position of an secondary ECLCLuster to find bremsstrahlung clusters
C Buffer
C Bundle Class to contain particles identified to come from the same actual/mc particle
C BW_t Description: The class to treat resonances, their lineshapes, and dispersion relation integral
C CACell The CACell class This Class stores all relevant information one wants to have stored in a cell for a Cellular automaton
C ScriptStatus.cached
C MetadataProvider::PayloadMetadataCache::CacheEntry Each cache entry
C cachezr_t Cached z-r struct
C cal_scale_error_func_set_t Structure type cal_scale_error_func_set_t
C CalcMeanCov< N, RealType > Class to calculate mean and and covariance between a number of parameters on running data without storing the actual values, also for weighted entries
► C Calculation
C Basf2Calculation
C CalculationQueue
C CalculationQueueItem
C CalibObjManager Manager class for collector registered data. Handles much of the TDirectory/TObject manipulation
C CalibPars The parameters related to single calibration interval
► C Calibration
C CDCDedxCalibration
C ECLDigitizerModule::calibration_t Calibration constants per channel
► C CalibrationAlgorithm Base class for calibration algorithms
C ARICHChannelMaskMaker ARICH channel mask calibration algorithm
C BeamSpotAlgorithm Class implementing BeamSpot calibration algorithm
C BoostVectorAlgorithm Class implementing BoostVector calibration algorithm
C CrudeT0CalibrationAlgorithm Algorithm class for crude T0 calibration
C FudgeFactorCalibrationAlgorithm Class for CDC fudge factor calibration
C SpaceResolutionCalibrationAlgorithm Class for Space resolution calibration
C T0CalibrationAlgorithm Class for T0 Correction
C TimeWalkCalibrationAlgorithm Class for Time walk calibration
C WireEfficiencyAlgorithm Class for Wire Efficiency estimation
C XTCalibrationAlgorithm Class to perform xt calibration for drift chamber
C CDCDedx1DCellAlgorithm A calibration algorithm for CDC dE/dx electron: 1D enta cleanup correction
C CDCDedx2DCellAlgorithm A calibration algorithm for CDC dE/dx electron 2D enta vs doca correction
C CDCDedxBadWireAlgorithm A calibration algorithm for CDC dE/dx to find the bad wires
C CDCDedxCosEdgeAlgorithm A calibration algorithm for CDC dE/dx electron cos(theta) dependence
C CDCDedxCosineAlgorithm A calibration algorithm for CDC dE/dx electron cos(theta) dependence
C CDCDedxHadBGAlgorithm A calibration algorithm for beta gamma curve and resolution fitting and save payloads
C CDCDedxHadSatAlgorithm A calibration algorithm for hadron saturation
C CDCDedxInjectTimeAlgorithm A calibration algorithm for CDC dE/dx injection time (HER/LER)
C CDCDedxMomentumAlgorithm A calibration algorithm for CDC dE/dx electron cos(theta) dependence
C CDCDedxRunGainAlgorithm A calibration algorithm for CDC dE/dx run gains
C CDCDedxWireGainAlgorithm A calibration algorithm for CDC dE/dx wire gains
C eclAutocovarianceCalibrationC1Algorithm Calibrate covariance matrix for crystals using delayed Bhabha events
C eclAutocovarianceCalibrationC3Algorithm Calibrate covariance matrix for crystals using delayed Bhabha events
C eclAutocovarianceCalibrationC4Algorithm Calibrate covariance matrix for crystals using delayed Bhabha events
C eclBhabhaTAlgorithm Calibrate ecl crystals using bhabha events
C eclCosmicEAlgorithm Class eclCosmiEAlgorithm
C eclEdgeAlgorithm ..Obtain payloads specifying the location of the edges of each ECL crystal
C eclGammaGammaEAlgorithm Calibrate ecl crystals using gamma pair events
C eclLeakageAlgorithm Calculate ECL energy leakage corrections
C eclMergingCrystalEAlgorithm Calibrate ecl crystals using previously created payloads
C eclMergingCrystalTimingAlgorithm Calibrate ecl crystals using previously created payloads
C eclMuMuEAlgorithm Calibrate ecl crystals using muon pair events
C eclNOptimalAlgorithm Algorithm that works with eclNOptimalCollector to find the number of crystals to be summed to get the best energy resolution for each test energy and for each group of crystals (8 groups per thetaID in the barrel)
C eclTValidationAlgorithm Validate the ecl timing calibrations using a hadronic event selection
C eclTimeShiftsAlgorithm Calibrate ecl crystals using previously created payloads
C eclWaveformTemplateCalibrationC1Algorithm Calibrate ecl crystals using gamma pair events
C eclWaveformTemplateCalibrationC2Algorithm Calibrate ecl crystals using gamma pair events
C eclWaveformTemplateCalibrationC3Algorithm Calibrate ecl crystals using gamma pair events
C eclWaveformTemplateCalibrationC4Algorithm Calibrate ecl crystals using gamma pair events
C eclee5x5Algorithm Calibrate ecl crystals using Bhabha events
C EKLMAlignmentAlongStripsAlgorithm EKLM time calibration algorithm
C InvariantMassAlgorithm Class implementing InvariantMass calibration algorithm
C KLMChannelStatusAlgorithm KLM channel status calibration algorithm
C KLMStripEfficiencyAlgorithm KLM channel status calibration algorithm
C KLMTimeAlgorithm KLM time calibration algorithm
C MillepedeAlgorithm Class implementing Millepede calibration algorithm
C MillepedeTreeConversionAlgorithm Creation of a plain TTree with residual and global derivative values from GBL data saved to a ROOT file
C PXDAnalyticGainCalibrationAlgorithm Class implementing the PXD gain calibration algorithm
C PXDChargeCalibrationAlgorithm Class implementing the PXD median cluster charge calibration algorithm
C PXDClusterPositionCalibrationAlgorithm Class implementing the PXD cluster position calibration algorithm
C PXDDataMCGainCalibrationAlgorithm Class implementing the PXD median cluster charge calibration algorithm
C PXDGainCalibrationAlgorithm Class implementing the PXD gain calibration algorithm
C PXDHotPixelMaskCalibrationAlgorithm Class implementing PXD hot pixel masking calibration algorithm
C PXDValidationAlgorithm Class implementing the PXD calibration validation algorithm
C SVD3SampleCoGTimeCalibrationAlgorithm Class implementing SVD3SampleCoGTimeCalibration calibration algorithm
C SVD3SampleELSTimeCalibrationAlgorithm Class implementing SVD3SampleELSTimeCalibration calibration algorithm
C SVDClusterTimeShifterAlgorithm Class implementing SVDClusterTimeShifter algorithm
C SVDCoGTimeCalibrationAlgorithm Class implementing SVDCoGTimeCalibration calibration algorithm
C SVDCrossTalkCalibrationsAlgorithm Class implementing SVDCrossTalkCalibrations calibration algorithm
C SVDHotStripsCalibrationsAlgorithm Class implementing SVDHotStripsCalibrations calibration algorithm
C SVDOccupancyCalibrationsAlgorithm Class implementing SVDOccupancyCalibrations calibration algorithm
C SVDTimeValidationAlgorithm Class implementing SVDTimeValidation algorithm
C SVDdEdxCalibrationAlgorithm Class implementing the SVD dEdx calibration algorithm
C SVDdEdxValidationAlgorithm Class implementing the SVD dEdx calibration algorithm
C TOPAlignmentAlgorithm Algorithm for geometrical alignment of TOP modules with dimuons or Bhabhas
C TOPAsicShiftsBS13dAlgorithm Calibration algorithm for carrier shifts of BS13d
C TOPChannelMaskAlgorithm Algorithm for masking of dead and hot channels
C TOPCommonT0BFAlgorithm Algorithm for common T0 calibration with a fit of bunch finder residuals
C TOPCommonT0LLAlgorithm Algorithm for common T0 calibration with neg
C TOPEventT0OffsetAlgorithm Algorithm for event T0 offset calibration
C TOPFillPatternOffsetAlgorithm Algorithm for calibration of fill pattern offset
C TOPLocalCalFitter This module is the fitter for the CAF collector TOPLaserCalibratorCollector
C TOPModuleT0DeltaTAlgorithm Algorithm for module T0 calibration with chi2 minimization of time differences between slots (method DeltaT)
C TOPModuleT0LLAlgorithm Algorithm for module T0 calibration with neg
C TOPPhotonYieldsAlgorithm Algorithm for photon pixel yields aimed for PMT ageing studies, for calibration of relative pixel efficiencies and for finding optically decoupled PMT's
C TOPPulseHeightAlgorithm Algorithm for pulse-height and threshold efficiency calibration
C TOPValidationAlgorithm Algorithm for automatic validation of the calibration
C TestBoundarySettingAlgorithm Test class implementing calibration algorithm
C TestCalibrationAlgorithm Test class implementing calibration algorithm
C TestDBAccessAlgorithm Test class implementing calibration algorithm
C CalibrationData Parameters and data relevant for single calibration interval
► C Callback
► C AbstractNSMCallback
► C NSMCallback
► C RCCallback
C DqmMasterCallback
C ERecoMasterCallback
C ERecoRunControlCallback
C EventServerCallback
C RFMasterCallback
C RFRunControlCallback
C RoiSenderCallback
C CALogger Simple logger for CA algorithm
C Candidate Structure containing variables relevant to the B-candidate
C CaptureStreamAbortHandler Small class to handle std::abort() calls by external libraries
C CAValidator< CellType > Validation tool for CA algorithm
C CDCAxialSegmentPair Class representing a pair of reconstructed axial segments in adjacent superlayer
C CDCAxialStereoFusion Utility class implementing the Kalmanesk combination of to two dimensional trajectories to one three dimensional trajectory
C CDCBFieldUtil Helper functions to interact with the magnetic field
C CDCChannelData CDCChannelData
C CDCCKFState Define states for CKF algorithm, which can be seed track or CDC wire hit
C CDCCKFStateCreator::CDCCKFWireHitCache Store basic wire info for faster access
C CDCDatabaseImporter CDC database importer
C CDCDedxDatabaseImporter DE/dx database importer
C CDCDedxHadSat Class to hold the hadron saturation functions
C CDCDedxMeanPred Class to hold the prediction of mean as a function of beta-gamma (bg)
C CDCDedxSigmaPred Class to hold the prediction of resolution depending dE/dx, nhit, and cos(theta)
C CDCDedxWidgetCurve Class to hold the beta-gamma (bg) mean function
C CDCDedxWidgetSigma Class to hold the beta-gamma (bg) resolution function
► C CDCDisplayRun
C CDCDebugDisplayRun
C KinkFinderModule::CDCForwardBackwardWallLine Structure to store the information about forward and backward walls of CDC
C CDCGeoControlPar The Class for CDC Geometry Control Parameters
C CDCGeometryLoader Load the CDC geometry from the conditions database
C CDCGeometryPar The Class for CDC Geometry Parameters
► C CDCGeometryTranslatorBase Abstract Base class for the geometry translator
C IdealCDCGeometryTranslator This class uses the ideal detector geometry for the translation of wire IDs into geometric positions
C RealisticCDCGeometryTranslator This class uses the realistic detector geometry (the one after alignment procedure) for the translation of wire IDs into geometric positions
► C CDCHitColorMap
C BackgroundTagColorMap
C MCPDGCodeColorMap
C MCParticleColorMap
C MCPrimaryColorMap
C MCSegmentIdColorMap
C PosFlagColorMap
C RLColorMap
C ReassignedSecondaryMap
C TOFColorMap
C TakenFlagColorMap
C ZeroDriftLengthColorMap
► C CDCHitStrokeWidthMap
C ZeroDriftLengthStrokeWidthMap
C CDCMCCloneLookUp Class providing information whether a PR CDC track is the best match or a clone
C CDCMCHitCollectionLookUp< ACDCHitCollection > Interface class to the Monte Carlo information for collections of hits
► C CDCMCHitCollectionLookUp< CDCSegment2D >
C CDCMCSegment2DLookUp Specialisation of the lookup for the truth values of two dimensional segments
► C CDCMCHitCollectionLookUp< CDCSegment3D >
C CDCMCSegment3DLookUp Specialisation of the lookup for the truth values of two dimensional segments
► C CDCMCHitCollectionLookUp< CDCTrack >
C CDCMCTrackLookUp Specialisation of the lookup for the truth values of reconstructed tracks
C CDCMCHitLookUp Interface class to the Monte Carlo information for individual hits
C CDCMCManager Class to organize and present the Monte Carlo hit information
C CDCMCMap Class to organize and present the Monte Carlo hit information
C CDCMCSegmentLookUp Legacy for python : interface to obtain the two dimensional segment mc lookup
C CDCMCTrackStore Class to organize and present the monte carlo hit information
C CDCObservations2D Class serving as a storage of observed drift circles to present to the Riemann fitter
C CDCRecoHit2D Class representing a two dimensional reconstructed hit in the central drift chamber
C CDCRecoHit3D Class representing a three dimensional reconstructed hit
C CDCRLWireHit Class representing an oriented hit wire including a hypotheses whether the causing track passes left or right
► C CDCRLWireHitPair A pair of oriented wire hits
C CDCTangent Class representing a linear track piece between two oriented wire hits
► C CDCRLWireHitTriple Class representing a triple of neighboring wire hits
C CDCFacet Class representing a triple of neighboring oriented wire with additional trajectory information
C CDCRobustSZFitter Utility class implementing robust versions of linear sz trajectory line fits
► C CDCSegmentColorMap
C SegmentFBInfoColorMap
C SegmentFirstInTrackIdColorMap
C SegmentFirstNPassedSuperLayersColorMap
C SegmentLastInTrackIdColorMap
C SegmentLastNPassedSuperLayersColorMap
C SegmentMCTrackIdColorMap
C CDCSegmentPair Class representing a pair of one reconstructed axial segment and one stereo segment in adjacent superlayer
C CDCSegmentTriple Class representing a triple of reconstructed segments in adjacent superlayer
C CDCSimControlPar The Class for CDC Simulation Control Parameters
C CDCSimHitLookUp Singletone class to gather local information about the hits
C CDCSimpleSimulation Class providing a simple simulation of the CDC mainly for quick unit test checks
► C CDCSVGDisplayModule
C QueueDrawer
C CDCSVGPlotter Helper class to generated the svg image from the various tracking objects
C CDCSVGPlotter
C CDCSZFitter Class implementing the z coordinate over travel distance line fit
C CDCSZObservations Class serving as a storage of observed sz positions to present to the sz line fitters
C CDCTrajectory2D Particle trajectory as it is seen in xy projection represented as a circle
C CDCTrajectory3D Particle full three dimensional trajectory
C CDCTrajectorySZ Linear trajectory in sz space
C CDCTriggerHoughCand Hough Candidates class
C CDCWire Class representing a sense wire in the central drift chamber
C CDCWireHit Class representing a hit wire in the central drift chamber
C CDCWireHit Class representing a hit wire in the central drift chamber
C CDCWireTopology Class representing the sense wire arrangement in the whole of the central drift chamber
C CellularAutomaton< ACellHolder > Implements the weighted cellular automaton algorithm
C CellularPathFollower< ACellHolder > Implements to pick up of the highest value path in neighborhood Following high value paths can be done two ways
C InverseRaytracer::CerenkovAngle Sine and cosine of Cerenkov angle
C ARICHRawDigit::FEBDigit::ChannelDigit Struct for ChannelDigit within FEBDigit struct
C ChannelGroup Channel group
C ChannelMapper Provides mapping between electronic channels and pixels
C CharBuffer Dynamic character buffer that knows its size
C ChebFitter Unbinned Maximum Likelihood fitter with a possibility to use Chebyshev interpolation
C Chi2MinimumFinder1D Minimum finder using tabulated chi^2 values in one dimension
C SVDOnlineToOfflineMap::ChipID Class to hold FADC+APV25 numbers
C SVDOnlineToOfflineMap::ChipInfo Struct to hold data about an APV25 chip
► C Circle2D 2D circle
C Arc2D 2D arc
C Circle2D A two dimensional circle in its natural representation using center and radius as parameters
C CKFResult< ASeed, AHit > Object for temporary storage of a CKF tree search result
► C CKFResult< RecoTrack, SpacePoint >
C CKFToPXDResult Specialized CKF Result for extrapolating into the PXD
C CKFToSVDResult Specialized CKF Result for extrapolating into the SVD
C CKFState< ASeed, AHit > State object to store one step in the CKF algorithm together with its parent (the state before), the hit (e.g
► C CKFState< RecoTrack, SpacePoint >
C CKFToPXDState Specialized CKF State for extrapolating into the PXD
C CKFToSVDState Specialized CKF State for extrapolating into the SVD
C ClassificationAnalysis
C ClassificationOverview
C CleanBasf2Execution
C Clear Functor to get the .clear() from an arbitrary objects
C CleoCones Class to calculate the Cleo clone variables
C ClosedLowerBoundedSet< MinType > Represents a closed lower bounded set of arithmetic types
C ClosedRange< MinType, MaxType > Represents a closed set of arithmetic types
C ClosedUpperBoundedSet< MaxType > Represents an upper bounded set of arithmetic types
C Cluster
C Cluster
C Cluster_t Struct to hold variables for PXD clusters
► C ClusterBase
C Cluster
C ClusterCache Class to remember recently assigned clusters This class will remember the current and the last pixel row to allow fast finding of the correct cluster a pixel belongs to
C ClusterCandidate Class representing a possible cluster during clustering of the PXD It supports merging of different clusters and keeps track of the highest charge inside the cluster
C Const::ClusterDetectors A class that defines the valid set of Cluster detectors
C ClustererParameters Struct containing the parameters for the clustering
C Clusterizend Clustering module
C ClusterProjection Helper struct to collect information about the 1D projection of a Pixel cluster
C ClustersOnSensor Small struct for storing all clusters of the same sensor in one container
C ClusterUtils Class to provide momentum-related information from ECLClusters
C DQMHistComparitorModule::CMPNODE The struct for reference histogram comparison
C Colors Utility functions related to colors
C ColumnFiller Struct to fill the different columns in a sqlite result row into a std::tuple
C CommandIoVsHelper
C CommandLine
C Common< AFunctor > Adapter of a category function to find the common category of several objects
C CompactSecIDs This class provides a computer convenient numbering scheme for the sectors in the sector map and for the N sectors combinations
C CompareCDCTracks Functor which which decides which of two tracks to declare as best match
C CompareMCParticlesByIndex Comparison of MCParticles by index
C compFirst Small helper functor to find a pair in a container of pairs, where .first matches the passed integer COULDDO: make this templated to take any arguments to the pair, instead of only ints and shorts
C compMCId Small helper functor to get the MCVXDPurityInfo with the passed ParticleId from a container of MCVXDPurityInfos
C Composition< AFunctor1, AFunctor2 > Functor factory from the functional composition of two functors
C Cond
C ConditionalGaussGenerator Class implementing n-dimensional random number generator from Gaussian distribution where the first component of the vector is generated first (using some external source) and the remaining components are generated based on the value of the first component
C ConditionsDB
C ConfigFile
C Configuration Class to enable configuration of the conditions database access in C++ and python
C Connection Simple wrapper for a SQLite database connection
C Const This class provides a set of constants for the framework
C array< T >::const_iterator STL iterator class
C map< K, T >::const_iterator STL iterator class
► C vector< T >::const_iterator STL iterator class
C DiscreteValue< T, ATag >
C DiscreteValue< float, ImpactTag >
C DiscreteValue< float, CurvTag >
C DiscreteValue< CurvWithArcLength2DCache, CurvTag >
C DiscreteValue< float, TanLTag >
C DiscreteValue< float, Z0Tag >
C DiscreteValue< Vector2D, Phi0Tag >
C DiscreteValue< float, PTag >
C DiscreteValue< float, QTag >
C DiscreteValue< T, ATag > Representation for a discrete position in an array of discrete positions
C string::const_iterator STL iterator class
► C vector< T >::const_iterator STL iterator class
C DiscreteValue< T, ATag >
C DiscreteValue< float, ImpactTag >
C DiscreteValue< float, CurvTag >
C DiscreteValue< CurvWithArcLength2DCache, CurvTag >
C DiscreteValue< float, TanLTag >
C DiscreteValue< float, Z0Tag >
C DiscreteValue< Vector2D, Phi0Tag >
C DiscreteValue< float, PTag >
C DiscreteValue< float, QTag >
C DiscreteValue< T, ATag > Representation for a discrete position in an array of discrete positions
C array< T >::const_reverse_iterator STL iterator class
C map< K, T >::const_reverse_iterator STL iterator class
C string::const_reverse_iterator STL iterator class
C vector< T >::const_reverse_iterator STL iterator class
C Constant< T > Generic functor to wrap a constant as a function
C Constraint
► C Constraint Class to manage the order of constraints and their filtering
C MergedConstraint Merge multiple constraints that we want to project simultaneously
C ConstraintConfiguration Constraint configuration class
► C Constraints
C CDCLayerConstraints
C CDCTimeZerosConstraint
C CDCWireConstraints
C VXDHierarchyConstraints
C ContinuousValue< T, ATag > Type to have values not based on discrete positions from an array
C NDFinder::ContributionInfo Collection of the hit contribution information needed for the hit to cluster relations
► C Conv2d
C SNConv2d
C copper_footer
C copper_header
C VXDMomentumEstimation< ClusterType >::CorrectionFitParameters Struct holding the parameters of the correction function to map them median of the estimation function to 0
C CountContainer Container for counting accepted and rejected stuff, just delivers some interfaces to make the code more readable
C counter< T > Small class counting usage
C counter< T > Tiny counter class for counting stuff
C counter< T > Tiny counter class for counting stuff
C counterMC< T > Tiny counter class for counting stuff retrieved from MC-bla
C Counters Holds various counters for tracking event, run, and cluster data
C CovarianceMatrixUtil Collection of functions related to covariance matrices
C CovariancePacked Struct to keep upper triangle of the covariance matrix
C TRGCDCLpar::Cpar Private class cpar
C cplacement_t Placement struct
C CppOrPyList Wrapper class for a list of strings to either be held in a std::vector or in a python list
C CprErrorMessage
► C CreatedFilter
► C Chooseable< AFilterFactory::CreatedFilter >
C ChooseableFilter< AFilterFactory > Convenvience wrapper to setup a Chooseable filter from a specific factory object
► C OnVarSet< AFilterFactory::CreatedFilter >
► C Recording< AFilterFactory::CreatedFilter >
► C UnionRecording< AFilterFactory::CreatedFilter >
C UnionRecordingFilter< AFilterFactory > Convenience template to create a recording filter for a filter factory
► C CDCPathFilterFactory::CreatedFilter
► C Chooseable< Belle2::CDCPathFilterFactory::CreatedFilter >
C ChooseableFilter< Belle2::CDCPathFilterFactory >
► C CDCPathPairFilterFactory::CreatedFilter
► C Chooseable< Belle2::CDCPathPairFilterFactory::CreatedFilter >
C ChooseableFilter< Belle2::CDCPathPairFilterFactory >
► C CDCStateFilterFactory::CreatedFilter
► C Chooseable< Belle2::CDCStateFilterFactory::CreatedFilter >
C ChooseableFilter< Belle2::CDCStateFilterFactory >
► C SegmentFilterFactory::CreatedFilter
► C Chooseable< Belle2::TrackFindingCDC::SegmentFilterFactory::CreatedFilter >
C ChooseableFilter< Belle2::TrackFindingCDC::SegmentFilterFactory >
► C SegmentTrackFilterFactory::CreatedFilter
► C Chooseable< Belle2::TrackFindingCDC::SegmentTrackFilterFactory::CreatedFilter >
C ChooseableFilter< Belle2::TrackFindingCDC::SegmentTrackFilterFactory >
► C StereoHitFilterFactory::CreatedFilter
► C Chooseable< Belle2::TrackFindingCDC::StereoHitFilterFactory::CreatedFilter >
C ChooseableFilter< Belle2::TrackFindingCDC::StereoHitFilterFactory >
► C TrackFilterFactory::CreatedFilter
► C Chooseable< Belle2::TrackFindingCDC::TrackFilterFactory::CreatedFilter >
C ChooseableFilter< Belle2::TrackFindingCDC::TrackFilterFactory >
► C TrackQualityFilterFactory::CreatedFilter
► C Chooseable< Belle2::TrackFindingCDC::TrackQualityFilterFactory::CreatedFilter >
C ChooseableFilter< Belle2::TrackFindingCDC::TrackQualityFilterFactory >
► C CreatedFilter
C Chooseable< typename AFilterFactory::CreatedFilter >
► C CreatorBase Pure virtual base class for all geometry creators
C AWESOMEGeometryCreator The creator for the AWESOME detector geometry
C GeoCDCCreator The GeoCDCCreator class
C GeoCDCCreatorReducedCDC The GeoCDCCreatorReducedCDC class
C GeoECLCreator The GeoECLCreator class
C GeoEKLMCreator Class GeoEKLMCreator
C GeoMagneticField The GeoMagneticField class
C GeoKLMCreator The creator for the KLM geometry of the Belle II detector
C MyDBCreator Very simple Creator class which actually does not do anything but shows how creators should implement loading the geometry from database
C GeoTOPCreator Geometry creator for TOP counter
C GeoHeavyMetalShieldCreator The creator for the HeavyMetalShield geometry of the Belle II detector
► C GeoVXDCreator The creator for the VXD geometry of the Belle II detector
C GeoPXDCreator The creator for the PXD geometry of the Belle II detector
C GeoSVDCreator The creator for the SVD geometry of the Belle II detector
C GeoVXDServiceCreator The creator for the VXD Service geometry of the Belle II detector
C GeoARICHBtestCreator The creator for the PXD geometry of the Belle II detector
C GeoARICHCreator The creator for the ARICH geometry of the Belle II detector
C BeamabortCreator The creator for the BEAMABORT geometry
C BgoCreator The creator for the BGO geometry
C GeoBKLMCreator This class creates the BKLM geometry of the Belle II detector
C CaveCreator The creator for the CAVE geometry
C ClawCreator The creator for the CLAW geometry
C CLAWSCreator The creator for the CLAWS geometry
C GeoCOILCreator The GeoCoilCreator class
C CsiCreator The creator for the CSI geometry
C DosiCreator The creator for the DOSI geometry
C FANGSCreator The creator for the FANGS geometry
C He3tubeCreator The creator for the HE3TUBE geometry
C GeoBeamPipeCreator The creator for the BeamPipe geometry of the Belle II detector
C GeoCryostatCreator The creator for the Cryostat geometry of the Belle II detector
C GeoFarBeamLineCreator The creator for the FarBeamLine geometry of the Belle II detector
C MicrotpcCreator The creator for the MICROTPC geometry
C Ph1bpipeCreator The creator for the PH1BPIPE geometry
C Ph1sustrCreator The creator for the PH1SUSTR geometry
C PindiodeCreator The creator for the PINDIODE geometry
C PlumeCreator The creator for the PLUME geometry
C QcsmonitorCreator The creator for the QCSMONITOR geometry
C DiamondCreator The creator for the DIAMOND geometry
C Fei4Creator The creator for the FEI4 geometry
C SddCreator The creator for the SDD geometry
C GeoSTRCreator To create the Belle2 structure geometry
C GeoServiceMaterialCreator The creator for the Service Material geometry of the Belle II detector
C CreatorFactory< T > Very simple class to provide an easy way to register creators with the CreatorManager
C CreatorManager Class to manage all creators and provide factory access
C CRY C++ Interface for the generator CRY
C CryostatElement The struct for CryostatElement
C ECLGeometryPar::CrystalGeom_t Crystal geometry
C crystalInfo Struct to hold relevant Crystal information
C ECLDigitizerModule::crystallinks_t Indices in arrays with info on ECL channels
C ECLDigitizerPureCsIModule::crystallinks_t Indices in arrays with info on ECL channels
C CsiGeometryPar The Class for CSI Geometry Parameters
C curl_t Curl struct
C CurlSession Struct encapsulating all the state information needed by curl
C CurvBinsSpec Strategy to construct discrete curve points from discrete overlap specifications
C CurvWithArcLength2DCache Class representing a curvature value that also caches two dimensional arc length to each layer in the CDC
► C CutClassifier
C CutAtBackgroundRejectionClassifier
C CellularAutomaton< ACellHolder >::CycleException Type for the very basic exception signal used in the detection of cycles
C Daemon
C DAQLogDB
C DAQLogMessage
C SVDPackerModule::data_A Implementation of the first data word
C SVDUnpackerModule::data_A Implementation of the first data word
C SVDPackerModule::data_B Implementation of the second data word
C SVDUnpackerModule::data_B Implementation of the second data word
C data_production
C DataArray Helper class for getting data words from a finesse buffer Keeps checksum counter for each extracted data word and calculates tcp checksum on request
C Database Singleton base class for the low-level interface to the database
C VXDHoughState::DataCache Cache containing the most important information of this state which will often be needed
C DataFlowVisualization Class to visualize data flow between modules
C dataframe_maker< T >
C dataframe_maker< ntuple< T... > >
C SVDPackerModule::DataInfo 6 samples and APV channel struct
► C Dataset Abstract base class of all Datasets given to the MVA interface The current event can always be accessed via the public members of this class
C CombinedDataset Wraps two other Datasets, one containing signal, the other background events Used by the reweighting method to train mc files against data files
C MultiDataset Wraps the data of a multiple event into a Dataset
C ROOTDataset Proivdes a dataset from a ROOT file This is the usually used dataset providing training data to the mva methods
C RegressionDataSet Dataset needed during the training of a regression method
C ReweightingDataset Dataset for Reweighting Wraps a dataset and provides each data-point with a new weight
C SPlotDataset Dataset for sPlot Wraps a dataset and provides each data-point twice, once as signal and once as background
C SidebandDataset Dataset for Sideband Subtraction Wraps a dataset and provides each data-point with a new weight
C SingleDataset Wraps the data of a single event into a Dataset
C SubDataset Wraps another Dataset and provides a view to a subset of its features and events
► C Dataset
C PriorDataLoader
C DataStore In the store you can park objects that have to be accessed by various modules
► C DataStoreEveElementMap_Base
C VisualRepMap::DataStoreEveElementMap Hide implementation in private class
C DataStorePackage
C DataStorePrinter
C DataStoreStreamer Stream/restore DataStore objects to/from EvtMessage
C DATCONSVDClusterCandidate Struct containing a cluster candidate for easier handling
C DATCONSVDDigit The DATCONSVDDigit class
C Date
► C DBAccessorBase Base class for DBObjPtr and DBArray for easier common treatment
C DBArray< Belle2::CDCChannelMap >
C DBArray< Belle2::CDCDisplacement >
C DBArray< Belle2::CDCFEElectronics >
C DBArray< Belle2::ECLDspData >
C DBArray< Belle2::ECLShowerShapeSecondMomentCorrection >
C DBArray< Belle2::TOPChannelMap >
C DBArray< Belle2::TOPFrontEndMap >
► C DBArray< Belle2::TOPPmtInstallation >
C OptionalDBArray< Belle2::TOPPmtInstallation >
► C DBArray< Belle2::TOPPmtQE >
C OptionalDBArray< Belle2::TOPPmtQE >
C DBArray< Belle2::TRGECLFAMPara >
C DBArray< Belle2::TestCalibObject >
C DBObjPtr< Belle2::ARICHGeometryConfig >
C DBObjPtr< Belle2::ARICHMergerMapping >
C DBObjPtr< Belle2::ARICHModulesInfo >
C DBObjPtr< Belle2::ARICHSimulationPar >
C DBObjPtr< Belle2::ARICHChannelMask >
C DBObjPtr< Belle2::ARICHChannelMapping >
C DBObjPtr< Belle2::ARICHCopperMapping >
C DBObjPtr< Belle2::ARICHReconstructionPar >
C DBObjPtr< Belle2::ARICHGlobalAlignment >
C DBObjPtr< Belle2::ARICHMirrorAlignment >
► C DBObjPtr< Belle2::ARICHAeroTilesAlignment >
C OptionalDBObjPtr< Belle2::ARICHAeroTilesAlignment >
C DBObjPtr< Belle2::BeamParameters >
► C DBObjPtr< Belle2::BeamSpot >
C OptionalDBObjPtr< Belle2::BeamSpot >
► C DBObjPtr< Belle2::CollisionBoostVector >
C OptionalDBObjPtr< Belle2::CollisionBoostVector >
► C DBObjPtr< Belle2::CollisionInvariantMass >
C OptionalDBObjPtr< Belle2::CollisionInvariantMass >
► C DBObjPtr< Belle2::CollisionAxisCMS >
C OptionalDBObjPtr< Belle2::CollisionAxisCMS >
C DBObjPtr< Belle2::MagneticField >
C DBObjPtr< Belle2::KLMChannelStatus >
► C DBObjPtr< Belle2::HardwareClockSettings >
C OptionalDBObjPtr< Belle2::HardwareClockSettings >
C DBObjPtr< Belle2::TOPCalChannelMask >
C DBObjPtr< Belle2::CDCTimeZeros >
C DBObjPtr< Belle2::CDCBadWires >
C DBObjPtr< Belle2::CDCBadBoards >
C DBObjPtr< Belle2::CDCPropSpeeds >
C DBObjPtr< Belle2::CDCTimeWalks >
C DBObjPtr< Belle2::CDCXtRelations >
C DBObjPtr< Belle2::CDCSpaceResols >
C DBObjPtr< Belle2::CDCFudgeFactorsForSigma >
C DBObjPtr< Belle2::CDCAlignment >
C DBObjPtr< Belle2::CDCMisalignment >
C DBObjPtr< Belle2::CDCEDepToADCConversions >
C DBObjPtr< Belle2::CDCADCDeltaPedestals >
C DBObjPtr< Belle2::CDCGeometry >
C DBObjPtr< Belle2::CDCCrossTalkLibrary >
C DBObjPtr< Belle2::CDCDedx1DCell >
C DBObjPtr< Belle2::CDCDedxBadWires >
C DBObjPtr< Belle2::CDCDedxWireGain >
C DBObjPtr< Belle2::CDCDedxScaleFactor >
C DBObjPtr< Belle2::CDCDedxMomentumCor >
C DBObjPtr< Belle2::CDCDedxRunGain >
C DBObjPtr< Belle2::CDCDedxInjectionTime >
C DBObjPtr< Belle2::CDCDedxCosineCor >
C DBObjPtr< Belle2::CDCDedx2DCell >
C DBObjPtr< Belle2::CDCDedxHadronCor >
C DBObjPtr< Belle2::CDCDedxADCNonLinearity >
C DBObjPtr< Belle2::CDCDedxCosineEdge >
C DBObjPtr< Belle2::CDCDedxMeanPars >
C DBObjPtr< Belle2::CDCDedxSigmaPars >
C DBObjPtr< Belle2::CDCdEdxPDFs >
► C DBObjPtr< Belle2::CDCAlphaScaleFactorForAsymmetry >
C OptionalDBObjPtr< Belle2::CDCAlphaScaleFactorForAsymmetry >
C DBObjPtr< Belle2::CDCCorrToThresholds >
C DBObjPtr< Belle2::CDCTrigger2DConfig >
C DBObjPtr< Belle2::CDCTriggerNeuroConfig >
► C DBObjPtr< Belle2::CDCTriggerDeadch >
C OptionalDBObjPtr< Belle2::CDCTriggerDeadch >
C DBObjPtr< Belle2::CDCTriggerTSFConfig >
C DBObjPtr< Belle2::ChargedPidMVAWeights >
► C DBObjPtr< Belle2::ECLPhotonEnergyResolution >
C OptionalDBObjPtr< Belle2::ECLPhotonEnergyResolution >
C DBObjPtr< Belle2::DatabaseRepresentationOfWeightfile >
C DBObjPtr< Belle2::DAFConfiguration >
C DBObjPtr< PayloadFile > Specialization of DBObjPtr in case of PayloadFiles
C DBObjPtr< Belle2::KLMElectronicsMap >
C DBObjPtr< Belle2::ECLCrystalCalib >
C DBObjPtr< Belle2::ECLTimeWalkCorrection >
C DBObjPtr< Belle2::ECLHadronComponentEmissionFunction >
C DBObjPtr< Belle2::ECLReferenceCrystalPerCrateCalib >
C DBObjPtr< Belle2::ECLDigitWaveformParameters >
C DBObjPtr< Belle2::ECLChannelMap >
C DBObjPtr< Belle2::ECLChargedPIDMVAWeights >
C DBObjPtr< Belle2::ECLChargedPidPDFs >
C DBObjPtr< Belle2::ECLDigitWaveformParametersForMC >
C DBObjPtr< TTree >
C DBObjPtr< Belle2::ECLLeakageCorrections >
C DBObjPtr< Belle2::ECLnOptimal >
C DBObjPtr< Belle2::ECLTrackClusterMatchingParameterizations >
C DBObjPtr< Belle2::ECLTrackClusterMatchingThresholds >
C DBObjPtr< Belle2::ECLAutoCovariance >
► C DBObjPtr< Belle2::ParticleWeightingLookUpTable >
C OptionalDBObjPtr< Belle2::ParticleWeightingLookUpTable >
► C DBObjPtr< Belle2::EventLimit >
C OptionalDBObjPtr< Belle2::EventLimit >
C DBObjPtr< Belle2::BunchStructure >
C DBObjPtr< Belle2::EventsOfDoomParameters >
► C DBObjPtr< Belle2::TrackFlippingCuts >
C OptionalDBObjPtr< Belle2::TrackFlippingCuts >
C DBObjPtr< Belle2::TRGGDLDBUnpacker >
C DBObjPtr< Belle2::TRGGDLDBBadrun >
C DBObjPtr< Belle2::TRGGRLConfig >
C DBObjPtr< Belle2::GeoConfiguration >
C DBObjPtr< Belle2::BKLMSimulationPar >
► C DBObjPtr< Belle2::KLMTimeCableDelay >
C OptionalDBObjPtr< Belle2::KLMTimeCableDelay >
C DBObjPtr< Belle2::KLMScintillatorDigitizationParameters >
C DBObjPtr< Belle2::KLMScintillatorFEEParameters >
C DBObjPtr< Belle2::KLMScintillatorFirmware >
C DBObjPtr< Belle2::KLMStripEfficiency >
C DBObjPtr< Belle2::KLMTimeWindow >
► C DBObjPtr< Belle2::KLMTimeConstants >
C OptionalDBObjPtr< Belle2::KLMTimeConstants >
► C DBObjPtr< Belle2::KLMTimeResolution >
C OptionalDBObjPtr< Belle2::KLMTimeResolution >
C DBObjPtr< Belle2::KLMTimeConversion >
C DBObjPtr< Belle2::KinkFinderParameters >
C DBObjPtr< Belle2::CKFParameters >
C DBObjPtr< Belle2::KLMLikelihoodParameters >
C DBObjPtr< Belle2::PIDCalibrationWeight >
C DBObjPtr< Belle2::PIDDetectorWeights >
C DBObjPtr< Belle2::PIDNeuralNetworkParameters >
C DBObjPtr< Belle2::PXDClusterShapeIndexPar >
C DBObjPtr< Belle2::PXDClusterPositionEstimatorPar >
C DBObjPtr< Belle2::PXDClusterPositionErrorPar >
C DBObjPtr< Belle2::PXDGainMapPar >
► C DBObjPtr< Belle2::PXDDHHFirmwareVersionPar >
C OptionalDBObjPtr< Belle2::PXDDHHFirmwareVersionPar >
C DBObjPtr< Belle2::PXDMaskedPixelPar >
C DBObjPtr< Belle2::PXDDeadPixelPar >
C DBObjPtr< Belle2::PXDClusterChargeMapPar >
C DBObjPtr< Belle2::ROICalculationParameters >
C DBObjPtr< Belle2::ROISimulationParameters >
C DBObjPtr< Belle2::SVDCalibrationsBase< SVDCalibrationsScalar< SVDCoGCalibrationFunction > > >
C DBObjPtr< Belle2::SVDRecoConfiguration >
C DBObjPtr< Belle2::SVDClusterTimeShifter >
C DBObjPtr< Belle2::SVDAbsoluteClusterTimeShift >
C DBObjPtr< Belle2::PayloadFile >
C DBObjPtr< Belle2::SVDGlobalConfigParameters >
C DBObjPtr< Belle2::SVDCalibrationsBase< SVDCalibrationsScalar< SVDChargeSimCal > > >
C DBObjPtr< Belle2::SVDCalibrationsBase< SVDCalibrationsScalar< SVDClusterCuts > > >
C DBObjPtr< Belle2::SVDCalibrationsBase< SVDCalibrationsScalar< SVDPosErrScaleFactors > > >
C DBObjPtr< Belle2::SVDCalibrationsBase< SVDCalibrationsScalar< SVDPositionErrorFunction > > >
C DBObjPtr< Belle2::SVDCalibrationsBase< SVDCalibrationsBitmap > >
C DBObjPtr< Belle2::SVDDQMPlotsConfiguration >
C DBObjPtr< Belle2::SVDEventT0Configuration >
C DBObjPtr< Belle2::SVDCalibrationsBase< SVDCalibrationsScalar< SVDHitTimeSelectionFunction > > >
C DBObjPtr< Belle2::SVDLocalConfigParameters >
C DBObjPtr< Belle2::SVDCalibrationsBase< SVDCalibrationsScalar< SVDMCFudgeFactorFunction > > >
C DBObjPtr< Belle2::SVDCalibrationsBase< SVDCalibrationsScalar< float > > >
C DBObjPtr< Belle2::SVDCalibrationsBase< SVDCalibrationsVector< float > > >
C DBObjPtr< Belle2::SVDCalibrationsBase< SVDCalibrationsVector< SVDStripCalAmp > > >
C DBObjPtr< Belle2::SVDTimeGroupingConfiguration >
C DBObjPtr< Belle2::SVDSpacePointSNRFractionSelector >
C DBObjPtr< Belle2::VXDAlignment >
C DBObjPtr< Belle2::SoftwareTriggerMenu >
C DBObjPtr< Belle2::DBRepresentationOfSoftwareTriggerCut >
C DBObjPtr< Belle2::TRGGDLDBFTDLBits >
C DBObjPtr< Belle2::TOPGeometry >
C DBObjPtr< Belle2::TOPCalChannelRQE >
C DBObjPtr< Belle2::TOPCalChannelThresholdEff >
C DBObjPtr< Belle2::TOPCalChannelPulseHeight >
C DBObjPtr< Belle2::TOPCalModuleAlignment >
C DBObjPtr< Belle2::TOPFrontEndSetting >
► C DBObjPtr< Belle2::TOPCalTimeWalk >
C OptionalDBObjPtr< Belle2::TOPCalTimeWalk >
C DBObjPtr< Belle2::TOPCalCommonT0 >
► C DBObjPtr< Belle2::TOPCalEventT0Offset >
C OptionalDBObjPtr< Belle2::TOPCalEventT0Offset >
► C DBObjPtr< Belle2::TOPCalFillPatternOffset >
C OptionalDBObjPtr< Belle2::TOPCalFillPatternOffset >
C DBObjPtr< Belle2::TOPCalChannelT0 >
C DBObjPtr< Belle2::TOPCalTimebase >
C DBObjPtr< Belle2::TOPCalAsicShift >
C DBObjPtr< Belle2::TOPCalModuleT0 >
C DBObjPtr< Belle2::TOPCalChannelThreshold >
C DBObjPtr< Belle2::TOPCalChannelNoise >
C DBObjPtr< Belle2::TRGGDLDBInputBits >
C DBObjPtr< Belle2::TRGGDLDBPrescales >
C DBObjPtr< Belle2::TRGGDLDBAlgs >
C DBObjPtr< Belle2::TestCalibMean >
C DBObjPtr< Belle2::TrackFitMomentumRange >
C DBObjPtr< Belle2::COILGeometryPar >
C DBObjPtr< Belle2::BeamPipeGeo >
C DBObjPtr< Belle2::CDCWireHitRequirements >
C DBObjPtr< Belle2::CDClayerTimeCut >
C DBObjPtr< Belle2::SVDdEdxPDFs >
C DBObjPtr< Belle2::PXDdEdxPDFs >
► C DBObjPtr< Belle2::ARICHGeoMergerCooling >
C OptionalDBObjPtr< Belle2::ARICHGeoMergerCooling >
► C DBArray< T > Class for accessing arrays of objects in the database
C OptionalDBArray< T > Optional DBArray : This class behaves the same as the DBArray except that it will not raise errors when an object could not be found in the database
► C DBObjPtr< T > Class for accessing objects in the database
C OptionalDBObjPtr< T > Optional DBObjPtr : This class behaves the same as the DBObjPtr except that it will not raise errors when an object could not be found in the database
C DBObjPtr< PayloadFile > Specialization of DBObjPtr in case of PayloadFiles
C PyDBArray Class to access a DB Array from Python
C PyDBObj Class to access a DBObjPtr from Python
► C DBImportBase Base class for importing objects to the database
C DBImportArray< T > Class for importing array of objects to the database
C DBImportObjPtr< T > Class for importing a single object to the database
C Database::DBImportQuery Struct for bulk write queries
► C DBInterface
C PostgreSQLInterface
C DBObjectLoader
C DBPointer< T, KEY, METHOD, NAME > Class for pointing to an element in an array stored in the database
C DQMHistAnalysisECLSummaryModule::dbr_sts_long_array Structure to get an array of long values from EPICS
C DBRecord
C DBStore Singleton class to cache database objects
C DBStoreEntry Class to hold one entry from the ConditionsDB in the DBStore
C DecayChain This class does a lot of stuff: Build decaytree structure allowing to index particles and handle the filtering of constraints across the tree
C DecayDescriptor The DecayDescriptor stores information about a decay tree or parts of a decay tree
C DecayDescriptorParticle Represents a particle in the DecayDescriptor
C DecayForest Contains several DecayTree objects, which belong all to the same candidate
C DecayHashMap
C DecayNode DecayNode describes the decay of a particle identified by its pdg code, into list of daughters
C DecayParticleNode
C DecayStringDecay Holds the information of a decay
C DecayStringParticle Holds the information of a particle in the decay string
C DecayTree< T > This is a helper class for the MCDecayFinderModule
C DecorrelationMatrix< Ndims > Class holding a Matrix that can be used to decorrelate input data to Machine Learning classifiers
C ZMQLogger::Decrementor Visitor Helper for decrementing a numerical value
C CDCDedxPIDCreatorModule::DEDX Helper structure for merging dEdx measurements
C DedxDriftCell A class to hold the geometry of a cell
► C DEDXEstimationTrainer
► C GroupedDEDXEstimationTrainer
► C FittedGroupedDEDXEstimatorTrainer
► C FunctionFittedGroupedDEDXEstimatorTrainer
C GaussianEstimatorTrainer
C GaussianEstimatorTrainerSQRT
C LandauEstimatorTrainer
C LandauEstimatorTrainerSQRT
C MaximumEstimatorTrainer
C MaximumEstimatorTrainerSQRT
C MedianEstimatorTrainer
C MedianEstimatorTrainerSQRT
C MVADEDXEstimationTrainer
C DedxLine A class to hold the endpoints and slope of a line
C DedxPoint A collection of classes that are useful for making a simple path length correction to the dE/dx measurement for each hit in a CDC cell
C defaults
C DefaultWave A functor to provide a simple model of APV25 strip response
C Clusterizend::DeletionBounds Struct containing the deletion bounds of a omega row
C DeltaRayPDF Parametrization of delta-ray PDF in pixels of single module
C DependencyMap Collect information about the dependencies between modules
C DeprecateProxy Internal class that registers a variable as deprecated
C Deref Functor to get the referenced object from an arbitrary objects
C YScanner::Derivatives Derivatives
► C DesSer A class definition of an input module for Sequential ROOT I/O
C DesSerCOPPER A class definition of an input module for Sequential ROOT I/O
C DesSerPrePC A class definition of an input module for Sequential ROOT I/O
► C Const::DetectorSet For sets of detector IDs in the form of EDetector values
C Const::RestrictedDetectorSet< VXDDetectors >
C Const::RestrictedDetectorSet< TrackingDetectors >
C Const::RestrictedDetectorSet< PIDDetectors >
C Const::RestrictedDetectorSet< ClusterDetectors >
C Const::RestrictedDetectorSet< ASetType > A class for sets of detector IDs whose content is limited to restricted set of valid detector IDs
C DetectorSurface Detector surfaces information
► C DetPlane
C ROIDetPlane ROIDetPlane describes the plane containing a sensor
C DetSurfCylBoundaries Simple class to encapsulate a detector surface's boundaries in cylindrical coordinates
► C dfs_visitor
C cycle_detector Simple struct to check boost graph for cyclic references
C dhc_commode_frame DHH common mode frame data struct
C dhc_dhe_end_frame DHE End frame data struct
C dhc_dhe_start_frame DHH start frame data struct
► C dhc_direct_readout_frame DHC direct readout frame data struct
C dhc_direct_readout_frame_raw DHC RAW direct readout frame data struct
C dhc_direct_readout_frame_zsd DHC Zero suppressed direct readout frame data struct
C dhc_end_frame DHC End frame data struct
C dhc_frame_header_word0 DHC frame header word data struct
C dhc_frames DHC frame wrapper class
C dhc_ghost_frame DHC Ghost frame data struct
C dhc_onsen_roi_frame ONSEN (debug) ROI frame data struct
C dhc_onsen_trigger_frame ONSEN Trigger frame data struct
C dhc_start_frame DHC start frame data struct
► C dict
C HashableCut
C TagFolderRainbowTable
C Digit Class to represent the coordinates of one pixel
C DigitValue Class representing the charge and particle contributions for one pixel
C DirectedNode< EntryType, MetaInfoType > The Node-Class
C DirectedNodeNetwork< EntryType, MetaInfoType > Network of directed nodes of the type EntryType
► C Directive
C RenderDocstring
► C disjunction
C contains_type< T, ntuple< ARGS... > >
► C Domain
C Basf2Domain
C DownloadableDatabase
C Downloader Simple class to encapsulate libcurl as used by the ConditionsDatabase
C DQM
C DQMCommonUtils The class collects utility functions for creating DQM histograms: prepared for PXD , SVD , VXD and Track DQM histograms
► C DQMEventProcessorBase The purpose of this class is to process one event() in DQMHistoModuleBase , which is a base for TrackDQMModule and AlignDQMModule
C AlignDQMEventProcessor The purpose of this class is to process one event() in AlignDQMModule
C TrackDQMEventProcessor The purpose of this class is to process one event() in TrackDQMModule
C DqmMemFile
C DqmSharedMem
C DriftLengthEstimator Helper construct implementing the (re)estimation of the drift length for various hit objects
C DriftTimeUtil Structure to expose some drift time and length functions from the CDCGeometryPar to Python
C DualNumber Simple structure implementing dual numbers which are used for exact evaluation of the derivatives, see https://en.wikipedia.org/wiki/Automatic_differentiation#Automatic_differentiation_using_dual_numbers
C DynamicLoader
C DynTree< AProperties, ASubPropertiesFactory > This is the base class for all hough trees
► C DynTree< WithWeightedItems< ADomain, T >, ADomainDivsion >
► C WeightedParititioningDynTree< WithSharedMark< T >, ADomain, ADomainDivsion >
C WeightedFastHoughTree< T, ADomain, ADomainDivsion > Dynamic tree structure with weighted items in each node which are markable through out the tree
► C WeightedParititioningDynTree< T, ADomain, ADomainDivsion > Type of tree for partitioning the hough space
C WeightedFastHoughTree< AItemPtr, HoughBox, BoxDivision >
► C DynTree< WithWeightedItems< HoughBox, WithSharedMark< AHitPointerType > >, BoxDivision >
► C WeightedParititioningDynTree< WithSharedMark< AHitPointerType >, HoughBox, BoxDivision >
C WeightedFastHoughTree< AHitPointerType, HoughBox, BoxDivision >
► C DynTree< WithWeightedItems< HoughBox, WithSharedMark< AHitPtr > >, BoxDivision >
► C WeightedParititioningDynTree< WithSharedMark< AHitPtr >, HoughBox, BoxDivision >
C WeightedFastHoughTree< AHitPtr, HoughBox, BoxDivision >
C early_stopping
C eb_statistics
C DQMHistAnalysisECLSummaryModule::ECLAlarmType Definition for different ECL alarm types
C ECLChannelMapper This class provides access to ECL channel map that is either a) Loaded from the database (see ecl/dbobject/include/ECLChannelMap.h)
► C ECLCompress Abstract class (interface) for ECL waveform compression/decompression to/from the BitStream storage
C ECLBaseCompress ECL waveform compression/decompression to/from the BitStream storage with the BASE algorithm
C ECLDCTCompress ECL waveform compression/decompression to/from the BitStream storage based on the Discrete Cosine Transform (DCT)
C ECLDeltaCompress ECL waveform compression/decompression to/from the BitStream storage with the DELTA algorithm
C EclConfiguration Singleton class to hold the ECL configuration
C EclConfigurationPure Singleton class to hold the ECL configuration for pure CsI calorimeter
C ECLCrystalData Class for obtaining crystal details for a given crystal cell An evolved look-up table
C EclData This class contains data for ECLSimHit 's and provides several relevant conversion functions for better event display
C ECLDatabaseImporter ECL database importer
C ECLDBTool The ECLDBTool class is designed to read / write object from / to database
C ECLDspUtilities This class contains static methods to make them accessible from pyROOT
C ECLGeometryPar The Class for ECL Geometry Parameters
C ECLLeakagePosition Class to get position information for a cluster for leakage corrections
C ECLLocalRunCalibAcc ECLLocalRunCalibAcc is the class designed to accumulate mean values, standard deviation and number of accepted events
C ECLLocalRunCalibUnit ECLLocalRunCalibUnit is the class designed for the control of mean value and the standard deviation accumulators
C EclNbr EclNbr class
C ECLNeighbours Class to get the neighbours for a given cell id
► C EclPainter Painter for EclData , parent class, created with EclPainterFactory
C EclPainter1D Painter for EclData , 1D histograms
C EclPainter2D Painter for EclData , 2D histograms
C EclPainterCommon Painter for EclData that shows common event characteristics on 1D histograms
C EclPainterPolar Painter for EclData , polar energy/event_count distribution
C EclPainterFactory Class that implements Factory pattern to create objects inherited from EclPainter
C ECLPedestalFit This struct is returned by the pedestalFit
method that fits the first 16 samples of the waveform (pedestal points) to find a peak there (that corresponds to background)
C ECLSampledShaper Digitisation shaper
C ECLShapeFit ShaperDSP fit results from _lftda function
C ECLShowerId Class to convert the shower id into CR, CS and Seed and vice versa
C ECLTimingUtilities Class to storing timing calibration functions
C EDepInGas The Class for Energy deposit in the gas
C RelationIndexContainer< FROM, TO >::Element Element type for the index
C SVDWaveform::ElementaryWaveform Type to store elementary waveform parameters
C EVEVisualization::ElementGroup Group of TEveElements, remembers whether user wants it visible or not
► C Embedding
C SNEmbedding
► C EmptyRun
► C MinimalRun
► C ReadOrGenerateEventsRun
► C StandardEventGenerationRun
C ClusterFilterValidationRun
C FitValidation
C SegmentPairCreationValidationRun
C SegmentQuadTreeRun
C FacetFilterTrainingRun
C FacetRelationFilterTrainingRun
► C ReadOrGenerateTrackedEventsRun
C StandardReconstructionEventsRun
► C TrackingValidationRun
C CombinedSVDTrackingValidation
C CombinedSVDTrackingValidationBkg
C SVDHoughTrackingValidation
C SVDHoughTrackingValidationBkg
C Standalone
C VXDTF2TrackingValidation
C VXDTF2TrackingValidationBkg
C CDCAutomaton
C CDCAutomaton
C CDCCR
C CDCCombined
C CDCCombined
C CDCFull
C CDCFull
C CDCLegendre
C CDCLegendre
C CosmicsAxialHough
C CosmicsHough
C Cosmics
C InvertedFullBkg
C Full
C FullBkg
C fullTrackingValidation_plusECL
C Full
C Muon
C CKFBkg
C toCDCCKFValidationBkg
C toCDCfromEclCKF
C toCDCfromEclCKF
C BackgroundClusterFilterTrainingRun
C FeasibleAxialSegmentPairFilterTrainingRun
C FeasibleSegmentPairFilterTrainingRun
C FeasibleSegmentRelationFilterTrainingRun
C FeasibleTrackRelationFilterTrainingRun
C RealisticAxialSegmentPairFilterTrainingRun
C RealisticSegmentPairFilterTrainingRun
C RealisticSegmentPairRelationFilterTrainingRun
C RealisticSegmentRelationFilterTrainingRun
C RealisticTrackRelationFilterTrainingRun
C SegmentTrackFilterTrainingRun
C TrackFilterTrainingRun
► C PostProcessingRunMixin
► C BrowseTFileOnTerminateRunMixin
C ClusterFilterValidationRun
C SegmentPairCreationValidationRun
C TrackingValidationRun
► C RunMixin
C RootOutputRunMixin
C WireHitPreparerRunMixin
C EndRec End record structure for the beamtest data
C EnergyLossEstimator Helper struct to provide consistent energy loss estimation throughout the CDC track finding
C EnergyLossForExtrapolator Calculate energy loss, fluctuation, and multiple-scattering angle for extrapolator
C EnergyMask A mask for energy masking
C NSMDataStore::Entry
► C Enum
C Connection
C ERRORNo
► C NSMCommand
C RCCommand
C RFCommand
► C NSMState
C RCState
► C Enum
C RunningTagUpdateMode
C DQMModes
C EventDistributionModes
C Location
C RunTypes
C SoftwareTriggerModes
C TestClusterControlDrmaa.SessionMock.JobState
► C Enum
C ComparisonState
C Environment This class stores all environment information required to run the framework, such as module or data filepaths, number of processes to be used in parallel processing etc
► C EnvironmentInformation
C Basf2EnvironmentInformation
C EnvironmentVariables Utility functions related to environment variables
► C Equal Binary functor for equality comparison of arbitrary objects - equivalent to std::equal_to<> (c++14)
C BinaryJoin< Equal, AFunctor1, AFunctor2 >
C EqualVisitor Separate Visitor struct for equal_to comparison of variant<double, int bool>
C ErrCode Abstract errorocode be aware that the default is success
C EvalVariadic Structure to serve as a placeholder for a variadic initializer list of statements to be evaluated
C Event Event containing two tracks
C Event Event containing two tracks
C EKLMAlignmentAlongStripsAlgorithm::Event Event : time, distance from hit to SiPM
C Event Structure containing variables relevant for the hadronic B decays
C Event Event containing two tracks
C KLMTimeAlgorithm::Event Event data
C event_header
C ro_summary::event_header
C ronode_status::event_header
C EventBuffer
C EventDataPlotter A class that can plot event related data types
C EventInspectorPocketDAQ
C EventMetaDataSerialization Helper class for (de)serializing the event meta data used for the event backup transferral
► C EventProcessor Core event processing loop
C HLTEventProcessor EventProcessor to be used on the HLT with all specialities of the HLT processing:
C SubEventModule Framework-internal module that implements the functionality of Path::forEach() as well as Path::doWhile()
C ZMQEventProcessor This class provides the core event processing loop for parallel processing with ZMQ
C pEventProcessor This class provides the core event processing loop for parallel processing
C EventRec Event record structure for the beamtest data
C EventSampler
C EventServer
C EventT0::EventT0Component Structure for storing the extracted event t0s together with its detector and its uncertainty
C EVEVisualization Produces visualisation for MCParticles, simhits, genfit::Tracks, geometry and other things
► C EvtBSemiTauonicAmplitude The base class for the calculation of the spin dependent amplitudes for the BSemiTauonic model based on [M
C EvtBSemiTauonicScalarMesonAmplitude The class calculates the spin dependent amplitudes of B->Dtaunu decays for the BSemiTauonic model based on [M
C EvtBSemiTauonicVectorMesonAmplitude The class calculates the spin dependent amplitudes of B->D*taunu decays for the BSemiTauonic model based on [M
C EvtBSemiTauonicDecayRateCalculator Class to calculate the differential decay rate, R(D) , R(D*) , polarizations of tau and D* using BSTD model based on [M
C EvtBSemiTauonicHelicityAmplitudeCalculator The class calculates the helicity amplitude of semi-tauonic B decays including new physics effects based on [M
C EvtBuffer
► C EvtDecayAmp
C EvtB0toKsKK Register Decay model EvtB0toKsKK
C EvtBCL The class provides the form factors for orbitally excited semileptonic decays
C EvtBSemiTauonic The EvtGen model of semi-tauonic B decays including new physics effects based on [M
C EvtBSemiTauonic2HDMType2 The EvtGen model of semi-tauonic B decays including the charged higgs effect of 2HDM Type2 based on [M
C EvtEtaFullDalitz Class for the simulation of the eta -> pi+pi-pi0 decay with an improved dalitz description
C EvtEtaPi0Dalitz Class for the simulation of the eta -> 3pi0 and eta'->3pi0 decays
C EvtEtaPrimeDalitz Class for the simulation of the eta' -> pi+ pi- eta and pi0 pi0 eta decays
C EvtKnunu The evtgen model to produce B-> K nu nubar decay sample
C EvtKstarnunu_REV The evtgen model to produce B-> Kstar nu nubar decay sample
C EvtBGL The class provides the form factors for orbitally excited semileptonic decays
C EvtBGL2 The class provides the form factors for orbitally excited semileptonic decays
C EvtBToDstarlnuNP Implementation of with new physics contributions and the BGL hadronic form factor parameterization
C EvtHQET3 The class provides the form factors for orbitally excited semileptonic decays
C EvtLLSW The class provides the decay amplitude for orbitally excited semileptonic decays
C EvtPHSPBBMix The class provides routine to decay vector-> particle particle with B0 mixing, coherent B0B0-like mixing if any
C EvtPHSPBMix The class provides routine to decay vector-> particle particle with B0 mixing, handles states with only one neutral B
C EvtVSSBMixNP Routine to decay vector-> scalar scalar with BB-like mixing and decoherence parameter lambda
C EvtVSSBMixSD Routine to decay vector -> scalar scalar with Spontaneous Disentanglement
C EvtYmSToYnSpipiCLEOboost Register Decay model EvtYmSToYnSpipiCLEOboost
C EvtbTosllNPR Description: Implementation of the B->K(*) l^+l^- decays with New Physics contributions and c\bar{c} resonances included at the amplitude level according to the note by Rahul Sinha and Rusa Mandal
► C EvtDecayIncoherent
C EvtBtoXsnunu_FERMI The evtgen model to produce non-resonant B-> Xs nu nubar decay sample
C EvtFlatDaughter The evtgen model to produce flat invariant mass distribution for 2nd and 3rd daughters
► C EvtDecayProb
C EvtPhspCP Register Decay model EvtPhspCP
C EvtGenDecays A class to perform decays via the external EvtGen decay program, see http://evtgen.warwick.ac.uk/ , the program manual provided with the EvtGen distribution, and D
C EvtGenInterface Class to interface EvtGen
C EvtGenModelRegister Class to keep a register of all Belle2 EvtDecayBases
C EvtHeader Header structure of streamed object list
C EvtLinSample Description: The simple helper class to generate arbitrary distribution based on a linear piece-wise approximation of it
C EvtMessage Class to manage streamed object
C EvtPointf Description: struct for 2-dimensional point in the float format instead of double to save memory
► C EvtRandomEngine
C EvtGenFwRandEngine Evtgen random generator
C EvtGenRandom A class to wrap the Pythia random number generator for use by EvtGen
► C EvtSemiLeptonicFF
C EvtBCLFF BCL Form Factors
C EvtBGL2FF The class provides the form factors for semileptonic D and D* decays with full mass dependence
C EvtBGLFF The class provides the form factors for semileptonic D and D* decays with full mass dependence
C EvtHQET3FF The class provides the form factors for semileptonic D & D* decays with full mass dependence
C EvtLLSWFF The class provides the form factors for orbitally excited semileptonic decays
C EvtSocketManager
C EvtSocketRecv
C EvtSocketSend
► C ExamplesTest
C ExamplesTest Extend the examples test class to actually run over the uncategorized examples:
C ExamplesTest Extend the examples test class to actually run over the FEI examples:
C ExamplesTest Extend the examples test class to actually run over the fitting examples:
C ExamplesTest Extend the examples test class to actually run over the GraFEI examples:
C ExamplesTest Extend the examples test class to actually run over the fitting examples:
C ExamplesTest Extend the examples test class to run over the KS selector examples:
C ExamplesTest Extend the examples test class to run over the Lambda selector examples:
C ExamplesTest Extend the examples test class to actually run over the mva examples:
C ExamplesTest Extend the examples test class to actually run over the fitting examples:
C ExamplesTest Extend the examples test class to actually run over the PID calibration examples:
C ExamplesTest Extend the examples test class to actually run over the post mdst identification examples:
C ExamplesTest Extend the examples test class to actually run over the fitting examples:
C ExamplesTest Extend the examples test class to actually run over the reconstruction examples:
C ExamplesTest Extend the examples test class to actually run over the simulation examples:
C ExamplesTest Extend the examples test class to actually run over the tagging examples:
C TutorialsTest
C TutorialsTest
C TutorialsTest
C TutorialsTest
C TutorialsTest
C TutorialsTest
C TutorialsTest
C TutorialsTest
C ExamplesTest Extend the examples test class to actually run over the variable manager examples:
► C Exception
C ClassVersionError
C ErrorWithExtraVariables
C ConstructorNotFoundError
C RunningTagUpdaterError
C InvalidLCAMatrix
► C Error
C ByteAlignError
C CreationError
C InterpretError
C ReadError
C VCDPhaseError
► C exception STL class
► C Exception
C DynamicLoadException
► C IOException
C DBHandlerException
► C NSMHandlerException
C NSMNotConnectedException
► C RCHandlerException
C RCHandlerFatalException
C TimeoutException
► C runtime_error STL class
C EventProcessor::StoppedBySignalException Exception thrown when execution is stopped by a signal
C FitParameterDimensionException Exception template, runtime_error implements what()
C SQLiteError Simple error class to be thrown if there is any sqlite error on any of the operations
C CalibrationAlgorithm::ExecutionData A class to hold all data that is needed ONLY for the most recent single execution of the algorithm
C Executor
► C Expert Abstract base class of all Expert Each MVA library has its own implementation of this class, so all libraries can be accessed via this common interface
C RegressionExpert< FastBDTExpert, RegressionFastBDTOptions >
C CombinationExpert Expert for the Combination MVA method
C FANNExpert Expert for the FANN MVA method
C FastBDTExpert Expert for the FastBDT MVA method
C ONNXExpert Expert for the ONNX MVA method
C PDFExpert Expert for the PDF MVA method
C PythonExpert Expert for the Python MVA method
C RegressionExpert< BaseClassifierExpert, RegressionClassifierOptions > Generic expert for the regression applications
C ReweighterExpert Expert for the Reweighter MVA method
► C TMVAExpert Expert for the TMVA MVA method
C TMVAExpertClassification Expert for the TMVA Classification MVA method
C TMVAExpertMulticlass Expert for the TMVA Multiclass MVA method
C TMVAExpertRegression Expert for the TMVA Regression MVA method
C TrivialExpert Expert for the Trivial MVA method
C ExporterEventInfo Bundles information for a single event to be stored by NonRootDataExportModule
C ExporterHitInfo Bundles information for a single hit to be stored by EventInfo (needed for HitExporter, which is needed by NonRootDataExportModule)
C ExporterTcInfo Bundles information for a single track candidate to be stored by EventInfo (needed for HitExporter, which is needed by NonRootDataExportModule)
C ExpRun Struct containing exp number and run number
C ExpRunEvt Struct with expNum, runNum, evtNum
► C ExtendedRiemannsMethod Class implementing the Riemann fit for two dimensional trajectory circle
► C CDCFitter2D< Belle2::TrackFindingCDC::ExtendedRiemannsMethod >
C CDCRiemannFitter Class implementing the Riemann fit for two dimensional trajectory circle
C ExtManager It is the main interface for the user to define the setup and start the propagation
C ExtState Data structure to define extrapolation state
C FacetFitter Utility class to fit hit triplet and relations of them
C EvtGenModelRegister::Factory< MODEL > Helper Class to easily register new EvtDecayBases for Belle2
C Factory This class is used for creating TH1F and TH2F objects
C SVDPackerModule::FADCTrailer Implementation of FADC Trailer
C SVDUnpackerModule::FADCTrailer Implementation of FADC Trailer
C ScriptStatus.failed
► C false_type
C DetectPropertyImpl< ToVoid< AToPredicate< Ts... > >, AToPredicate, Ts... > Implementation of the detection idiom - specialisation for the detected case
► C all_same< T, types ... >
C all_same< T, T, types ... > The all_same struct is meant to check that all the types in a template pack are of the same type
C all_same< > The all_same struct is meant to check that all the types in a template pack are of the same type
C all_same< T > The all_same struct is meant to check that all the types in a template pack are of the same type
C all_same< T, T, types ... > The all_same struct is meant to check that all the types in a template pack are of the same type
C contains_type< T, ntuple< ARGS... > >
C DetectPropertyImpl< typename, class,... > Implementation of the detection idiom - base case is not detected
C all_same< types > The all_same struct is meant to check that all the types in a template pack are of the same type
C contains_type< T, Ntuple >
C FarBeamLineElement The struct for FarBeamLineElement
C fast_equal_frequency_binning
C FBDTTrainSample< Ndims > Bundle together the classifier input and the target value into one struct for easier passing around
C TOPRawWaveform::FeatureExtraction Feature extraction data
C ARICHRawDigit::FEBDigit Struct for front-end board
C FileCatalog This class provides an interface to the file (metadata) catalog
► C FileDescriptor
C Fifo
C File
C Inotify
C TCPServerSocket
C TCPSocket
C UDPSocket
C FileHandler
C FileSystem Utility functions related to filename validation and filesystem access
C Filter< typePack > This class is used to select pairs, triplets... of objects
C Filter< Belle2::OperatorAnd, FilterA, FilterB, templateObserverType > Realization of the AND operator between two objects of the Filter class
C Filter< Belle2::OperatorNot, someFilter, templateObserverType > Realization of a NOT operator for the Filter classes
C Filter< Belle2::OperatorOr, FilterA, FilterB, templateObserverType > Realization of the OR operator between two objects of the Filter class
► C Filter< Variable, RangeType, Observer > Basic Filter ///
C Filter< Variable, RangeType, Belle2::ActivatableFilter, Observer > Activatable Filter /// TODO: Remove, as it is no longer used...?
C Filter< Variable, RangeType, Belle2::BypassableFilter, Observer > Bypassable Filter ///
C FilterExceptions Exception which are thrown by members of the FilterClasses
C FilterFactory< AFilter > Factory that can create appropriate filter instances from a name
► C FilterFactory< BaseAxialSegmentPairFilter >
C AxialSegmentPairFilterFactory Factory that can create appropriate axial segment pair filters from associated names
► C FilterFactory< BaseCDCPathFilter >
C CDCPathFilterFactory Factory that can create appropriate cluster filters from associated names
► C FilterFactory< BaseCDCPathPairFilter >
C CDCPathPairFilterFactory Factory that can create appropriate cluster filters from associated names
► C FilterFactory< BaseCDCStateFilter >
C CDCStateFilterFactory Factory that can create appropriate cluster filters from associated names
► C FilterFactory< BaseClusterFilter >
C ClusterFilterFactory Factory that can create appropriate cluster filters from associated names
► C FilterFactory< BaseFacetFilter >
C FacetFilterFactory Factory that can create appropriate facet filters from associated names
► C FilterFactory< BaseFacetRelationFilter >
C FacetRelationFilterFactory Factory that can create appropriate facet relation filters from associated names
► C FilterFactory< BasePathFilter >
C PathFilterFactory Factory that can create appropriate cluster filters from associated names
► C FilterFactory< BasePXDPairFilter >
C PXDPairFilterFactory Factory that can create appropriate cluster filters from associated names
► C FilterFactory< BasePXDResultFilter >
C PXDResultFilterFactory Factory that can create appropriate cluster filters from associated names
► C FilterFactory< BasePXDStateFilter >
C PXDStateFilterFactory Factory that can create appropriate cluster filters from associated names
► C FilterFactory< BaseRelationFilter >
C RelationFilterFactory Factory that can create appropriate filters for relations between hits from associated names
► C FilterFactory< BaseSegmentFilter >
C SegmentFilterFactory Factory that can create appropriate segment filters for new tracks from associated names
► C FilterFactory< BaseSegmentPairFilter >
C SegmentPairFilterFactory Factory that can create appropriate segment pair filters from associated names
► C FilterFactory< BaseSegmentPairRelationFilter >
C SegmentPairRelationFilterFactory Factory that can create appropriate segment pair relation filters from associated names
► C FilterFactory< BaseSegmentRelationFilter >
C SegmentRelationFilterFactory Factory that can create appropriate segment relation filters from associated names
► C FilterFactory< BaseSegmentTrackFilter >
C SegmentTrackFilterFactory Factory that can create appropriate segment to track combinations filters from associated names
► C FilterFactory< BaseSegmentTripleFilter >
C SegmentTripleFilterFactory Factory that can create appropriate segment triple filters from associated names
► C FilterFactory< BaseSegmentTripleRelationFilter >
C SegmentTripleRelationFilterFactory Factory that can create appropriate segment triple relation filters from associated names
► C FilterFactory< BaseStereoHitFilter >
C StereoHitFilterFactory Factory that can create appropriate stereo hit to track combination filters from associated names
► C FilterFactory< BaseSVDPairFilter >
C SVDPairFilterFactory Factory that can create appropriate cluster filters from associated names
► C FilterFactory< BaseSVDResultFilter >
C SVDResultFilterFactory Factory that can create appropriate cluster filters from associated names
► C FilterFactory< BaseSVDStateFilter >
C SVDStateFilterFactory Factory that can create appropriate cluster filters from associated names
► C FilterFactory< BaseTrackFilter >
► C TrackFilterFactory Factory that can create appropriate track filters from associated names
C TrackQualityFilterFactory Derived class of TrackFilterFactory with a truth target that also discards clones Probably this whole class could be removed if TrackFilterFactory would be templated with the type of the TruthVarSet as a template argument
► C FilterFactory< BaseTrackletFilter >
C TrackletFilterFactory Factory that can create filters for tracklets = SpacePointTrackCands from associated names
► C FilterFactory< BaseTrackRelationFilter >
C TrackRelationFilterFactory Factory that can create appropriate track relation filters from associated names
► C FilterFactory< BaseWireHitFilter >
C WireHitFilterFactory Factory that can create appropriate wireHit filters from associated names
C FilterID Class to identify a filter type used by sectorFriends
C FilterMill< PointType > Small class which stores the filters/selectionVariables to be used for a secMap and has an interface for applying them
C FilterParamMap Variant of types allowed to be forwarded to a filter selected at runtime
C FilterProperties
C FiltersContainer< point_t > This class contains everything needed by the VXDTF that is not going to change during a RUN, i.e
C FilterValueDataSet< SecIDSetType > Relevant information needed for filling a TTree containing train-data for the secMap
C FinalTriggerDecisionCalculator Helper class to give the getFinalTriggerDecision to python
C ScriptStatus.finished
C FirstOfPairInBox< AHitInBoxAlgorithm > Helper class to redirect only the first element in a pair to the child algorithm
C FirstTypeImpl< ATypes > Helper type to take the first type of a variadic sequence of types
C FirstTypeImpl< AType > Specialisation where there is exactly one type given
C FirstTypeImpl< AType, ATypes... > Specialisation where there is more than one type given
C FirstTypeImpl<> Specialisation where there is exactly one type given
C FitManager This class
C VXDMomentumEstimation< ClusterType >::FitParameters Struct holding the parameters of the estimation function which maps dEdX to p
C FitParams Class to store and manage fitparams (statevector)
C EclConfiguration::fitparams_t Struct for the fit parameters
C EclConfigurationPure::fitparamspure_t A struct for the fit parameters for a single channel of the pure CsI calorimeter (in the simulation, all calorimeter channels normally use the same set of fit parameters)
C TOPTemplateFitter::FitResult Structure holding values from template fit
C NewV0Fitter::FittedTrack Structure to save track data of the last successful iteration
C Fitter3DUtility A class that holds functions for 3D tracking
► C FlightTimeEstimator Helper struct to provide consistent flight time estimation throughout the CDC track finding
C BeamEventFlightTimeEstimator Concrete estimator for the regular beam event setup
C CosmicRayFlightTimeEstimator Concrete estimator for the cosmic ray setup - estimates negative times on incoming arm
C FlowMonitor
C Fork
► C Formatter
C DefaultValueFormatter
► C Formatter
C TolerateMissingKeyFormatter
► C FormulaParserBase Base class with the non-templated part of the formula parser
C FormulaParser< VariableConstructor > FormulaParser to parse a text formula like "a + b * c ^ d" where the separate parts can be either variables (with and without arguments) or numbers
C FourHitFilters The class 'FourHitFilters ' bundles filter methods using 4 hits which are stored in B2Vector3Ds
C FourHitVariables Class that allows the calculation of simple variables to estimate the quality of two triplets of hits using four hits
C FourVector Yet another four vector class, with metric +—
C FoxWolfram Class to calculate the Fox-Wolfram moments up to order 8
C FpgaUtility A class that holds FPGA related functions
C Framework This class combines all subsystems of the framework, and exports the main interface to Python
C FrontEndMapper Provides mapping between electronics module position within a TOP module and SCROD ID, COPPER and Finesse slot
C SVDPackerModule::FTBHeader Implementation of FTB Header
C SVDUnpackerModule::FTBHeader Implementation of FTB Header
C SVDPackerModule::FTBTrailer Implementation of FTB Trailer
C SVDUnpackerModule::FTBTrailer Implementation of FTB Trailer
C FullSecID Class to identify a sector inside of the VXD
C FunBoost Functor to minimize median of residuals^2
C SelectionVariable< templateArgumentType, Nargs, templateReturnType >::FunctionOf< n, returnType, parameterType, Ts > This struct is an internal utility
C SelectionVariable< templateArgumentType, Nargs, templateReturnType >::FunctionOf< 0, returnType, parameterType, Ts... > This struct is an internal utility
C FunctorTag Tag class to facilitate marking of class as a functor in the sense of this code
► C G4CSGSolid
C BelleCrystal Belle crystal in Geant4
C BelleLathe BelleLathe class
► C G4EquationOfMotion
C G4MonopoleEquation Monopole equation of motion class
► C G4ErrorSurfaceTarget
C ExtCylSurfaceTarget Defines a closed cylinder for the geant4e "target", the surface that encloses the volume within which track extrapolation is done
► C G4MagneticField
C MagneticField The Class for the Belle2 magnetic field implementation for Geant4
C G4MonopoleFieldSetup Monopole field setup singleton class, that takes care of switching between conventional particle transportation and monopole transportation
► C G4ParticleDefinition
C G4LongLivedNeutral A class to hold long-lived neutral particle description
C G4Monopole A class to hold monopole description as a particle
► C G4Polyhedron
C PolyhedronBelleCrystal Belle crystal in polyhedron
C PolyhedronBelleLathe Belle lathe polyhedron
► C G4RunManager
C RunManager The run manager controls the flow of the Geant4 program and manages the event loop(s) within a run
C G4SafeNavigator Guards against leaving the physical volume
C G4TriangularPrism Triangular prism
► C G4UImessenger
C ExtMessenger Define the mechanism by which the user can communicate with the geant4e extrapolator using geant4 UI commands
► C G4UserEventAction
C EventAction The Event Action class
► C G4UserStackingAction
C StackingAction The basf2 stacking action
► C G4UserSteppingAction
► C MaterialScanBase Base class for Material Scans
► C MaterialScan2D Base class to create a Material Scan of the detector geometry
C MaterialScanPlanar Specific implementaion of MaterialScan to scan parallel to a given plane
C MaterialScanSpherical Specific implementation of MaterialScan to do Spherical scanning
C MaterialScanRay MaterialScan implementation to shoot one ray along a defined direction and record the Material as a function of travel depth
C SteppingAction The Class for the stepping action
C TRGCDCSteppingAction A class to control a track in G4
► C G4UserTrackingAction
C TrackingAction The Tracking Action class
► C G4VContinuousProcess
C ExtEnergyLoss Define physics process to calculate energy loss without fluctuations
► C G4VDiscreteProcess
C ExtMagFieldLimitProcess Defines the physics process that avoids hit invocation in sensitive volumes
C ExtStepLengthLimitProcess Defines the physics process that avoids hit invocation in sensitive volumes
► C G4VEmFluctuationModel
C G4mplIonisationWithDeltaModel Concrete monopole ionisation model
► C G4VEmModel
C G4mplIonisationWithDeltaModel Concrete monopole ionisation model
► C G4VEnergyLossProcess
C G4mplIonisation Monopole ionisation class
► C G4VExceptionHandler
C Geant4MaterialInterfaceExceptioHandler This class implements a custom exception handler for Geant4 which is used to record whether a critical exception occurred when calling the G4Navigator
C StepExceptionHandler Class to handle G4Exception raised during PropagateOneStep()
► C G4VModularPhysicsList
C Belle2PhysicsList Custom Geant4 physics list for Belle II with options to add optical physics, standard EM physics and high precision neutrons
C ExtPhysicsList Standalone physics list for the geant4e extrapolator
C PhysicsList The basf2 physics list
► C G4VPhysicsConstructor
C G4LongLivedNeutralPhysics LongLivedNeutral physics Class – to be registered in the physics list
C G4MonopolePhysics Monopole physics class to register on the physics list
C AntiBaryonPhysics Anti-baryon hadronic physics constructor for Belle II physics list
C ExtPhysicsConstructor Define geant4e-specific physics
C GammaLeptoNuclearPhysics Gamma-nuclear, electro-nuclear and muon-nuclear physics constructor for Belle II physics list
C Geant4ePhysics Define geant4e-specific physics
C HyperonPhysics Hyperon hadronic physics constructor for Belle II physics list
C IonPhysics Ion hadronic physics constructor for Belle II physics list
C KaonPhysics Kaon hadronic physics constructor for Belle II physics list
C NeutronPhysics Neutron hadronic physics constructor for Belle II physics list
C PionPhysics Pion hadronic physics constructor for Belle II physics list
C ProtonPhysics Proton hadronic physics constructor for Belle II physics list
► C G4VPrimaryGenerator
C MCParticleGenerator This class creates Geant4 primary particles from MCParticle list The generator assumes that each particle in the list has exactly one mother
► C G4VProcess
C G4LongLivedNeutralTransportation Concrete class that does the geometrical transport
C G4MonopoleTransportation Concrete class that does the geometrical transport
► C G4VRestDiscreteProcess
C G4LongLivedNeutralDecay This class is a decay process
► C G4VSensitiveDetector
► C SensitiveDetectorBase Base class for all Sensitive Detectors to create hits during simulation
C AWESOMESensitiveDetector Sensitive Detector implementation of the AWESOME detector
C BkgSensitiveDetector The Class for BeamBackground Sensitive Detector
C CDCSensitiveDetector The Class for CDC Sensitive Detector
C BkgSensitiveDiode Class for ECL Sensitive Detector for neutron background study
C SensitiveDetector Class for ECL Sensitive Detector
C SensitiveDiode Class for ECL Sensitive Detector
C SensitiveDetector KLM sensitive-detector class
C SensitiveBar Class providing information on MCParticles hitting the bars
C SensitivePMT Class providing SimHits
► C SensitiveDetectorBase Base class for Sensitive Detector implementation of PXD and SVD
C SensitiveDetector< PXDSimHit, PXDTrueHit >
C SensitiveDetector< SVDSimHit, SVDTrueHit >
C SensitiveDetector< SimHitClass, TrueHitClass > Sensitive Detector implementation of PXD and SVD
C SensitiveAero This is optional (temporary) class that provides information on track parameters on aerogel plane, until tracking is not prepared
C SensitiveDetector The Class for ARICH Sensitive Detector
C SensitiveDetector Sensitive Detector implementation of the BEAMABORT detector
C SensitiveDetector Sensitive Detector implementation of the BGO detector
C SensitiveDetector Sensitive Detector implementation of the CAVE detector
C SensitiveDetector Sensitive Detector implementation of the CLAW detector
C SensitiveDetector Sensitive Detector implementation of the CLAWS detector
C SensitiveDetector Sensitive Detector implementation of the CSI detector
C SensitiveDetector Sensitive Detector implementation of the DOSI detector
C SensitiveDetector Sensitive Detector implementation of the FANGS detector
C SensitiveDetector Sensitive Detector implementation of the HE3TUBE detector
C SensitiveDetector The IR Sensitive Detector class
C SensitiveDetector Sensitive Detector implementation of the MICROTPC detector
C SensitiveDetector Sensitive Detector implementation of the PH1BPIPE detector
C SensitiveDetector Sensitive Detector implementation of the PH1SUSTR detector
C SensitiveDetector Sensitive Detector implementation of the PINDIODE detector
C SensitiveDetector Sensitive Detector implementation of the PLUME detector
C SensitiveDetector Sensitive Detector implementation of the QCSMONITOR detector
C SensitiveDetector Sensitive Detector implementation of the SRSENSOR detector
► C G4VSteppingVerbose
C StepTiming Class to perform more detailed timing studies of the Geant4 simulation
► C G4VUserDetectorConstruction
C DetectorConstruction Class responsible to connect to geometry to simulation
► C G4VUserPrimaryGeneratorAction
C PrimaryGeneratorAction Inherits from G4VuserPrimaryGeneratorAction and specifies how a primary event should be generated
► C G4VUserPrimaryParticleInformation
C UserInfo< G4VUserPrimaryParticleInformation, MCParticleGraph::GraphParticle & >
► C G4VUserTrackInformation
C UserInfo< G4VUserTrackInformation, MCParticleGraph::GraphParticle & >
C TOPNominalTTS::Gauss Gaussian distribution parameters
C TOPPDFCollection::Gaussian Parameters to describe a Gaussian
C TOPPmtTTSPar::Gaussian Gaussian distribution parameters
C DeltaRayPDF::GausXY Normal (Gaussian) distribution: an entry for the table
► C GblTrackSegmentController
C GblMultipleScatteringController TrackSegmentController for use with GblFitter in Belle2
C GenB0Tag Class to determine generated decay mode of B0 and B0bar
C GenBplusTag Class to determine generated decay modes of B+ and B-
C GenBsTag Class to determine generated decay mode of Bs0 and Bs0bar
C GenDTag Class to determine generated decay mode of D*, Ds, D0, D+, and their anti-particles
C GeneralCut< AVariableManager > This class implements a common way to implement cut/selection functionality for arbitrary objects
C GeneralizedCircle A generalized circle
C GeneralVector< T > 3-vector with members of arbitrary type, especially members can be dual numbers
C GenericLockGuard< AMutex > Lock Guard for a Mutex instance
C GenTauTag Class to determine generated decay mode of tau+ and tau-
C GeoCache Class to facilitate easy access to sensor information of the VXD like coordinate transformations or pitch size
C GeometryManager Class to manage the creation and conversion of the geometry
C GeometryPar Provides BKLM geometry parameters for simulation, reconstruction etc (from Gearbox or DataBase)
C GeoTools The class collects utility functions for numbering layers, sensors snd chips based on current VXD geometry
C GeoVXDAssembly Class to group some Geant4 volumes and place them all at once with a given transformation matrix
C GeoVXDRadiationSensors Class to create the diamond radiation sensor geometry if defined
C Get< I > Functor to get the I part (as of std::get<I>
) from an arbitrary objects
C GetArcLength Helper Functor to get the arc length of a given result
C GetAutomatonCell Getter functor for the automaton cell of an object
C GetEStereoKind Generic functor to get the stereo kind from an object
C GetILayer Generic functor to get the superlayer id from an object
C GetIndexInTuple< AType, ATuple > Looks up, at which index the given Type can be found in a tuple
C GetISuperLayer Generic functor to get the superlayer id from an object
C GetLowerCurv Functor to get the lower curvature bound of a hough box
C GetUpperCurv Functor to get the upper curvature bound of a hough box
C GetWeight Generic functor to get the weight from an object
C GetWireHit Generic functor to get the wire hit from an object
C GlobalCalibrationManager Class to hold hierarchy of whole Belle2
► C GlobalDeformation
C Bowing
C Clamshell
C Curl
C Elliptical
C RadialExpansion
C Skew
C Telescope
C Twist
C ZExpansion
C GlobalDerivatives Class for easier manipulation with global derivatives (and their labels)
► C GlobalDerivativesHierarchy Class for alignment/calibration parameter hierarchy & constraints
C LorentShiftHierarchy 1D Hierarchy for Lorentz shift correction
C RigidBodyHierarchy 6D Hierarchy of rigid bodies
C GlobalLabel Class to convert to/from global labels for Millepede II to/from detector & parameter identificators
C GlobalNames Bundles filter methods using 2 hits
► C GlobalParamSetAccess Base accessor class to store different DBObjects e.g
C GlobalParamSet< Belle2::alignment::EmptyGlobalParamSet >
C GlobalParamSet< DBObjType > Template class for generic access to DB objects
C GlobalParamTimeLine Convenient class to automatically create payloads from allowed time dependence of parameter, load their value from database, update the constants one by one usually from Millepde result) and output the final payloads (including EventDependencies) such that one can store them (updated) in the database
C GlobalParamVector The central user class to manipulate any global constant in any DB object Used to retrieve global parameters from database and access the for update
C GlobalProcHandler A class to manage processes for parallel processing
C GraFEIIgniteTrainer
► C grammar
C DecayStringGrammar< Iterator > This class describes the grammar and the syntax elements of decay strings
► C Greater Binary functor for greater comparison of arbitrary objects - equivalent to std::greater<> (c++14)
C BinaryJoin< Greater, AFunctor1, AFunctor2 >
C TEclEnergyHit::greater_CellId Struct greater_CellId
C TEclEnergyHit::greater_Energy Struct greater_Energy
C GRLNeuro Class to represent the GRL Neuro
C GroupProxy Internal class that registers a variable group with Manager when constructed
C h2m_footer_t
C h2m_header_t
C HadronBgPrep Class to prepare sample for fitting in beta gamma bins
C HadronCalibration Class to perform the fitting in beta gamma bins
C HadronPrep Class to prepare sample for hadron saturation calibration
C HadronSaturation Class to perform the hadron saturation calibration
C HarmonicMoments Class to calculate the Harmonic moments up to order 8 with respect to a given axis
► C HarvestingRun
C ElossHarvestingRun
C LegendreBinningValidationRun
C SegmentFitValidationRun
C hash< Belle2::SubGraphID > Customized hash-function for being able to use unordered_map
C hash< std::set< int > > Hash function used by unordered_set
C EventBuffer::Header
C NSMDataPaket::Header
C NSMDataStore::Header
C SharedEventBuffer::Header
C CDCTriggerMLPData::HeaderSet
► C Helix Helix parameter class
C CDCTriggerTrack Track created by the CDC trigger
C UncertainHelix This class represents an ideal helix in perigee parameterization including the covariance matrix of the 5 perigee parameters
C Helix Extension of the generalized circle also caching the perigee coordinates
C HelixHelper Helper class representing a helical track
C HelixSwimmer Utility for propagation of a particle along helix
C HelixUtils Utility for helix<->x,p conversions
C hepevt_type HEPEVT common block of PYTHIA6
C HepevtReader Class to read Hepevt files and store the content in a MCParticle graph
C HepMCReader Class to read HepMC files and store the content in a MCParticle graph
► C HepRandomEngine
C RandomEngine Interface class to make Geant4 use the Belle2 RandomGenerator
C HistDelta Class to keep track of delta histograms
C HistObject Class to keep track of delta histograms
C HistogramMapping Utility to store received histograms (hierarchical tree structures) from clients (as an event message), with a function to add multiple histogram trees together
C Histograms
C HistoManager
C HistoManager2
C HistoRelay
C HistoRelay2
C HistoServer
C HistoServer2
C Hit Structure to hold some of the calpulse data
C TimeDigitizer::Hit Hit data other than time
C SensitiveDiode::hit_t Simple hit structure
C KLMDQM2Module::HitData Hit data
C KLMStripEfficiencyCollectorModule::HitData Hit data
C HitInfo Struct containing the track segment (hit) information from the Track Segment Finder (TSF)
C TOPLaserHitSelectorModule::hitInfo_t Structure to hold hit information, used in double cal
C HitInHyperBox An algorithm to check if a hit is contained in a hyperbolic cosine hough box
C HitInQuadraticBox Predicate class to check for the containment of hits in a p q hough space part
C HitInZ0TanLambdaBox Predicate class to check for the containment of hits in a z0 tan lambda hough space part
C HitInZ0TanLambdaBoxUsingZ Predicate class to check for the containment of hits in a z0 tan lambda hough space part using a different algorithm than normal
C FilterMill< PointType >::HitPair Small struct containing pointers to two hits
C HitPatternCDC Hit pattern of CDC hits within a track
C HitPatternVXD Hit pattern of the VXD within a track
C FilterMill< PointType >::HitQuadruplet Small struct containing pointers to four hits
► C HitRateBase Abstract base class for monitoring beam background hit rates All the monitoring classes must inherit from this one
C ARICHHitRateCounter Class for monitoring beam background hit rates of ARICH
C CDCHitRateCounter Class for monitoring beam background hit rates of CDC
C ECLHitRateCounter Class for monitoring beam background hit rates of ECL
C KLMHitRateCounter Class for monitoring beam background hit rates of EKLM
C PXDHitRateCounter Class for monitoring beam background hit rates of PXD
C SVDHitRateCounter Class for monitoring beam background hit rates of SVD
C TOPHitRateCounter Class for monitoring beam background hit rates of TOP
C ReattachCDCWireHitsToRecoTracksModule::HitToAddInfo Internal structure to store the information about a hit to be added
C FilterMill< PointType >::HitTriplet Small struct containing pointers to three hits
C HLTFile
C HLTMainLoop
C HLTSocket
C HLTStreamHelper Helper class for data store serialization
C HopfieldNetwork Hopfield Algorithm with number based inputs
C Hough3DFinder A class to finded stereo TS hits related to 2D tracks
C CDCTrigger3DFitterModule::HoughVoter Class for the Hough voter
► C ICalibrationParametersDerivatives
C AlignableBKLMRecoHit Alignable BKLM hit
C AlignableCDCRecoHit This class is used to transfer CDC information to the track fit and Millepede
C AlignableEKLMRecoHit Alignable EKLM hit
C AlignablePXDRecoHit This class is used to transfer PXD information to the track fit
C AlignableSVDRecoHit This class is used to transfer SVD information to the track fit
C AlignableSVDRecoHit2D This class is used to transfer SVD information to the track fit
C Id Generic identity functor
C RelationArray::Identity Struct for identity transformation on indices
C identity_t
► C IGlobalParamInterface Some tentative base class to allow to add functionality to the default behavior, like manipulate constants in DB objects after calibration is finished All methods to override have default implementation which does nothing
C CDCGlobalParamInterface CDC interface
C VXDGlobalParamInterface Very tentative interface for VXD
C ImpactBinsSpec Strategy to construct discrete impact points from discrete overlap specifications
C FilterParamMap::Impl Define the implementation
C MVAExpert::Impl Implementation of the class to interact with the MVA package
C Recorder::Impl Record the MVA variables
► C InBox
C StereoHitContained< InBox >
C ZMQLogger::Incrementor Visitor Helper for incrementing a numerical value
► C Index
C Basf2ModuleIndex
C Basf2VariableIndex
► C IndexError
C ReadError
C Indirect Functor to get the indirection from an arbitrary objects
► C Info
C UserInfo< Info, Payload > UserInfo class which is used to attach additional information to Geant4 particles and tracks
C SensitiveDetectorDebugHelper::info Struct with all the branches needed
C InitialParticleGeneration Generate Collision
► C InMemoryDataset
C GraphDataSet
C InotifyEvent
C InPhi0Box Checker if a position is contained in a family of curves over phi0
C InPhi0CurvBox Checker if a position is contained in a family of curves over phi0 and curvature
C InPhi0CurvTanLBox Checker if a position is contained in a family of curves over phi0 and tan lambda
C InPhi0ImpactBox Checker if a position is contained in a family of curves over phi0 and impact
C InPhi0ImpactCurvBox Checker if a position is contained in a family of curves over phi0, impact and curvature
C InPhi0TanLBox Checker if a position is contained in a family of curves over phi0 and tan lambda
C TrgBit::InputBitPattern Input bit pattern class
► C InputContext Class representing a resource context for gearbox
C FileContext InputContext which serves the content of a plain file
C StringContext InputContext which just returns the value of a string previously assigned
C InputController A static class to control supported input modules
► C InputHandler Class to provide an InputContext for a given XML resource name
C FileHandler InputHandler which will read XML from plain files, optionally gzip compressed
C StringHandler InputHandler which just takes the uri as XML data
C InputHandlerFactory< T > Helper class to easily register new input handlers
C InputParser
► C integral_constant
C GetIndexInTuple< AType, std::tuple< AHeadType, ATailTypes... > > Specialisation for the case that the first type in the tuple is not the AType asked for. Recursion case
C GetIndexInTuple< AType, std::tuple< AType, ATailTypes... > > Specialisation for the case that the first type in the tuple is equal to the AType asked for. Recursion end
C GetIndexInTuple< AType, std::tuple<> > Specialisation to terminate the recursion in case it was not found
C Product< factor, factors... > Template class specialisation for compile time computation of products
C Product<> Template class specialisation for compile time computation of products
► C IntEnum
C EventCode
C InterceptorScopeGuard< T > Simple RAII guard for output interceptor
C InterceptOutput< STDOUT, STDERR > Class to intercept stdout and stderr and either capture, discard or keep them unmodified depending on the template arguments
► C InterceptOutput< CaptureStream, CaptureStream >
C OutputToLogMessages Capture stdout and stderr and convert into log messages
► C Interface Exception to be thrown in case of an empty result
C GearDir GearDir is the basic class used for accessing the parameter store
C Gearbox Singleton class responsible for loading detector parameters from an XML file
C TRGTOPTRD2TTSConverterModule::interimTimeStamp
C track_maker_t::internal
C Intersection Intersection of muid-extrapolated track with a KLM layer
C IntervalOfValidity A class that describes the interval of experiments/runs for which an object in the database is valid
C IntervalOfValidity
C IntervalSelector
C InvariantMassMuMuIntegrator The integrator aims to evaluate convolution of PDFgenLevel and resolution function
C PDFConstructor::InverseRaytracerDirect Structure that enables defining a template function: direct photons
C PDFConstructor::InverseRaytracerReflected Structure that enables defining a template function: reflected photons
C ronode_info::io_info
C mybuf::io_status
C IOInfo
► C ios_base STL class
► C basic_ios< Char > STL class
► C basic_istream< Char > STL class
► C basic_iostream< Char > STL class
► C basic_fstream< Char > STL class
► C fstream STL class
C FileSystem::TemporaryFile Helper file to create a temporary file and ensure deletion if object goes out of scope
► C basic_ostream< Char > STL class
C basic_iostream< Char > STL class
C IoVSet
► C IPythonHandler
C Basf2IPythonHandler
► C IPythonWidget
C DependencyViewer
C ModuleViewer
C PathViewer
C CollectionsViewer
C LogViewer
C ProgressBarViewer
C StatisticsViewer
► C StylingWidget
C StylingWidget
C BFieldComponentQuad::irange_t Start and stop indices to narrow search in array
C IsNaN Unary functor for equality comparison to NAN
C ISuperLayerUtil This is a utility class for the free ISuperLayer type
C ItemFilter
► C IterableDataset
C ArrayDataset
C Const::DetectorSet::Iterator Iterator
C array< T >::iterator STL iterator class
C map< K, T >::iterator STL iterator class
C span< T >::iterator
C ObjectStatement< ObjectType, Columns >::iterator Iterator class to allow iterating over the rows
C string::iterator STL iterator class
C vector< T >::iterator STL iterator class
C IWireUtil This is a utility class for the free IWire type
C JacobianMatrixUtil Collection of functions related to jacobian matrices
► C JsonBase
C Comparison
C ComparisonResult
► C HtmlContent
C ComparisonHtmlContent
► C NTuple
C ComparisonNTuple
► C Package
C ComparisonPackage
► C Plot
C ComparisonPlot
► C PlotFile
C ComparisonPlotFile
► C Revision
C ComparisonRevision
C Revisions
C Script
C KalmanCalculator Does the calculation of the gain matrix, updates the cov and fitpars
C KalmanStepper< Dimension > Class to bundle all algorithms needed for the kalman update procedure
► C KarimakisMethod Class implementing the Karimaki fit for two dimensional trajectory circle
► C CDCFitter2D< KarimakisMethod >
C CDCKarimakiFitter Class implementing the fitter using Karimakis method
C KeepStream Dummy class which keeps the stream unmodified
C RawRootFile.Key
C KeyValBox< KeyType, ValueType > Minimal container storing a pair of < KeyType, ValueType>
C KeyValuePrinter Create human-readable or JSON output for key value pairs
► C KFitBase KFitBase is a base class for kinematical fitters
C FourCFitKFit FourCFitKFit is a derived class from KFitBase to perform 4 momentum-constraint kinematical fit
C MassFitKFit MassFitKFit is a derived class from KFitBase to perform mass-constraint kinematical fit
C MassFourCFitKFit MassFourCFitKFit is a derived class from KFitBase to perform mass and 4 momentum-constraint kinematical fit
C MassPointingVertexFitKFit MassPointingVertexFitKFit is a derived class from KFitBase It performs a kinematical fit with three constraints: the invariant mass is constrained to its PDG value, the tracks are forced to a common vertex, and the momentum vector is forced to point to an externally provided space point
C MassVertexFitKFit MassVertexFitKFit is a derived class from KFitBase to perform mass-vertex-constraint kinematical fit
C RecoilMassKFit RecoilMassKFit is a derived class from KFitBase to perform a kinematical fit with a recoil mass constraint
C VertexFitKFit VertexFitKFit is a derived class from KFitBase to perform vertex-constraint kinematical fit
C KFitConst KFitConst is a container of constant names
C KFitError KFitError is a container of error codes and a macro function
C KFitTrack::KFitPXE KFitPXE is a container of the track information (Lorentz vector, position, and error matrix)
C KFitTrack KFitTrack is a container of the track information (Lorentz vector, position, and error matrix), and a set of macro functions to set/get the contents
C KinkFitter KinkFitter class to create Kink mdst's objects from reconstructed tracks
C KKGenInterface Interface class for using the KKMC generator
C KLMCalibrationChecker KLM calibration checker
C KLMChannelIndex KLM channel index
C KLMDatabaseImporter KLM database importer
C KLMDisplacementGenerator Module for generation of KLM displacement or alignment data
C KLMElectronicsMapImporter KLM database importer
► C KLMElementArrayIndex KLM element array index
C KLMChannelArrayIndex KLM channel array index
C KLMModuleArrayIndex KLM module array index
C KLMPlaneArrayIndex KLM plane array index
C KLMSectorArrayIndex KLM sector array index
C KLMElementNumbers KLM element numbers
C KLMGeometryPar Wrapper class around bklm::GeometryPar and EKLM::GeometryData
C KLMLikelihoodParametersImporter This class imports KLMLikelihoodParameters into the database
C KLMTime KLM time conversion
C KLMTrackFinder Track finding procedure
C KLMTrackFitter Track fitting procedure
C klmtrgLayerCounter
C klmtrgLinearFit
C KlongCalculatorUtils Utility class to calculate the Klong kinematics
C KoralW C++ interface for the FORTRAN 4-fermion final state generator KoralW
C KsfwMoments Moment-calculation of the k_sfw improved Super-Fox-Wolfram moments
C LabToCms Class implementing general Lorentz Transformation between LAB and CMS system
C TRGTOPDQMModule::largestEnergy
C TRGTOPDQMModule::largestNHits
C LaserCalibratorFit A class do laser calibration fit provide different fitting method (under development)
► C LatexObject
C DefineColourList
C Graphics
C Itemize
C LatexFile
C Listing
C LongTable
C Section
C String
C SubSection
C SubSubSection
C TitlePage
► C Layer
C EnhancedRelations
C Relations
C ARICHGeoAerogelPlane::layer Struct to hold aerogel layer parameters
► C Less Binary functor for less comparison of arbitrary objects - equivalent to std::less<> (c++14)
C BinaryJoin< Less, AFunctor1, AFunctor2 >
C TEclEnergyHit::less_CellId Struct less_CellId
C TEclEnergyHit::less_Energy Struct less_Energy
► C Lexer
C B2Lexer
C B2ParameterLexer
C LHEReader Class to read LHE files and store the content in a MCParticle graph
C Likelihoods Structure for TOPLikelihood members
► C Line2D 2D line
C LineSegment2D 2D line segment
C Line2D A two dimensional normal line
► C Linear
C SNLinear
C Linear_fit_of_Hits_t
C LinearDivision< ABox, divisions > Factory object that constructs sub boxes from a given box with optional overlaps
► C list
C NonstrictChoices
C NonstrictChoices
C ListIndexGenerator ListIndexGenerator is a generator for all the combinations of the sublists (FlavorSpecificParticle = 0, SelfConjugatedParticle = 1) of a set of particle lists
C LocalMetadataComparison
C LocalMetadataProvider
C FileSystem::Lock Helper class for locking a file
C LogConfig The LogConfig class
► C LogConnectionBase Abstract base class for the different types of log connections
C LogConnectionConsole Implements a log connection to an IO Stream
C LogConnectionFilter Implements a log connection that filters repeated messages
C LogConnectionJSON Implements a log connection to stdout but with messages formatted as json objects to allow easy parsing by other tools, say jupyter notebooks
C LogConnectionTxtFile Implements a log connection to a text file
C LogConnectionUDP Log Connection to send the log message as JSON to a UDP server
C LogFile
C LogicalVolumes Logical volumes of EKLM
C PDFConstructor::LogL Useful data type for returning the results of log likelihood calculation
C LogLikelihoods Structure for the output of PID log likelihoods to a flat ntuple
C LogListener
C LogMessage The LogMessage class
C LogMethod The LogMethod class
C LogModRealm Class to modify the log level dependent on the execution realm
C LogPythonInterface Thin wrapper to expose a usable interface to the logging framework in python
C LogReplacementFilter
C LogSystem Class for logging debug, info and error messages
C LogVar Class to store variables with their name which were sent to the logging service
C LogVariableStream Specialized implementation of an ostream-like class where the << operator can be used to insert values
C LookupTable< T > Class which holds precomputed values of a function
C LowerBoundedSet< InfType > Represents a lower bounded set of arithmetic types
C LowHitsAxialTrackUtil Utility structure gathering heuristic functions used during the search for non-helix or low hit count tracks
► C MagneticFieldComponent Abstract base class for BField components
C BFieldFrameworkInterface Simple BFieldComponent to just wrap the existing BFieldMap with the new BFieldManager
C MagneticFieldComponent3D Describe one component of the Geometry
C MagneticFieldComponentConstant Describe one component of the Geometry
C Mails Provides functionality to send mails in case of failed scripts / validation plots
C SVDPackerModule::MainHeader Implementation of FADC Header
C SVDUnpackerModule::MainHeader Implementation of FADC Header
C MakeMotherKFit MakeMotherKFit is a class to build mother particle from kinematically fitted daughters
C MakeROOTCompatible Helper class for converting strings into a ROOT-friendly format (e.g.: removing special characters in branch names, etc.)
C Manager Global list of available variables
C map< K, T > STL class
C Map2Vector Helper class to make a vector of all possible combinations of int
numbers contained in the input vectors (passed as values in a map)
► C Mapping< T > Interface defining a mapping of objects to attribute values e.g. a color
C ConstantMapping< T > Realizing a mapping returning a constant attribute value regardless of object or position
► C CycleMapping< T > Realizing a mapping from a pool of values to be cycled from the index
C DefaultColorCycleMapping< const RecoTrack >
C DefaultColorCycleMapping< const CDCSegment2D >
► C Mapping< AObject >
► C CycleMapping< AObject >
C DefaultColorCycleMapping< AObject > Class template for coloring objects in different Colors
► C Mapping< const CDCHit >
C BackgroundTagColorMap CDCHit to color map by their associated CDCSimHit::getBackgroundTag property
C MCPDGCodeColorMap CDCHit to color map by the associated MCParticle::getPDG()
C MCParticleColorMap CDCHit to color map by their associated MCParticle::getArrayId() property
C MCPrimaryColorMap CDCHit to color map by the isPrimary information as well as the secondary process type in case the particle is not primary
C MCSegmentIdColorMap CDCHit to color map by their Monte Carlo segment id
C NLoopsColorMap Segment to color map by the number of passed loops
C PosFlagColorMap CDCHit to color map by their associated CDCSimHit::getPosFlag property
C RLColorMap CDCHit to color map by their local right left passage information from Monte Carlo truth
C ReassignedSecondaryMap CDCHit to color map indicating the reassignment to a different MCParticle
C SimHitIsBkgColorMap CDCHit to color map by CDCSimHit::getBackgroundTag()
C SimHitPDGCodeColorMap CDCHit to color map by the associated CDCSimHit::getPDG()
C TOFColorMap CDCHit to color map by their associated CDCSimHit::getFlightTime
C TakenFlagColorMap CDCHit to color map highlighting the CDCHits that posses the do not use flag
C ZeroDriftLengthColorMap CDCHit to color map highlighting the CDCHits with 0 drift length
C ZeroDriftLengthStrokeWidthMap CDCHit to stroke width map highlighting the CDCHits with 0 drift length
► C Mapping< const CDCSegment2D >
C SegmentFBInfoColorMap Segment to color map based on the forward or backward alignment relative to the match Monte Carlo track
C SegmentFirstInTrackIdColorMap Segment to color map by the in track id of the first hit
C SegmentFirstNPassedSuperLayersColorMap Segment to color map by the number of passed superlayers of the first hit
C SegmentLastInTrackIdColorMap Segment to color map by the in track id of the last hit
C SegmentLastNPassedSuperLayersColorMap Segment to color map by the number of passed superlayers of the last hit
C SegmentMCTrackIdColorMap Segment to color map based on the matched MCTrackId
► C Mapping< const RecoTrack >
C MCRecoTrackMatchingStatusColorMap Color mapping showing the match status of the monte carlo track
C RecoTrackMatchingStatusColorMap Color mapping showing the match status of the pattern recognition track
C Mapping_t Mapping class
C RestOfEvent::Mask Structure of Rest of Event mask
C Materials Materials for EKLM
C Materials Thin wrapper around the Geant4 Material system
C MaximumPtTrack Temporary data structure holding the track(s) with the maximum pT
C MCMatching Functions to perform Monte Carlo matching for reconstructed Particles
C MCond
C MCParticleGraph Class to build, validate and sort a particle decay chain
C MCParticleInfo This struct is used by the TrackingPerformanceEvaluation Module to save information of reconstructed tracks
C EVEVisualization::MCTrack Hold MC tracks and associated visualisation objects
C MCTrackIdPurityPair Structure representing a matched Monte Carlo track id with the corresponding purity
C MCTrajectoryPoint Small struct to encode a position/momentum without additional overhead
C MCUtil Class bundling all helper functions for the MC information used in the PXD CKF
C MCVXDPurityInfo The MC VXD Purity info container class
C MeasurementAdder Algorithm class to translate the added detector hits (e.g
C MeasurementCreatorFactory< BaseMeasurementCreatorType > This is the base class for all MeasurementCreatorFactories used in the MeasurementCreatorModule
► C MeasurementCreatorFactory< BaseMeasurementCreator >
C AdditionalMeasurementCreatorFactory Add measurement creators that do not rely on a specific hit type, but rather add measurements without corresponding hit
► C MeasurementCreatorFactory< BKLMBaseMeasurementCreator >
C BKLMMeasurementCreatorFactory Add all measurement creators related to BKLM hits
► C MeasurementCreatorFactory< CDCBaseMeasurementCreator >
C CDCMeasurementCreatorFactory Add all measurement creators related to CDC hits
► C MeasurementCreatorFactory< EKLMBaseMeasurementCreator >
C EKLMMeasurementCreatorFactory Add all measurement creators related to EKLM hits
► C MeasurementCreatorFactory< PXDBaseMeasurementCreator >
C PXDMeasurementCreatorFactory Add all measurement creators related to PXD hits
► C MeasurementCreatorFactory< SVDBaseMeasurementCreator >
C SVDMeasurementCreatorFactory Add all measurement creators related to SVD hits
C MemoryPool< T, chunkSize > Class to provide a constant access time memory pool for one kind of objects
C ProfileModule::MemTime An internal struct to store pairs of memory usage and time
► C MetadataProvider Base class for a payload metadata provider
C CentralMetadataProvider Class to obtain payload metadata from the central database server via REST requests
C LocalMetadataProvider Class to obtain metadata of all valid payloads from a local SQLite file instead of the central server
C NullMetadataProvider Fallback provider if no providers are given: Will raise an error if used but allows processing if no payloads are requested or all are taken locally from testing payload storage
C MetadataService This class provides a service for writing metadata about the basf2 execution and about output files to a json file
C MetaOptionParser
C Method
► C Metric
C PerfectEvent
C PerfectLCA
C PerfectMasses
C MillepedeCalibration
C TOPTemplateFitter::MinimizationSums Variables used during template fit minimization
C Chi2MinimumFinder1D::Minimum Result of minimum finder
C MinMax Small class for storing min and max
C MinMaxCollector< DataType > A container for collecting data, where min- and max-quantiles near q(0) and q(1) are to be found
C RaytracerBase::Mirror Spherical mirror data in module local frame
C MisalignmentCache Class to hold misalignment information
C SVDOnlineToOfflineMap::missingAPV Struct to hold missing APVs information
C MLRange< ClassifierType, Ndims, CutType > Range used for the Machine Learning assisted TrackFinding approach
C MMutex
► C Module
C PrintCollections
C ProgressPython
► C Module
C MinModule
C MinModule
C AccessingDataStoreModule
C AccessingDataStoreModule
C CDCHistMakerModule
C CheckNegativeWeights
C ClusterEfficiency
C PayloadImporter
C PayloadImporter
C PayloadImporter
C DumpDigits
C ShapeFitterModule
C PrintPXDHits
C CompareTransformationsModule
C GraFEIModule
C LCASaverModule
C NNFilterModule
C SaveFlag
C TrainDataSaver
C PXDHitErrors
C PXDHitErrorsTTree
C PhokharaEvtgenAnalysisModule
C CheckTrueHits
C CreateLogics
C PyTrigger
C dbImporterModule
C SVDChargeSharing
C defaultChargeSimulationImporter
C defaultCoGTimeCalibrationImporter_pol1TBdep
C defaultCoGTimeCalibrationImporter_pol3TBindep
C defaultELSTimeCalibrationImporter_pol1TBdep
C defaultELSTimeCalibrationImporter_pol3TBindep
C defaultCoGTimeCalibrationImporter_pol1TBdep
C defaultCoGTimeCalibrationImporter_pol3TBindep
C defaultSVDClusteringImporter
C defaultSVDCoGOnlyErrorScaleFactorsImporter
C defaultSVDCoGOnlyPositionErrorImporter
C defaultCrossTalkStripsImporter
C defaultSVDConfigParametersImporter
C defaultFADCMaskedStripsImporter
C defaultSVDHitTimeSelectionImporter
C defaultHotStripsImporter
C defaultNoiseImporter
C defaultOccupancyImporter
C defaultSVDOldDefaultErrorScaleFactorsImporter
C defaultPedestalImporter
C defaultPulseShapeImporter
C configImporterToDBModule
C dbImporterModule
C testSVDShaperDigitOrdering
C timeGroupingConfigurationImporter
C SVDValidationTTreeCluster
C SVDValidationTTreeRecoDigit
C SVDValidationTTreeRecoTrack
C SVDValidationTTreeSimhit
C SVDValidationTTreeSpacePoint
C SVDValidationTTreeStrip
C SVDValidationTTreeTrueHit
C CheckMCParticles
C SetVXDSensitiveThreshold
C WaveformAnalyzer
C ConstraintsGenerator
C CreateMisalignmentModule
C MakePlots
C PackerUnpackerTest
C AverageQE
C MCParticlesTestingModule
C TestingModule
C printBGInfo
C PackerUnpackerTestModule
C Ntuple
C CheckCalibDB
C Histogrammer
C CheckCalibDB
C CheckCalibDB
C SaveHisto
C Check_info
C Histogrammer
C CheckTBCAsic
C CheckPayloadMetadata
C CheckPayloadNames
C SVDTrigger
C DisplayDataTest
C DisplayHLTTags
C printSVDLadders
C printSVDPitches Test SVD geometry
C printSVDSensors
C printSVDSizes
C printSVDStripLengths
C printSVDStripPositions
C printMobility
C printVelocity Test SVD SensorInfo getters
C printAduEquivalent
C printElectronicNoise Test SVD SensorInfo getters
C CheckRelationBremClusterTestModule
C SearchForHits
C CheckTrackClusterMatching
C ECLPackerUnpackerTestModule
C addECLDigitsModule
C addECLCalDigitsModule
C checkNumOutOfTimeDigitsModule
C Skim
C WriteData
C SaveModuleT0
C PrintInfo
C HighlighterModule
C GenerateHist
C InspectorModule
C Histogrammer
C TestModule
C Monitor
C PrintTRGTime
C VisualizeVertex
C TreeWriterModule
C PlotClusterPositionEstimatorPayload
C MinModule
C SaveCanvases
C printPIDLikelihoods
C PrintCalibTriggerResults
C PxdPackerUnpackerTestModule
C PxdROIPayloadTestModule
C MinModule
C WFDisplay
C TOPDisplay
C Split
C TOPLaserHistogrammerModule
C TOPTBCResolution
C SVDCoGTimeCalibrationImporterModule
C SVDCoGTimeCalibrationCheckModule
C SVDCoGTimeCalibrationImporterModule
C dump_clusters
C dump_digits
C skim6SampleEventsPyModule
C skimFineTRGEventsPyModule
C skimLowHighEventT0EventsPyModule
C skimOutRNDTrgModule
C skimSVDBurstEventsModule
C skimSVDTriggerBinEventsPyModule
C svdCoGCalibrationAnalysisTool
C SVDGroupingPerformance
C SvdPackerUnpackerTestModule
C Ntuple
C Ntuple
C ShiftDigits
C SVDClustersQuickCheck
C SVDRecoDigitsQuickCheck
C PopulateEvents
C PXDPositionEstimation
C DigitTest
C DigitsTest
C RawDigitsTest
C PyTrigger
C BGHistogrammer
C Histogrammer
C CosmicAnalysis
C Ana
C Skim
► C Module
C ShowMCParticles
C TestModule
C EventCountLimiter
C EventDisplayer
C EventInspector
C EventInspectorLookback
C TestModule
C KLMK0LPlotModule
C ShowMCParticles
C svdEventT0ConfigurationImporter
C recoConfigurationImporter
C svdSpacePointSelectionFunctionImporter
C SplitMultiplicities
C MakePlots
C TestModule
► C VariablesToTable
C VariablesToHDF5
C SelectTRGTypes
C Generator
C NumBestChecker
C RankChecker
C NoopModule
C TestModule
C PrinterModule
C CountEvents
C EvtMetaDataTest
C NoopModule
C InjectPXDDigits
C TestModule
C PackerUnpackerTest
C SelectTRGTypes
C DelayEvents
C PrintName
C ReturnFalse
C SelectOddEvents
C casefilter
C nnt_eventfilter
C randommaker
C nntd
C CheckEventNumbers
C CountEvents
► C PerEventStatisticsGetterModule
C SVDExtraEventStatisticsModule
C CountEvents
C TestModule
C PXDBackgroundGenerator Class for the PXD background generator module
C PXDReader
C ParticleStatisticsModule
C SillyGeneratorModule
C BrokenEventsModule
C NoopModule
C TestingModule
C TestModule
C TestModule
C CheckForCorrectHLTResults
C RandomTestModule
C ErrorInEvent
C ErrorInInit
C skimCrossTalkEventsModule
C MVAExtraInfoChecker
C CheckNumbering
C InjectSimHits
C SetAsideSimHits
C CheckOrderingOfDigits
C CreateDigits
C PrintDigitsAndClusters
C CDCHitUniqueAssumer
C HitCleaner
► C HarvestingModule
C VxdCdcMergerHarvesterMCSide
C VxdCdcMergerHarvesterPRSide
C ClusterFilterValidationModule
C FitValidationModule
C VxdCdcPartFinderHarvester
C MCParticleHarvester
C MCTrajectoryHarvester
C ReconstructionPositionHarvester
C SeedsAnalyser
C SegmentFakeRatesModule
C SegmentFinderParameterExtractorModule
C WrongRLInfoCounter
C ElossHarvestingModule
C LegendreBinningValidationModule
C SegmentFitValidationModule
C Saving1stMVAData
C Saving2ndMVAData
C SegmentPairCreationValidationModule
► C PickleHarvestingModule
C SummarizeTriggerResults
C SummarizeTriggerVariables
C EventwiseTrackingValidationModule
C MCSideTrackingValidationModule
C PRSideTrackingValidationModule
C EventInfoHarvester
C HitInfoHarvester
C TrackInfoHarvester
C VxdCdcMergerHarvester
C QueueHarvester
► C PathModule
C CombinedTrackingValidationModule
► C WrapperModule
► C IfModule
► C IfStoreArrayPresentModule
C IfMCParticlesPresentModule
C IfStoreArrayNotPresentModule
C PyProfilingModule
C Reader
► C TrackingValidationModule
C ExpertTrackingValidationModule
C TestModule
C is2DSkim
C CheckZS
C SleepOnInitModule
C Module Define the geometry of a BKLM module Each sector [octant] contains Modules
► C Module
C MakePlots
C PXDPayloadROIUnpackerModule
C PXDRawROIUnpackerModule
C ShowMCParticles
C SetMetaTimeModule
C PrintObjectsModule
C CDCPlotModule
C CheckFrontEndMaps
C TestDoWhile
C MakeRelations
C ImportFrontEndMaps
C MinModule
C EventRangePathSplitter
C ExtraInfoPathSplitter
C StopModule
C EffModule
C CheckPresenceOfTrackToMCParticleRelation
► C Module
C EdgeLayer
C GlobalLayer
C NodeLayer
C MultiTrainLoss
C WeightNet
C Model Class for the ConvNet generator model
C Attention
C CBAM_attention
C EncoderBlock
C GBlock
► C Generator
C Model
C ILA
C MultiheadAttention
C RelationalReasoning
C bn
C ccbn
C identity
C myBN
C Model Class for the ResNet generator model
C ResidualBlock Class for the residual block layer
C Model
C TCCE
► C Module
C myModel
► C Module
C DefaultModel
C Layer
C MultilayerPerceptron
► C Module
C GATGAPModel
C GATModule
C GraFEIModel
C PriorModel
C myModel
C ModuleAlignment Alignment of a TOP module
C ModuleCondition Wraps a condition set on a Module instance
C ModuleID_t Intermediate object generated to contain configurations in a sorted fashion
C DependencyMap::ModuleInfo Stores information on inputs/outputs of a module, as obtained by requireInput()/optionalInput()/registerEntry();
C ModuleManager The ModuleManager Class
► C ModuleParamBase Base class for module parameter
C ModuleParam< bool >
C ModuleParam< T > A single parameter of the module
C ModuleParamInfoPython Class to store basic information about a parameter
C ModuleParamList The Module parameter list class
C ModuleProxyBase The base module proxy class is used to create new instances of a module
C ModuleStatistics Keep track of time and memory consumption during processing
C ModuleStatistics
C MonitorDB
C MRUCache< KEY, VALUE > Class implementing a generic Most Recently Used cache
C MsgHandler A class to encode/decode an EvtMessage
C MuidBuilder Build the Muid likelihoods starting from the hit pattern and the transverse scattering in the KLM
C MuidElementNumbers Muid element numbers
C MuidProb Class computes probability density for Muid calculation
C MultipassCellularPathFinder< ACellHolder > Class to combine the run of the cellular automaton and the repeated path extraction
C MultivariateNormalGenerator Class to generate normal distributed, correlated random numbers given the mean values and the covariance matrix of all dimensions
► C MutableMapping
► C ValidationFiguresOfMerit
C ValidationManyFiguresOfMerit
C Mutex
C MVAExpert Class to interact with the MVA package, based on class with same name in CDC package
C MVAExpert Class to interact with the MVA package
C mybuf
C MyFancyClassifier
C Named< T > A mixin class to attach a name to an object. Based on class with same name in CDC package
► C NamedFloatTuple An abstract tuple of float value where each value has an associated name
C FixedSizeNamedFloatTuple< CDCPathBasicVarNames >
C FixedSizeNamedFloatTuple< CDCPathTruthVarNames >
C FixedSizeNamedFloatTuple< CDCStateBasicVarNames >
C FixedSizeNamedFloatTuple< CDCStateTruthVarNames >
C FixedSizeNamedFloatTuple< CDCfromEclPathTruthVarNames >
C FixedSizeNamedFloatTuple< CDCfromEclStateTruthVarNames >
C FixedSizeNamedFloatTuple< PXDResultTruthVarNames >
C FixedSizeNamedFloatTuple< PXDStateBasicVarNames >
C FixedSizeNamedFloatTuple< PXDStateTruthVarNames >
C FixedSizeNamedFloatTuple< RelationSVDResultVarNames >
C FixedSizeNamedFloatTuple< SVDResultTruthVarNames >
C FixedSizeNamedFloatTuple< SVDStateBasicVarNames >
C FixedSizeNamedFloatTuple< SVDStateTruthVarNames >
C FixedSizeNamedFloatTuple< SVDStateVarNames >
C FixedSizeNamedFloatTuple< AdvancedSegmentVarNames >
C FixedSizeNamedFloatTuple< BasicAxialSegmentPairVarNames >
C FixedSizeNamedFloatTuple< BasicClusterVarNames >
C FixedSizeNamedFloatTuple< BasicFacetRelationVarNames >
C FixedSizeNamedFloatTuple< BasicFacetVarNames >
C FixedSizeNamedFloatTuple< BasicSegmentPairRelationVarNames >
C FixedSizeNamedFloatTuple< BasicSegmentPairVarNames >
C FixedSizeNamedFloatTuple< BasicSegmentRelationVarNames >
C FixedSizeNamedFloatTuple< BasicSegmentVarNames >
C FixedSizeNamedFloatTuple< BasicTrackRelationVarNames >
C FixedSizeNamedFloatTuple< BasicTrackVarSetNames >
C FixedSizeNamedFloatTuple< BendFacetRelationVarNames >
C FixedSizeNamedFloatTuple< BendFacetVarNames >
C FixedSizeNamedFloatTuple< FitAxialSegmentPairVarNames >
C FixedSizeNamedFloatTuple< FitFacetRelationVarNames >
C FixedSizeNamedFloatTuple< FitFacetVarNames >
C FixedSizeNamedFloatTuple< FitSegmentPairRelationVarNames >
C FixedSizeNamedFloatTuple< FitSegmentRelationVarNames >
C FixedSizeNamedFloatTuple< FitTrackRelationVarNames >
C FixedSizeNamedFloatTuple< FitlessAxialSegmentPairVarNames >
C FixedSizeNamedFloatTuple< FitlessFacetVarNames >
C FixedSizeNamedFloatTuple< FitlessSegmentPairVarNames >
C FixedSizeNamedFloatTuple< FitlessSegmentRelationVarNames >
C FixedSizeNamedFloatTuple< HitGapAxialSegmentPairVarNames >
C FixedSizeNamedFloatTuple< HitGapSegmentPairVarNames >
C FixedSizeNamedFloatTuple< HitGapSegmentRelationVarNames >
C FixedSizeNamedFloatTuple< HitGapTrackRelationVarNames >
C FixedSizeNamedFloatTuple< SegmentTrackTruthVarNames >
C FixedSizeNamedFloatTuple< SegmentTrackVarNames >
C FixedSizeNamedFloatTuple< StereoHitTruthVarNames >
C FixedSizeNamedFloatTuple< StereoHitVarNames >
C FixedSizeNamedFloatTuple< TrailSegmentPairVarNames >
C FixedSizeNamedFloatTuple< TruthSegmentPairRelationVarNames >
C FixedSizeNamedFloatTuple< TruthSegmentPairVarNames >
C FixedSizeNamedFloatTuple< AVarNames >
C FixedSizeNamedFloatTuple< ANames > Generic class that contains a fixed number of named float values
C DBObject::NameValue
C NSMData::NameValue
C NDFinder Class to represent the CDC NDFinder
C NDFinderParameters Struct of NDFinder parameters
C NDFinderTrack Class for a found NDFinder track
C CDCTriggerMLPData::NeuroSet Struct to keep one set of training data for either training, validation or testing
C NeuroTrigger Class to represent the CDC Neurotrigger
C NewV0Fitter Improved V0 fitter class
C NNTParam< T > Class to represent a complete set to describe a Neurotrigger
C Node
C NodeCompatibilityCheckerBase< NodeType > Most trivial node compatibility checker, says always true
C NodeCompatibilityCheckerCA< NodeType > Simple NodeCompatibilityChecker, which checks for compatible Neighboring states of passed nodes (does no extended validation check)
C NodeCompatibilityCheckerPathCollector< NodeType > Simple NodeCompatibilityChecker, which checks for compatible Neighboring states of passed nodes (does no extended validation check)
C NodeFactory Wrapper class for static node compile functions
C NodeFamilyDefiner< ContainerType, NodeType, NeighbourContainerType > This class assigns a common family identifier to all CACells in the network that are connected
C NoiseMap Base Class to represent pixel dependent Noise Map
C NoiseMap Base Class to represent strip-dependent noise map
C NoReplacementField
C Not Functor to get the logical negation from an arbitrary objects
C NSMCommunicator
C NSMcon
C NSMcontext_struct
C nsmd_tcpq
C NSMdat
C NSMdat_rcv
C NSMdat_snd
C NSMDataPaket
C NSMDataStore
C NSMdmsg
C NSMmem_struct
C NSMmsg
C NSMnod
► C NSMNode
C RCNode
C NSMNodeDaemon
C NSMparse_struct
C NSMref
C NSMreg
C NSMreq
C NSMrequest
C NSMsch
C NSMsys_struct
C NSMtcphead_struct
C NSMudpbuf
► C NSMVHandler
C NSMVHandlerFloat
C NSMVHandlerFloatArray
C NSMVHandlerInt
C NSMVHandlerIntArray
C NSMVHandlerRef
► C NSMVHandlerText
C RCConfigHandler
► C ntuple_base_t
C ntuple< event_nr, digit_id, subdetector, section, sector, plane, layer, strip >
C ntuple< geo_id, subdetector, section, sector, layer, plane, slopeX, offsetX, slopeY, offsetY >
C ntuple< subdetector, section, sector, layer, plane, slopeX, offsetX, slopeY, offsetY >
C ntuple< subdetector, section, sector, plane, track_id, slopeXY, interceptXY, ipXY, chisqXY, Nhits >
C ntuple< KLM_TRG_definitions::slopeX, KLM_TRG_definitions::offsetX, KLM_TRG_definitions::slopeY, KLM_TRG_definitions::offsetY >
C ntuple< KLM_TRG_definitions::layer >
C ntuple< T >
C NumberOfHitsGetter Helper Functor to get the Number of hits of a given result
C ObjArrayIterator< ArrayType, ValueType > Optimizes class to iterate over TObjArray and classes inheriting from it
► C object
C State
C State
C PerfectEvent
C PerfectLCA
C PerfectMasses
► C SN
C SNConv2d
C SNEmbedding
C SNLinear
► C Bits
► C BitArray
C BitStream
► C ConstBitStream
C BitStream
► C ConstByteStore
C ByteStore
C MmapByteArray
► C ObjectDescription
C Basf2Object
C ObjectStatement< ObjectType, Columns > SQLite prepared statement wrapper
C Observer Observer base class which can be used to evaluate the VXDTF2's Filters
C Observer3HitPrintResults This observer does simply print the name of the SelectionVariable and the result of its value-function as a Warning(if failed) or as an Info (if succeeded)
C ObserverCheckFilters This observer searches logs the response for each of SelectionVariables used in the filters If the pointer to the StoreArray is set the results will be put into the datastore
C ObserverCheckMCPurity This observer searches for mcParticles attached to the hits given and stores the information found to be retrieved later
C ObserverPrintResults This observer does simply print the name of the SelectionVariable and the result of its value-function as a Warning(if failed) or as an Info (if succeeded)
C TOPCalEventT0Offset::OffsetData Calibration constants of a detector component
C on_common_args_t
C ONNXTensorView View a Dataset 's m_input as ONNX Tensor and also set up output buffers/Tensors
► C Options Abstract base class of all Options given to the MVA interface
C GeneralOptions General options which are shared by all MVA trainings
C MetaOptions Meta Options which modify the underlying training by doing sPlot, Multiclass and HyperparameterSearch
► C SpecificOptions Specific Options , all method Options have to inherit from this class
► C RegressionOptions< FastBDTOptions >
C RegressionFastBDTOptions Explicit template specification for FastBDTs for regression options
C CombinationOptions Options for the Combination MVA method
C FANNOptions Options for the FANN MVA method
C FastBDTOptions Options for the FANN MVA method
C ONNXOptions Options for the ONNX MVA method
C PDFOptions Options for the PDF MVA method
C PythonOptions Options for the Python MVA method
C RegressionOptions< BaseClassifierOptions > Generic options of the Regression MVA methods hosting the number of bins (and the base classifier options)
C ReweighterOptions Options for the Reweighter MVA method
► C TMVAOptions Options for the TMVA MVA method
C TMVAOptionsClassification Options for the TMVA Classification MVA method
C TMVAOptionsMulticlass Options for the TMVA Multiclass MVA method
C TMVAOptionsRegression Options for the TMVA Regression MVA method
C TrivialOptions Options for the Trivial MVA method
C TrgBit::OutputBitPattern Output bit pattern class
C OverlapMatrixCreator Creates a vector of vectors, that knows which track is conflicting with which other
C OverlapResolverNodeInfo Struct for holding information needed by overlap resolving algorithms for one node
C PackedAutoCovariance Packed covariance matrix
► C pair< T1, T2 > STL class
► C Range< typename std::vector< T >::iterator >
C SortedRange< typename std::vector< T >::iterator >
► C Range< typename std::vector< T >::const_iterator >
C SortedRange< typename std::vector< T >::const_iterator >
C WeightedRelation< ACollectorItem, const ACollectionItem >
C WeightedRelation< Belle2::CKFToPXDState >
C WeightedRelation< Belle2::CKFToSVDState >
C WeightedRelation< const Belle2::RecoTrack, const Belle2::RecoTrack >
C WeightedRelation< const Belle2::TrackFindingCDC::WithAutomatonCell< const RecoTrack * > >
C WeightedRelation< Belle2::TrackFindingCDC::CDCWireHit >
C WeightedRelation< Belle2::TrackFindingCDC::CDCTrack, const Belle2::TrackFindingCDC::CDCRLWireHit >
C WeightedRelation< const Belle2::TrackFindingCDC::CDCFacet >
C WeightedRelation< const Belle2::TrackFindingCDC::CDCSegment2D >
C WeightedRelation< Belle2::TrackFindingCDC::CDCTrack, const Belle2::TrackFindingCDC::CDCSegment2D >
C WeightedRelation< const Belle2::TrackFindingCDC::CDCSegmentPair >
C WeightedRelation< const Belle2::TrackFindingCDC::CDCSegmentTriple >
C WeightedRelation< const Belle2::TrackFindingCDC::CDCTrack >
C WeightedRelation< AHit >
C WeightedRelation< Belle2::vxdHoughTracking::VXDHoughState >
► C Range< AIterator > A pair of iterators usable with the range base for loop
C CDCWireLayer Class representing a sense wire layer in the central drift chamber
C CDCWireSuperLayer Class representing a sense wire superlayer in the central drift chamber
C SortedRange< AIterator > A pair of iterators usable with the range base for loop
C Relation< AFrom, ATo > Type for two related objects
C WeightedRelation< AFrom, ATo > Type for two related objects with a weight
C WireNeighborPair Class representing a pair of neighbors in the CDC in a single layer For certain circumstances it is allowed that both wires point to nullptr, e.g
► C pair< T1, T2 > STL class
C Range< typename std::vector< T >::iterator >
C Range< typename std::vector< T >::const_iterator >
C WeightedRelation< ACollectorItem, const ACollectionItem >
C WeightedRelation< Belle2::CKFToPXDState >
C WeightedRelation< Belle2::CKFToSVDState >
C WeightedRelation< const Belle2::RecoTrack, const Belle2::RecoTrack >
C WeightedRelation< const Belle2::TrackFindingCDC::WithAutomatonCell< const RecoTrack * > >
C WeightedRelation< Belle2::TrackFindingCDC::CDCWireHit >
C WeightedRelation< Belle2::TrackFindingCDC::CDCTrack, const Belle2::TrackFindingCDC::CDCRLWireHit >
C WeightedRelation< const Belle2::TrackFindingCDC::CDCFacet >
C WeightedRelation< const Belle2::TrackFindingCDC::CDCSegment2D >
C WeightedRelation< Belle2::TrackFindingCDC::CDCTrack, const Belle2::TrackFindingCDC::CDCSegment2D >
C WeightedRelation< const Belle2::TrackFindingCDC::CDCSegmentPair >
C WeightedRelation< const Belle2::TrackFindingCDC::CDCSegmentTriple >
C WeightedRelation< const Belle2::TrackFindingCDC::CDCTrack >
C WeightedRelation< AHit >
C WeightedRelation< Belle2::vxdHoughTracking::VXDHoughState >
C Range< AIterator > A pair of iterators usable with the range base for loop
C Relation< AFrom, ATo > Type for two related objects
C WeightedRelation< AFrom, ATo > Type for two related objects with a weight
C WireNeighborPair Class representing a pair of neighbors in the CDC in a single layer For certain circumstances it is allowed that both wires point to nullptr, e.g
C MultiHoughSpaceFastInterceptFinder::paircompare This sorting makes sure the clusters can be searched from bottom left of the HS to top right normally, a C++ array looks like a matrix: (0, 0 ) ... (maxX, 0 ) ... ... (0, maxY) ... (maxX, maxY) but for sorting we want it to be like regular coordinates (0, maxY) ... (maxX, maxY) ... ... (0, 0 ) ... (maxX, 0 ) By setting the offset to the maximum allowed number of cells (2^14) and simplifying (16384 - lhs.second) * 16384 + lhs.first < (16384 - rhs.second) * 16384 + rhs.first to (rhs.second - lhs.second) * 16384 < rhs.first - lhs.first we get the formula below
C SingleHoughSpaceFastInterceptFinder::paircompare This sorting makes sure the clusters can be searched from bottom left of the HS to top right normally, a C++ array looks like a matrix: (0, 0 ) ... (maxX, 0 ) ... ... (0, maxY) ... (maxX, maxY) but for sorting we want it to be like regular coordinates (0, maxY) ... (maxX, maxY) ... ... (0, 0 ) ... (maxX, 0 ) By setting the offset to the maximum allowed number of cells (2^14) and simplifying (16384 - lhs.second) * 16384 + lhs.first < (16384 - rhs.second) * 16384 + rhs.first to (rhs.second - lhs.second) * 16384 < rhs.first - lhs.first we get the formula below
C DisplayUI::Parameter Wraps a module parameter that can be toggled from the UI
C Parameter< AType > This class represents a quantity which value can be set both permanently and temporarily
C ParameterBinder Bind the given parameter to the sqlite statement
C PedeResult::parameterData Struct to hold data for a parameter
C ParameterLine2D A line with a support point and tangential vector
C GRLNeuro::Parameters Struct to keep neurotrigger parameters
C NeuroTrigger::Parameters Struct to keep neurotrigger parameters
C ParticleGun::Parameters Struct to keep all necessary parameters for the particle gun
C SGCosmic::Parameters Struct to keep all necessary parameters for the cosmic generator
C ParameterVectorUtil Structure to gather some utility functions for the ParameterVector
C BFieldComponentQuad::ParamPoint3 Quadrupole lense data structure
C ParticleAndWeight This struct is used to store and sort the tag tracks
► C ParticleBase Base class for all particles
► C Composite A class for composite particles, where the daughters must be ignored by the fitter
C RecoResonance A class for resonances
► C InternalParticle Another unnecessary layer of abstraction
C Resonance Class for resonances as internal particles
C Origin Representation of the beamspot as a particle
► C RecoParticle Base for RecoNeutral RecoTrack
C RecoNeutral Representation of the neutral particle constraint
C RecoTrack Representation of all charged final states FIXME rename since this name is taken in tracking
C ParticleGenerator ParticleGenerator is a generator for all the particles combined from the given ParticleLists
C ParticleGun Class to generate tracks in the particle gun and store them in a MCParticle graph
C ParticleIndexGenerator ParticleIndexGenerator is a generator for all the combinations of the particle indices stored in the particle lists
C ParticleListHelper Class to help managing creation and adding to ParticleLists
C ParticleProperties This struct is used by the StandardTrackingPerformanceModule to save information of reconstructed tracks
C ParticlesArray Structure for particle hypothesis dependent arrays
C Const::ParticleSet A set of ParticleType objects, with defined order
C MCParticleGraph::ParticleSorter Class to go over all the particles in the Graph an sort them in a sensible way
► C Const::ParticleType For identifying different particle types
C Const::ChargedStable Provides a type-safe way to pass members of the chargedStableSet set
C Const::Cluster Provides a type-safe way to pass members of the clusterSet set
C ParticleWeightingAxis Class for handling LookUp tables
C ParticleWeightingBinLimits Just pair of numbers - min and max values of bin border
C ParticleWeightingKeyMap Class for handling KeyMap
C PathCollectorRecursive< ContainerType, NodeType, NeighbourContainerType, NodeCompatibilityCheckerType > Path finder for generic ContainerType
► C PathElement Base for classes that can be elements of a Path
► C Module Base class for Modules
► C FindletModule< TrackFindingCDC::FindletStoreArrayInput< BaseEventTimeExtractorModuleFindlet< AFindlet > > >
C Chi2BasedT0ExtractorModule Module implementation using only the chi2
C DriftLengthBasedT0ExtractorModule Module implementation using only the drift lengths
C FullGridChi2TrackTimeExtractorModule Module implementation using only the chi2
C FullGridDriftLengthTrackTimeExtractorModule Module implementation using the drift length and the chi2
► C FindletModule< TrackQualityEstimator >
C TFCDC_TrackQualityEstimatorModule Module implementation using the TrackTrackQualityEstimator findlet
► C FindletModule< HitBasedT0Extractor >
C CDCHitBasedT0ExtractionModule Module implementation using the CDCHitBasedT0Extractor
► C FindletModule< AxialTrackFinderLegendre >
C TFCDC_AxialTrackFinderLegendreModule CDC tracking module, using Legendre transformation of the drift time circles
► C FindletModule< AxialTrackFinderHough >
C TFCDC_AxialTrackFinderHoughModule Module implementation using the AxialTrackFinderHough
► C FindletModule< AxialTrackCreatorSegmentHough >
C TFCDC_AxialTrackCreatorSegmentHoughModule Module implementation using the AxialTrackCreatorSegmentHough
► C FindletModule< AxialTrackCreatorMCTruth >
C TFCDC_AxialTrackCreatorMCTruthModule Module implementation using the AxialTrackCreatorMCTruth
► C FindletModule< MonopoleAxialTrackFinderLegendre >
C TFCDC_MonopoleAxialTrackFinderLegendreModule Module implementation using the MonopoleAxialTrackFinderLegendre Modification of conventional AxialTrackFinderLegendre
► C FindletModule< AxialStraightTrackFinder >
C TFCDC_AxialStraightTrackFinderModule Module implementation using the AxialStraightTrackFinder
► C FindletModule< ClusterPreparer >
C TFCDC_ClusterPreparerModule Module implementation using the ClusterPreparer
► C FindletModule< SuperClusterCreator >
C TFCDC_SuperClusterCreatorModule Module implementation using the SuperClusterCreator
► C FindletModule< ClusterRefiner< BridgingWireHitRelationFilter > >
C TFCDC_ClusterRefinerModule Module implementation using the ClusterRefiner
► C FindletModule< ClusterBackgroundDetector >
C TFCDC_ClusterBackgroundDetectorModule Module implementation using the ClusterBackgroundDetector
► C FindletModule< TrackFinderSegmentPairAutomaton >
C TFCDC_TrackFinderSegmentPairAutomatonModule Module implementation using the TrackFinderSegmentPairAutomaton
► C FindletModule< TrackFinderSegmentTripleAutomaton >
C TFCDC_TrackFinderSegmentTripleAutomatonModule Module implementation using the TrackFinderSegmentTripleAutomaton
► C FindletModule< TrackCreatorSingleSegments >
C TFCDC_TrackCreatorSingleSegmentsModule Module implementation using the TrackCreatorSingleSegments
► C FindletModule< TrackCreatorSegmentPairAutomaton >
C TFCDC_TrackCreatorSegmentPairAutomatonModule Module implementation using the TrackCreatorSegmentPairAutomaton
► C FindletModule< TrackCreatorSegmentTripleAutomaton >
C TFCDC_TrackCreatorSegmentTripleAutomatonModule Module implementation using the TrackCreatorSegmentTripleAutomaton
► C FindletModule< SegmentPairCreator >
C TFCDC_SegmentPairCreatorModule Module implementation using the SegmentPairCreator
► C FindletModule< AxialSegmentPairCreator >
C TFCDC_AxialSegmentPairCreatorModule Module implementation using the AxialSegmentPairCreator
► C FindletModule< SegmentTripleCreator >
C TFCDC_SegmentTripleCreatorModule Module implementation using the SegmentTripleCreator
► C FindletModule< SegmentFinderFacetAutomaton >
C TFCDC_SegmentFinderFacetAutomatonModule Module implementation using the SegmentFinderFacetAutomaton
► C FindletModule< FacetCreator >
C TFCDC_FacetCreatorModule Module implementation using the FacetCreator
► C FindletModule< SegmentCreatorFacetAutomaton >
C TFCDC_SegmentCreatorFacetAutomatonModule Module implementation using the SegmentCreatorFacetAutomaton
► C FindletModule< SegmentLinker >
C TFCDC_SegmentLinkerModule Module implementation using the SegmentLinker
► C FindletModule< SegmentOrienter >
C TFCDC_SegmentOrienterModule Module implementation using the SegmentOrienter
► C FindletModule< SegmentFitter >
C TFCDC_SegmentFitterModule Module implementation using the SegmentFitter
► C FindletModule< SegmentRejecter >
C TFCDC_SegmentRejecterModule Module implementation using the SegmentRejecter
► C FindletModule< SegmentCreatorMCTruth >
C TFCDC_SegmentCreatorMCTruthModule Module implementation using the SegmentCreatorMCTruth
► C FindletModule< SegmentTrackCombiner >
C TFCDC_SegmentTrackCombinerModule Module for the combination of tracks and segments
► C FindletModule< StereoHitFinder >
C TFCDC_StereoHitFinderModule Tries to add CDC stereo hits to the found CDC tracks by applying a histogramming method with a quad tree
► C FindletModule< MonopoleStereoHitFinderQuadratic >
C TFCDC_MonopoleStereoHitFinderQuadraticModule Tries to add CDC stereo hits to the found CDC tracks by applying a histogramming method with a quad tree
► C FindletModule< MonopoleStereoHitFinder >
C TFCDC_MonopoleStereoHitFinderModule Tries to add CDC stereo hits to the found CDC tracks by applying a histogramming method with a 3D hough tree looking for hyperbolic cosines
► C FindletModule< TrackLinker >
C TFCDC_TrackLinkerModule Module implementation using the TrackLinker
► C FindletModule< TrackCombiner >
C TFCDC_TrackCombinerModule Module implementation using the TrackCombiner
► C FindletModule< TrackRejecter >
C TFCDC_TrackRejecterModule Module implementation using the TrackRejecter
► C FindletModule< TrackQualityAsserter >
C TFCDC_TrackQualityAsserterModule Module implementation using the TrackQualityAsserter
► C FindletModule< TrackOrienter >
C TFCDC_TrackOrienterModule Module implementation using the TrackOrienter
► C FindletModule< TrackFlightTimeAdjuster >
C TFCDC_TrackFlightTimeAdjusterModule Module implementation using the TrackFlightTimeAdjuster
► C FindletModule< TrackExporter >
C TFCDC_TrackExporterModule Module implementation using the TrackExporter
► C FindletModule< WireHitPreparer >
C TFCDC_WireHitPreparerModule Module to set up the cdcwire hits used in all CDC track finding algorithms (except Trasan)
► C FindletModule< WireHitCreator >
C TFCDC_WireHitCreatorModule Module implementation using the WireHitCreator
► C FindletModule< HitReclaimer >
C TFCDC_HitReclaimerModule Module to reclaim CDC hits
► C FindletModule< WireHitBackgroundDetector >
C TFCDC_WireHitBackgroundDetectorModule Module counterpart to the WireHitBackgroundDetector findlet, which marks CDCWireHits as background based on the result of a filter
► C FindletModule< CKFToSVDSeedFindlet >
C CDCToSVDSeedCKFModule Seed-finding combinatorial Kalman Filter that combines every RecoTrack with every SVD track, then filters the combinations
► C FindletModule< CKFToSVDFindlet >
C CDCToSVDSpacePointCKFModule Combinatorial Kalman Filter used for extrapolating CDC tracks into SVD and create merged tracks
► C FindletModule< CosmicsTrackMergerFindlet >
C CosmicsTrackMergerModule Module linking tracks based on their Phi parameter
► C FindletModule< DATCONFPGAFindlet >
C DATCONModule DATCON module which implementation is close to the one actually used on the FPGA
► C FindletModule< MCVXDCDCTrackMergerFindlet >
C MCVXDCDCTrackMergerModule This module merges tracks which are reconstructed, separately, in the silicon (PXD+VXD) and in the CDC using MC
► C FindletModule< vxdHoughTracking::SVDHoughTracking >
C SVDHoughTrackingModule Full Hough Transformation based SVD track finding
► C FindletModule< CKFToCDCFindlet >
C ToCDCCKFModule Combinatorial Kalman Filter that extrapolates every RecoTrack into the CDC and collects wire hits
► C FindletModule< CKFToCDCFromEclFindlet >
C ToCDCFromEclCKFModule Combinatorial Kalman Filter that extrapolates every ECLShower into the CDC and collects wire hits
► C FindletModule< CKFToPXDFindlet >
C ToPXDCKFModule Combinatorial Kalman Filter that extrapolates every RecoTrack into the PXD and collects space points
► C FindletModule< AsicBackgroundLibraryCreator >
C AsicBackgroundLibraryCreatorModule Module for creating ASIC background library
► C FindletModule< CDCTrackingEventLevelMdstInfoFillerFromHitsFindlet >
C CDCTrackingEventLevelMdstInfoFillerFromHitsModule Module interface to the CDCTrackingEventLevelMdstInfoFillerFromHitsFindlet
► C FindletModule< CDCTrackingEventLevelMdstInfoFillerFromSegmentsFindlet >
C CDCTrackingEventLevelMdstInfoFillerFromSegmentsModule Module interface to the CDCTrackingEventLevelMdstInfoFillerFromSegmentsFindlet
► C FindletModule< TrackFinderAutomaton >
C TFCDC_TrackFinderAutomatonModule Module for the cellular automaton tracking for the CDC on regular events
► C FindletModule< TrackFinderCosmics >
C TFCDC_TrackFinderCosmicsModule Module for the cellular automaton tracking for the CDC on cosmic events
► C FindletModule< TrackFinder >
C TFCDC_TrackFinderModule Module for the track finder combining global and local search
C ARICHDigitizerModule ARICH digitizer module
C ARICHFillHitsModule Fill ARICHHit collection from ARICHDigits
C ARICHMCParticlesModule Module to match ARICH hits to MCParticles
C ARICHNtupleModule ARICH reconstruction efficiency test module
C ARICHPackerModule Raw data packer for ARICH
C ARICHReconstructorModule ARICH subdetector main module
C ARICHRelateModule Creates relations between ARICHAeroHits and ExtHits
C ARICHUnpackerModule Raw data unpacker for ARICH
C AWESOMEBasicModule The AWESOME basic module
C AddVXDTrackCandidateSubSetsModule Module that creates additional candidates that each miss a different SpacePoint
C AlignmentGeneratorModule Generate VXD misalignment and store in database
C AllParticleCombinerModule This module combines all particles of the provided list to one mother particle
C AnalysisConfigurationModule Class to hold general basf2 configuration Used to initiate and configure CreateAnalysis object
► C AsyncWrapper Wraps a given Module to execute it asynchronously
C AsyncDisplayModule Wraps DisplayModule and starts it in a forked process
C EclDisplayAsyncModule Displays energy distribution in ECL
C B2BIIConvertBeamParamsModule Convert the IpProfile and Benergy to BeamParameters , BeamSpot , CollisionInvariantMass and CollisionBoostVector
C B2BIIConvertMdstModule Module converts Belle MDST objects (Panther records) to Belle II MDST objects
C B2BIIFixMdstModule Declaration of class B2BIIFixMdst
C B2BIIMdstInputModule Module reads Belle MDST files and converts Belle_event record to Belle II EventMetaData StoreObjectPointer
C BBBremInputModule The BBBrem Generator module
C BGOverlayExecutorModule Overlay of measured background with simulated data (Digits or Clusters)
C BGOverlayInputModule Beam BG data input, either in form of Digits or raw data
C BHWideInputModule The BHWide Generator module.vectorToPair
C BKLMAnaModule A class defining a module that perform efficiencies studies on bklm
C BKLMDigitAnalyzerModule Module useful to quickly analyze BKLM unpacked data
C BKLMSimHistogrammerModule Convert BKLM raw simulation hits to digitizations
C BKLMTrackingModule This module perform straight line track finding and fitting for BKLM
► C BaseRecoFitterModule A base class for all modules that implement a fitter for reco tracks
C DAFRecoFitterModule DAF fitter
C KalmanRecoFitterModule Kalman fitter
► C BaseTrackTimeEstimatorModule Base Module estimating the track time of RecoTracks - before or after the fit
C IPTrackTimeEstimatorModule Base Module estimating the track time of RecoTracks - before or after the fit
C PlaneTriggerTrackTimeEstimatorModule Module estimating the track time of RecoTracks - before or after the fit
C RadiusTrackTimeEstimatorModule Module estimating the track time of RecoTracks - before or after the fit
C BeamBkgGeneratorModule Beam background generator based on SAD files
C BeamBkgHitRateMonitorModule A module to monitor detector hit rates of beam background Output is to a flat ntuple
C BeamBkgMixerModule New beam background mixer; this one doesn't need ROF files
C BeamBkgTagSetterModule A module that sets m_backgroundTag variable in SimHits (see BackgroundMetaData.h )
C BeamParametersModule Setting of beam parameters
C BeamSpotMonitorModule Module for the monitoring of the BeamSpot position and size
C BelleBremRecoveryModule Brem recovery module (used in past belle analyses) This module add four vector of all the brem photon to the four vector associated to the charged particle
C BelleMCOutputModule KLM digitization module
C BelleNbarMVAModule Apply nbarMVA for Belle I
C BestCandidateSelectionModule Ranks particles by the values of a variable
C BestVXDFamilyCandidateSelectorModule Module that selects the best candidate for each SPTC family
C BestVXDTrackCandidatesSelectorModule Module that selects a subset with a fixed size x out of all SpacePointTrackCandidates
C BoostMCParticlesModule Module for boosting the MCParticles from CM to LAB frame
C BremsFinderModule Bremsstrahlung finder correction module For each lepton in the input particle list, this module copies it to the output particle list and uses the results of the eclTrackBremFinder module to look for a possible bremsstrahlung photon; if this photon exists, adds its four momentum to the leptons in the output list
C BtubeCreatorModule Create a B particle from a Bbar particle
C CDCCosmicAnalysisModule Analysis module for CDC CR data
C CDCHitFilterModule CDCHitFilter: Filters CDC hits according to given configuration criteria
C CDCPackerModule CDCPackerModule : The CDC Raw Hits Decoder
C CDCRecoTrackFilterModule The module excluding hits of specified Slayers in the RecoTracks
C CDCUnpackerModule CDCUnpackerModule : The CDC Raw Hits Decoder
C CDCCKFTracksCombinerModule Module to combine RecoTracks
C CDCCosmicSelectorAfterFullSimModule The Class for
C CDCCosmicSelectorModule The Class for
C CDCCosmicTrackMergerModule Module use to select two cosmic tracks event and merger these two tracks become one
C CDCCrossTalkAdderModule The Class for overlaying signal-induced asic cross-talk
C CDCDedxCorrectionModule This module may be used to apply the corrections to dE/dx per the calibration constants
C CDCDedxHitSaverModule Module that stores CDC hit information needed for dedx
C CDCDedxPIDCreatorModule Module that creates PID likelihoods from CDC hit information stored in CDCDedxHits using parameterized means and resolutions
C CDCDedxPIDModule Extract CDC dE/dx information from fitted tracks
C CDCDedxScanModule This class performs the same function as CDCDedxPIDModule , but does so without using real objects from basf2
C CDCDedxSkimCDSTModule Extracts dE/dx information for calibration testing
C CDCDedxSkimModule This module may be used to skim a data sample according to a specific set of cuts
C CDCDigitizerModule The Class for Detailed Digitization of CDC
C CDCInitialT0DeterminationModule Determine crude t0
C CDCJobCntlParModifierModule The Class for Detailed Digitization of CDC
C CDCTrigger2DFinderModule
C CDCTrigger2DFitterModule Module for the 2D Fitter of the CDC trigger
C CDCTrigger3DFitterModule Module for the 3D Fitter of the CDC trigger
C CDCTriggerETFModule Module for the Event Time Finder of the CDC trigger
C CDCTriggerHoughETFModule
C CDCTriggerMCMatcherModule A module to match CDCTriggerTracks to MCParticles
C CDCTriggerNDFinderModule CDC Trigger NDFinder Module
C CDCTriggerNeuroDataModule
C CDCTriggerNeuroIDHistModule Description
C CDCTriggerNeuroModule The neural network module of the CDC trigger
C CDCTriggerRecoHitMatcherModule A module to match CDCTriggerTracks to RecoTracks
C CDCTriggerRecoMatcherModule A module to match CDCTriggerTracks to RecoTracks
C CDCTriggerTSFFirmwareModule This class is the interface between TSim/basf2 TSF module and the firmware simulation core of XSim/ISim
C CDCTriggerTSFModule Module for the Track Segment Finder of the CDC trigger
C CDCTriggerTrackCombinerModule Module to combine the information from the various track trigger stages
C CDCTriggerUnpackerModule Unpack the trigger data recorded in B2L
C CRYInputModule The CRY Generator module
C CertifyParallelModule A class definition of an input module for Sequential ROOT I/O
C ChargedPidMVAModule This module evaluates the response of an MVA trained for binary charged particle identification between two hypotheses, S and B
C ChargedPidMVAMulticlassModule This module evaluates the response of a multi-class MVA trained for global charged particle identification
C Chi2MCTrackMatcherModule Monte Carlo matcher using the helix parameters for matching by chi2-method
C ClusterMatcherModule Match KLM Clusters to close ECL Clusters
C CollectorTestModule CollectorTestModules
C ContinuumSuppressionBuilderModule Creates for each Particle in given ParticleList an ContinuumSuppression dataobject and makes basf2 relation between them
C Convert2RawDetModule A class definition of a module to convert from RawCOPPER or RawDataBlock to RawDetector objects
C CopyRecoTracksWithOverlapModule Copy RecoTracks with overlap hits in VXD to a new StoreArray (Will need a refit)
C CosmicsAlignmentValidationModule Module to find Track correlation in cosmic events
C CosmicsModule The Cosmics module Generates tracks with the cosmics generator and store them into the MCParticle class
C CreateConsistencyInfoModule If you want to merge two events with the 'MergeDataStoreModule ', it might be necessary to make sure that this combination of events make sense
C CreateFieldMapModule Create Field maps of the Belle II magnetic field used in the simulation
C CurlTaggerModule This module is designed to tag curl tracks
C CurlingTrackCandSplitterModule Module for checking SpacePointTrackCandidates for curling behaviour and splitting them into Track Candidate Stubs (each of them being a SpacePointTrackCand again) which do not show curling behaviour
C DAQPerfModule A class definition of an input module for Sequential ROOT I/O
► C DQMHistAnalysisModule The base class for the histogram analysis module
C DQMHistAnalysisARICHModule Make summary of data quality from reconstruction
C DQMHistAnalysisARICHMonObjModule Example module of how to use MonitoringObject in DQMHistAnalysis module
C DQMHistAnalysisCDCDedxModule DQM analysis module grab canvases from DQM module and perform higher level operation like histogram fitting and add many useful cosmetic
C DQMHistAnalysisCDCEpicsModule Make summary of data quality from reconstruction
C DQMHistAnalysisCDCMonObjModule Make summary of data quality from reconstruction
C DQMHistAnalysisDAQMonObjModule Make summary of data quality from reconstruction
C DQMHistAnalysisDeltaEpicsMonObjExampleModule DQM Delta Histogram Test code and example
C DQMHistAnalysisDeltaTestModule DQM Delta Histogram Test code and example
C DQMHistAnalysisECLConnectedRegionsModule This module is for analysis of ECL DQM histograms
C DQMHistAnalysisECLModule This module is for analysis of ECL DQM histograms
C DQMHistAnalysisECLOutOfTimeDigitsModule This module exports the average value of out-of-time ECLCalDigits into EPICS and MiraBelle
C DQMHistAnalysisECLShapersModule This module is for analysis of ECL DQM histograms
C DQMHistAnalysisECLSummaryModule This module provides a high-level display to show which ECLCollectors have channels with various type of issues See https://indico.belle2.org/event/10116/contributions/66837/attachments/23993/35443/2023.09.06_ecl.dqm.status_mikhail.remnev.pdf
C DQMHistAnalysisEpicsEnableModule Example module of how to use MonitoringObject in DQMHistAnalysis module
C DQMHistAnalysisEpicsExampleModule Class definition for the output module of Sequential ROOT I/O
C DQMHistAnalysisEpicsOutputModule Example module of how to use MonitoringObject in DQMHistAnalysis module
C DQMHistAnalysisEventT0EfficiencyModule Class definition
C DQMHistAnalysisEventT0TriggerJitterModule Class definition
C DQMHistAnalysisExampleFlagsModule Class definition for the output module of Sequential ROOT I/O
C DQMHistAnalysisExampleModule Class definition for the output module of Sequential ROOT I/O
C DQMHistAnalysisHLTModule Class for HLT-related histogram analysis
C DQMHistAnalysisHLTMonObjModule Creates monitoring object for HLT
C DQMHistAnalysisInput2Module Class to read histograms from a root file for online analysis modules
C DQMHistAnalysisInputPVSrvModule Class definition for the output module of Sequential ROOT I/O
C DQMHistAnalysisInputRootFileModule Class to read histograms from a root file for offline testing of analysis modules
C DQMHistAnalysisInputTestModule Class to dynamically fill histograms from a config file for offline testing of analysis modules
C DQMHistAnalysisKLM2Module Analysis of KLM DQM histograms
C DQMHistAnalysisKLMModule Analysis of KLM DQM histograms
C DQMHistAnalysisMiraBelleModule Make summary of data quality from reconstruction
C DQMHistAnalysisMonObjModule Example module of how to use MonitoringObject in DQMHistAnalysis module
C DQMHistAnalysisOutputFileModule Class definition for the output module of Sequential ROOT I/O
C DQMHistAnalysisOutputImagesModule Class definition for the output to image module
C DQMHistAnalysisOutputMonObjModule Class definition for the module to store MonitoringObject to output root file
C DQMHistAnalysisOutputRelayMsgModule Class definition for the output module of Sequential ROOT I/O
C DQMHistAnalysisPXDCMModule DQM Histogram Analysis for PXD Common Modes
C DQMHistAnalysisPXDChargeModule DQM Histogram Analysis for PXD Cluster Charge
C DQMHistAnalysisPXDDAQModule DQM Histogram Analysis for PXD DAQ
C DQMHistAnalysisPXDERModule PXD DQM AnalysisModule
C DQMHistAnalysisPXDEffModule DQM Histogram Analysis for PXD Efficiency
C DQMHistAnalysisPXDFitsModule Class definition for the output module of Sequential ROOT I/O
C DQMHistAnalysisPXDInjectionModule DQM Histogram Analysis for PXD occupancy after Injection
C DQMHistAnalysisPXDReductionModule DQM Histogram Analysis for PXD Reduction
C DQMHistAnalysisPXDTrackChargeModule DQM Histogram Analysis for PXD Cluster Charge
C DQMHistAnalysisPeakModule DQM Histogram Analysis for simple peaking distributions
C DQMHistAnalysisPhysicsModule DQM Histogram Analysis for Physics
C DQMHistAnalysisRooFitExampleModule Class definition for the output module of Sequential ROOT I/O
C DQMHistAnalysisRunNrModule DQM Histogram Analysis for PXD Common Modes
C DQMHistAnalysisSVDDoseModule The SVD dose-monitoring DQM analysis module
C DQMHistAnalysisSVDGeneralModule Class definition for the output module of Sequential ROOT I/O
► C DQMHistAnalysisSVDModule Class definition for common method
C DQMHistAnalysisSVDClustersOnTrackModule Class definition for the output module of Sequential ROOT I/O
C DQMHistAnalysisSVDEfficiencyModule Class definition for the output module of Sequential ROOT I/O
C DQMHistAnalysisSVDOccupancyModule Class definition for the output module of Sequential ROOT I/O
C DQMHistAnalysisSVDUnpackerModule Class definition for the output module of Sequential ROOT I/O
C DQMHistAnalysisSVDOnMiraBelleModule Class derived from HistoModule , for SVD monitoring variables at MiraBelle
C DQMHistAnalysisTOPModule Class for TOP histogram analysis
C DQMHistAnalysisTRGECLModule Module for DQM histogram of ECL trigger event timing
C DQMHistAnalysisTRGEFFModule Make summary of data quality from reconstruction
C DQMHistAnalysisTRGGDLModule Make summary of data quality from reconstruction
C DQMHistAnalysisTRGModule DQM Trigger Histogram code and example
C DQMHistAnalysisTrackingAbortModule Analysis of HLT Tracking DQM plots
C DQMHistAnalysisTrackingERModule Analysis of ER Tracking DQM plots
C DQMHistAnalysisTrackingHLTModule Analysis of HLT Tracking DQM plots
C DQMHistAnalysisV0Module Class definition for the output module of Sequential ROOT I/O
C DQMHistAutoCanvasModule Class definition for the reference histogram display
C DQMHistComparitorModule Class definition for the reference histogram display
C DQMHistDeltaHistoModule Class for generating snapshots for histograms
C DQMHistInjectionModule DQM Histogram Analysis for PXD Efficiency
C DQMHistOutputToEPICSModule Write DQM Histogram Content to EPICS Arrays
C DQMHistReferenceModule Class to add DQM reference histograms
C DQMHistSnapshotsModule Class for generating snapshots for histograms
C DataWriterModule Module to write Ntuples for KlId BKG classifier training
► C DeSerializerModule A class definition of an input module for Sequential ROOT I/O
► C DeSerializerCOPPERModule A class definition of an input module for Sequential ROOT I/O
C DeSerializerFILEModule A class definition of an input module for Sequential ROOT I/O
► C DeSerializerPCModule A class definition of an input module for Sequential ROOT I/O
C DeSerializerHLTModule A class definition of an input module for Sequential ROOT I/O
C DeSerializerPrePCModule A class definition of an input module for Sequential ROOT I/O
C DeSerializerPXDModule A class definition of an input module for Sequential ROOT I/O
C DensityScalerModule Scale density of simulation/reconstruction geometry
C DesSerPrePCMainModule A class definition of an input module for Sequential ROOT I/O
C DisplayModule The event display module
C DistanceCalculatorModule Calculates distance between two vertices, distance of closest approach between a vertex and a track, distance of closest approach between a vertex and Btube
C DqmHistoManagerModule Class definition of DqmHistoManager module
C Ds2RawFileModule A class definition of an input module for Sequential ROOT I/O
C Ds2RawModule A class definition of an input module for Sequential ROOT I/O
C Ds2RbufModule A class definition of an input module for Sequential ROOT I/O
C Ds2SampleModule A class definition of an input module for Sequential ROOT I/O
C DummyDataPackerModule Module to store dummy data in RawCOPPER object
► C DummyDataSourceModule A class definition of an input module for Sequential ROOT I/O
C DummyDataSourceFileModule A class definition of an input module for Sequential ROOT I/O
C DuplicateVertexMarkerModule Identify duplicate vertices (distinct particles, but built from the same daughters) and mark the one with best chi2
C ECLLOMModule This module simulates ECL Luminosity Online Monitor logic, i.e
► C ECLCRFinderModule Class to find connected regions
C ECLCRFinderPureCsIModule Class to find connected regions, pureCsI version
C ECLChargedPIDDataAnalysisModule The ECL Charged PID Data Analysis Module
C ECLChargedPIDDataAnalysisValidationModule This module dumps a tree and a set of histograms of ECL PID-related info used for validation, starting from an input file w/ particle-gun-generated charged stable particles (and antiparticles)
C ECLChargedPIDMVAModule This module implements charged particle identification using ECL-related observables via a multiclass MVA
C ECLChargedPIDModule The module implements charged particle identification using ECL-related observables
► C ECLClusterPSDModule This module computes shower variables using pulse shape information from offline two component fits
C ECLClusterPSDPureCsIModule Class derived from ECL, only difference are the names
C ECLClusterPropertiesModule This module calculates some properties of ECL clusters
C ECLCompressBGOverlayModule The ECLCompressBGOverlay module compresses recorded waveforms triggered by the random trigger and to use them in simulation to follow background conditions
► C ECLCovarianceMatrixModule Class to perform the shower correction
C ECLCovarianceMatrixPureCsIModule The very same module but for PureCsI
C ECLDataAnalysisModule The ECL Data Analysis Module
C ECLDigiStudyModule A module to analyse digit level information
► C ECLDigitCalibratorModule Class to find calibrate digits and convert waveform fit information to physics quantities
C ECLDigitCalibratorPureCsIModule Class derived from ECLDigitCalibratorModule , only difference are the names
C ECLDigitizerModule The ECLDigitizer module
C ECLDigitizerPureCsIModule The ECLDigitizerPureCsI module
C ECLDumpGeometryModule Dump location and direction of all ECL crystals
C ECLEventT0Module EventT0 from ECL
C ECLExpertModule Module to perform the ECL Klong ID classification
C ECLFillCellIdMappingModule Fills a dataobject that provides mapping between cell id and ECLCalDigit store array
► C ECLFinalizerModule Class to perform the shower correction
C ECLFinalizerPureCsIModule The very same module but for PureCsI
C ECLHitDebugModule Class to represent the hit of one cell
► C ECLLocalMaximumFinderModule Class to find connected regions
C ECLLocalMaximumFinderPureCsIModule Class to find connected regions, pureCsI version
C ECLLocalRunCalibratorModule ECLLocalRunCalibratorModule is the module developed to perform ECL local run calibration
C ECLMatchingPerformanceExpertModule This module takes the Track collection as input and checks if one of the related ExtHits matches with an ECLCalDigit of at least 2 MeV
C ECLPackerModule Module that pack's MC info into a dataformat that comes from the detector
► C ECLShowerCorrectorModule Class to perform the shower correction
C ECLShowerCorrectorPureCsIModule The very same module but for PureCsI
► C ECLShowerShapeModule Class to perform the shower correction
C ECLShowerShapePureCsIModule The very same module but for PureCsI
► C ECLSplitterN1Module Class to perform the shower correction
C ECLSplitterN1PureCsIModule The very same module but for PureCsI
► C ECLSplitterN2Module Class to perform the shower correction
C ECLSplitterN2PureCsIModule The very same module but for PureCsI
C ECLTRGInformationModule Module to get ECL TRG energy information
C ECLTrackBremFinderModule Module to assign ECL Clusters resulting from Bremsstrahlung to the primary electron track
C ECLTrackCalDigitMatchModule Module to find the closest ECLCalDigits to an extrapolated track
C ECLTrackClusterMatchingModule The module creates and saves a Relation between Tracks and ECLCluster in the DataStore
C ECLTrackClusterMatchingParametrizationExpertModule The module saves information on ExtHits and related cluster into a file
C ECLTrackClusterMatchingPerformanceModule This module takes the MCParticle collection as input and checks if the related reconstructed track is matched to an ECLCluster
C ECLTriggerClusterMatcherModule Match ECLTRGClusters to ECLClusters
C ECLTrimShowersAndDigitsModule Create new dataobjects containing only the ECLShower and ECLCalDigits associated with the selected ECLCluster , which is the one with maximum related MC energy
C ECLUnpackerModule ECL unpacker module
C ECLWaveformFitModule Module performs offline fit for saved ECL waveforms
C EKLMDataCheckerModule Module for checking of collected data
C EclCovMatrixNtupleModule Module to write ECL waveform and fitted time and amplitude information in a root ntuple
C EclDisplayModule Displays energy distribution in ECL
C EffPlotsModule This module takes the MCParticles, the RecoTracks and Tracks/V0 in input and produce a root file containing various histograms showing the efficiencies (as a function of different variables) of the V0 finding module
C ElapsedTimeModule A class definition of an input module for Sequential ROOT I/O
C EnergyBiasCorrectionModule Energy bias correction
C EvReductionModule A class definition of an input module for Sequential ROOT I/O
C EventErrorFlagModule Module to check or add error flags of the EventMetaData
C EventInfoPrinterModule The event meta data info module
C EventInfoSetterModule Module to set event, run, experiment numbers
C EventKinematicsModule Module to compute global quantities related to the event kinematics, like total missing energy and mass2, visible energy, etc
C EventLimiterModule The EventLimiter module
C EventShapeCalculatorModule Module to compute event shape variables starting from three lists of particle objects (tracks, gammas, Klongs)
C EventT0CombinerModule Module to combine the EventT0 values from multiple sub-detectors
C EventT0GeneratorModule Module generates discrete event t0 in ~4ns steps (bunch spacing) according to (double) gaussian distribution and adds it to the production and decay times of MCParticles
C EventT0ShifterModule Module that shifts the time of all MCParticles so that the collision is at t=0
C EventT0ValidationModule This module to design collect the event t0 values base on different detectors and physics processes
C EventsOfDoomBusterModule Module that flags an event destined for doom at reconstruction, based on the size of selected hits/digits containers after the unpacking
C EvtGenDecayModule This module decays unstable particles using EvtGen
C ExportGeometryModule The ExportGeometry module
C ExtModule The geant4e-based track extrapolation module
C ExtraInfoPrinterModule Prints the names of the ExtraInfos for a ParticleList or for the Event
C ExtraInfoRemoverModule This module deletes the extrainfo of each particle in the given ParticleLists
C FBXWriterModule The FBX-writer module
C FastBDTClassifierAnalyzerModule Module to evaluate a trained fastBDT
C FastBDTClassifierTrainingModule Module for collecting the data and training a FastBDT classifier
C FastRbuf2DsModule A class definition of an input module for Sequential ROOT I/O
C FillTrackFitNtupleModule This module takes the Tracks and the RecoTrack input and produce a root file containing an nutple showing the track fit members in parallel for different particle hypotheses
C FittedTracksStorerModule A module to copy only the fitted reco tracks to the output store array
C FixMergedObjectsModule If the content of two DataStores are merged using the 'MergeDataStoreModule ', then Relations of the objects are corrected
C FlavorTaggerInfoBuilderModule Creates for each Particle and RestOfEvent object in the DataStore a FlavorTaggerInfo dataobject and makes basf2 relation between them
C FlavorTaggerInfoFillerModule Creates a new flavorTaggerInfoMap DataObject for the specific methods
C FlipQualityModule This module can be used for applying the MVA filters and get the 2 flipping QIs
C FlippedRecoTracksMergerModule Module to merge the original and flipped RecoTracks
C FragmentationModule The Fragmentation module
C FullSimModule The full Geant4 simulation module
C FullSimTimingModule Provide more detailled timing info for FullSim module
C TRGGDLUnpackerModule A module of TRG TRG Unpacker
C GFTC2SPTCConverterModule Module for converting genfit::TrackCands to SpacePointTrackCands
C GRLNeuroModule The module for application of the neural networks of the GRL
C GRLNeuroTrainerModule The trainer module for the neural networks of the CDC trigger
C GearboxModule The Gearbox module
C GenRawSendModule
C GeneratedVertexDisplacerModule "Takes a list of PDG values and lifetime parameters to displaces the vertex of MCParticles with matching PDG value and their subsequent daughters corresponding to the given lifetime parameter(s). Can be used between the generator and the detector simulation. Lifetime options are "flat", "fixed" and "exponential" where the lifetime(s) should be passed as c*tau in units of [cm]. Furthermore, a "fixedLength" option can be used where the lifetime parameter takes the desired fixed decaylength in units of [cm]
► C GeneratorBaseModule The base module for generator modules, which sets the generator information as EventExtraInfo
C AafhInputModule AAFH Generator to generate 2-fermion events like e+e- -> e+e-e+e-
C BabayagaNLOInputModule The Babayaga.NLO Generator module
C EvtGenInputModule The EvtGenInput module
C KKGenInputModule The KKGenInput module
C KoralWInputModule The KoralW Generator module
C PhokharaInputModule The Phokhara Generator module.vectorToPair
C TrepsInputModule Input from TREPS generator for ee->eeff
C GeneratorPreselectionLeptonicModule Generator filtering
C GeneratorPreselectionModule Generator preselection
C GenfitVisModule Visualize genfit::Tracks using the genfit::EventDisplay
C GeometryModule Module to facilitate Geometry creation
C GetEventFromSocketModule A class definition of an input module for Sequential ROOT I/O
C HLTDQM2ZMQModule Module to collect DQM histograms (written out by HistoModules) and send them every time period to a running ZMQ DQM server (either a finalhistoserver or a proxyhistorver)
C HLTDs2ZMQModule On every event, serialize the data store and send the binary data out to the connected ZMQ application (most likely a collector or final collector)
C HLTDs2ZMQRawModule On every event, serialize the data store and send the binary data out to the connected ZMQ application (most likely a collector or final collector)
C HLTZMQ2DsDirectModule Special ZMQ2Ds module without the HLT-specific handling of initialization and begin/end run
C HLTZMQ2DsModule Input module in the ZMQ reconstruction path receiving events via ZMQ and deserializing the to the data store
C HelixErrorScalerModule Scale the error of helix parameters
C HepMCInputModule The HepMCInput module
C HepMCOutputModule The HepMCOutput module
C HepevtInputModule The HepevtInput module
C HepevtOutputModule The HepevtOutput module
C HexDataPackerModule Module to store dummy data in RawCOPPER object
C HistoManagerModule Class definition of HistoManager module
► C HistoModule HistoModule.h is supposed to be used instead of Module.h for the modules with histogram definitions to be managed by HistoManager
C ARICHDQMModule Make summary of data quality from reconstruction
C ARICHRateCalModule Fill ARICHHit collection from ARICHDigits
C ARICHRawUnpackerModule Fill ARICHHit collection from ARICHDigits
C AnalysisPhase1StudyModule Study module for BEAST
C B2BIIMCParticlesMonitorModule Declaration of class B2BIIMCParticlesMonitor
C CDCCRTestModule CDC Cosmic test calibration module
C CDCDQMModule Make summary of data quality from reconstruction
C CDCDedxDQMModule This module to design collect CDC dEdx monitoring for DQM and only minimal information are stored
C CDCDedxValidationModule First version committed on Feb 21 2019 Extracts dE/dx information for validation and writes a ROOT file
C CDCTriggerNeuroDQMModule CDC Trigger DQM Module
C CDCTriggerNeuroDQMOnlineModule CDC Trigger DQM Module
► C CalibrationCollectorModule Calibration collector module base class
C ARICHChannelMaskModule ARICH channel-mask calibration: data collector
C BeamSpotCollectorModule This collects the track parameters of the mu+mu- events for calibration of the BeamSpot using CAF and AirFlow
C BoostVectorCollectorModule This collects the track parameters and momenta of the mu+mu- events for calibration of the BoostVector using CAF and AirFlow
C CDCBadWireCollectorModule Collect hit information for cdc calibration with CAF
C CDCCalibrationCollectorModule Collect hit information for cdc calibration with CAF
C CDCCrudeT0CollectorModule Collector for crude t0
C CDCFudgeFactorCalibrationCollectorModule Collect hit information for cdc calibration with CAF
C CDCT0CalibrationCollectorModule Collect hit information for cdc calibration with CAF
C CDCDedxElectronCollectorModule A collector module for CDC dE/dx electron calibrations
C CDCDedxHadronCollectorModule A collector module for CDC dE/dx hadron calibrations
C CaTestModule Testing module for collection of calibration data
C DummyCollectorModule Basically empty Collector, makes only a tiny amount of output data
C ECLBhabhaTCollectorModule This module generates time vs crystal 2D histograms to later (in eclBhabhaTAlgorithm ) find time crystal/crate offsets from bhabha events
C EKLMAlignmentAlongStripsCollectorModule EKLM time calibration (data collection)
C EcmsCollectorModule Collector for the collision energy calibration based on the hadronic modes
C KLMChannelStatusCollectorModule KLM channel status calibration (data collection)
C KLMStripEfficiencyCollectorModule Module KLMStripEfficiencyCollectorModule
C KLMTimeCollectorModule Collect hit information for KLM time calibration with CAF
C MillepedeCollectorModule Calibration data collector for Millepede Algorithm
C PXDClusterChargeCollectorModule Collector module for PXD gain calibration
C PXDClusterPositionCollectorModule Calibration collector module for PXD cluster position estimation
C PXDHotPixelMaskCollectorModule Calibration Collector Module for PXD hot pixel masking from PXDDigits
C PXDPerformanceCollectorModule Collector module for PXD gain calibration and PXD calibration validation
C PXDPerformanceVariablesCollectorModule Collector module for PXD gain calibration and PXD calibration validation
C PXDRawHotPixelMaskCollectorModule Calibration Collector Module for PXD hot pixel masking from PXDRawHits
C SVDClusterTimeShifterCollectorModule This module creates and fills histograms based on cluster-sizes so that the mean of SVD-cluster time distribution could be calculated
C SVDCrossTalkCalibrationsCollectorModule Collector module used to create the histograms needed for the cross talk calibration
C SVDOccupancyCalibrationsCollectorModule This This module collects hits from shaper digits to compute per sensor SVD occupancy using mu+mu- events for calibration of the SVDOccupancyCalibration payload using CAF
C SVDTimeCalibrationCollectorModule Collector module used to create the histograms needed for the SVD CoG-Time calibration
C SVDTimeValidationCollectorModule Collector module used to create the histograms needed for the SVD CoG-Time calibration
C SVDdEdxCollectorModule Collector module used to create the histograms needed for the SVD dE/dx calibration
C SVDdEdxValidationCollectorModule Collector module used to create the histograms needed for the SVD dE/dx calibration
C TOPAlignmentCollectorModule Collector for geometrical alignment of a TOP module with dimuons or Bhabhas
C TOPAsicShiftsBS13dCollectorModule Collector for carrier shifts of BS13d
C TOPChannelMaskCollectorModule Collector for preparing masks of hot and dead channels
C TOPCommonT0BFCollectorModule Collector for common T0 calibration with a fit of bunch finder residuals (method BF)
C TOPCommonT0LLCollectorModule Collector for common T0 calibration with neg
C TOPLaserCalibratorCollectorModule Collector module for the TOP channelT0 calibration and, more in general, for the time resolution studies using the laser and pulser data
C TOPModuleT0DeltaTCollectorModule Collector for module T0 calibration with chi2 minimization of time differences between slots (method DeltaT)
C TOPModuleT0LLCollectorModule Collector for module T0 calibration with neg
C TOPOffsetCollectorModule Collector for eventT0 and fill pattern offset calibrations
C TOPPhotonYieldsCollectorModule Collector for photon pixel yields aimed for PMT ageing studies and for finding optically decoupled PMT's
C TOPPulseHeightCollectorModule Collector for channel pulse-height distributions
C TOPValidationCollectorModule Collector for automatic validation of calibration with dimuon events
C eclAutocovarianceCalibrationC1CollectorModule Calibration collector module to estimate noise level of delayed Bhabha waveforms
C eclAutocovarianceCalibrationC3CollectorModule Calibration collector module that uses delayed Bhabha to compute coveriance matrix
C eclAutocovarianceCalibrationC4CollectorModule Calibration collector module that uses delayed Bhabha to compute coveriance matrix
C eclBhabhaTimeCalibrationValidationCollectorModule This module generates 'TimevsCrys' histogram to later (in eclBhabhaTAlgorithm ) find time offset from bhabha events
C eclCosmicECollectorModule Class eclCosmicECollectorModule
C eclEdgeCollectorModule Collector to store ECL crystal locations
C eclGammaGammaECollectorModule Calibration collector module that uses e+e- --> gamma gamma to do ECL single crystal energy calibration
C eclHadronTimeCalibrationValidationCollectorModule This module generates 'TimevsCrys' histogram to later (in eclBhabhaTAlgorithm ) find time offset from bhabha events
C eclLeakageCollectorModule Store information needed to calculate ECL energy leakage corrections
C eclMuMuECollectorModule Calibration collector module that uses muon pairs to do ECL single crystal energy calibration
C eclNOptimalCollectorModule Collector that runs on single photon MC samples to find the number of crystals to be summed to get the best energy resolution for each test energy and for each group of crystals (8 groups per thetaID in the barrel)
C eclTimeShiftsPlottingCollectorModule This modules looks up crystal and crate time offset constants from the database and saves them to a tree for the algorithm to plot as a function of run number
C eclWaveformTemplateCalibrationC1CollectorModule Calibration collector module that uses delayed Bhabha to compute coveriance matrix
C eclWaveformTemplateCalibrationC2CollectorModule Calibration collector module that uses delayed Bhabha to compute coveriance matrix
C eclee5x5CollectorModule Calibration collector module that uses e+e- --> e+e- to do ECL single crystal energy calibration
C CsIStudyModule Analyze simulations of CsI readings in BEAST
C DAQMonitorModule A module for producing general DAQ DQM histograms
► C DQMHistoModuleBase This class serves as a base for the TrackDQMModule and AlignDQMModule (and possibly other DQM histogram modules)
C AlignDQMModule DQM of Alignment for off line residuals per sensor, layer, keep also On-Line DQM from tracking: their momentum, Number of hits in tracks, Number of tracks
C TrackDQMModule DQM of tracks their momentum, Number of hits in tracks, Number of tracks
C TrackingExpressRecoDQMModule Tracking ExpressReco DQM
C TrackingHLTDQMModule Tracking HLT DQM
C DelayDQMModule Processing Delay DQM Module
C DetectorOccupanciesDQMModule DQM Module for basic detector quantities before the HLT filter
C ECLDQMInjectionModule The ECL Occ after Injection DQM module
C ECLBackgroundModule A module to study background campaigns and produce histograms
C ECLDQMConnectedRegionsModule This module is created to monitor ECL Data Quality
C ECLDQMEXTENDEDModule This module is created to monitor ECL electronics logic in frame of DQM system
C ECLDQMModule This module is created to monitor ECL Data Quality
C ECLDQMOutOfTimeDigitsModule This module produces DQM histograms to monitor the distribution of out-of-time ECLCalDigits
C EventT0DQMModule This module to design collect the event t0 values base on different detectors and physics processes
C IPDQMModule This Module , made for monitors the position and the size of the interaction point using mu+mu- events
C KLMDQM2Module Additional Module for KLMDQM plots after HLT filters
C KLMDQMModule KLM data quality monitor module
C MonitorDataCOPPERModule A class definition of an input module for Sequential ROOT I/O
C MonitorDataModule A class definition of an input module for Sequential ROOT I/O
C OverlapResidualsModule The module studies VXD hits from overlapping sensors of a same VXD layer
C PXDDAQDQMModule The PXD DAQ DQM module
C PXDGatedDHCDQMModule The PXD Gatint after Injection DQM module
C PXDGatedModeDQMModule The PXD for GatedMode DQM module
C PXDInjectionDQMModule The PXD Occupancy after Injection DQM module
C PXDROIDQMModule The raw PXD DQM module
C PXDRawDQMChipsModule The raw PXD DQM module
C PXDRawDQMModule The raw PXD DQM module
C PXDDQMClustersModule PXD DQM Module
C PXDDQMCorrModule PXD DQM Corr Module
C PXDDQMEfficiencyModule Creates the basic histograms for PXD Efficiency DQM Simplified and adopted version of the testbeam pxd efficiency module
C PXDDQMEfficiencySelftrackModule Creates the basic histograms for PXD Efficiency DQM Simplified and adopted version of the testbeam pxd efficiency module
C PXDDQMExpressRecoModule PXD DQM Module
C PXDRawDQMCorrModule PXD DQM Corr Module
C PXDTrackClusterDQMModule DQM of cluster in matched tracks
C PhysicsObjectsDQMModule Physics objects DQM module
C PhysicsObjectsMiraBelleBhabhaModule A module template
C PhysicsObjectsMiraBelleDst2Module DQM modules to monitor D* related variables
C PhysicsObjectsMiraBelleDstModule DQM modules to monitor D* related variables
C PhysicsObjectsMiraBelleEcmsBBModule Collector for the collision energy calibration based on the hadronic modes
C PhysicsObjectsMiraBelleHadronModule DQM modules to monitor hadron related variables
C PhysicsObjectsMiraBelleModule A module template
C ROIDQMModule The HLT ROI DQM module
C SVDDQMDoseModule The SVD dose-monitoring DQM module
C SVDDQMInjectionModule The SVD Occupancy after Injection DQM module
C SVDDQMClustersOnTrackModule SVD DQM Module for Clusters related to Tracks
C SVDDQMEfficiencyModule Creates the basic histograms for SVD Efficiency DQM
C SVDDQMExpressRecoModule SVD DQM Module for Express Reco
C SVDDQMHitTimeModule This module to design collect the svd hit time for different detectors trigger timing and physics processes
C SVDROIDQMModule Creates basic DQM for ROI creation on ExpressReco
C SVDUnpackerDQMModule SVD DQM Module for the Unpacker
C CosmicRayHLTDQMModule A class definition of an input module for Sequential ROOT I/O
C SoftwareTriggerHLTDQMModule Module defining the STM histograms
C StatisticsTimingHLTDQMModule Module for Event Time Statistics DQM plots
C TOPDQMModule TOP DQM histogrammer
C TOPGainEfficiencyCalculatorModule Module for channel-by-channel gain/efficiency analysis
C TOPInterimFENtupleModule Module to produce ntuple from TOPDigits and TOPRawDigits
C TOPLaserHitSelectorModule Module for pixel-by-pixel gain/efficiency analysis
C TOPPDFCheckerModule Module for checking analytic PDF used in likelihood calculation
C TOPTBCComparatorModule Module for the comparison of different sets of time base correction (TBC) constants and to produce monitoring plots out of a given set
C TOPWaveformQualityPlotterModule Plots and histograms of waveforms and feature extracted parameters
C TRGCDCT2DDQMModule DQM module of TRGCDCT2D
C TRGCDCT3DDQMModule DQM module for TRGCDCT3D
C TRGCDCTSFDQMModule DQM module of TRGCDCTSF
C TRGECLDQMModule Module of ecl trigger DQM
C TRGECLEventTimingDQMModule This module is for ecl trigger DQM related to L1 event timing
C TRGEFFDQMModule Make summary of data quality from reconstruction
C TRGGDLDQMModule
C TRGGDLModule A module to simulate the Global Decision Logic
C TRGGRLDQMModule
C TRGRAWDATAModule
C TRGTOPDQMModule
C TTDDQMModule TTD Injection DQM module
C TrackAnaModule A class definition of an input module for Sequential ROOT I/O
C TrackingAbortDQMModule Tracking DQM Module to monitor aborts & background conditions before the HLT filter
C V0ObjectsDQMModule DQM modules to monitor V0 objects
C VXDDQMExpressRecoModule VXD DQM Module
C BeamabortStudyModule Study module for Beamaborts (BEAST)
C BgoStudyModule Study module for Bgos (BEAST)
C cdcDQM7Module The module for Data Quality Monitor
C ClawStudyModule Study module for Claws (BEAST)
C ClawsStudyModule Study module for Clawss (BEAST)
C CsiStudy_v2Module Study module for Csis (BEAST)
C DosiStudyModule Study module for Dosis (BEAST)
C FANGSStudyModule Study module for Fangs (BEAST)
C He3tubeStudyModule Study module for He3tubes (BEAST)
C MicrotpcStudyModule Study module for Microtpcs (BEAST)
C TPCStudyModule Study module for TPCs (BEAST)
C PindiodeStudyModule Study module for Pindiodes (BEAST)
C QcsmonitorStudyModule Study module for Qcsmonitor (BEAST)
C vxdDigitMaskingModule PXD DQM Module
C HitLevelInfoWriterModule Extracts dE/dx information for calibration testing
C HitXPModule This module from a data root file builds a tree of hitXP (see the class to know all the information contained)
C InclusiveBtagReconstructionModule Inclusively reconstructs anti-B:tag
from input ParticleLists for given B:sig
C InclusiveDstarReconstructionModule Inclusive D* reconstruction module
C InclusiveParticleCheckerModule Check for the existence of an inclusive particle in the list of generated particles
C InteractiveModule Start an interactive python shell in each call of event()
C IoVDependentConditionModule Module which sets its return value based on the fact, if the event is in the given run/exp interval or not
C KLMClusterAnaModule Module for KLM cluster reconstruction efficiency studies
C KLMClusterEfficiencyModule Module for KLM cluster reconstruction efficiency studies
C KLMClustersReconstructorModule Module KLMClustersReconstructorModule
C KLMDigitTimeShifterModule KLM digit time shifter module
C KLMDigitizerModule KLM digitization module
C KLMExpertModule Module to perform the KLM KlId classification
C KLMMuonIDDNNExpertModule KLMMuonIDDNNExpert for calculating Neural Network based muonID
C KLMPackerModule KLM raw packer
C KLMReconstructorModule Create BKLMHit1ds from BKLMDigits and then create KLMHit2ds from BKLMHit1ds; create KLMHit2ds from EKLMDigits
C KLMScintillatorSimulatorModule Module KLMScintillatorSimulatorModule
C KLMTrackingModule This module perform straight line track finding and fitting for BKLM/EKLM
C KLMTriggerModule
C KLMUnpackerModule KLM unpacker
C KinkFinderModule Kink finder module
C KlongDecayReconstructorExpertModule Reco missing module
C KlongMomentumCalculatorExpertModule Reco missing module
C KlongMomentumUpdaterExpertModule Calculate and update the two body B decay kinematics
C KlongValidationModule Module used by the validation server to generate root files for the validation
C LHEInputModule The LHEInput module
C LowEnergyPi0IdentificationExpertModule Calculation of low-energy pi0 identification value
C LowEnergyPi0VetoExpertModule Calculation of low-energy pi0 veto value
C MCDecayFinderModule Find decays in MCParticle list matching a given DecayString
► C MCMatcherECLClustersModule Class to represent the hit of one cell
C MCMatcherECLClustersPureCsIModule Same module but for pure CsI
C MCMatcherKLMClustersModule Module for MC matching for KLM clusters
C MCMatcherParticlesModule MC matching module: module performs MC matching (sets the relation Particle -> MCParticle ) for all particles and its (grand)^N-daughter particles in the user-specified ParticleList
C MCMatcherTRGECLModule Class to represent the hit of one cell
C MCPXDROICreatorModule The MCPXDROICreatorModule module Create artificial ROI just for PXDDigits from either all charged primary MCParticles or slow pions from D* decays on MC information
C MCRecoTracksMatcherModule This module compares tracks generated by some pattern recognition algorithm for PXD , SVD and CDC to ideal Monte Carlo tracks and performs a matching from the former to the underlying MCParticles
C MCRelationCreatorModule Module to combine RecoTracks
C MCTrackCandClassifierModule The MCTrackCandClassifier Definition Module
C MCV0MatcherModule A module matching the V0s from the mcV0Matcher to MC particles
C MLSegmentNetworkProducerModule Segment network producer module with a Machine Learning classifier
C MVAExpertModule This module adds an ExtraInfo to the Particle objects in a given ParticleList
C MVAMultipleExpertsModule This module adds an ExtraInfo to the Particle objects in a given ParticleList
C MVAPrototypeModule This module can be used as a prototype for your own module which uses MVA weightfiles
C MasterClassModule Module to write out data in a format for Belle II masterclasses
C MaterialScanModule The MaterialScan module
C MdstPIDModule Module to fill PIDLikelihoods
C MergeDataStoreModule Internal module used by Path.add_independent_merge_path()
C MergerCosmicTracksModule Module use to select two cosmic tracks event and merger these two tracks become one
C MuidModule The geant4e-based muon identification module
C NeutralHadron4MomentumCalculatorModule Calculates 4-momentum of a neutral hadron in a given decay chain e.g
C NeutralHadronMatcherModule Module to geometrically match neutral hadrons (KL, neutrons) to ECL clusters
C NoKickCutsEvalModule This module evaluate the cuts used to select the training sample of the SectorMap
C NtuplePhase1_v6Module Read SKB PVs, simulated measurements of BEAST sensors, and write scaled simulated Ntuple in BEAST phase 1 data format
C OnlineEventT0CreatorModule Module to write the EventT0s computed on the online systems (HLT)
C OnlyWriteOutParticleListsModule Marks all objects in DataStore except those of type ParticleList as WrtieOut=False
C OpticalGunModule Source of optical photons for the simulation of the TOP laser system
C ParticleKinematicFitterModule Kinematic fitter module
C OverlapCheckerModule The geometry overlap check module
C OverrideGenerationFlagsModule Override generation flags
C PIDCalibrationWeightCreatorModule Module that creates WeightMatrix and uploads it to the DB
C PIDNeuralNetworkParametersCreatorModule Module that creates PID neural network parameters and uploads them to the DB
C PIDNtupleModule Makes PID ntuple from mdst input
C ActivatePXDClusterPositionEstimatorModule The ActivatePXDClusterPositionEstimator module
C ActivatePXDGainCalibratorModule The ActivatePXDGainCalibrator module
C ActivatePXDPixelMaskerModule The ActivatePXDPixelMasker module
C PXDBackgroundModule PXD Background module
C PXDBadSensorTagModule The PXD bad sensor tagger module
C PXDBeamBackHitFilterModule The PXDBeamBackHitFilter module
C PXDBgTupleProducerModule PXD Background Tuple Producer
C PXDClusterCheckModule The PXDClusterCheck module
C PXDClusterizerModule The PXDClusterizer module
C PXDDigitSorterModule The PXDDigitSorter module
C PXDDigitizerModule The PXD Digitizer module
C PXDEventPlotModule Plot each event with ROI and Pixels
C PXDGatedInfoFillerModule PXD Gates Mode information on readout gate basis
C PXDMCBgTupleProducerModule PXD MC Background Tuple Producer
C PXDPackerErrModule The PXDPackerErr module
C PXDPackerModule The PXDPacker module
C PXDPostErrorCheckerModule The PXD DAQ Post Unpacking Error Check
C PXDROIPlotModule Plot each event with ROI and Pixels
C PXDRawDumperModule Dump Raw PXD/ ONSEN event data
C PXDRawHitMaskingModule The PXDRawHitMasking module
C PXDRawHitSorterModule The PXDRawHitSorter module
C PXDReadRawBonnDAQMatchedModule Module to Load BonnDAQ file and store it as RawPXD in Data Store This is meant for lab use (standalone testing, debugging) without an event builder
C PXDReadRawBonnDAQModule Module to Load Raw PXD Data from DHH network-dump file and store it as RawPXD in Data Store This is meant for lab use (standalone testing, debugging) without an event builder
C PXDReadRawONSENModule A class definition of an input module for Sequential ROOT I/O
C PXDUnpackerModule The PXDUnpacker module
C PXDUnpackerOTModule The PXDUnpackerOT module
C PXDUnpackerOldModule The PXDUnpacker module
C PXDClusterPropFilterModule The module produce a StoreArray of PXDCluster with specific properties
C PXDClustersFromTracksModule The PXDClustersFromTracks module
C PXDDQMEfficiencyNtupleModule Creates Ntuples for PXD Efficiency analysis
C PXDDQMEfficiencyNtupleSelftrackModule Creates Ntuples for PXD Efficiency analysis
C PXDDQMTrackRawNtupleModule Creates Ntuples for PXD Trigger analysis
C PXDInjectionVetoEmulatorModule The module produces a StoreObjPtr of PXDInjectionBGTiming containing PXD timing for gated mode operation
C PXDPerformanceModule PXD Performance module
C PXDROIFinderAnalysisModule The PXD Data Reduction Analysis Module
C PXDROIFinderModule The PXD ROI Finder Module
C PXDRawHitFilterModule The module produce a StoreArray of PXDRawHit inside the ROIs
C PXDSVDCutModule The module to deactivate the SpacePointTrackCandidates with less than minSVDSPs SVD SpacePoints
C PXDSpacePointCreatorModule Imports Clusters of the pxd detector and converts them to spacePoints
C PXDTrackingEventLevelMdstInfoFillerModule This module adds additional global event level information about PXD track finding to the MDST object 'EventLevelTrackingInfo '
C PXDclusterFilterModule The module produce a StoreArray of PXDCluster inside the ROIs
C PXDdigiFilterModule The module produce a StoreArray of PXDDigit inside the ROIs, thus simulating "ONSEN" ROI selection
C PairGenModule The PairGen module
C ParallelTrackFilterModule Generates a new StoreArray from the input StoreArray which contains only tracks that meet the specified criteria
C PartialSelectModule The PartialSelect module
C PartialSeqRootReaderModule A class definition of an input module for Sequential ROOT I/O
C ParticleCombinerFromMCModule Particle combiner module
C ParticleCombinerModule Particle combiner module
C ParticleCopierModule Module for creating copies of Particles
C ParticleExtractorFromROEModule Extract particles from ROE and fill them in ParticleList
C ParticleGunModule The ParticleGun module
C ParticleListManipulatorModule Module for copying Particles (actually their indices) from two or more ParticleLists(s) to another ParticleList
C ParticleLoaderModule Loads MDST dataobjects as Particle objects to the StoreArray<Particle> and collects them in specified ParticleList
C ParticleMCDecayStringModule Adds the Monte Carlo decay string to a Particle
C ParticleMassHypothesesUpdaterModule This module creates a new particle list with the desired pdg code using tracks from an input particle list (basically updates the mass hypotheses of the input list)
C ParticleMassUpdaterModule This module replaces the mass of the particles inside the given particleLists with the invariant mass of the particle corresponding to the given pdgCode
C ParticleMomentumUpdaterModule This module replaces the momentum of the Particle in the target particle list by p(beam) - p(selected daughters)
C ParticlePrinterModule Prints particle list to screen
C ParticleSelectorModule Loops over all Particles in the ParticleList and removes those Particles from the ParticleList that do not pass given selection criteria
C ParticleStatsModule This module summarises the ParticleLists in the event
C ParticleVertexFitterModule Vertex fitter module
C ParticleWeightingLookUpCreatorModule Module that creates LookUpTable and upload it to the DB
C ParticleWeightingModule Module to append weights from the database into the extraInfo of Particles
C PhaseSpaceAnalysisModule Module for analysing the phase space of genfit::TrackCand(s) and SpacePointTrackCand(s) NOTE: this is just a very simple module that takes the MCParticleID of any TC and collects some information from them
C PhotonEfficiencySystematicsModule Adds Photon Detection Efficiency Data/MC ratios To Particle List
C Pi0VetoEfficiencySystematicsModule Adds Pi0Veto Efficiency Data/MC ratios To Particle List
C PostMergeUpdaterModule If the content of two DataStores are merged using the 'MergeDataStoreModule ', several kinematic properties might need fix
C PrescaleModule The Prescale module
C PrintBeamParametersModule Print the BeamParameters every time they change
C PrintCollectionsModule Prints the contents of DataStore in each event, listing all objects and arrays (including size)
C PrintDataModule Read RawCOPPER objects and shows their hex dump
► C PrintDataTemplateModule Module to get data from DataStore and send it to another network node
C CheckErrorEventModule Count the number of CRC error events by checking RawCOPPER 's header/trailer and EventMetaData
C MakeDumHSLBDataModule Module to make a binary file from Raw*** events for input of wirte-dumhsbx
C Root2BinaryModule Dump basf2 objects to a binary file
C PrintEventRateModule Print event rate of input data
C PrintMCParticlesModule The PrintMCParticles module
C PrintTauTauMCParticlesModule The PrintTauTauMCParticles module
C ProfileModule A module that measures the execution time and memory usage per event
C ProgressBarModule Display a progress bar and an estimate of remaining time when number of events is known (e.g
C ProgressModule Periodically writes the number of processed events/runs to the logging system to give a progress indication
C PruneDataStoreModule Clears the content of the DataStore while it keeps entries matching the regex expression in the matchEntries option
C PruneGenfitTracksModule Module to prune genfit::Tracks
C PruneRecoHitsModule Module to prune RecoTracks
C PruneRecoTracksModule Module to prune RecoTracks
C PseudoVertexFitterModule Pseudo Vertex fitter module
C PyModule Python wrapper for Belle2::Module
C QualityEstimatorVXDModule Quality estimation module for SpacePointTrackCandidates
C ROIGeneratorModule The ROI generator Module
C ROIPayloadAssemblerModule The ROI Payload Assembler Module
C ROIReadTestModule The ROI to ONSEN Module
C ROISenderModule The ROI to ONSEN Module
C ROIfindingConditionFromDBModule Module which sets its return value based on the payload whether ROI-finding was enabled for the given run/exp interval or not
C RT2SPTCConverterModule Module for converting RecoTracks to SpacePointTrackCands
C RandomBarrierModule Sets gRandom to an independent generator for the following modules
C Raw2DsModule A class definition of an input module for Sequential ROOT I/O
C RawInputModule A class definition of an input module for Sequential ROOT I/O
C RawSecMapMergerModule The RawSecMapMergerModule
C Rbuf2DsModule A class definition of an input module for Sequential ROOT I/O
C Rbuf2RbufModule A class definition of an input module for Sequential ROOT I/O
C ReceiveEventModule A class definition of an input module for Sequential ROOT I/O
C RecoTrackCreatorModule Module turning trackCands to reco tracks (will be unneeded once we create reco tracks from the beginning)
C RecoTrackParticleLoaderModule Takes fitted RecoTracks and creates Particles from them directly, skipping the step of creating Tracks and TrackFitResults
C RecoTrackStoreArrayCombinerModule Module to combine RecoTracks
C RecoTracksCopierModule Module to copy RecoTracks
C RecoTracksReverterModule Module to revert RecoTracks
C RegisterEventLevelTrackingInfoModule Module to create the EventLevelTrackingInfo that is used to set general tracking-related flags
C RelatedTracksCombinerModule Module to combine RecoTracks
C RemoveMCParticlesModule The RemoveMCParticles module
C RemoveParticlesNotInListsModule Removes all Particles that are not in a given list of ParticleLists (or daughters of those)
C ReprocessorModule Reprocessor Module
C RestOfEventBuilderModule Creates for each Particle in given ParticleList an RestOfEvent (ROE) dataobject and makes basf2 relation between them
C RestOfEventInterpreterModule Creates a mask (vector of boolean values) for tracks and clusters in RestOfEvent regarding their usage
C RestOfEventPrinterModule Prints ROE information and masks to screen
C RestOfEventUpdaterModule Updates an existing mask (map of boolean values) for tracks or eclClusters in RestOfEvent with an available property (e.g
C Root2RawModule A class definition of an input module for Sequential ROOT I/O
C RootInputModule Module to read TTree data from file into the data store
C RootOutputModule Write objects from DataStore into a ROOT file
C RxModule Module to decode data store contents from RingBuffer
C RxSocketModule A class definition of an input module for Sequential ROOT I/O
C SADInputModule The SAD Input module
C SPTC2GFTCConverterModule Module for converting SpacePointTrackCands to genfit::SpacePointTrackCands
C SPTC2RTConverterModule Module turning SpacePointsTrackCands to RecoTracks
C SPTCRefereeModule Module that does some sanity checks on SpacePointTrackCands that have been created by conversion from genfit::TrackCands by the TrackFinderMCTruth (or any other for that matter)
C SPTCmomentumSeedRetrieverModule A module for creating momentum seeds for spacepoint track candidates
C SPTCvirtualIPRemoverModule A module for checking and removing the virtual IP if wanted
C SVD3SamplesEmulatorModule This module takes the SVDShaperDigit as input and select three consecutive samples starting from the one chosen by the user
C SVD6SampleEventSkimModule SVD 6-sample event skim module
C SVDBackgroundModule SVD Background module
C SVDBeamBackHitFilterModule The SVDBeamBackHitFilter module
C SVDClusterizerModule The SVD Clusterizer
C SVDDatabaseTestModule Return the calibration results for the noises and the constants measured during the svd local runs (charge, ADC pulse, peaking time, pulse width)
C SVDDigitizerModule The SVD Digitizer module
C SVDMissingAPVsClusterCreatorModule SVDMissingAPVsClusterCreatorModule : The SVD MissingAPVsClusterCreator
C SVDPackerModule SVDPackerModule : The SVD Raw Hits Creator
C SVDRecoDigitCreatorModule The SVD RecoDigit Creator
C SVDShaperDigitSorterModule The SVDShaperDigitSorter module
C SVDSimpleClusterizerModule SVDSimpleClusterizerModule : The SVD SimpleClusterizer
C SVDUnpackerModule SVDUnpackerModule : The SVD Raw Hits Decoder
C SVDVariablesToStorageModule A module for validating SVD data
C SVDB4CommissioningPlotsModule The SVD B4CommissioningPlots Module
C SVDChannelMappingModule The Channel Mapping Check Module
C SVDChargeSharingAnalysisModule Module for monitoring DSSD cluster charge deposition in regard of capacitive charge sharing between adjacent strips in a cluster for data and the simulation
C SVDClusterCalibrationsMonitorModule Module to produce a list of histogram showing the uploaded calibration constants
C SVDClusterEvaluationModule The SVD ClusterEvaluation Module
C SVDClusterEvaluationTrueInfoModule Clustering Performance, using true information
C SVDClusterFilterModule Generates a new StoreArray from the input StoreArray which has all specified Clusters removed
C SVDClusterQualityEstimatorCalibrationModule Generate PDFs for assigning probability that cluster generated from signal particle
C SVDClusterQualityEstimatorModule Calculates the probability of a cluster originating from signal hit
C SVDCoGTimeEstimatorModule This module builds the SVDRecoDigits (calibrated and fitted strips) from the SVDShaperDigits
C SVDCrossTalkFinderModule Flags potential cross talk strips on Origami sensors
C SVDDataFormatCheckModule This module checks the format of the data that we are going to reconstruct checking the SVDModeByte and the SVDDAQDiagnostic
C SVDEventInfoSetterModule Module to set the SVDEventInfo in the simulation
C SVDEventT0EstimatorModule This module estimates the EventT0 as the average of cluster time of SVD clusters associated to tracks
C SVDEventT0PerformanceTTreeModule The module is used to create a TTree to study SVD EventT0
C SVDHotStripFinderModule A module template
C SVDLatencyCalibrationModule This module performs an analysis to find the APV25 latency
C SVDLocalCalibrationsCheckModule Module to produce a list of histogram showing the uploaded local calibration constants
C SVDLocalCalibrationsMonitorModule Module to produce a list of histogram showing the uploaded local calibration constants
C SVDMaxStripTTreeModule The module is used to create a TTree to study the number of strips fired per event per APV chip
C SVDOccupancyAnalysisModule The SVD OccupancyAnalysis Module
C SVDOverlapResolverModule SVD overlap resolver module
C SVDPerformanceModule The (TB) SVD Performance Module
C SVDPerformanceTTreeModule The module is used to create a TTree to study SVD clusters, genfit unbiased residuals and many other properties related to the track they belong to
C SVDPositionErrorScaleFactorImporterModule Module that produces a localdb with position error scale factors for different position algorithms
C SVDROIFinderAnalysisDataModule The Module evaluates the efficiency on SVD based on the number of empty ROIs
C SVDROIFinderAnalysisModule This module performs the analysis of the SVD data reduction module performances
C SVDROIFinderModule The SVD ROI Finder Module
C SVDShaperDigitFilterModule The module produce a StoreArray of SVDShaperDigit inside the ROIs
C SVDShaperDigitsFromTracksModule Generates two new StoreArray from the input StoreArray
C SVDSpacePointCreatorModule Imports Clusters of the SVD detector and converts them to spacePoints
C SVDSpacePointQICalibrationModule Imports Clusters of the SVD detector and converts them to spacePoints
C SVDStripMaskingModule This module removes the strips to be masked read form the SVDHotStripsCalibration
C SVDTimeCalibrationsMonitorModule Module to produce a list of histogram showing the uploaded calibration constants
C SVDTimeGroupingModule Imports Clusters of the SVD detector and converts them to spacePoints
C SVDTrackingEventLevelMdstInfoFillerModule This module adds additional global event level information about SVD track finding to the MDST object 'EventLevelTrackingInfo '
C SVDTriggerQualityGeneratorModule This module generates a StoreObjPtr that contains random trigger quality chosen between FINE and COARSE
C SVDZeroSuppressionEmulatorModule This module filters out strips that do not pass a ZS cut from the SVDShaperDigit StoreArray
C ScanCDCGeoModule Test module to save CDC geometry information to ntuple file
C SecMapTrainerBaseModule The SecMapTrainerBaseModule this module analyzes a big number of events (pGun or evtGen) to create raw sectorMaps which are needed for the VXDTF 2.0
C SecMapTrainerVXDTFModule The SecMapTrainerVXDTFModule this module analyzes a big number of events (pGun or evtGen) to create raw sectorMaps which are needed for the VXDTF
C SectorMapBootstrapModule The SegmentFilterConverterModule is a module able to read the cutoff values for filtering the Segments written in the xml gear box and write it in the new redesigned format
C SegmentNetworkAnalyzerModule Class for analyzing the contents of the SegmentNetwork
C SegmentNetworkProducerModule The Segment Network Producer Module
C SelectDaughtersModule Redefine (select) the daughters of a particle
C SeqRootInputModule Module to read files produced by SeqRootOutputModule
C SeqRootMergerModule A class definition of an input module for Sequential ROOT I/O
C SeqRootOutputModule Output module for sequential ROOT I/O
C SerializerModule A class definition of an input module for Sequential ROOT I/O
C SetRecoTrackMomentumModule Set momentum magnitude for RecoTracks to given value (for runs without magnetic field)
C SetupGenfitExtrapolationModule Setup material handling and magnetic fields for use by genfit's extrapolation code (RKTrackRep)
C SignalSideParticleFilterModule The module returns true if the current RestOfEvent object is related to any of the Particles in the input ParticleLists
C SignalSideParticleListCreatorModule The module creates a ParticleList and fills it with one of the daughter Particles
C SignalSideVariablesToDaughterExtraInfoModule The module writes properties (values of specified variables) of the particle related to the current ROE as an ExtraInfo to the single particle in the input ParticleList
C SignalSideVariablesToExtraInfoModule The module writes property of single particle found in the input ParticleList as an ExtraInfo to the Particle related to the current ROE
C SimulateEventLevelTriggerTimeInfoModule Module to create the EventLevelTriggerTimeInfo that stores information from the Trigger Timing Distribution (TTD) Will not be registered if it already exists as we want to use the EventLevelTriggerTimeInfo from the BG Overlay For now this module creates just an empty object (flag is set to indicate that it is invalid)
C SkimFilterModule This module filters events based on presence of candidates in a list of ParticleLists
C SmearPrimaryVertexModule This module smears the primary vertex (the interaction point) according to the values stored in BeamParameters
C SoftwareTriggerModule Module to perform cuts on various variables in the event
C SoftwareTriggerResultPrinterModule Write out the software trigger results in an easily accessible summary table
C SpacePoint2TrueHitConnectorModule Module that tries to register a relation between SpacePoints and TrueHits, hence making some MC Information easily accessible for other modules working with SpacePoints (e.g
C SpacePointCreatorTestModule Tester module for the validity of the SpacePointCreatorModule
C StandardTrackingPerformanceModule This module takes the MCParticle and the genfit::Track collection as input and writes out a root file with some information of the reconstructed tracks
C StatisticsSummaryModule A module that displays the sum of multiple modules in the module statistics
C SteerRootInputModule Internal module used by Path.add_independent_merge_path()
C StorageDeserializerModule A class definition of an input module for Sequential ROOT I/O
C StorageRootOutputModule Write objects from DataStore into a ROOT file
C StorageSerializerModule Class definition for the output module of Sequential ROOT I/O
C StorageZMQ2DsModule Input module in the ZMQ reconstruction path receiving events via ZMQ and deserializing the to the data store
C StudyMaterialEffectsModule StudyMaterialEffectsModule
C SubEventModule Framework-internal module that implements the functionality of Path::forEach() as well as Path::doWhile()
C SwitchDataStoreModule Internal module used by Path.add_independent_path()
C TCConvertersTestModule Module for testing if the converting Modules do their job as intened
C TOPAlignerModule Alignment of TOP
C TOPBackgroundModule TOP backgound module
C TOPBunchFinderModule Bunch finder: searches for the bunch crossing where the interaction happened using track-based TOP likelihood
C TOPCalPulseGeneratorModule Generator of calibration pulses Output to TOPSimCalPulses
C TOPChannelMaskerModule Masks dead PMs from the reconstruction
C TOPChannelT0CalibratorModule A module for alternative channel T0 calibration with collision data Note: after this kind of calibration one cannot do the geometrical alignment This module can also be used to check the calibration
C TOPChannelT0MCModule TOP Channel T0 MC Extraction module (under development)
C TOPCommonT0CalibratorModule A module for common T0 calibration with collision data (dimuons or bhabhas)
C TOPCosmicT0FinderModule Event T0 finder for global cosmic runs
C TOPDigitizerModule TOP digitizer
C TOPDoublePulseGeneratorModule Generator of double calibration pulses Output to TOPDigits
C TOPGeometryParInitializerModule Class for initializing TOPGeometryPar
C TOPLLScannerModule A module to perform the TOP PID likelihood scan and find the actual minimum as function of the mass
C TOPLaserCalibratorModule T0 Laser calibration module (under development)
C TOPMCTrackMakerModule Constructs Tracks and ExtHits from MCParticles and TOPBarHits Utility needed for testing and debugging of TOP reconstruction
C TOPModuleT0CalibratorModule A module for module T0 calibration with collision data (dimuons or bhabhas) Useful when the geometrical alignment need not to be repeated
C TOPNtupleModule Module to write out a ntuple summarizing TOP reconstruction output
C TOPPDFDebuggerModule TOP reconstruction module
C TOPPackerModule Raw data packer
C TOPRawDigitConverterModule TOPRawDigits to TOPDigits converter
C TOPReconstructorModule TOP reconstruction module
C TOPRingPlotterModule A module to plot the x-t images from TOP, and in general study the distribution of the digits associated to the particles in a particleList
C TOPTimeBaseCalibratorModule Time base calibrator
C TOPTimeRecalibratorModule Utility module for re-calibrating time of TOPDigits pulseWidth and timeError are not changed although they may depend no calibration!
C TOPTriggerDigitizerModule Digitizer that provides time stamps for TOP trigger
C TOPUnpackerModule Raw data unpacker
C TOPWaveformFeatureExtractorModule Waveform feature extractor: module adds rawDigits that are found in waveforms by feature extraction but are not already present in RawDigits
C TOPXTalkChargeShareSetterModule Crosstalk & chargeshare flag setter
C TRGCDCETFUnpackerModule A module of TRGCDCETFUnpacker
C TRGCDCModule A module to simulate the CDC trigger
C TRGCDCT3DConverterModule A module of TRGCDCT3DConverter
C TRGCDCT3DUnpackerModule A module of TRGCDCT3DUnpacker
C TRGCDCTSFUnpackerModule A module of TRGCDCTSF Unpacker
C TRGCDCTSStreamModule A module to process CDC trigger data
C TRGECLBGTCHitModule
C TRGECLFAMModule A module of FAM
C TRGECLModule A module of ETM
C TRGECLQAMModule
C TRGECLRawdataAnalysisModule A module of ETM
C TRGECLTimingCalModule Class ECL Trigger Timiing Calibration Module
C TRGECLUnpackerModule A module of TRG ECL Unpacker
C TRGGDLCosmicRunModule Module that returns true if the trigger condition for the 2017 cosmic runs is fulfilled
C TRGGDLDSTModule
C TRGGDLSummaryModule
C TRGGRLInjectionVetoFromOverlayModule Module for adding to MC samples the information about the TRG active veto from beam background overlay files
C TRGGRLMatchModule Match between CDC trigger track and ECL trigger cluster
C TRGGRLModule A module to simulate the Global Decision Logic
C TRGGRLProjectsModule A module to simulate the Global Decision Logic
C TRGGRLUnpackerModule A module of TRGGRLUnpacker
C TRGTOPTRD2TTSConverterModule TRG TOP Raw Digits to TimeStamps Converter
C TRGTOPUnpackerModule TRG TOP Unpacker
C TRGTOPUnpackerWaveformModule TRG TOP Unpacker for Timestamps
C TRGTOPWaveformPlotterModule
C TTDUnpackerModule TTD Unpacker module
C TagUniqueSignalModule Loops through the particle list finds a unique signal candidate for each event
C TagVertexModule Tag side Vertex Fitter module for modular analysis
C TauDecayMarkerModule Module to identify generated tau pair decays, using MCParticle information
C TauDecayModeModule Module to classify tau decay events according to a mapping given by the user or with a default mapping based on the TauolaBelle2 decay list
C TeeggInputModule The TEEGG Generator module.vectorToPair
C TestCalibDBAccessModule Returns the calibration result from SoftwareTriigerResult for skimming out calibration flagged events
C TheKillerModule This Modules kills basf2 as horribly as possible (or selected)
C TouschekTURTLEInputModule The TouschekTURTLE Input module
C TrackCreatorModule Takes RecoTracks coming from the event reconstructions and fits them with the configured list of particles hypothesis and stores the result in MDST-usable Belle2::Track and Belle2::TrackFitResult classes
C TrackFilterModule Generates a new StoreArray from the input StoreArray which has all specified Tracks removed
C TrackFinderMCTruthRecoTracksModule This module uses the simulated truth information (MCParticles and their relations) to determine which hits belong to which particles and writes track candidates filled with necessary information into the DataStore
C TrackFinderVXDBasicPathFinderModule The TrackFinderVXDBasicPathFinder is a low momentum Si-only trackfinder
C TrackFinderVXDCellOMatModule The TrackFinderVXDCellOMatModule is a low momentum Si-only trackfinder
C TrackFinderVXDCosmicsStandaloneModule The TrackFinderVXDCosmicsStandaloneModule Track finder for linear cosmic tracks measured by the VXD without magnetic field and without other subdetectors
C FindletModule< AFindlet > Adapter of a findlet to a module that exposes the parameters of the findlet and manages the IO with the DataStore
C ReattachCDCWireHitsToRecoTracksModule Module to loop over low-ADC/TOT CDCWireHits and fitted RecoTracks, and reattach the hits to the tracks if they are closer than a given distance
C TrackFitResultEstimatorModule Create a TrackFitResult from the momentum of a Particle and make a relation between them
C TrackIsoCalculatorModule Calculate track isolation variables on the input ParticleList
C TrackQETrainingDataCollectorModule Quality Estimator Data Collector Module to collect data for a MVA training using VXDQE_teacher.py
C TrackQualityEstimatorMVAModule Quality estimation module for SpacePointTrackCandidates using multivariate analysis (MVA)
C TrackSetEvaluatorGreedyDEVModule The Greedy algorithm Track-set-evaluator
C TrackSetEvaluatorHopfieldNNDEVModule The Hopfield algorithm Trackset Evaluator
C TrackTimeEstimatorModule Computes the track time, defined as the difference between the average of SVD clusters time and the SVDEvent T0
C TrackToMCParticleRelatorModule A module to set relations from Track to MCParticle via the RecoTrack the Track is related to
C TrackFinderVXDAnalizerModule The TrackFinderVXDAnalizerModule
C TrackingEfficiencyModule Tracking efficiency systematics module: removes tracks from the lists at random for efficiency studies
C TrackingEnergyLossCorrectionModule Tracking energy systematics module: allows for the application of an additive energy correction which is read from a ParticleWeightingLookUpTable payload
C TrackingMomentumScaleFactorsModule Tracking momentum systematics module: allows for the application of a corrective momentum scale factor which is read from a ParticleWeightingLookUpTable payload
C TrackingPerformanceEvaluationModule This module takes the MCParticles, the Tracks, the RecoTrack , and the MCRecoTracks input and produce a root file containing various histograms showing the performance of the tracking package: fitter, pattern recognition algorithms
C TreeFitterModule Module to fit an entire decay tree
C TriggerSkimModule Returns the calibration result from SoftwareTriigerResult for skimming out calibration flagged events
C TwoBodyISRPhotonCorrectorModule This module corrects the energy and momentum of high-energy ISR photons in single ISR events based on the beam energy, photon direction, and the mass of the recoil particle
C TxModule Module for encoding data store contents into a RingBuffer
C TxSocketModule A class definition of an input module for Sequential ROOT I/O
C UdstListFilterModule Module to filter udst content based on a particle list
C UpdateParticleTrackCandModule Updates the seed in TrackCand based on fitted state (at vertex)
C V0DaughterMassUpdaterModule This module replaces the mass of two daughters of the selected V0 particles inside the given particleLists with masses of given pdgCode
C V0FinderModule V0 finder module
C V0findingPerformanceEvaluationModule This module takes the MCParticles, the V0 candidates input and produce a root file containing various histograms showing the performance of the V0 finding module
C VRMLWriterModule The VRML-writer module
C VXDMisalignmentModule The VXD misalignment module
C VXDCDCTrackMergerModule VXDCDCTrackMergerModule a module to merge VXD and CDC tracks
C VXDDedxPIDModule Extract dE/dx from fitted tracks
C VXDDedxPIDRemakerModule Module that re-makes VXD PID likelihoods by taking dE/dx stored in VXDDedxTracks and lookup table PDF's from DB
C VXDQETrainingDataCollectorModule VXD Quality Estimator Data Collector Module to collect data for a MVA training using VXDQE_teacher.py
C VXDQualityEstimatorMVAModule Quality estimation module for SpacePointTrackCandidates using multivariate analysis (MVA)
C VXDSimpleClusterizerModule Module to convert TrueHits into Clusters using a simplified process
C VXDTFTrainingDataCollectorModule The VXDTFTrainingDataCollectorModule
C VXDTrackCandidatesQualityIndicatorCutterModule Module that selects a subset with a fixed minimum qualityIndicator out of all SpacePointTrackCandidates
C VariableToReturnValueModule Module to calculate variable specified by the user and set return value accordingly
C VariablesToEventBasedTreeModule Module to calculate variables specified by the user for a given ParticleList and save them into a TTree
C VariablesToEventExtraInfoModule For each particle in the input list the selected variables are saved in an event-extra-info field with the given name, Can be used to save MC truth information, for example, in a ntuple of reconstructed particles
C VariablesToExtraInfoModule For each particle in the input list the selected variables are saved in an extra-info field with the given name, Can be used when wanting to save variables before modifying them, e.g
C VariablesToHistogramModule Module to calculate variables specified by the user for a given ParticleList and save them into an Histogram
C VariablesToNtupleModule Module to calculate variables specified by the user for a given ParticleList and save them into a ROOT TTree
C ZMQRxOutputModule Module connecting the worker path with the output path on the output side
C ZMQRxWorkerModule Module connecting the input path with the worker path on the worker side
C ZMQTxInputModule Module connecting the input path with the worker path on the input side
C ZMQTxWorkerModule Module connecting the worker path with the output path on the worker side
C ARICHBackgroundModule ARICH digitizer module
C arichBtestModule The UserTutorial module
C arichToNtupleModule This module extends existing variablesToNtuple to append detailed arich information to candidates in the analysis output ntuple
C BeamDigitizerModule Beam tube digitizer
C BeamabortModule The Beamabort module
C BgoDigitizerModule Bgo tube digitizer
C BgoModule The Bgo module
C CaveModule The Cave module
C ClawDigitizerModule Claw tube digitizer
C ClawModule The Claw module
C CLAWSModule The CLAWS module
C ClawsDigitizerModule Claws tube digitizer
C CsIDigitizerModule Digitizer for the BEAST CsI system
C CsiDigitizer_v2Module Csi tube digitizer_v2
C CsiModule The Csi module
C DosiDigitizerModule Dosi tube digitizer
C DosiModule The Dosi module
C eclWaveformCalibCollectorModule Store information needed to calculate ECL waveform template shapes
C FANGSDigitizerModule FANGS ATLAS FE-I4B ASIC chip digitizer
C FANGSModule The FANGS module
C He3DigitizerModule He3 tube digitizer
C He3tubeModule The He3tube module
C MicrotpcModule The Microtpc module
C TpcDigitizerModule Micro TPC digitizer
C Ph1bpipeModule The Ph1bpipe module
C Ph1sustrModule The Ph1sustr module
C PinDigitizerModule Pin tube digitizer
C PindiodeModule The Pindiode module
C PlumeDigitizerModule PLUME digitizer
C PlumeModule The Plume module
C QcsmonitorDigitizerModule Qcsmonitor tube digitizer
C QcsmonitorModule The Qcsmonitor module
C SrsensorModule The Srsensor module
C svdDumpModule Class definition of svdClsHistoManager module
C Path Implements a path consisting of Module and/or Path objects
C PathIterator Iterator over a Path (returning Module pointers)
C Gearbox::PathOverride Struct to override a path in the XML file with a custom value
C PathUtils Helper utils for path arithmetic needed in the pEventProcessor
C Gearbox::PathValue Struct for caching results from the xml file
C PayloadFile A wrapper class for payload files used by the Database and DBStore classes
C PayloadInformation
C PayloadProvider::PayloadLocation Simple struct to represent a lookup location
C PayloadMetadata Simple struct to group all information necessary for a single payload
C MetadataProvider::PayloadMetadataCache Simple caching structure to keep the payload information for this and the last exp/run
C PayloadProvider Class to find payload files in a list of locations
C PCmsLabTransform Class to hold Lorentz transformations from/to CMS and boost vector
C PDF1Dim Binned one dimensional PDF (a projection of PDF to time axis)
C TOPReconstructorModule::PDFCollection A collection of PDF's of charged stable particles for a given track
C PDFConstructor PDF construction and log likelihood determination for a given track and particle hypothesis
C SignalPDF::PDFExtra Extra information about single PDF peak
C SignalPDF::PDFPeak Single PDF peak
C TOPAssociatedPDF::PDFPeak Parameters of a PDF peak
C PedeApplication Class interfacing Millepede solver (Pede)
C PedeResult Class to process Pede result file(s)
C TOPGeoPrism::PeelOffRegion Parameters of peel-off cookie region (corresponds to 2x2 PMT's)
► C PerformanceEvaluationBaseClass This module takes the MCParticles, the genfit Tracks, the genfit TrackCand, and the MCTrackCands input and produce a root file containing various histograms showing the performance of the tracking package: fitter, pattern recognition algorithms
C EffPlotsModule This module takes the MCParticles, the RecoTracks and Tracks/V0 in input and produce a root file containing various histograms showing the efficiencies (as a function of different variables) of the V0 finding module
C FillTrackFitNtupleModule This module takes the Tracks and the RecoTrack input and produce a root file containing an nutple showing the track fit members in parallel for different particle hypotheses
C TrackingPerformanceEvaluationModule This module takes the MCParticles, the Tracks, the RecoTrack , and the MCRecoTracks input and produce a root file containing various histograms showing the performance of the tracking package: fitter, pattern recognition algorithms
C V0findingPerformanceEvaluationModule This module takes the MCParticles, the V0 candidates input and produce a root file containing various histograms showing the performance of the V0 finding module
C PerigeeCircle Extension of the generalized circle also caching the perigee coordinates
► C PersistenceManager Abstract base class defining the interface for persisting variables
C ConcreteVariablesToHistogramPersistenceManager A PersistenceManager that writes variables to ROOT histograms (TH1D)
C ConcreteVariablesToNtuplePersistenceManager A PersistenceManager that writes variables to a ROOT TTree
C PersistenceManagerFactory A factory class that creates specific PersistenceManager objects
C Phi0BinsSpec Strategy to construct discrete phi0 points from discrete overlap specifications
C Phokhara C++ Interface for the Fortran generator PHOKHARA
C ScintillatorSimulator::Photoelectron Photoelectron data
C PhotonState State of the Cerenkov photon in the quartz optics
C PickleModule
C PIDCalibrationWeightUtil Class to call calibration weight matrix
C Const::PIDDetectors A class that defines the valid set of PID detectors
C PIDNeuralNetwork Class to call PID neural network
C PIDPriorsTable This class holds the prior distribution for a single particle species
C PIDTree Structure for the output of PID log likelihoods + tracking info to a flat ntuple
C Pixel Class to represent one pixel, used in clustering for fast access
C PixelPositions::PixelData Position and size of a pixel
C PixelEfficiencies Pixel relative efficiencies of a single module
C PixelMasks Pixel masks of a single module
C PixelPositions Pixel positions and dimensions in module local frame
C YScanner::PixelProjection Down-stream projection of a pixel to prism entrance window w/ a clip on bar exit thickness
C PlainMatrix< T, M, N > A matrix implementation to be used as an interface typ through out the track finder
C PlainMatrixUtil Utility functions for the PlainMatrix
► C PlanarMeasurement
C AlignableBKLMRecoHit Alignable BKLM hit
C AlignableEKLMRecoHit Alignable EKLM hit
► C PXDRecoHit PXDRecoHit - an extended form of PXDCluster containing geometry information
C AlignablePXDRecoHit This class is used to transfer PXD information to the track fit
► C PlanarMomentumMeasurement Measurement class implementing a planar hit geometry (1 or 2D) with only a momentum measurement
C PlanarVXDMomentumMeasurement< HitType > Measurement class implementing a planar hit geometry (1 or 2D) with a momentum measurement based on the VXD dEdX information with setable parameters (see VXDMomentumEstimationMeasurementCreator )
► C SVDRecoHit SVDRecoHit - an extended form of SVDHit containing geometry information
C AlignableSVDRecoHit This class is used to transfer SVD information to the track fit
► C SVDRecoHit2D SVDRecoHit - an extended form of SVDHit containing geometry information
C AlignableSVDRecoHit2D This class is used to transfer SVD information to the track fit
C Plane Plane
C Plane_t Struct for plane
C Plane_t Define plane struct
► C Plotter
C Box
C Correlation
C CorrelationMatrix
C Diagonal
C Difference
C Distribution
C Importance
C Multiplot
C Overtraining
C PrecisionRecallCurve
C PurityAndEfficiencyOverCut
C PurityOverEfficiency
C RejectionOverEfficiency
C SignalToNoiseOverCut
C TSNE
C TrueVsFalsePositiveRate
C VerboseDistribution
C Point3D< T >
C Point3D< T >
C Point_t Struct for Point
C Polygon2D 2D polygon
C PostProcessingParticleWeighting Post-processing particle weighting
C PrecisionMatrixUtil Collection of functions related to precision matrices
C PrecisionUtil Utility collection for functions to determine a curvature precision such at a hough box covers a certain percentage of hits in the legendre algorithms
► C PrimitivePlotter A base class for plots of primitive objects
C SVGPrimitivePlotter A concrete plotter that can draw primitive objects to standalone SVG files
C Prior
C Priors
C RaytracerBase::Prism Prism data in module local frame
C PDFConstructor::PrismSolution Solution of inverse raytracing in prism
C Process
► C Process
C CalculationProcess
► C Process
► C CalculationProcess
C Basf2CalculationProcess
C ProcessController
C ProcessedEventBackup Storage item for the event backup storing the event message, the time stamp and the event meta data
C ProcessedEventsBackupList List-like structure for storing and retaining event backups
► C ProcessingSignalListener Interface for an algorithm part that needs to receive the module processing signals
C Advancer Helper findlet for performing an extrapolation of a mSoP of one plane to another plane using the representation stored in the mSoP
► C CompositeProcessingSignalListener Partial implementation for an algorithm part that wants to dispatch processing signals to subobjects
► C BaseVarSet< Object >
C UnionVarSet< Object >
C BaseVarSet< Relation< const typename ABaseVarSet::Object > >
C BaseVarSet< typename FirstType< AVarSets... >::Object >
C BaseVarSet< typename AVarNames::Object >
► C BaseVarSet< CDCPathBasicVarNames::Object >
► C VarSet< CDCPathBasicVarNames >
C CDCPathBasicVarSet Var set to store basic quantities related to CDC CKF
► C BaseVarSet< CDCPathTruthVarNames::Object >
► C VarSet< CDCPathTruthVarNames >
C CDCPathTruthVarSet Var set to store basic quantities related to CDC CKF (using truth information)
► C BaseVarSet< CDCStateBasicVarNames::Object >
► C VarSet< CDCStateBasicVarNames >
C CDCStateBasicVarSet Var set to store basic quantities related to CDC CKF
► C BaseVarSet< CDCStateTruthVarNames::Object >
► C VarSet< CDCStateTruthVarNames >
C CDCStateTruthVarSet Var set to store basic quantities related to CDC CKF (using truth information)
► C BaseVarSet< CDCfromEclPathTruthVarNames::Object >
► C VarSet< CDCfromEclPathTruthVarNames >
C CDCfromEclPathTruthVarSet Var set to store basic quantities related to CDC CKF (using truth information)
► C BaseVarSet< CDCfromEclStateTruthVarNames::Object >
► C VarSet< CDCfromEclStateTruthVarNames >
C CDCfromEclStateTruthVarSet Var set to store basic quantities related to CDC CKF (using truth information)
► C BaseVarSet< PXDResultTruthVarNames::Object >
► C VarSet< PXDResultTruthVarNames >
C PXDResultTruthVarSet Var set used in the CKF for calculating the probability of a correct result, which knows the truth information if two tracks belong together or not
► C BaseVarSet< PXDStateBasicVarNames::Object >
► C VarSet< PXDStateBasicVarNames >
C PXDStateBasicVarSet Var set used in the VXD-CDC-Merger for calculating the probability of a VXD-CDC-track match
► C BaseVarSet< PXDStateTruthVarNames::Object >
► C VarSet< PXDStateTruthVarNames >
C PXDStateTruthVarSet Var set used in the VXD-CDC-Merger for calculating the probability of a VXD-CDC-track match, which knows the truth information if two tracks belong together or not
► C BaseVarSet< RelationSVDResultVarNames::Object >
► C VarSet< RelationSVDResultVarNames >
C RelationSVDResultVarSet Var set used in the VXD-CDC-Merger for calculating the probability of a VXD-CDC-track match, which knows the truth information if two tracks belong together or not
► C BaseVarSet< SVDResultTruthVarNames::Object >
► C VarSet< SVDResultTruthVarNames >
C SVDResultTruthVarSet Var set used in the CKF for calculating the probability of a correct result, which knows the truth information if two tracks belong together or not
► C BaseVarSet< SVDStateBasicVarNames::Object >
► C VarSet< SVDStateBasicVarNames >
C SVDStateBasicVarSet Var set used in the VXD-CDC-Merger for calculating the probability of a VXD-CDC-track match
► C BaseVarSet< SVDStateTruthVarNames::Object >
► C VarSet< SVDStateTruthVarNames >
C SVDStateTruthVarSet Var set used in the VXD-CDC-Merger for calculating the probability of a VXD-CDC-track match, which knows the truth information if two tracks belong together or not
► C BaseVarSet< SVDStateVarNames::Object >
► C VarSet< SVDStateVarNames >
C SVDStateVarSet Var set used in the VXD-CDC-Merger for calculating the probability of a VXD-CDC-track match
► C BaseVarSet< AdvancedSegmentVarNames::Object >
► C VarSet< AdvancedSegmentVarNames >
C AdvancedSegmentVarSet Class to compute floating point variables from a segment which can be recorded as a flat TNtuple or serve as input to a MVA method
► C BaseVarSet< BasicAxialSegmentPairVarNames::Object >
► C VarSet< BasicAxialSegmentPairVarNames >
C BasicAxialSegmentPairVarSet Class to compute floating point variables from a segment relation which can be recorded as a flat TNtuple or serve as input to a MVA method
► C BaseVarSet< BasicClusterVarNames::Object >
► C VarSet< BasicClusterVarNames >
C BasicClusterVarSet Class to compute floating point variables from a wire hit cluster which can be recorded as a flat TNtuple or serve as input to a MVA method
► C BaseVarSet< BasicFacetRelationVarNames::Object >
► C VarSet< BasicFacetRelationVarNames >
C BasicFacetRelationVarSet Class to compute floating point variables from a facet relation which can be recorded as a flat TNtuple or serve as input to a MVA method
► C BaseVarSet< BasicFacetVarNames::Object >
► C VarSet< BasicFacetVarNames >
C BasicFacetVarSet Class to compute floating point variables from a facet which can be recorded as a flat TNtuple or serve as input to a MVA method
► C BaseVarSet< BasicSegmentPairRelationVarNames::Object >
► C VarSet< BasicSegmentPairRelationVarNames >
C BasicSegmentPairRelationVarSet Class to compute floating point variables from an axial stereo segment pair relation which can be recorded as a flat TNtuple or serve as input to a MVA method
► C BaseVarSet< BasicSegmentPairVarNames::Object >
► C VarSet< BasicSegmentPairVarNames >
C BasicSegmentPairVarSet Class to compute floating point variables from an axial stereo segment pair which can be recorded as a flat TNtuple or serve as input to a MVA method
► C BaseVarSet< BasicSegmentRelationVarNames::Object >
► C VarSet< BasicSegmentRelationVarNames >
C BasicSegmentRelationVarSet Class to compute floating point variables from a segment relation which can be recorded as a flat TNtuple or serve as input to a MVA method
► C BaseVarSet< BasicSegmentVarNames::Object >
► C VarSet< BasicSegmentVarNames >
C BasicSegmentVarSet Class to compute floating point variables from a segment which can be recorded as a flat TNtuple or serve as input to a MVA method
► C BaseVarSet< BasicTrackRelationVarNames::Object >
► C VarSet< BasicTrackRelationVarNames >
C BasicTrackRelationVarSet Class to compute floating point variables from a track relation which can be recorded as a flat TNtuple or serve as input to a MVA method
► C BaseVarSet< BasicTrackVarSetNames::Object >
► C VarSet< BasicTrackVarSetNames >
C BasicTrackVarSet Class to compute floating point variables from a track which can be recorded as a flat TNtuple or serve as input to a MVA method
► C BaseVarSet< BendFacetRelationVarNames::Object >
► C VarSet< BendFacetRelationVarNames >
C BendFacetRelationVarSet Class to compute floating point variables from a facet relation which can be recorded as a flat TNtuple or serve as input to a MVA method
► C BaseVarSet< BendFacetVarNames::Object >
► C VarSet< BendFacetVarNames >
C BendFacetVarSet Class to compute floating point variables from a facet which can be recorded as a flat TNtuple or serve as input to a MVA method
► C BaseVarSet< FitAxialSegmentPairVarNames::Object >
► C VarSet< FitAxialSegmentPairVarNames >
C FitAxialSegmentPairVarSet Class to compute floating point variables from a segment relation which can be recorded as a flat TNtuple or serve as input to a MVA method
► C BaseVarSet< FitFacetRelationVarNames::Object >
► C VarSet< FitFacetRelationVarNames >
C FitFacetRelationVarSet Class to compute floating point variables from a facet relation which can be recorded as a flat TNtuple or serve as input to a MVA method
► C BaseVarSet< FitFacetVarNames::Object >
► C VarSet< FitFacetVarNames >
C FitFacetVarSet Class to compute floating point variables from a facet which can be recorded as a flat TNtuple or serve as input to a MVA method
► C BaseVarSet< FitSegmentPairRelationVarNames::Object >
► C VarSet< FitSegmentPairRelationVarNames >
C FitSegmentPairRelationVarSet Class to compute floating point variables from an axial stereo segment pair relation which can be recorded as a flat TNtuple or serve as input to a MVA method
► C BaseVarSet< FitSegmentRelationVarNames::Object >
► C VarSet< FitSegmentRelationVarNames >
C FitSegmentRelationVarSet Class to compute floating point variables from a segment relation which can be recorded as a flat TNtuple or serve as input to a MVA method
► C BaseVarSet< FitTrackRelationVarNames::Object >
► C VarSet< FitTrackRelationVarNames >
C FitTrackRelationVarSet Class to compute floating point variables from a track relation which can be recorded as a flat TNtuple or serve as input to a MVA method
► C BaseVarSet< FitlessAxialSegmentPairVarNames::Object >
► C VarSet< FitlessAxialSegmentPairVarNames >
C FitlessAxialSegmentPairVarSet Class to compute floating point variables from a segment relation which can be recorded as a flat TNtuple or serve as input to a MVA method
► C BaseVarSet< FitlessFacetVarNames::Object >
► C VarSet< FitlessFacetVarNames >
C FitlessFacetVarSet Class to compute floating point variables from a facet which can be recorded as a flat TNtuple or serve as input to a MVA method
► C BaseVarSet< FitlessSegmentPairVarNames::Object >
► C VarSet< FitlessSegmentPairVarNames >
C FitlessSegmentPairVarSet Class to compute floating point variables from an axial stereo segment pair which can be recorded as a flat TNtuple or serve as input to a MVA method
► C BaseVarSet< FitlessSegmentRelationVarNames::Object >
► C VarSet< FitlessSegmentRelationVarNames >
C FitlessSegmentRelationVarSet Class to compute floating point variables from a segment relation which can be recorded as a flat TNtuple or serve as input to a MVA method
► C BaseVarSet< HitGapAxialSegmentPairVarNames::Object >
► C VarSet< HitGapAxialSegmentPairVarNames >
C HitGapAxialSegmentPairVarSet Class to compute floating point variables from a segment relation which can be recorded as a flat TNtuple or serve as input to a MVA method
► C BaseVarSet< HitGapSegmentPairVarNames::Object >
► C VarSet< HitGapSegmentPairVarNames >
► C HitGapSegmentPairVarSet Class to compute floating point variables from an axial stereo segment pair which can be recorded as a flat TNtuple or serve as input to a MVA method
C SkimmedHitGapSegmentPairVarSet Class to compute floating point variables from an axial stereo segment pair which can be recorded as a flat TNtuple or serve as input to a MVA method
► C BaseVarSet< HitGapSegmentRelationVarNames::Object >
► C VarSet< HitGapSegmentRelationVarNames >
C HitGapSegmentRelationVarSet Class to compute floating point variables from a segment relation which can be recorded as a flat TNtuple or serve as input to a MVA method
► C BaseVarSet< HitGapTrackRelationVarNames::Object >
► C VarSet< HitGapTrackRelationVarNames >
C HitGapTrackRelationVarSet Class to compute floating point variables from a track relation which can be recorded as a flat TNtuple or serve as input to a MVA method
► C BaseVarSet< Relation< const ABaseVarSet::Object > >
C RelationVarSet< ABaseVarSet > Generic class that generates the same variables from a each of a pair of instances
► C BaseVarSet< SegmentTrackTruthVarNames::Object >
► C VarSet< SegmentTrackTruthVarNames >
C SegmentTrackTruthVarSet Class to compute floating point variables from a segment to track match which can be recorded as a flat TNtuple or serve as input to a MVA method
► C BaseVarSet< SegmentTrackVarNames::Object >
► C VarSet< SegmentTrackVarNames >
C SegmentTrackVarSet Class to compute floating point variables from a segment to track match which can be recorded as a flat TNtuple or serve as input to a MVA method
► C BaseVarSet< StereoHitTruthVarNames::Object >
► C VarSet< StereoHitTruthVarNames >
C StereoHitTruthVarSet Class to compute floating point variables from a stereo hit to track match which can be recorded as a flat TNtuple or serve as input to a MVA method
► C BaseVarSet< StereoHitVarNames::Object >
► C VarSet< StereoHitVarNames >
C StereoHitVarSet Class to compute floating point variables from a stereo hit to track match which can be recorded as a flat TNtuple or serve as input to a MVA method
► C BaseVarSet< TrailSegmentPairVarNames::Object >
► C VarSet< TrailSegmentPairVarNames >
C TrailSegmentPairVarSet Class to compute floating point variables from an axial stereo segment pair which can be recorded as a flat TNtuple or serve as input to a MVA method
► C BaseVarSet< TruthSegmentPairRelationVarNames::Object >
► C VarSet< TruthSegmentPairRelationVarNames >
C TruthSegmentPairRelationVarSet Class to compute floating point variables from an axial stereo segment pair relation which can be recorded as a flat TNtuple or serve as input to a MVA method
► C BaseVarSet< TruthSegmentPairVarNames::Object >
► C VarSet< TruthSegmentPairVarNames >
C TruthSegmentPairVarSet Class to compute floating point variables from an axial stereo segment pair which can be recorded as a flat TNtuple or serve as input to a MVA method
► C BaseVarSet< AVarNames::Object >
C VarSet< AVarNames > Generic class that generates some named float values from a given object
► C BaseVarSet< FirstType< AVarSets... >::Object >
C VariadicUnionVarSet< BasicAxialSegmentPairVarSet, HitGapAxialSegmentPairVarSet >
C VariadicUnionVarSet< BasicAxialSegmentPairVarSet, FitlessAxialSegmentPairVarSet, FitAxialSegmentPairVarSet >
C VariadicUnionVarSet< BasicFacetVarSet, FilterVarSet< Chi2FacetFilter > >
C VariadicUnionVarSet< BasicSegmentPairVarSet, SkimmedHitGapSegmentPairVarSet >
C VariadicUnionVarSet< BasicSegmentPairVarSet, FitlessSegmentPairVarSet, FitSegmentPairVarSet >
C VariadicUnionVarSet< BasicSegmentPairRelationVarSet, FitSegmentPairRelationVarSet >
C VariadicUnionVarSet< BasicSegmentRelationVarSet, HitGapSegmentRelationVarSet >
C VariadicUnionVarSet< BasicSegmentRelationVarSet, FitlessSegmentRelationVarSet, FitSegmentRelationVarSet >
C VariadicUnionVarSet< BasicTrackRelationVarSet, HitGapTrackRelationVarSet >
C VariadicUnionVarSet< BasicTrackRelationVarSet, FitTrackRelationVarSet >
C VariadicUnionVarSet< AVarSets > Class that accommodates many variable sets and presents them as on set of variables
► C Filter< std::pair< const CDCCKFPath *, const CDCCKFPath * > >
C ArcLengthBasedCDCPathPairFilter For the two paths with the same number of hits prefers one with shortest arcLength ("densest path")
C ArcLengthBasedCDCfromEclPathPairFilter For the two paths with the same number of hits prefers one with shortest arcLength ("densest path")
C Chi2BasedCDCPathPairFilter Prefers path with smallest sum dist^2 / length of path
C DistanceBasedCDCPathPairFilter For the two paths with the same number of hits prefers one with smallest sum dist^2
C DuplicateCDCPathPairFilter Simple filter to distinguish between photon conversion and Bremsstrahlung
C HitDistanceBasedCDCPathPairFilter Prefers path with smallest sum dist^2 / length of path
C MCTruthCDCPathPairFilter For the two paths select the one with the most of MC matched hits
► C Filter< CDCCKFPath >
C SeedChargeCDCPathFilter Check if charge of fitted path corresponds to charge of seed
C SizeCDCPathFilter Return the size of the path
► C Filter< std::pair< const CDCCKFPath *, CDCCKFState * > >
C DistanceCDCStateFilter Give a weight based on the distance from the hit to the path
C ExtrapolateAndUpdateCDCStateFilter An extrapolateAndUpdate filter for all CDC states
C MCTruthCDCStateFilter Give a weight based on the mc truth information (1 or NAN)
C MCTruthEclSeedFilter Give a weight based on the mc truth information (1 or NAN)
C RoughCDCStateFilter A very rough filter for all CDC states
C RoughCDCfromEclStateFilter A very rough filter for all CDC states
► C Filter< std::pair< const std::vector< TrackFindingCDC::WithWeight< const AState * > >, AState * > >
C AdvanceFilter< AState, AnAdvancer > Filter which can be used on a pair of path (vector of states) and states, which will call the extrapolate function of the given advancer class, to extrapolate the last path state to the plane of the new state and store the mSoP in the new state
C KalmanFilter< AState, AKalmanStepper > Filter which can be used on a pair of path (vector of states) and states, which will call the kalmanStep function of the given stepper class, to update the mSoP of the new state with a klaman update
► C Filter< std::pair< const CKFToPXDState *, const CKFToPXDState * > >
C AngularDistancePXDPairFilter Base filter for CKF PXD states
C CylinderDistancePXDPairFilter Base filter for CKF PXD states
C InterceptDistancePXDPairFilter Base filter for CKF PXD states
C LoosePXDPairFilter Base filter for CKF PXD states
C SensorPXDPairFilter Base filter for CKF PXD states
C Filter< CKFToPXDResult >
► C Filter< std::pair< const std::vector< TrackFindingCDC::WithWeight< const CKFToPXDState * > >, CKFToPXDState * > >
► C AllPXDStateFilter A very simple filter for all space points
C NonIPCrossingStateFilter< AllPXDStateFilter >
C SimplePXDStateFilter A very simple filter for all space points
► C Filter< std::pair< const CKFToSVDState *, const CKFToSVDState * > >
C DistanceSVDPairFilter Base filter for CKF SVD states
C LooseSVDPairFilter Base filter for CKF SVD states
C SectorMapBasedSVDPairFilter Filter for relations between CKF SVD states based on SectorMaps
C SensorSVDPairFilter Base filter for CKF SVD states
► C Filter< CKFToSVDResult >
C WeightSVDResultFilter Base filter for CKF SVD results (on overlap check)
► C Filter< std::pair< const std::vector< TrackFindingCDC::WithWeight< const CKFToSVDState * > >, CKFToSVDState * > >
► C AllSVDStateFilter A very simple filter for all space points
C NonIPCrossingStateFilter< AllSVDStateFilter >
C ResidualSVDStateFilter A very simple filter for all space points
C SimpleSVDStateFilter A very simple filter for all space points
► C Filter< CDCAxialSegmentPair >
► C MCSymmetric< BaseAxialSegmentPairFilter >
C MCAxialSegmentPairFilter Filter for the construction of axial to axial segment pairs based on simple criteria
C AllAxialSegmentPairFilter Filter accepting all axial to axial segment pairs
C SimpleAxialSegmentPairFilter Filter for the construction of axial to axial segment pairs based on simple criteria
► C Filter< CDCWireHitCluster >
C AllClusterFilter Filter accepting all clusters
► C Filter< const CDCFacet >
► C MCSymmetric< BaseFacetFilter >
C MCFacetFilter Filter for the construction of good facets based on Monte Carlo information
C AllFacetFilter Filter for the construction of good facets based on simple criteria
C Chi2FacetFilter Filter for the construction of good facets based in the chi2 fit
C FeasibleRLFacetFilter Filter for the construction of good facets investigating the feasibility of the right left passage hypotheses combination
C RealisticFacetFilter Filter for the construction of good facets based on simple criteria
C SimpleFacetFilter Filter for the construction of good facets based on simple criteria
C Filter< CDCSegment2D >
► C Filter< CDCSegmentPair >
► C MCSymmetric< BaseSegmentPairFilter >
C MCSegmentPairFilter Filter for the construction of axial to stereo segment pairs based on MC information
C AllSegmentPairFilter Filter for the construction of axial to stereo segment pairs based on simple criteria
C SimpleSegmentPairFilter Filter for the construction of axial to axial segment pairs based on simple criterions
C Filter< WeightedRelation< CDCTrack, const CDCSegment2D > >
► C Filter< CDCSegmentTriple >
► C MCSymmetric< BaseSegmentTripleFilter >
C MCSegmentTripleFilter Filter for the construction of segment triples based on Monte Carlo information
C AllSegmentTripleFilter Filter for the construction of segment triples based on simple criteria
C SimpleSegmentTripleFilter Filter for the construction of segment triples based on simple criteria
C Filter< WeightedRelation< CDCTrack, const CDCRLWireHit > >
C Filter< CDCTrack >
► C Filter< CDCWireHit >
C AllWireHitFilter Filter accepting all hits
C CutsFromDBWireHitFilter Filter rejecting hits according to DB values
► C Filter< std::pair< const std::vector< TrackFindingCDC::WithWeight< const VXDHoughState * > >, VXDHoughState * > >
C FiveHitFilter Basic working principle: use ThreeHitVariables and provide three B2Vector3D to each variable
C FourHitFilter Filter for four hits
C QualityIndicatorFilter Filter for >= 3 hits using QualityEstimators
C ThreeHitFilter Filter for three hits
C TwoHitVirtualIPFilter Filter for two hits plus a virtual IP
C TwoHitVirtualIPQIFilter Filter for two hits plus a virtual IP using QualityEstimators
► C Filter< std::pair< const VXDHoughState *, const VXDHoughState * > >
C AngleAndTimeRelationFilter Filter for relations based on the polar angle difference and the time difference of the hits
C SimpleRelationFilter Filter for relations based on the polar angle difference
C Filter< SpacePointTrackCand >
► C Filter< PXDResultVarSet::Object >
► C OnVarSet< Filter< PXDResultVarSet::Object > >
► C ChoosableFromVarSet< Filter< PXDResultVarSet::Object > >
► C ChoosableFromVarSetFilter< PXDResultVarSet >
C SizePXDResultFilter Base filter for CKF PXD results (on overlap check)
► C Filter< SVDResultVarSet::Object >
► C OnVarSet< Filter< SVDResultVarSet::Object > >
► C ChoosableFromVarSet< Filter< SVDResultVarSet::Object > >
► C ChoosableFromVarSetFilter< SVDResultVarSet >
C SizeSVDResultFilter Base filter for CKF SVD results (on overlap check)
► C Filter< Relation< const CDCFacet > >
► C RelationFilter< const CDCFacet >
► C BaseFacetRelationFilter Base class for filtering the neighborhood of facets
► C MCSymmetric< BaseFacetRelationFilter >
C MCFacetRelationFilter Class filtering the neighborhood of facets with Monte Carlo information
C AllFacetRelationFilter Filter accepting all facet relations with a default weight
C Chi2FacetRelationFilter Class filtering the neighborhood of facets based on chi2 from a fit both facets
C SimpleFacetRelationFilter Class filtering the neighborhood of facets based on simple criterions
► C Filter< Relation< const CDCSegmentPair > >
► C RelationFilter< const CDCSegmentPair >
► C BaseSegmentPairRelationFilter Base class for filtering the neighborhood of axial stereo segment pairs
► C MCSymmetric< BaseSegmentPairRelationFilter >
C MCSegmentPairRelationFilter Class filtering the neighborhood of axial stereo segment pairs with monte carlo information
C AllSegmentPairRelationFilter Relation filter that lets all possible combinations pass
C SimpleSegmentPairRelationFilter Class filtering the neighborhood of axial stereo segment pairs based on simple criteria
► C Filter< Relation< const CDCSegmentTriple > >
► C RelationFilter< const CDCSegmentTriple >
► C BaseSegmentTripleRelationFilter Base class for filtering the neighborhood of segment triples
► C MCSymmetric< BaseSegmentTripleRelationFilter >
C MCSegmentTripleRelationFilter Class filtering the neighborhood of segment triples with monte carlo information
C AllSegmentTripleRelationFilter Class excepting all segment triples
C SimpleSegmentTripleRelationFilter Class filtering the neighborhood of segment triples based on simple criterions
► C Filter< Relation< const CDCTrack > >
► C RelationFilter< const CDCTrack >
► C BaseTrackRelationFilter Base class for filtering the neighborhood of tracks
► C MCSymmetric< BaseTrackRelationFilter >
C MCTrackRelationFilter Filter for the construction of track relations based on MC information
C AllTrackRelationFilter Relation filter that lets all possible combinations pass
C PhiTrackRelationFilter Relation filter that lets only possibilities with small phi distance pass
► C Filter< ATruthVarSet::Object >
► C OnVarSet< Filter< ATruthVarSet::Object > >
► C ChoosableFromVarSet< Filter< ATruthVarSet::Object > >
► C ChoosableFromVarSetFilter< ATruthVarSet > Convince template to create a filter returning on variable from a set of variables
► C TruthVarFilter< ATruthVarSet > MC Filter Type using a VarSet and the truth variable in it
C Sloppy< TruthVarFilter< ATruthVarSet > >
► C Filter< AVarSet::Object >
► C OnVarSet< Filter< AVarSet::Object > >
► C MVA< Filter< AVarSet::Object > >
C MVAFilter< AVarSet > Convenience template to create a mva filter for a set of variables
► C Recording< Filter< AVarSet::Object > >
C RecordingFilter< AVarSet > Convenience template to create a recording filter for a set of variables
C FilterOnVarSet< AVarSet > Convenience template to create a filter operating on a specific set of variables
► C Filter< Relation< AObject > >
C RelationFilter< AObject > Base class for filtering the neighborhood of objects
► C Findlet< CDCCKFPath >
C CDCCKFEclSeedCreator Findlet for
C CDCCKFPathMerger Merge similar paths
C CDCCKFPathSelector Select the m_maximalCandidatesInFlight paths for further processing
► C Findlet< const CDCCKFResult >
C CDCCKFResultStorer Store resulting tracks and relations on the dataStore
► C Findlet< CDCCKFState, const CDCCKFState, const TrackFindingCDC::CDCWireHit *const >
C CDCCKFStateCreator Create CKF states, based on the current path. Perform some basic selection at this stage (based on phi, max. jump of layers)
► C Findlet< const TrackFindingCDC::CDCWireHit >
C CKFToCDCFindlet Main findlet of the ToCDCCKF module
C CKFToCDCFromEclFindlet Main findlet of the ToCDCCKF module
► C Findlet< AState, AState, TrackFindingCDC::WeightedRelation< AState > >
C CKFRelationCreator< AState, ASeedRelationFilter, AHitRelationFilter > Findlet for applying filters for creating hit-hit and hit-seed relations
► C Findlet< const TrackFindingCDC::WithWeight< const AState * >, TrackFindingCDC::WithWeight< AState * > >
► C OnStateApplier< AState > Helper findlet which applies its () operator to all pairs of path and state with all states in the given child state list
C LayerToggledApplier< CKFToPXDState, LimitedOnStateApplier< CKFToPXDState, TrackFindingCDC::ChooseableFilter< PXDStateFilterFactory > > >
C LayerToggledApplier< CKFToSVDState, LimitedOnStateApplier< CKFToSVDState, TrackFindingCDC::ChooseableFilter< SVDStateFilterFactory > > >
C LayerToggledApplier< AState, AFindlet > A special findlet, which is chooseable based on a given findlet for layers higher than N, N and for the rest
C LimitedOnStateApplier< AState, AFilter > Specialisation of the OnStateApplier , which (a) uses a filter for the () operator, which is configurable (b) does only allow for the best N candidates in the child states
C StateRejecter< AState, AFilter > Reject some (or all) states from a given list of child states using 5 filters
C Findlet< typename AFilter::Object, typename AFilter::Object >
► C Findlet< AResult >
C ResultStorer< AResult > This findlet does also handle the storing of the results
► C Findlet< const AResult, const SpacePoint *const >
C SpacePointTagger< AResult, ACluster > Findlet for tagging all space points in the results vector as used
► C Findlet< RecoTrack * >
C BaseEventTimeExtractorModuleFindlet< AFindlet > Base class for most of the time extraction modules doing a track selection beforehand
C TrackFitterAndDeleter Findlet to fit tracks and remove all non fitted ones
C TrackLoader Findlet for loading the seeds from the data store
C TrackSelector Select the tracks for the event time extraction
► C Findlet< const AState, AState, const TrackFindingCDC::WeightedRelation< AState >, AResult >
C TreeSearcher< AState, AStateRejecter, AResult > Findlet for constructing result paths out of a list of states, which are connected with weighted relations
► C Findlet<>
C CKFToPXDFindlet Combinatorial Kalman Filter to extrapolate CDC Reco Tracks into the VXD (PXD ) and collect space points
C CKFToSVDFindlet Combinatorial Kalman Filter to extrapolate CDC Reco Tracks into the VXD (SVD ) and collect space points
C CKFToSVDSeedFindlet Findlet for combining CDC tracks with SVD tracks
C CosmicsTrackMergerFindlet Links tracks based on a filter criterion. It is based on the TrackLinker in the TF_CDC package
C DATCONFPGAFindlet Findlet for performing the DATCON ROI calculation close to the implementation on FPGA
C MCVXDCDCTrackMergerFindlet Findlet for merging VXD and CDC tracks with MC information
C FindletStoreArrayInput< TWrappedFindlet > Findlet which can wrap another Findlet and forward the contents of a StoreArray to the wrapped findlet
C TrackFinder Complete findlet implementing track finding with the cellular automaton in two stages
► C TrackFinderAutomaton Complete findlet implementing track finding with the cellular automaton in two stages
C TrackFinderCosmics Complete findlet implementing track finding with the cellular automaton in two stages - version suitable for cosmics
C SVDHoughTracking Main Findlet for the SVDHoughTracking
C Findlet< CKFToSVDResult, TrackFindingCDC::WeightedRelation< const RecoTrack, const RecoTrack > >
► C Findlet< const TrackFindingCDC::WeightedRelation< const RecoTrack, const RecoTrack > >
C RelationApplier Relate the SVD and CDC tracks in the given relations also in the store array
► C Findlet< CKFToSVDState, CKFToSVDState, TrackFindingCDC::WeightedRelation< CKFToSVDState > >
C RelationFromSVDTracksCreator Simplified relation creator only creating relations between states of CDC Reco Track seeds and states with SpacePoints, that: (a) for the seed states: connect every seed with every lst hit of the SVD Reco Tracks (b) for the hit states: are in the same SVD Reco Track and follow each other directly
► C Findlet< const SpacePoint * >
C SpacePointLoader Load the space points from the store array to the given vector
► C Findlet< const DATCONSVDDigit, SVDCluster >
C DATCONSVDClusterizer Findlet for clustering DATCONSVDDigits and creating SVDClusters that are used for tracking in DATCON
► C Findlet< const SVDCluster, const SVDCluster, std::pair< VxdID, std::pair< long, long > >, std::pair< VxdID, std::pair< long, long > > >
C DATCONSVDClusterLoaderAndPreparer Findlet for loading SVDClusters that were created by the DATCONSVDClusterizer findlet and prepare them for usage in the FastInterceptFinder2D by calculating the conformal transformed x,y coordinates and the creating pairs of coordinates for finding track candidates in r-phi and r-z
► C Findlet< const std::pair< VxdID, std::pair< long, long > >, std::pair< double, double > >
C FastInterceptFinder2DFPGA Findlet for finging intersections of sinosoidal curves in the 2D Hough space by iteratively calling fastInterceptFinder2d
► C Findlet< const std::pair< VxdID, long >, const std::pair< VxdID, long > >
C ROICalculator Findlet to calculate ROI on the PXD sensors based on input hits
► C Findlet< DATCONSVDDigit, DATCONSVDDigit >
C SVDShaperDigitConverter Findlet for converting SVDShaperDigits into DATCONSVDDigits
► C Findlet< const std::pair< double, double >, const std::pair< double, double >, std::pair< VxdID, long >, std::pair< VxdID, long > >
C ToPXDExtrapolator Findlet to extrapolate found tracks to the PXD sensors and calculate intercepts
► C Findlet< AIOTypes... >
► C BaseEventTimeExtractor< RecoTrack * >
C GridEventTimeExtractor< Belle2::Chi2BasedEventTimeExtractor >
C GridEventTimeExtractor< Belle2::DriftLengthBasedEventTimeExtractor >
► C IterativeEventTimeExtractor< Chi2BasedEventTimeExtractor >
C IterativeChi2BasedEventTimeExtractor Class to iteratively extract the event t0 using the chi-squared approach
► C IterativeEventTimeExtractor< DriftLengthBasedEventTimeExtractor >
C IterativeDriftLengthBasedEventTimeExtractor Class to iteratively extract the event t0 using the drift-length approach
C Chi2BasedEventTimeExtractor Event time extraction based on the principle of arXiv:0810.2241
C DriftLengthBasedEventTimeExtractor Event time extraction based on the principle of the CDC drift time calculation
C FullGridChi2TrackTimeExtractor Class to extract the event t0 using the chi-squared approach
C FullGridDriftLengthTrackTimeExtractor Class to extract the event t0 using the drift-length approach
C GridEventTimeExtractor< AFindlet > Generic findlet applying a certain time extractor multiple times
C IterativeEventTimeExtractor< AFindlet > Generic findlet applying a certain time extractor multiple times
► C BaseEventTimeExtractor< TrackFindingCDC::CDCWireHit & >
C HitBasedT0Extractor Findlet to extract the T0 time of an event only using CDC Hits
C BaseEventTimeExtractor< AIOTypes > Class to extract the event t0
► C Findlet< const CDCWireHit >
C CDCTrackingEventLevelMdstInfoFillerFromHitsFindlet Findlet for storing in mdsts some hit-based information per event
C HitReclaimer A small findlet that removes flags from hits not accepted by conventional tracking
► C Findlet< const CDCSegment2D >
C CDCTrackingEventLevelMdstInfoFillerFromSegmentsFindlet Findlet for storing in mdsts some segment-based information per event
► C Findlet< RecoTrack *, RecoTrack * >
C StoreArrayMerger This findlet has helper function to
► C Findlet< WeightedRelation< ACollectorItem, const ACollectionItem > >
C BestMatchSelector< ACollectorItem, ACollectionItem > Selector to remove all relations in the list, which share the same collection item - except the one which the highest weight - and vice versa
C CutSelector< ACollectorItem, ACollectionItem > Selector to remove all weighted relations with a weight below a certain cut value
C FilterSelector< ACollectorItem, ACollectionItem, AFilter > Selector to remove all weighted relations, where a definable Filter gives NaN as a result
C SingleMatchSelector< ACollectorItem, ACollectionItem, AComparer > Selector to remove all relations in the list, which share the same collection item - except one in case the useOnlySingleBestCandidate is set to false (then, only the one with the heightest weight is used)
► C Findlet< IOType * >
C StoreArrayLoader< IOType > Helper findlet to allow combined findlets to import data from the DataStore
► C Findlet< IOType >
C StoreVectorSwapper< IOType, a_alwaysWrite > Refines the clustering of wire hits from clusters to clusters
► C Findlet< const CDCWireHit, CDCTrack >
C AxialStraightTrackFinder Generates straight axial tracks from IP to an ECL cluster
C AxialTrackCreatorMCTruth Findlet that generates tracks from wire hits using the mc truth information
C AxialTrackFinderHough Generates axial tracks from hit using the special leaf processing inspired by the hough algorithm
C AxialTrackFinderLegendre Generates axial tracks from hit using special leaf postprocessing
C MonopoleAxialTrackFinderLegendre Generates monopole-like axial tracks from hit using special leaf postprocessing
► C Findlet< CDCWireHit &, CDCWireHitCluster, CDCWireHitCluster >
C ClusterPreparer Findlet to cluster the wire hits in the CDC to form locally connected groups with two granularities.";
► C Findlet< CDCWireHit &, CDCTrack & >
C MonopoleStereoHitFinder Complex findlet for finding stereo hits from monopoles to a list of cdc tracks
C MonopoleStereoHitFinderQuadratic Complex findlet for finding stereo hits from monopoles to a list of cdc tracks
C StereoHitFinder Complex findlet for finding stereo hits to a list of cdc tracks
► C Findlet< CDCWireHitCluster &, CDCSegment2D >
C SegmentFinderFacetAutomaton Findlet implementing the segment finding part of the full track finder
► C Findlet< CDCSegment2D &, CDCTrack & >
C SegmentTrackCombiner Findlet for the combination of tracks and segments
► C Findlet< const CDCSegment2D, CDCTrack >
C AxialTrackCreatorSegmentHough Generates axial tracks from segments using the hough algorithm
C TrackFinderSegmentPairAutomaton Findlet implementing the track finding from segments using a cellular automaton over segment pairs
C TrackFinderSegmentTripleAutomaton Findlet implementing the track finding from segments using a cellular automaton over segment triples
► C Findlet< CDCTrack & >
C CDCMCCloneLookUpFiller Findlet to exports CDCTracks as RecoTracks
C TrackExporter Findlet to exports CDCTracks as RecoTracks
C TrackFlightTimeAdjuster Findlet to adjust the flight time of tracks relative to the flight time zero
C TrackInspector Findlet for inspecting and printing out CDCtracks on a R-z plane for debug purposes
C TrackNormalizer Findlet for normalizing the track (trajectory) into common requirements (e.g. let it start at the first hit etc.)
C TrackQualityAsserter This module applies configurable correction functions to all found tracks
C TrackQualityEstimator Deletes fake tracks that have been rejected by a filter
C TrackRejecter Deletes fake tracks that have been rejected by a filter
C TrackSZFitter Findlet for fitting a list of tracks in the SZ direction and replace their trajectory 3D
► C Findlet< CDCWireHit >
C WireHitCreator Combines the geometrical information and the raw hit information into wire hits, which can be used from all modules after that
C WireHitPreparer Findlet preparing the wire hits for the track finding
► C Findlet< const CDCWireHit, const CDCTrack >
C AsicBackgroundLibraryCreator Finds ASICs with single signal hit, records info to the library
C Findlet< const AState *const, const Relation< AState >, AResult >
C Findlet< const AState *const, const WeightedRelation< AState >, AResult >
► C Findlet< CDCWireHit & >
C AsicBackgroundDetector Marks hits as background based on the result of a filter
C WireHitBackgroundBlocker Marks hits as background based on simple heuristics
C WireHitBackgroundDetector Marks hits as background based on the result of a filter
C WireHitMCMultiLoopBlocker Marks all hits that are not on the first loop of the track as background
► C Findlet< const CDCSegment2D, CDCAxialSegmentPair >
C AxialSegmentPairCreator Class providing construction combinatorics for the axial stereo segment pairs
► C Findlet< const ECLCluster *const, const CDCWireHit *const, CDCTrack >
C AxialStraightTrackCreator A findlet that searches for straight tracks in CDC coming form IP to an ECL cluster
► C Findlet< const CDCWireHit *const, CDCTrack >
C AxialTrackCreatorHitHough Generates axial tracks from hit using the special leaf processing inspired by the legendre algorithm
C AxialTrackCreatorHitLegendre Generates axial tracks from hit using special leaf postprocessing
C AxialTrackHitMigrator Exchanges hits between axial tracks based on their distance to the respective trajectory
C Findlet< CDCTrack &, const CDCWireHit *const >
► C Findlet< CDCWireHitCluster & >
C ClusterBackgroundDetector Marks clusters as background based on a background measure
C Findlet< CDCWireHit, CDCWireHitCluster >
► C Findlet< const CDCWireHitCluster, CDCWireHitCluster >
C ClusterRefiner< Belle2::TrackFindingCDC::BridgingWireHitRelationFilter >
C ClusterRefiner< AWireHitRelationFilter > Refines the clustering of wire hits from super clusters to clustexrs
► C Findlet< const CDCWireHitCluster, CDCFacet >
C FacetCreator Class providing construction combinatorics for the facets
C Findlet< CDCWireHit &, CDCRLWireHit & >
► C Findlet< CDCSegment2D & >
C SegmentAliasResolver Resolves between the potential alias versions of the segments and contained hits
C SegmentFitter Fits segments with the Riemann method
C SegmentRejecter Deletes fake segments that have been rejected by a filter
► C Findlet< const CDCFacet, const WeightedRelation< const CDCFacet >, CDCSegment2D >
C SegmentCreatorFacetAutomaton Findlet that generates segments within clusters based on a cellular automaton on triples of hits
► C Findlet< const CDCWireHit, CDCSegment2D >
C SegmentCreatorMCTruth Findlet that generates segments from wire hits using the mc truth information
► C Findlet< const CDCSegment2D, CDCSegment2D >
C SegmentLinker Links segments in the same super cluster by linking paths of segments in a cellular automaton
C SegmentOrienter Fixes the orientation of segments by a simple heuristic
► C Findlet< const CDCSegment2D, CDCSegmentPair >
C SegmentPairCreator Class providing construction combinatorics for the axial stereo segment pairs
► C Findlet< WeightedRelation< CDCTrack, const CDCSegment2D > &, CDCTrack &, const CDCSegment2D >
C SegmentTrackAdderWithNormalization Add the matched segments to the tracks and normalize the tracks afterwards
► C Findlet< const CDCSegment2D, const CDCAxialSegmentPair, CDCSegmentTriple >
C SegmentTripleCreator Class providing construction combinatorics for the axial stereo segment pairs
► C Findlet< const CDCTrack, const CDCTrack, CDCTrack >
C TrackCombiner Combines two sets of tracks to one final set by merging tracks that have large overlaps
► C Findlet< const CDCSegmentPair, const WeightedRelation< const CDCSegmentPair >, CDCTrack >
C TrackCreatorSegmentPairAutomaton Findlet that generates tracks based on a cellular automaton of segment pairs
► C Findlet< const CDCSegmentTriple, const WeightedRelation< const CDCSegmentTriple >, CDCTrack >
C TrackCreatorSegmentTripleAutomaton Findlet that generates tracks based on a cellular automaton of segment triples
► C Findlet< const CDCSegment2D, CDCTrack & >
C TrackCreatorSingleSegments Searches for segments that have not been used at all and creates tracks from them
C Findlet< CDCTrack >
► C Findlet< const CDCTrack, CDCTrack >
C TrackLinker Links tracks based on a filter criterion
C TrackOrienter Fixes the orientation of tracks by a simple heuristic
C Findlet< AObject, WeightedRelation< AObject > >
► C Findlet< VXDHoughState, std::vector< VXDHoughState * > >
C MultiHoughSpaceFastInterceptFinder Findlet for finding intersections of sinusoidal curves in the 2D Hough space by iteratively calling FastInterceptFinder2d
C SingleHoughSpaceFastInterceptFinder Findlet for finding intersections of sinusoidal curves in the 2D Hough space by iteratively calling FastInterceptFinder2d
► C Findlet< const TrackFindingCDC::WithWeight< const AHit * >, TrackFindingCDC::WithWeight< AHit * > >
► C OnHitApplier< AHit > Helper findlet which applies its () operator to all pairs of path and hit with all hits in the given child hit list
C PathLengthToggledApplier< VXDHoughState, LimitedOnHitApplier< VXDHoughState, TrackFindingCDC::ChooseableFilter< PathFilterFactory > > >
C LimitedOnHitApplier< AHit, AFilter > Specialisation of the OnHitApplier , which (a) uses a filter for the () operator, which is configurable (b) does only allow for the best N candidates in the child hits
C PathLengthToggledApplier< AHit, AFindlet > A special findlet, which chooses the filter based on the current path length
► C Findlet< std::vector< AHit * >, SpacePointTrackCand >
C RawTrackCandCleaner< AHit > Findlet for rejecting wrong SpacePointTrackCands and for removing bad hits
C Findlet< SpacePointTrackCand, const SpacePoint *const >
► C Findlet< AHit *, TrackFindingCDC::WeightedRelation< AHit > >
C RelationCreator< AHit, Belle2::vxdHoughTracking::LayerRelationFilter< TrackFindingCDC::ChooseableFilter< RelationFilterFactory > > >
C RelationCreator< AHit, ARelationFilter > Findlet for applying filters for creating hit-hit relations in each track candidate
► C Findlet< const SpacePointTrackCand >
C ROIFinder Findlet for performing the simple SVDHoughTracking ROI calculation
► C Findlet< const SpacePoint *, VXDHoughState >
C SpacePointLoaderAndPreparer Findlet for loading SVDSpacePoints and prepare them for usage in the FastInterceptFinder2D by creating VXDHoughStates in which the BeamSpotPosition is used to calculate the conformal transformed x,y coordinates and the creating pairs of coordinates for finding track candidates in r-phi and r-z
► C Findlet< AHit *, const TrackFindingCDC::WeightedRelation< AHit >, AResult >
C SVDHoughTrackingTreeSearcher< AHit, APathFilter, AResult > Findlet for constructing result paths out of a list of hits, which are connected with weighted relations
► C Findlet< SpacePointTrackCand >
C TrackCandidateOverlapResolver Findlet for rejecting wrong SpacePointTrackCands and for removing bad hits
► C Findlet< SpacePointTrackCand, SpacePointTrackCand >
C TrackCandidateResultRefiner Findlet for rejecting wrong SpacePointTrackCands and for removing bad hits
► C Findlet< CDCCKFResult >
C CDCCKFDuplicateRemover Remove duplicate paths created from ECLShowers These typically come from the seeding with two charge assumptions and Bremsstrahlung
► C Findlet< const CDCCKFPath, CDCCKFResult >
C CDCCKFResultFinalizer Findlet to finalize CKF Paths in terms of final result
► C Findlet< RecoTrack *const, CDCCKFPath >
C CDCCKFSeedCreator Create a CKF seed based on RecoTrack (presumably from VXDTF2)
► C Findlet< const CDCCKFState, CDCCKFState >
C CDCCKFStateFilter A stack of pre-, helix-extrapolation- , Kalman-extrapolation- and Kalman-update-filters
► C Findlet< AFilter::Object, AFilter::Object >
C OverlapResolver< AFilter > Simple findlet for searching the best candidate for a given seed applying the given filter
► C Findlet< const CKFToSVDResult, TrackFindingCDC::WeightedRelation< const RecoTrack, const RecoTrack > >
C RecoTrackRelator The results of the CKF ar in the form (seed -> vector of hits)
C Findlet< CDCCKFPath, const TrackFindingCDC::CDCWireHit *const >
► C Findlet< AnObject *const, AState >
C StateCreator< AnObject, AState > Create new states and add them to a vector from a given object vector
► C Findlet< WeightedRelation< ACollectorItem, const ACollectionItem > & >
► C AdderInterface< ACollectorItem, ACollectionItem > Base class for a findlet, which uses a reduced/thinned list of weighted relations between collector and collection items to absorb the matched collection items into a collector item
C RelationAdder< ACollectorItem, ACollectionItem > Class to add relations between the matched items
► C Findlet< CDCWireHit &, CDCWireHitCluster >
C ClusterCreator< AWireHitRelationFilter > Refines the clustering of wire hits from clusters to clusters
C SuperClusterCreator Refines the clustering of wire hits from clusters to clusters
C Findlet< ACellHolder *const, WeightedRelation< ACellHolder > const, std::vector< ACellHolder * > >
► C Findlet< ACollectorItem, const ACollectionItem, WeightedRelation< ACollectorItem, const ACollectionItem > >
► C MatcherInterface< ACollectorItem, ACollectionItem > Base class for a findlet, which outputs a list of weighted relations between elements in a list of CollectorItems and a list of CollectionItems
C SharingHitsMatcher< ACollectorItem, ACollectionItem > A generic matcher algorithm which outputs all combinations of elements with the number of shared hits as a weight
► C Findlet< CDCWireHit &, CDCRLWireHit >
C RLTaggedWireHitCreator Findlet for creating a list of RLWireHits (always bot hypothesis) from a list of WireHits using only the non-taken non-axial hits
► C Findlet< WeightedRelation< CDCTrack, const CDCRLWireHit > & >
► C AdderInterface< CDCTrack, CDCRLWireHit >
C StereoHitTrackAdder Class to add the matched hits to the track and set the taken flag correctly
C Findlet< const AState *const, const Relation< AState >, std::vector< const AState * > >
► C Findlet< AObject *const, WeightedRelation< AObject > >
C WeightedRelationCreator< AObject, ARelationFilter > Findlet that combines geometrical constrained pairs of objects to relations and selects them by the filter given as template parameter
C Findlet< const AState *const, const WeightedRelation< AState >, std::vector< const AState * > >
► C Findlet< VXDHoughState, const VxdID, VXDHoughState * >
C HitSelector Select hits to be analysed in the Hough Space intercept finder for a given layer 6 sensor based on the simple sensor friend map
► C Findlet< RecoTrack *const, Belle2::CKFToPXDState >
► C StateCreator< RecoTrack, Belle2::CKFToPXDState >
C StateCreatorWithReversal< Belle2::CKFToPXDState >
► C Findlet< const Belle2::SpacePoint *const, Belle2::CKFToPXDState >
C StateCreator< const Belle2::SpacePoint, Belle2::CKFToPXDState >
► C Findlet< Belle2::CKFToPXDState, Belle2::CKFToPXDState, TrackFindingCDC::WeightedRelation< Belle2::CKFToPXDState > >
C CKFRelationCreator< Belle2::CKFToPXDState, Belle2::LayerPXDRelationFilter< TrackFindingCDC::ChooseableFilter< PXDPairFilterFactory > > >
► C Findlet< const Belle2::CKFToPXDState, Belle2::CKFToPXDState, const TrackFindingCDC::WeightedRelation< Belle2::CKFToPXDState >, Belle2::CKFToPXDResult >
C TreeSearcher< Belle2::CKFToPXDState, Belle2::StateRejecter< CKFToPXDState, ChooseableOnPXDStateApplier >, Belle2::CKFToPXDResult >
► C Findlet< Belle2::TrackFindingCDC::ChooseableFilter< PXDResultFilterFactory >::Object, Belle2::TrackFindingCDC::ChooseableFilter< PXDResultFilterFactory >::Object >
C OverlapResolver< Belle2::TrackFindingCDC::ChooseableFilter< PXDResultFilterFactory > >
► C Findlet< const Belle2::CKFToPXDResult, const SpacePoint *const >
C SpacePointTagger< Belle2::CKFToPXDResult, Belle2::PXDCluster >
► C Findlet< Belle2::CKFToPXDResult >
C ResultStorer< Belle2::CKFToPXDResult >
► C Findlet< RecoTrack *const, Belle2::CKFToSVDState >
► C StateCreator< RecoTrack, Belle2::CKFToSVDState >
C StateCreatorWithReversal< Belle2::CKFToSVDState >
► C Findlet< const Belle2::SpacePoint *const, Belle2::CKFToSVDState >
C StateCreator< const Belle2::SpacePoint, Belle2::CKFToSVDState >
► C Findlet< Belle2::CKFToSVDState, Belle2::CKFToSVDState, TrackFindingCDC::WeightedRelation< Belle2::CKFToSVDState > >
C CKFRelationCreator< Belle2::CKFToSVDState, Belle2::LayerSVDRelationFilter< TrackFindingCDC::ChooseableFilter< SVDPairFilterFactory > > >
► C Findlet< const Belle2::CKFToSVDState, Belle2::CKFToSVDState, const TrackFindingCDC::WeightedRelation< Belle2::CKFToSVDState >, Belle2::CKFToSVDResult >
C TreeSearcher< Belle2::CKFToSVDState, Belle2::StateRejecter< CKFToSVDState, ChooseableOnSVDStateApplier >, Belle2::CKFToSVDResult >
► C Findlet< Belle2::TrackFindingCDC::ChooseableFilter< SVDResultFilterFactory >::Object, Belle2::TrackFindingCDC::ChooseableFilter< SVDResultFilterFactory >::Object >
C OverlapResolver< Belle2::TrackFindingCDC::ChooseableFilter< SVDResultFilterFactory > >
► C Findlet< const Belle2::CKFToSVDResult, const SpacePoint *const >
C SpacePointTagger< Belle2::CKFToSVDResult, Belle2::SVDCluster >
► C Findlet< Belle2::CKFToSVDResult >
C ResultStorer< Belle2::CKFToSVDResult >
► C Findlet< WeightedRelation< const Belle2::RecoTrack, const const Belle2::RecoTrack > >
C BestMatchSelector< const Belle2::RecoTrack, const Belle2::RecoTrack >
► C Findlet< const Belle2::TrackFindingCDC::WithAutomatonCell< const RecoTrack * > *const, WeightedRelation< const Belle2::TrackFindingCDC::WithAutomatonCell< const RecoTrack * > > >
C WeightedRelationCreator< const Belle2::TrackFindingCDC::WithAutomatonCell< const RecoTrack * >, Belle2::PhiRecoTrackRelationFilter >
► C Findlet< WeightedRelation< Belle2::RecoTrack *, const Belle2::RecoTrack * > >
C BestMatchSelector< Belle2::RecoTrack *, Belle2::RecoTrack * >
► C Findlet< WeightedRelation< Belle2::RecoTrack *, const Belle2::RecoTrack * > & >
► C AdderInterface< Belle2::RecoTrack *, Belle2::RecoTrack * >
C RelationAdder< Belle2::RecoTrack *, Belle2::RecoTrack * >
► C Findlet< const Belle2::SpacePoint * >
C StoreArrayLoader< const Belle2::SpacePoint >
► C Findlet< Belle2::TrackFindingCDC::CDCWireHit *const, WeightedRelation< Belle2::TrackFindingCDC::CDCWireHit > const, Belle2::TrackFindingCDC::CDCWireHitCluster >
C Clusterizer< Belle2::TrackFindingCDC::CDCWireHit, Belle2::TrackFindingCDC::CDCWireHitCluster >
► C Findlet< DataStoreInputTypeRefType * >
C StoreArrayLoader< DataStoreInputTypeRefType >
► C Findlet< WeightedRelation< Belle2::TrackFindingCDC::CDCTrack, const Belle2::TrackFindingCDC::CDCRLWireHit > >
C FilterSelector< Belle2::TrackFindingCDC::CDCTrack, Belle2::TrackFindingCDC::CDCRLWireHit, Belle2::TrackFindingCDC::ChooseableFilter< Belle2::TrackFindingCDC::StereoHitFilterFactory > >
C SingleMatchSelector< Belle2::TrackFindingCDC::CDCTrack, Belle2::TrackFindingCDC::CDCRLWireHit, Belle2::TrackFindingCDC::BinaryJoin< Less, AFunctor1, AFunctor2 > >
► C Findlet< const Belle2::TrackFindingCDC::CDCFacet *const, WeightedRelation< const Belle2::TrackFindingCDC::CDCFacet > >
C WeightedRelationCreator< const Belle2::TrackFindingCDC::CDCFacet, Belle2::TrackFindingCDC::ChooseableFilter< FacetRelationFilterFactory > >
► C Findlet< Belle2::TrackFindingCDC::CDCFacet >
C StoreVectorSwapper< Belle2::TrackFindingCDC::CDCFacet >
► C Findlet< const Belle2::TrackFindingCDC::CDCSegment2D *const, WeightedRelation< const Belle2::TrackFindingCDC::CDCSegment2D > >
C WeightedRelationCreator< const Belle2::TrackFindingCDC::CDCSegment2D, Belle2::TrackFindingCDC::ChooseableFilter< SegmentRelationFilterFactory > >
► C Findlet< WeightedRelation< Belle2::TrackFindingCDC::CDCTrack, const Belle2::TrackFindingCDC::CDCRecoHit3D > >
C SingleMatchSelector< Belle2::TrackFindingCDC::CDCTrack, Belle2::TrackFindingCDC::CDCRecoHit3D, Belle2::TrackFindingCDC::BinaryJoin< Less, AFunctor1, AFunctor2 > >
► C Findlet< Belle2::TrackFindingCDC::CDCTrack, const Belle2::TrackFindingCDC::CDCSegment2D, WeightedRelation< Belle2::TrackFindingCDC::CDCTrack, const Belle2::TrackFindingCDC::CDCSegment2D > >
► C MatcherInterface< Belle2::TrackFindingCDC::CDCTrack, Belle2::TrackFindingCDC::CDCSegment2D >
C SharingHitsMatcher< Belle2::TrackFindingCDC::CDCTrack, Belle2::TrackFindingCDC::CDCSegment2D >
► C Findlet< WeightedRelation< Belle2::TrackFindingCDC::CDCTrack, const Belle2::TrackFindingCDC::CDCSegment2D > >
C CutSelector< Belle2::TrackFindingCDC::CDCTrack, Belle2::TrackFindingCDC::CDCSegment2D >
C FilterSelector< Belle2::TrackFindingCDC::CDCTrack, Belle2::TrackFindingCDC::CDCSegment2D, Belle2::TrackFindingCDC::ChooseableFilter< Belle2::TrackFindingCDC::SegmentTrackFilterFactory > >
C SingleMatchSelector< Belle2::TrackFindingCDC::CDCTrack, Belle2::TrackFindingCDC::CDCSegment2D >
► C Findlet< Belle2::TrackFindingCDC::CDCWireHit >
C StoreVectorSwapper< Belle2::TrackFindingCDC::CDCWireHit, true >
► C Findlet< Belle2::TrackFindingCDC::CDCSegment2D >
C StoreVectorSwapper< Belle2::TrackFindingCDC::CDCSegment2D >
► C Findlet< Belle2::TrackFindingCDC::CDCTrack >
C StoreVectorSwapper< Belle2::TrackFindingCDC::CDCTrack >
► C Findlet< const Belle2::TrackFindingCDC::CDCSegmentPair *const, WeightedRelation< const Belle2::TrackFindingCDC::CDCSegmentPair > >
C WeightedRelationCreator< const Belle2::TrackFindingCDC::CDCSegmentPair, Belle2::TrackFindingCDC::ChooseableFilter< SegmentPairRelationFilterFactory > >
► C Findlet< Belle2::TrackFindingCDC::CDCSegmentPair >
C StoreVectorSwapper< Belle2::TrackFindingCDC::CDCSegmentPair >
► C Findlet< const Belle2::TrackFindingCDC::CDCSegmentTriple *const, WeightedRelation< const Belle2::TrackFindingCDC::CDCSegmentTriple > >
C WeightedRelationCreator< const Belle2::TrackFindingCDC::CDCSegmentTriple, Belle2::TrackFindingCDC::ChooseableFilter< SegmentTripleRelationFilterFactory > >
► C Findlet< Belle2::TrackFindingCDC::CDCSegmentTriple >
C StoreVectorSwapper< Belle2::TrackFindingCDC::CDCSegmentTriple >
► C Findlet< const Belle2::TrackFindingCDC::CDCTrack *const, WeightedRelation< const Belle2::TrackFindingCDC::CDCTrack > >
C WeightedRelationCreator< const Belle2::TrackFindingCDC::CDCTrack, Belle2::TrackFindingCDC::ChooseableFilter< TrackRelationFilterFactory > >
► C Findlet< AHit *, const TrackFindingCDC::WeightedRelation< AHit >, Result >
C SVDHoughTrackingTreeSearcher< AHit, Belle2::vxdHoughTracking::PathLengthToggledApplier< VXDHoughState, LimitedOnHitApplier< VXDHoughState, TrackFindingCDC::ChooseableFilter< PathFilterFactory > > >, Result >
► C Findlet< std::vector< Belle2::vxdHoughTracking::VXDHoughState * >, SpacePointTrackCand >
C RawTrackCandCleaner< Belle2::vxdHoughTracking::VXDHoughState >
► C Findlet< Belle2::vxdHoughTracking::VXDHoughState *, TrackFindingCDC::WeightedRelation< Belle2::vxdHoughTracking::VXDHoughState > >
C RelationCreator< Belle2::vxdHoughTracking::VXDHoughState, Belle2::vxdHoughTracking::LayerRelationFilter< TrackFindingCDC::ChooseableFilter< RelationFilterFactory > > >
► C Findlet< Belle2::vxdHoughTracking::VXDHoughState *, const TrackFindingCDC::WeightedRelation< Belle2::vxdHoughTracking::VXDHoughState >, Result >
C SVDHoughTrackingTreeSearcher< Belle2::vxdHoughTracking::VXDHoughState, Belle2::vxdHoughTracking::PathLengthToggledApplier< VXDHoughState, LimitedOnHitApplier< VXDHoughState, TrackFindingCDC::ChooseableFilter< PathFilterFactory > > >, Result >
► C BaseVarSet< AObject > Generic class that generates some named float values from a given object
► C VarSet< PXDResultVarNames >
C PXDResultVarSet Var set used in the VXD-CDC-Merger for calculating the probability of a VXD-CDC-track match, which knows the truth information if two tracks belong together or not
► C VarSet< SVDResultVarNames >
C SVDResultVarSet Var set used in the VXD-CDC-Merger for calculating the probability of a VXD-CDC-track match, which knows the truth information if two tracks belong together or not
► C VarSet< TruthAxialSegmentPairVarNames >
C TruthAxialSegmentPairVarSet Class to compute floating point variables from an axial stereo segment pair which can be recorded as a flat TNtuple or serve as input to a MVA method
► C VarSet< FilterVarNames< AFilter > >
C FilterVarSet< AFilter > Class to compute floating point variables from a filter response which can be recorded as a flat TNtuple or serve as input to a MVA method
► C VarSet< BkgTruthClusterVarNames >
C BkgTruthClusterVarSet Class to compute floating point variables from a wire hit cluster which can be recorded as a flat TNtuple or serve as input to a MVA method
► C VarSet< TruthSegmentVarNames >
► C TruthSegmentVarSet Class to compute floating point variables from a segment which can be recorded as a flat TNtuple or serve as input to a MVA method
C BkgTruthSegmentVarSet Class to compute floating point variables from a segment which can be recorded as a flat TNtuple or serve as input to a MVA method
► C VarSet< FitSegmentPairVarNames >
C FitSegmentPairVarSet Class to compute floating point variables from an axial stereo segment pair which can be recorded as a flat TNtuple or serve as input to a MVA method
► C VarSet< BestMatchedTruthVarNames >
C BestMatchedTruthVarSet Class to compute floating point variables from a track which can be recorded as a flat TNtuple or serve as input to a MVA method
► C VarSet< TruthTrackVarNames >
C TruthTrackVarSet Class to compute floating point variables from a track which can be recorded as a flat TNtuple or serve as input to a MVA method
► C VarSet< CDCWireHitVarNames >
C CDCWireHitVarSet Var set used in the VXD-CDC-Merger for calculating the probability of a VXD-CDC-track match, which knows the truth information if two tracks belong together or not
C UnionVarSet< AObject > Class that accommodates many variable sets and presents them as on set of variables
► C Filter< AObject > Base class for filters on a generic object type
► C OnVarSet< Filter< typename AVarSet::Object > >
C MVA< Filter< typename AVarSet::Object > >
C Recording< Filter< typename AVarSet::Object > >
► C RelationFilter< CKFToPXDState >
C LayerPXDRelationFilter< TrackFindingCDC::ChooseableFilter< PXDPairFilterFactory > >
C LayerPXDRelationFilter< AFilter, APrefilter > Base filter for CKF PXD states
► C RelationFilter< CKFToSVDState >
C LayerSVDRelationFilter< TrackFindingCDC::ChooseableFilter< SVDPairFilterFactory > >
C LayerSVDRelationFilter< AFilter, APrefilter > Base filter for CKF SVD states
► C RelationFilter< const CellularRecoTrack >
C PhiRecoTrackRelationFilter Relation filter that lets only possibilities with small phi distance pass
► C RelationFilter< const CDCSegment2D >
► C BaseSegmentRelationFilter Base class for filtering the neighborhood of segments
► C MCSymmetric< BaseSegmentRelationFilter >
C MCSegmentRelationFilter Filter for the construction of segment relations based on MC information
► C RelationFilter< CDCWireHit >
C BridgingWireHitRelationFilter Wire hit relation filter that is compensating for hit inefficiencies
C WholeWireHitRelationFilter Class mapping the neighborhood of wires to the neighborhood of wire hits
► C RelationFilter< VXDHoughState >
C LayerRelationFilter< TrackFindingCDC::ChooseableFilter< RelationFilterFactory > >
C LayerRelationFilter< AFilter > Relation filter the creation of relations
► C Findlet< AIOTypes > Interface for a minimal algorithm part that wants to expose some parameters to a module
► C StateCreator< RecoTrack, AState >
C StateCreatorWithReversal< AState > An adaption of the normal state creator introducing another parameter to reverse the seed
C StateRejecter< CKFToPXDState, ChooseableOnPXDStateApplier >
C StateRejecter< CKFToSVDState, ChooseableOnSVDStateApplier >
► C MatcherInterface< CDCTrack, CDCRLWireHit >
C StereoHitTrackQuadTreeMatcher< Belle2::TrackFindingCDC::HyperHough< std::pair< CDCRecoHit3D, const CDCRLWireHit * >, FirstOfPairInBox< HitInHyperBox >, 4, 3, 2 > >
C StereoHitTrackQuadTreeMatcher< Belle2::TrackFindingCDC::QuadraticLegendre< std::pair< CDCRecoHit3D, const CDCRLWireHit * >, FirstOfPairInBox< HitInQuadraticBox >, 2, 2 > >
C StereoHitTrackQuadTreeMatcher< Belle2::TrackFindingCDC::Z0TanLambdaLegendre< std::pair< CDCRecoHit3D, const CDCRLWireHit * >, FirstOfPairInBox< HitInZ0TanLambdaBox >, 2, 2 > >
C StereoHitTrackQuadTreeMatcher< AQuadTree > A matcher algorithm for using a stereo quad tree for matching rl tagged wire hits to tracks
C StackTreeSearcher CKF tree searcher which traces several best paths
C AxialTrackMerger Findlet implementing the merging of axial tracks found in the legendre tree search
C Clusterizer< ACellHolder, ACluster > Implementation of the clustering Clusters elements of a given collection using the relations presented by a neighborhood
C TreeTraversal< AStateRejecter, AState, AResult > General implementation of a tree search algorithm using a given classes as state and results and one strategy class to decide, which child states should be traversed next
C WeightedTreeTraversal< AStateRejecter, AState, AResult > General implementation of a tree search algorithm using a given classes as state and results and one strategy class to decide, which child states should be traversed next
C RecoTrackStorer Store RecoTracks into StoreArray
C ProcessListener
C ProcessMonitor Class to monitor all started framework processes (input, workers, output), kill them if requested and handle the signals from the OS
C ProcessStatisticsPython Python interface for ProcessStatistics
C ProcessSubmitter
C ProcessViewer
C ProcHandler A class to manage processes for parallel processing
C Product< factors > Template class for compile time computation of products
C ProfilePlot
C ECLShowerShapeModule::ProjectedECLDigit Struct used to hold information of the digits projected to a plane perpendicular to the shower direction
C Projection Class to store the projected residuals and the corresponding jacobian as well as the covariance matrix in the system of residuals
► C Prompts
C Basf2IPythonPrompt
C Property
► C ProTool
► C Transform
C CDF
C ToFlat
C Proxy Internal class that registers a variable with Manager when constructed
C PThread
C PDFConstructor::Pull Data type for storing photon pull w.r.t PDF peak
C PullAnalysis
C PulseHeightGenerator Generates pulse height according to distribution: P(x) = (x/x0)^p1 * exp(-(x/x0)^p2), p1 >= 0, p2 > 0 in the range 0 to xmax
C PXDClusterPositionEstimator Singleton class that estimates cluster positions taking into account the estimated track incidence angles into the sensor
C PXDClusterShape Class to correct estimation of cluster error and position base on its shape
C PXDDAQDHCStatus The PXD DAQ DHC Status class
C PXDDAQDHEStatus The PXD DAQ DHE Status class
C PXDDAQDHPStatus The PXD DAQ DHP Status class
C PXDDAQPacketStatus The PXD DAQ Packet Status class
C PXDGainCalibrator Singleton class for managing gain corrections for the PXD
C PXDIgnoredPixelsMap This class provides a check for ignored (=cold, hot or otherwise deffective) pixels for the use in PXD data reconstruction
C PXDKalmanStepper Kalman stepper implementation for the PXD CKF
C PXDLocalDAQFile A class to manage I/O for a chain of blocked files
C PXDMappingLookup Class to make the mapping between u/v cell ID of pixels back to DCD drain lines, pixel row/col, DCD and Switcher IDs Details: Belle Note: BELLE2-NOTE-TE-2015-01 "The vertex detector numbering scheme" https://docs.belle2.org/record/243/files/Belle%20II%20note%200010.pdf PXD WhiteBook 3.1.3 Sensor Design and Appendix #3 https://xwiki.desy.de/xwiki/bin/download/BI/Belle%20II%20Internal/Detector%20WebHome/PXD%20WebHome/WebHome/PXDwb.pdf?rev=2.1
C PXDPixelMasker Singleton class for managing pixel masking for the PXD
C pydat2_type PYDAT2 common block of PYTHIA6
C PyEstimator Class to invoke a pretrained python estimator that follows the sklearn interface
C PyStoreArray A (simplified) python wrapper for StoreArray
C PyStoreObj (simplified) python wrapper for StoreObjPtr
C PythonInitializerSingleton Singleton class which handles the initialization and finalization of Python and numpy
C PythonVariableManager
C QAM
C QuadTreeItem< AData > This class serves as a wrapper around all things that should go into a QuadTree
C QuadTreeNode< AX, AY, AItem > Class which holds quadtree structure
C QuadTreeProcessor< AX, AY, AData > This abstract class serves as a base class for all implementations of track processors
► C QuadTreeProcessor< long, float, const CDCWireHit >
C AxialHitQuadTreeProcessor A QuadTreeProcessor for TrackHits
C QualityEstimationResults Container for complete fit/estimation results
► C QualityEstimatorBase BaseClass for QualityEstimators
C QualityEstimatorCircleFit Class containing the algorithm to perform the simple circle fit
C QualityEstimatorLineFit3D Testbeam: Coords: Sensors: ^
C QualityEstimatorMC Class implementing the algorithm used for the MC based quality estimation
C QualityEstimatorRandom Class implementing a random quality estimation
C QualityEstimatorRiemannHelixFit Based on R
C QualityEstimatorTripletFit Does a tripletFit of the given hits The filter is based on the paper 'A New Three-Dimensional Track Fit with Multiple Scattering' by Andre Schoening et al
► C QueueHarvester
C FitHarvester
► C VXDHarvester
C PXDHarvester
C SVDHarvester
C Quiet
C RandomNumbers The class for handling the random number generation
C Range< InfType, SupType > Represents a range of arithmetic types
C BFieldComponentQuad::range_t Range data structure
C RangeInBox< AHitInBoxAlgorithm > Predicate class to check for the containment of items in a rangeobject in a hough space part
C RaveKinematicVertexFitter Part of the RaveInterface together with RaveSetup
C RaveSetup Part of the RaveInterface together with RaveVertexFitter It holds all global options for the RaveVertexFitter and also takes care that stuff like the magnetic field is correctly set up in way Rave can access it
C RaveVertexFitter Part of the RaveInterface together with RaveSetup
C RawCluster Class representing a raw cluster candidate during clustering of the SVD
C RawCOPPERPackerInfo Struct to contain header information used by RawCOPPERFormat::Packer()
C RawData KLM raw data
► C RawDataBlockFormat The RawDataBlockFormat class Format information for rawdata handling
► C RawCOPPERFormat The Raw COPPER class This class stores data received by COPPER via belle2linkt Data from all detectors except PXD are stored in this class
► C RawCOPPERFormat_latest The Raw COPPER class ver.1 ( the latest version since May, 2014 ) This class stores data received by COPPER via belle2linkt Data from all detectors except PXD are stored in this class
C PostRawCOPPERFormat_latest The Raw COPPER class ver
C PreRawCOPPERFormat_latest The Raw COPPER class ver.1 ( the latest version since May, 2014 ) This class stores data received by COPPER via belle2linkt Data from all detectors except PXD are stored in this class
C RawCOPPERFormat_v0 The Raw COPPER class ver.0 ( from August, 2013 to April, 2014 ) This class stores data received by COPPER via belle2linkt Data from all detectors except PXD are stored in this class
► C RawCOPPERFormat_v1 The Raw COPPER class ver.1 ( the latest version since May, 2014 ) This class stores data received by COPPER via belle2linkt Data from all detectors except PXD are stored in this class
C PostRawCOPPERFormat_v1 The Raw COPPER class ver.1 ( the latest version since May, 2014 ) This class stores data received by COPPER via belle2linkt Data from all detectors except PXD are stored in this class
C PreRawCOPPERFormat_v1 The Raw COPPER class ver.1 ( the latest version since May, 2014 ) This class stores data received by COPPER via belle2linkt Data from all detectors except PXD are stored in this class
► C RawCOPPERFormat_v2 The Raw COPPER class ver.1 ( the latest version since May, 2014 ) This class stores data received by COPPER via belle2linkt Data from all detectors except PXD are stored in this class
C PostRawCOPPERFormat_v2 The Raw COPPER class ver.2 This class stores data received by COPPER via belle2link Data from all detectors except PXD are stored in this class
C PreRawCOPPERFormat_v2 The Raw COPPER class ver.1 ( the latest version since May, 2014 ) This class stores data received by COPPER via belle2linkt Data from all detectors except PXD are stored in this class
► C RawFTSWFormat The Raw FTSW class
C RawFTSWFormat_latest The Raw FTSW class 3 ( 2019.8.20 )
C RawFTSWFormat_v1 The Raw FTSW class ver.1
C RawFTSWFormat_v2 The Raw FTSW class ver.2
C RawTLUFormat The Raw TLU class Class for data from DAQ PC for TLU(Trigger Logic Unit) It is supposed to be used only in the DESY beam test
C RawDataCollectedMinMax Takes care of collecting raw data and staying below RAM-threshold
C RawHeader_latest The Raw Header class ver.1 ( the latest version since May, 2014 ) This class defines the format of the header of RawCOPPER class data and used for extracting header info from RawCOPPER object
C RawHeader_v0 The Raw Header class ver.0 ( from August, 2013 to April, 2014 ) This class defines the format of the header of RawCOPPER class data and used for extracting header info from RawCOPPER object
C RawHeader_v1 The Raw Header class ver.1 ( the latest version since May, 2014 ) This class defines the format of the header of RawCOPPER class data and used for extracting header info from RawCOPPER object
C RawHeader_v2 The Raw Header class ver.1 ( the latest version since May, 2014 ) This class defines the format of the header of RawCOPPER class data and used for extracting header info from RawCOPPER object
C RawRevRb2Sock
C RawRevSock2Rb
C RawRootFile
C RawSecMapRootInterface To be used as an interface to root-stuff
C SegmentNetworkProducerModule::RawSectorData Simple struct for collecting raw data for a single sector
C RawTrailer_latest The Raw Trailer class ver.1 ( the latest version since May, 2014 ) This class defines the format of the trailer of RawCOPPER class data and used for extracting trailer info from RawCOPPER object
C RawTrailer_v0 The Raw Trailer class ver.0 ( from August, 2013 to April, 2014 ) This class defines the format of the trailer of RawCOPPER class data and used for extracting trailer info from RawCOPPER object
C RawTrailer_v1 The Raw Trailer class ver.1 ( the latest version since May, 2014 ) This class defines the format of the trailer of RawCOPPER class data and used for extracting trailer info from RawCOPPER object
C RawTrailer_v2 The Raw Trailer class ver.1 ( the latest version since May, 2014 ) This class defines the format of the trailer of RawCOPPER class data and used for extracting trailer info from RawCOPPER object
► C RaytracerBase Base class with geometry data
C FastRaytracer Fast photon propagation in quartz optics
C InverseRaytracer Utility for solving inverse ray-tracing problem
C YScanner Utility for expanding the PDF in y direction
C Rb2Sock
C RbTupleManager Class to manage histograms defined in registered modules
C RCConfig
C RCNodeDaemon
► C Reader
C FileReader< File >
C FileReader< Fifo >
C FileReader< TCPSocket >
C BufferedReader
C FileReader< FD >
C ReaderSAD Class to read files that have been created by SAD and store their content in a MCParticle graph
C RootInputModule::ReadStats For collecting statistics over multiple files
C ReattachCDCWireHitsToRecoTracksModule::ReconstructionResults Internal structure to store the results of the reconstruction
C Recorder Class to fill a tree from a set of variables
C RecoTrackGenfitAccess This class allows access to the genfit::Track of the RecoTrack
C RecoTrackUtil Structure to summarize utility function to output a list of hits into a RecoTrack
► C ReferenceFrame Abstract base class of all reference frames
C CMSFrame CMS frame
C CMSRotationFrame Stack frame for cms and Rotation frame
C LabFrame Lab frame
C RestFrame Rest frame of a particle
C RotationFrame Rotation frame around vector
C RefHistObject Class to keep track of reference histograms with the original
► C Refiner
C CdRefiner
C ExpertLevelRefiner
C FilterRefiner
C GroupByRefiner
► C Plot2DRefiner
C SaveProfilesRefiner
C SaveScatterRefiner
C SaveClassificationAnalysisRefiner
C SaveFiguresOfMeritRefiner
C SaveHistogramsRefiner
C SavePullAnalysisRefiner
C SaveTreeRefiner
C SelectRefiner
C RelationEntry Struct for relations
C RelationFilterUtil Name Structured creation of neighborhoods
C RelationIndex< FROM, TO > Provides access to fast ( O(log n) ) bi-directional lookups on a specified relation
► C RelationIndexBase Baseclass for all RelationIndexContainers
C Element< FROM, TO >
C ElementIndex< FROM, TO >
C RelationIndexContainer< FROM, TO > Class to store a bidirectional index between two StoreArrays
C RelationIndexManager Manager to keep a cache of existing RelationIndexContainers
► C RelationVectorBase Base class for RelationVector<T>
C RelationVector< T > Class for type safe access to objects that are referred to in relations
C RelationArray::ReplaceMap< MapType > Struct to replace indices based on a map-like container
C RelationArray::ReplaceVec< VecType > Struct to replace indices based on a sequential container
C ResolutionAnalysis
C YScanner::Result Single PDF peak data
C KLMChannelStatusAlgorithm::Results Calibration results
C KLMStripEfficiencyAlgorithm::Results Calibration results or supplementary results calculated from the input data
C array< T >::reverse_iterator STL iterator class
C map< K, T >::reverse_iterator STL iterator class
C string::reverse_iterator STL iterator class
C vector< T >::reverse_iterator STL iterator class
C RevRb2Sock
C RevSock2Rb
C REvtSocketRecv
C REvtSocketSend
C Reweighter
C ReweighterParticle
► C RFConf
C RFNodeManager
C RFConf_t
C RFFlowStat
C RFLogManager
C RfNodeInfo
C RfUnitInfo::RfNodeInfo
C rfnodeinfo
► C RFNSM
C RFNodeManager
C RFNSM_Status
C RFProcessManager
► C RFServerBase
C ERecoDistributor
C ERecoEventProcessor
C ERecoEventSampler
C ERecoMaster
C RFDqmServer
C RFEventProcessor
C RFEventServer
C RFMaster
C RFOutputServer
C RFRoiSender
C RfShm_Cell
C RfShm_Data
C RfUnitInfo
C RiemannsMethod Class implementing the Riemann fit for two dimensional trajectory circle
C RingBuffer Class to manage a Ring Buffer placed in an IPC shared memory
C RingBufInfo Internal metadata structure for RingBuffer
► C RndmEngine
C FragmentationRndm Minimal class for external random generator to be used in PYTHIA
C ro_summary
C ROIGeometry This class appends the VXDIntercept infos of a track to the list of intercepts
C ROIDQMModule::ROIHistoAccumulateAndFill Struct: histograms to be filled once per event + filling function + accumulate function
C SVDROIDQMModule::ROIHistoAccumulateAndFill Struct: histograms to be filled once per event + filling function + accumulate function
C ROIinfo ROIinfo contains the parameters that can be changed by the user in the python script
C ROIrawID ROIrawID
C ROIToUnitTranslator< aIntercept > Translator for ROI-geometry-information into a list of pixels or strips
C ronode_info
C ronode_status
C RootFileCreationManager This single instance class takes track of all open ROOT files open in "create" mode, usually meant for all the ntuple output modules
C RootFileInfo Helper class to factorize some necessary tasks when working with Belle2 output files
C RootParameterTracker Production notes for RootParameterTracker :
C RootQuantityExtract
C CurlingTrackCandSplitterModule::RootVariables Internal DataStore for ROOT output variables
C PhaseSpaceAnalysisModule::RootVariables Helper class to have all RootVariables assembled in one container
C SegmentNetworkAnalyzerModule::RootVariables Keep all the variables for rootoutput in one struct
C SpacePoint2TrueHitConnectorModule::RootVariables Helper struct to access root variables inside the module
C RunDB
C RunInfoBuffer
C ScriptStatus.running
C RunningTagUpdater
C RunNumber
C RunNumberTable
► C RuntimeError
C ConditionsDB.RequestError
C RWLock
C BeamBkgGeneratorModule::SADTree Structure of the TTree in the SAD file
C SameSignChecker Small helper for checking the same sign of two, four or eight floats
C SampleGenerator
C Scalar< T > Class wrapping a scalar type (for which std::is_scalar is true)
► C ScalarToClass
C Named< Float_t * >
C WithAutomatonCell< const RecoTrack * >
C WithWeight< Object * >
C WithWeight< AItem >
C Named< T > A mixin class to attach a name to an object
C Unmarkable< T > Mixin class to attach a mark that is shared among many instances
C WithAutomatonCell< T > Mixin class to attach an automaton cell to an object or pointer
C WithSharedMark< T > Mixin class to attach a mark that is shared among many instances
C WithWeight< T > A mixin class to attach a weight to an object
C ScalarToClassImpl< T, a_isScalar > Helper type function to replace a T with Scalar<T> when std::is_scalar<T>
C ScalarToClassImpl< T, true > Specialisation for scalar types
C MaterialScan2D::ScanParams Helper struct to Store Parameters of a Scan
C ScintillatorFirmware FPGA fitter class
C ScintillatorSimulator Digitize EKLMSim2Hits to get EKLM StripHits
C ScopeGuard Simple ScopeGuard to execute a function at the end of the object lifetime
C ScriptStatus Enumeration of the states a script can be during its execution cycle
C Scrooge Executes greedy algorithm for vector of QITrackOverlap structs
C SecIDPair Allows to set outer and inner secID
C SecIDQuadruplet Allows to set outer, outerCenter, innerCenter and inner secID
C SecIDTriplet Allows to set outer, center and inner secID
C SecMapTrainer< FilterFactoryType > This class contains all relevant tools for training a VXDTFFilters
C SecMapTrainerTC Simple Hit class used for sectorMap-training
C NDFinder::SectorBinning Data type to collect a binning
C SectoredLinearDivision< ABox, divisions > Factory object that constructs sub boxes from a given box with optional overlaps
C SectorGraph< FilterType > All subgraphs
C SectorsOnSensor< sectorID > This class associates to an ordered pairs of normalized local coordinates a compact sector id
C SectorSupportLogicalVolumes Sector support logical volumes
C SectorSupportSolids Sector support solids
C SeedGetter Helper Functor to get the Seed of a given result
C Segment< HitType > The Segment class This class represents segments of track candidates needed for TrackFinderVXD-Modules
C SegmentInPhi0CurvBox Predicate class to check for the containment of segments in a phi0 curv hough space part
C SegmentInZ0TanLambdaBox Predicate class to check for the containment of hits in a z0 tan lambda hough space part
C SelectedECLCluster Temporary data structure holding the ECL clusters used for this analysis
C TOPTrack::SelectedHit Selected photon hit from TOPDigits
C SelectionVariable< templateArgumentType, Nargs, templateReturnType > Base class of the selection variable objects used for pair filtering
► C SelectionVariable< PointContainerType, 0, int >
C ZIGGZAGGRZ_NAME< PointType, PointContainerType > Checks whether chain of segments are zigg-zagging (changing sign of curvature of neighbouring segments) in the R-Z-plane, returns number of charge-signs found (if != 1, then the given hitContainer is ziggZagging)
C ZIGGZAGGXYWITHSIGMA_NAME< PointType, PointContainerType > Checks whether chain of segments are zigg-zagging (changing sign of curvature of neighbouring segments) in the X-Y-plane, returns number of charge-signs found (if != 1, then the given hitContainer is ziggZagging)
C ZIGGZAGGXY_NAME< PointType, PointContainerType > Checks whether chain of segments are zigg-zagging (changing sign of curvature of neighbouring segments) in the X-Y-plane, returns number of charge-signs found (if != 1, then the given hitContainer is ziggZagging)
► C SelectionVariable< PointType, 2, double >
C COSDIRECTIONXY_NAME< PointType > This is a specialization returning floats, where value calculates the cos of the angle of the segment of two hits in the XY plane
C DISTANCE1DZSQUARED_NAME< PointType > This is the specialization for SpacePoints with returning floats, where value calculates the squared distance between two hits in 1D on the Z-axis
C DISTANCE1DZ_NAME< PointType > This is the specialization for SpacePoints with returning floats, where value calculates the distance between two hits in 1D on the Z-axis
C DISTANCE2DXYSQUARED_NAME< PointType > This is the specialization for SpacePoints with returning floats, where value calculates the squared distance between two hits in 2D on the X-Y-plane
C DISTANCE3DNORMED_NAME< PointType > This is the specialization for SpacePoints with returning floats, where value calculates the normed distance between two hits in 3D
C DISTANCE3DSQUARED_NAME< PointType > This is the specialization for SpacePoints with returning floats, where value calculates the squared distance between two hits in 3D
C DISTANCEINTIME_U_NAME< PointType > This variable returns the time difference among the U side clusters of the two space points
C DISTANCEINTIME_V_NAME< PointType > This variable returns the time difference among the V side clusters of the two space points
C SLOPERZ_NAME< PointType > This is the specialization for SpacePoints with returning floats, where value calculates the slope in R-Z for a given pair of hits
► C SelectionVariable< PointType, 3, B2Vector3D >
C CIRCLECENTERXY_NAME< PointType > Calculates the center of the circle for 3 hits in the XY plane and returns a B2Vector3 with the result (z=0)
► C SelectionVariable< PointType, 3, double >
C ANGLE3DFULL_NAME< PointType > Calculates the angle between the hits/vectors (3D), returning unit: angle in degrees
C ANGLE3DSIMPLE_NAME< PointType > Calculates the angle between the hits/vectors (3D), returning unit: none (calculation for degrees is incomplete, if you want readable numbers, use Angle3DFull instead)
C ANGLERZFULL_NAME< PointType > Calculates the angle between the hits/vectors (RZ), returning unit: angle in degrees
C ANGLERZSIMPLE_NAME< PointType > Calculates the angle between the hits/vectors (RZ), returning unit: none (calculation for degrees is incomplete, if you want readable numbers, use AngleRZFull instead)
C ANGLEXYFULL_NAME< PointType > Calculates the angle between the hits/vectors (XY ), returning unit: angle in degrees
C CIRCLEDIST2IP_NAME< PointType > Calculates the distance of the point of closest approach of circle to the IP, returning unit: cm
C CIRCLERADIUS_NAME< PointType > Calculates the estimation of the circle radius of the 3-hit-tracklet, returning unit: cm
C COSANGLEXY_NAME< PointType > Calculates the angle between the hits/vectors (XY ), returning unit: none (calculation for degrees is incomplete, if you want readable numbers, use AngleXYFull instead):
C DELTASLOPERZ_NAME< PointType > Calculates deviations in the slope of the inner segment and the outer segment, returning unit: none
C DELTASLOPEZOVERS_NAME< PointType > Compares the "slopes" z over arc length
C DELTASOVERZ_NAME< PointType > Calculates the helixparameter describing the deviation in arc length per unit in z
C DISTANCEINTIME< PointType > This variable returns the difference among the V and U side clusters of th ecenter space point
C HELIXPARAMETERFIT_NAME< PointType > Calculates the helixparameter describing the deviation in z per unit angle, returning unit: none
C PT_NAME< PointType > Calculates the estimation of the transverse momentum of the 3-hit-tracklet, returning unit: GeV/c
► C SelectionVariable< PointType, 3, int >
C SIGNCURVATUREXYERROR_NAME< PointType > Calculates the sign of the curvature for three hits
C SIGNCURVATUREXY_NAME< PointType > Calculates the sign of the curvature for three hits
► C SelectionVariable< PointType, 3, std::array< double, 9 > >
C MLHANDOVER_NAME< PointType, Ndims > SelectionVariable that is used for the Machine Learning (ML) based filters
► C SelectionVariable< PointType, 4, double >
C DELTACIRCLERADIUS_NAME< PointType > Calculates delta-circleRadius-value (difference in circle radii of 2 subsets of the hits), returning unit: cm
C DELTADISTCIRCLECENTER_NAME< PointType > Calculates the distance between the estimated circle centers (using 2 subsets of given hits) in the xy-plane, returning unit: cm
C DELTAPT_NAME< PointType > Calculates dpt-value (dpt= difference in transverse momentum of 2 subsets of the hits), returning unit: GeV/c
► C SelectionVariable< spacePoint, 2, bool >
C BooleanVariable Small filter illustrating the behavior of a filter which is compatible with boolean comparisons
► C SelectionVariable< spacePoint, 2, float >
C SquaredDistance1Dx Small filter illustrating the behavior of a distance1D-filter in X
C SquaredDistance2Dxy Small filter illustrating the behavior of a distance2D-filter in XY
C SquaredDistance3D Small filter illustrating the behavior of a distance3D-filter
C SelectionVariableFactory< PointType > The factory,as the name implies, does not implement at all the factory paradigm
► C Selector Abstract base class for curl track selectors
C SelectorCut Simple cut based selector for curl tracks taken from Belle note 1079
C SelectorMVA MVA based selector for tagging curl tracks in Belle and Belle II
► C SelectSubsetBase Type-independent implementation details of SelectSubset
► C SelectSubset< Particle >
C ParticleSubset Specialised SelectSubset<Particle> that also fixes daughter indices and all ParticleLists
C SelectSubset< Belle2::SpacePointTrackCand >
C SelectSubset< Belle2::CDCDedxTrack >
C SelectSubset< Belle2::ECLShower >
C SelectSubset< Belle2::ECLCalDigit >
C SelectSubset< Belle2::PXDCluster >
C SelectSubset< Belle2::PXDRawHit >
C SelectSubset< Belle2::PXDDigit >
C SelectSubset< Belle2::Track >
C SelectSubset< Belle2::RecoHitInformation >
C SelectSubset< Belle2::SVDCluster >
C SelectSubset< Belle2::SVDShaperDigit >
C SelectSubset< Belle2::ECLCluster >
C SelectSubset< Belle2::KLMCluster >
C SelectSubset< Belle2::V0 >
C SelectSubset< StoredClass > Class to create a subset of a given StoreArray together with the relations with other StoreArrays
C SelVarHelper< PointType, DataType > Collection of functions and related stuff needed for SelectionVariables implementing 2-, 3- and 4-hitfilters
C SemaphoreLocker Handles creation, locking and unlocking of System V semaphores
C Sender
C sender_argv
C SendHeader
C SendTrailer
C SensitiveDetectorDebugHelper Small helper class to facilitate debugging of VXD::SensitiveDetector implementation
C PXDBackgroundModule::SensorData Struct to hold data of an PXD sensor
C PXDBgTupleProducerModule::SensorData Struct to hold data of an PXD sensor
C PXDMCBgTupleProducerModule::SensorData Struct to hold data of an PXD sensor
C SVDBackgroundModule::SensorData Struct to hold data of an SVD sensor
C DQMHistAnalysisSVDDoseModule::SensorGroup A struct to define the sensors group we average over
C SVDDQMDoseModule::SensorGroup A struct to define non-trivial histograms in a human-readable way
C SVDOnlineToOfflineMap::SensorID Class to hold numbers related to sensor
C SVDOnlineToOfflineMap::SensorInfo Struct to hold data about a sensor
► C SensorInfoBase Base class to provide Sensor Information for PXD and SVD
C SensorInfo Specific implementation of SensorInfo for PXD Sensors which provides additional pixel specific information
C SensorInfo Specific implementation of SensorInfo for SVD Sensors which provides additional sensor specific information
C SensorTraversal Class to keep track of the traversal of the sensitive volume for one track
C SensorTraversal Class to keep track of the traversal of the sensitive volume for one track
C SeqFile A class to manage I/O for a chain of blocked files
► C SequentialRunByRun
C KLMAlignment
► C Serializable
► C AbstractDBObject
C DBObject
C NSMData
C NSMMessage
C NSMVar
C Time
C TestClusterControlDrmaa.SessionMock
C SGCosmic Class to generate tracks in the cosmics generator and store them in a MCParticle graph
C CDCRLWireHitTriple::Shape Type for the different shapes of a triple of neighboring wire hits
► C shape_t Shape
C pent_t Pentagon shape
► C quadrilateral_t Quadrilateral shape struct
C quadrilateral_barrel_t Quadrilateral struct for barrel
C quadrilateral_endcap_t Quadrilateral struct for end cap
C ShaperDSP_t Class include function that calculate electronic response from energy deposit
C SharedEventBuffer
► C SharedMem
► C RFSharedMem
C RFNodeManager
C SharedMemory
C ShieldLogicalVolumes Shield logical volumes
C EvtGenDecays::Signal Map of signal particle info
C CDCDigitizerModule::SignalInfo Structure for saving the signal information
C SignalInterpolation2 Interpolation of signal shape using function values and the first derivative
C SignalPDF Parametrization of signal PDF in a single pixel
C EclConfiguration::signalsample_t Struct for a signal sample
C EclConfigurationPure::signalsamplepure_t Struct for a signal sample for the pure CsI calorimeter
C simpleBitfield< T > Helper class for setting up a bitfield that can be used to store several flags in one variable TODO: move this from this header (possibly to some helperStuff header) and make some tests!
C SimpleCluster Type for found clusters
C SimpleClusterCandidate Class representing a cluster candidate during simple clustering of the SVD
C CDCSimpleSimulation::SimpleSimHit Structure to accommodate information about the individual hits during the simulation
C SimpleVariableRecorder Class to write collected variables into a root file, Used by VXDQETrainingDataCollectorModule
C SinEqLine Helper class to calculate roots for the function f(x) = sin x - slope * x - intercept
C SingleElementSet< Type > Represents a set containing a single element;
C RunManager::SingletonDestroyer Destroyer class to delete the instance of the RunManager class when the program terminates
C TRGCDCLpav::Singular Exception class, no covarience matrix
C TRGCDCLpav::Singular_c Exception class, no covarience matrix_c
C Size Functor to get the .size() from an arbitrary objects
C SizeT< size_t > Helper construct for TMP that provides an index at compile time to recurse through type lists
C ScriptStatus.skipped
C SliceFit Class to do the slice fit
C TRGTOPDQMModule::slotDecision
C Sock2Rb
► C SocketIO
C RSocketRecv
C RSocketSend
C SocketRecv
C SocketSend
C SocketManager
► C SoftwareTriggerCalculation Base class for all calculation algorithms to be used when calculating the variables needed in the SoftwareTrigger modules for the cuts
C FilterCalculator Implementation of a calculator used in the SoftwareTriggerModule to fill a SoftwareTriggerObject for doing HLT cuts
C SkimSampleCalculator Implementation of a calculator used in the SoftwareTriggerModule to fill a SoftwareTriggerObject for selecting particles for skimming and data quality monitoring
► C SoftwareTriggerCutBase Base class for the SoftwareTriggerCut and its DBRepresentation
C DBRepresentationOfSoftwareTriggerCut Class to handle storing SoftwareTriggerCuts in the database
C SoftwareTriggerCut Software Trigger Cut to be used in the Software Trigger Modules
C SoftwareTriggerDBHandler Helper class for performing up- and downloads of SoftwareTriggerCuts from the database
C SoftwareTriggerVariableManager::SoftwareTriggerVariable Class which represents an abstract variable in the SoftwareTriggerVariableManager
C SoftwareTriggerVariableManager Variable Manager for the software trigger cuts
C Solids All solids of EKLM
C InverseRaytracer::Solution Solution of inverse ray-tracing
C solution_t Solution struct
C ONSENBinData::sose_frame_t
C SpacePointTrackCandCreator< SPTCContainerType > Small class to take simple vectors of SpacePoints and convert them to real SpacePointTrackCands
C SpaceResolutionCalibration Class for Space resolution calibration
C span< T >
C SphericityEigenvalues Class to calculate the Sphericity tensor eigenvalues and eigenvectors starting from an array of 3-momenta The tensor itself is not stored, only its eigenvalues and eigenvectors are
C Spline Spline structure for zero-order & linear splines
C Splitter Class that allows to split runs into the intervals of intended properties given by the lossFunction
C SpotParam Structure containing most of the beam spot parameters
C SPTCSelectorXBestPerFamily Algorithm to collect the x best TrackCandidates per family based on a VXD Quality estimator method output
C DQMHistDeltaHistoModule::SSNODE The struct for the snapshots
C DQMHistSnapshotsModule::SSNODE The struct for the snapshots
C StandaloneCosmicsCollector Track finding algorithm class for linear tracks produced by cosmics in the VXD without magnetic field
C State
C State
C State
C State
C State
C State
C State
C CKFState< ASeed, AHit >::stateCache Cache containing the most important information of this state which will often be needed
► C static_visitor
C convertToPythonObjectVisitor Helper function object to unpack a value from a variant to a python object
C AssignParameterVisitor A helper class to unpack a boost::variant parameter value and set it in the parameter list
C StaticSector< HitType, Filter2sp, Filter3sp, Filter4sp > Class to describe a static sector of the sector map
► C Statistics
C Basf2CalculationQueueStatistics
C Statistics
C StatisticsColumn
C StatisticsVisitor
C StepInformation Simple struct to keep information about steps in the sensitive detector
C StorageStreamHelper Helper class for data store serialization
► C StoreAccessorBase Base class for StoreObjPtr and StoreArray for easier common treatment
C StoreArray< Particle >
C StoreArray< Belle2::ARICHDigit >
C StoreArray< Belle2::RawFTSW >
C StoreArray< Belle2::ARICHHit >
C StoreArray< Belle2::ARICHTrack >
C StoreArray< Belle2::ARICHLikelihood >
C StoreArray< Belle2::ARICHSimHit >
C StoreArray< Belle2::Track >
C StoreArray< Belle2::ExtHit >
C StoreArray< Belle2::MCParticle >
C StoreArray< Belle2::ARICHAeroHit >
C StoreArray< Belle2::ARICHInfo >
C StoreArray< Belle2::AWESOMESimHit >
C StoreArray< Belle2::SpacePointTrackCand >
C StoreArray< Belle2::Particle >
C StoreArray< Belle2::ECLCluster >
C StoreArray< Belle2::KLMCluster >
C StoreArray< Belle2::TrackFitResult >
C StoreArray< Belle2::V0 >
C StoreArray< Belle2::BelleTrkExtra >
C StoreArray< Belle2::PIDLikelihood >
C StoreArray< Belle2::KLMHit2d >
C StoreArray< Belle2::KLMDigit >
C StoreArray< Belle2::KLMDigitRaw >
C StoreArray< Belle2::KLMDigitEventInfo >
C StoreArray< Belle2::KLMSimHit >
C StoreArray< Belle2::BKLMHit1d >
C StoreArray< Belle2::BKLMTrack >
C StoreArray< Belle2::RecoTrack >
C StoreArray< Belle2::RecoHitInformation >
C StoreArray< Belle2::CDCHit >
C StoreArray< Belle2::ECLDigit >
C StoreArray< Belle2::ECLDsp >
C StoreArray< Belle2::PXDDigit >
C StoreArray< Belle2::PXDCluster >
C StoreArray< Belle2::SVDShaperDigit >
C StoreArray< Belle2::SVDCluster >
C StoreArray< Belle2::TOPDigit >
C StoreArray< Belle2::PXDSimHit >
C StoreArray< Belle2::SVDSimHit >
C StoreArray< Belle2::CDCSimHit >
C StoreArray< Belle2::TOPSimHit >
C StoreArray< Belle2::ECLSimHit >
C StoreArray< Belle2::ECLHit >
C StoreArray< Belle2::BeamabortSimHit >
C StoreArray< Belle2::CLAWSSimHit >
C StoreArray< Belle2::ClawSimHit >
C StoreArray< Belle2::FANGSSimHit >
C StoreArray< Belle2::PlumeSimHit >
C StoreArray< Belle2::PindiodeSimHit >
C StoreArray< Belle2::He3tubeSimHit >
C StoreArray< Belle2::MicrotpcSimHit >
C StoreArray< Belle2::QcsmonitorSimHit >
C StoreArray< Belle2::BgoSimHit >
C StoreArray< Belle2::CsiSimHit >
C StoreArray< Belle2::Btube >
C StoreArray< Belle2::RawCDC >
C StoreArray< Belle2::CDCRawHit >
C StoreArray< Belle2::CDCRawHitWaveForm >
C StoreArray< Belle2::ECLShower >
C StoreArray< Belle2::CDCDedxTrack >
C StoreArray< Belle2::CDCDedxHit >
C StoreArray< Belle2::CDCDedxLikelihood >
C StoreArray< Belle2::CDCTriggerSegmentHit >
C StoreArray< Belle2::CDCTriggerTrack >
C StoreArray< Belle2::CDCTriggerHoughCluster >
C StoreArray< Belle2::CDCTrigger3DFinderInfo >
C StoreArray< Belle2::CDCTriggerMLPInput >
C StoreArray< Belle2::Bitstream< signalBus > >
C StoreArray< Belle2::RawTRG >
C StoreArray< Belle2::Bitstream< MergerBus > >
C StoreArray< Belle2::Bitstream< TSFOutputBus > >
C StoreArray< Belle2::Bitstream< T2DOutputBus > >
C StoreArray< Belle2::CDCTriggerFinderClone >
C StoreArray< Belle2::Bitstream< NNBus > >
C StoreArray< Belle2::Bitstream< DNNBus > >
C StoreArray< Belle2::Cluster >
C StoreArray< Belle2::ContinuumSuppression >
C StoreArray< Belle2::RawDataBlock >
C StoreArray< Belle2::RawCOPPER >
C StoreArray< Belle2::RawSVD >
C StoreArray< Belle2::RawTOP >
C StoreArray< Belle2::RawARICH >
C StoreArray< Belle2::RawECL >
C StoreArray< Belle2::RawKLM >
C StoreArray< genfit::Track >
C StoreArray< Belle2::CsiHit >
C StoreArray< Belle2::CsiDigiHit >
C StoreArray< Belle2::RawPXD >
C StoreArray< Belle2::ECLCalDigit >
C StoreArray< Belle2::BeamBackHit >
C StoreArray< Belle2::ECLTrig >
C StoreArray< Belle2::TRGECLWaveform >
C StoreArray< Belle2::ECLConnectedRegion >
C StoreArray< Belle2::ECLPidLikelihood >
C StoreArray< Belle2::ECLLocalMaximum >
C StoreArray< Belle2::ECLPureCsIInfo >
C StoreArray< Belle2::ECLDspWithExtraMCInfo >
C StoreArray< Belle2::KlId >
C StoreArray< Belle2::ECLDebugHit >
C StoreArray< Belle2::TRGECLUnpackerStore >
C StoreArray< Belle2::TRGECLUnpackerEvtStore >
C StoreArray< Belle2::ECLTriggerCell >
C StoreArray< Belle2::BremHit >
C StoreArray< Belle2::ECLEnergyCloseToTrack >
C StoreArray< Belle2::TRGECLCluster >
C StoreArray< Belle2::RestOfEvent >
C StoreArray< Belle2::FlavorTaggerInfo >
C StoreArray< Belle2::FlavorTaggerInfoMap >
C StoreArray< Belle2::TRGGDLUnpackerStore >
C StoreArray< Belle2::SpacePoint >
C StoreArray< genfit::TrackCand >
C StoreArray< Belle2::PXDTrueHit >
C StoreArray< Belle2::SVDTrueHit >
C StoreArray< Belle2::ROIid >
C StoreArray< Belle2::KLMClusterShape >
C StoreArray< Belle2::KLMScintillatorFirmwareFitResult >
C StoreArray< Belle2::KLMMuonIDDNNInputVariable >
C StoreArray< Belle2::EKLMAlignmentHit >
C StoreArray< Belle2::KLMTrack >
C StoreArray< Belle2::Kink >
C StoreArray< Belle2::TRGECLDigi0MC >
C StoreArray< Belle2::TRGECLHitMC >
C StoreArray< Belle2::TOPLikelihood >
C StoreArray< Belle2::VXDDedxLikelihood >
C StoreArray< Belle2::KLMMuidLikelihood >
C StoreArray< T_bitstream >
C StoreArray< Belle2::V0ValidationVertex >
C StoreArray< Belle2::ObserverInfo >
C StoreArray< Belle2::OnlineEventT0 >
C StoreArray< Belle2::TOPSimCalPulse >
C StoreArray< Belle2::PXDRawHit >
C StoreArray< Belle2::PXDRawROIs >
C StoreArray< Belle2::PXDRawAdc >
C StoreArray< Belle2::PXDIntercept >
C StoreArray< Belle2::PXD2TrackEvent >
C StoreArray< Belle2::StringWrapper >
C StoreArray< Belle2::HE3G4TrackInfo >
C StoreArray< Belle2::TPCG4TrackInfo >
C StoreArray< Belle2::SADMetaHit >
C StoreArray< Belle2::SVDRecoDigit >
C StoreArray< Belle2::SVDDAQDiagnostic >
C StoreArray< Belle2::SVDIntercept >
C StoreArray< StoredClass >
C StoreArray< Belle2::MCParticleTrajectory >
C StoreArray< TObject >
C StoreArray< Belle2::TOPBarHit >
C StoreArray< Belle2::TOPSimPhoton >
C StoreArray< Belle2::TOPRawDigit >
C StoreArray< Belle2::TOPTimeZero >
C StoreArray< Belle2::TOPRawWaveform >
C StoreArray< Belle2::TOPLikelihoodScanResult >
C StoreArray< Belle2::TOPPDFCollection >
C StoreArray< Belle2::TOPAssociatedPDF >
C StoreArray< Belle2::TOPPixelLikelihood >
C StoreArray< Belle2::TOPProductionEventDebug >
C StoreArray< Belle2::TOPPull >
C StoreArray< Belle2::TOPSlowData >
C StoreArray< Belle2::TOPInterimFEInfo >
C StoreArray< Belle2::TOPProductionHitDebug >
C StoreArray< Belle2::TOPTemplateFitResult >
C StoreArray< Belle2::TRGCDCETFUnpackerStore >
C StoreArray< Belle2::TRGCDCT3DUnpackerStore >
C StoreArray< Belle2::TRGCDCTSFUnpackerStore >
C StoreArray< Belle2::TRGECLBGTCHit >
C StoreArray< Belle2::TRGECLUnpackerSumStore >
C StoreArray< Belle2::TRGECLDigi0 >
C StoreArray< Belle2::TRGECLHit >
C StoreArray< Belle2::TRGECLFAMAna >
C StoreArray< Belle2::TRGECLTrg >
C StoreArray< Belle2::TRGECLTiming >
C StoreArray< Belle2::TRGTOPTimeStampsSlot >
C StoreArray< Belle2::TRGTOPTimeStamp >
C StoreArray< Belle2::TRGTOPCombinedT0Decision >
C StoreArray< Belle2::TRGTOPSlotTiming >
C StoreArray< Belle2::TRGTOPWaveFormTimeStampsSlot >
C StoreArray< Belle2::TRGTOPWaveFormTimeStamp >
C StoreArray< Belle2::TagVertex >
C StoreArray< Belle2::KLMMuidHit >
C StoreArray< Belle2::TrackClusterSeparation >
C StoreArray< Belle2::OverlapNetwork >
C StoreArray< TSFOutputBitStream >
C StoreArray< T2DOutputBitStream >
C StoreArray< SimHitClass >
C StoreArray< TrueHitClass >
C StoreArray< Belle2::VXDDedxTrack >
C StoreArray< Belle2::BeamabortHit >
C StoreArray< Belle2::BgoHit >
C StoreArray< Belle2::ClawHit >
C StoreArray< Belle2::ClawsHit >
C StoreArray< Belle2::CsiHit_v2 >
C StoreArray< Belle2::DosiHit >
C StoreArray< Belle2::FANGSHit >
C StoreArray< Belle2::He3tubeHit >
C StoreArray< Belle2::MicrotpcHit >
C StoreArray< Belle2::PindiodeHit >
C StoreArray< Belle2::PlumeHit >
C StoreArray< Belle2::QcsmonitorHit >
C StoreArray< SpacePoint >
C StoreArray< PXDCluster >
C StoreArray< SpacePointTrackCand >
C StoreArray< DirectedNodeNetworkContainer >
C StoreArray< SVDCluster >
C StoreArray< MCParticle >
► C StoreObjPtr< StoreWrapper< T > >
C StoreWrappedObjPtr< T > This class is for convenience access and registration of objects, that are stored inside the StoreWrapper on the DataStore
C StoreObjPtr< Belle2::EventMetaData >
C StoreObjPtr< Belle2::ParticleList >
C StoreObjPtr< Belle2::EventExtraInfo >
C StoreObjPtr< Belle2::FileMetaData >
C StoreObjPtr< Belle2::SoftwareTriggerResult >
C StoreObjPtr< Belle2::SVDEventInfo >
C StoreObjPtr< Belle2::EventT0 >
C StoreObjPtr< Belle2::TRGSummary >
C StoreObjPtr< Belle2::MCInitialParticles >
► C StoreObjPtr< StoreWrapper< std::vector< Belle2::TrackFindingCDC::CDCTrack > > >
C StoreWrappedObjPtr< std::vector< Belle2::TrackFindingCDC::CDCTrack > >
C StoreObjPtr< Belle2::EventLevelTriggerTimeInfo >
C StoreObjPtr< Belle2::SimClockState >
C StoreObjPtr< TMatrix >
C StoreObjPtr< Belle2::BinnedEventT0 >
C StoreObjPtr< Belle2::MergedEventConsistency >
C StoreObjPtr< Belle2::EventLevelClusteringInfo >
C StoreObjPtr< Belle2::ECLWaveforms >
C StoreObjPtr< Belle2::ECLCellIdMapping >
C StoreObjPtr< Belle2::ECLTRGInformation >
C StoreObjPtr< Belle2::EventKinematics >
C StoreObjPtr< Belle2::ProcessStatistics >
C StoreObjPtr< Belle2::EventShapeContainer >
C StoreObjPtr< Belle2::ParticleExtraInfoMap >
C StoreObjPtr< Belle2::DirectedNodeNetworkContainer >
C StoreObjPtr< Belle2::RestOfEvent >
C StoreObjPtr< Belle2::RawCOPPER >
C StoreObjPtr< Belle2::ROIpayload >
C StoreObjPtr< Belle2::RandomGenerator >
C StoreObjPtr< Belle2::SoftwareTrigger::SoftwareTriggerVariables >
C StoreObjPtr< Belle2::KLMChannelMapValue< unsigned int > >
C StoreObjPtr< Belle2::DisplayData >
C StoreObjPtr< Belle2::PXDDAQStatus >
C StoreObjPtr< Belle2::EventLevelTrackingInfo >
C StoreObjPtr< Belle2::PXDInjectionBGTiming >
C StoreObjPtr< Belle2::PXDGatedModeInfo >
C StoreObjPtr< Belle2::RootMergeable< TTree > >
C StoreObjPtr< Belle2::SetMergeable< std::unordered_set< uint64_t > > >
C StoreObjPtr< Belle2::StringWrapper >
C StoreObjPtr< Belle2::TOPRecBunch >
C StoreObjPtr< Belle2::TOPAsicMask >
C StoreObjPtr< Belle2::TRGGDLDST >
C StoreObjPtr< Belle2::TRGGRLInfo >
C StoreObjPtr< Belle2::TauPairDecay >
► C StoreObjPtr< StoreWrapper< std::vector< Belle2::TrackFindingCDC::CDCWireHit > > >
C StoreWrappedObjPtr< std::vector< Belle2::TrackFindingCDC::CDCWireHit > >
C StoreObjPtr< Belle2::RootMergeable< TH1D > >
C StoreObjPtr< Belle2::RootMergeable< TH2D > >
C RelationArray Low-level class to create/modify relations between StoreArrays
C StoreArray< T > Accessor to arrays stored in the data store
► C StoreObjPtr< T > Type-safe access to single objects in the data store
C StoreWrappedObjPtr< std::vector< StrippedIOType< I > > >
C StoreContent Basf2 (Belle II Analysis Software Framework) # Author: The Belle II Collaboration # # See git log for contributors and copyright holders
C StoreContentList
C StoreEntry Wraps a stored array/object, stored under unique (name, durability) key
C ReaderSAD::straightElement Calculates the transformation matrix from local SAD to global geant4 space
C stream_statistics
C StreamHelper Helper class for data store serialization
► C StreamInterceptor Base class with all necessary features to intercept output to a file descriptor
C CaptureStream Class to capture anything written to stream into a string
C DiscardStream Simple class to just discard anything written to stream by redirecting it to /dev/null
C string STL class
C StringFormulaConstructor Example struct to be used with the FormulaParser to create a string representation of the formula, mainly for testing and debugging
C StringToVector Converts a given string to the std::vector<T>
C StringUtil
C EKLMDataCheckerModule::StripData Strip data information
C stripInCluster Structure containing the relevant information of eachstrip of the cluster
C StripInRawCluster Structure containing the relevant information of each strip of the raw cluster
► C Styling< AObject > Interface for a mapping of object and an index to styling attributes
► C ChooseableStyling< const RecoTrack >
C ChooseableRecoTrackStyling This Class handles the mapping from the colormapping-method name given as a string to the actual color mapping for RecoTrack
► C ChooseableStyling< const CDCSegment2D >
C ChooseableSegmentStyling This Class handles the mapping from the colormapping-method name given as a string to the actual AColorMap for CDCSegments
► C ChooseableStyling< const CDCHit >
C ChooseableHitStyling This Class handles the mapping from the colormapping-method name given as a string to the actual color mapping for CDCHits
► C ChooseableStyling< AObject > Implementation of a styling composed from several predefined mappings chooseable by their name
C DefaultColorCycleStyling< AObject > Class template for coloring objects with stroke colors prepared to be the default color cycle
C FixedStyling< AObject > Implementation of a styling from fixed attribute map
C SubGraph< FilterType > All relevant stuff needed for dealing with a subGraph
C SubGraphID Stores the ID of a subgraph, which is basically a chain of FullSecID coded as unsigned ints
► C SubTrigger Enum class SubTriggerType : unsigned char {Merger , TSF, T2D, T3D, Neuro , ETF};
C Merger Unpacker for the merger reader (TSF which reads the merger output)
C Neuro< bitwidth, T_bitstream > Unpacker for the Neuro
C Tracker2D Unpacker for the 2D tracker
C SuperKEKBTree Structure for the input of the data SUPERKEKB (TTree "Data_SUPERKEKB")
► C ShaperDSP_t::sv123shift_t Struct to encapsulate the electronic response from energy deposit
C ShaperDSP_t::shaperdspshift_t Struct for a shift of the shaper dsp
C SVD3SampleCoGTimeCalibrations This class defines the dbobject and the methods to access the SVD calibrations from the local runs providing the constants needed to correct the cluster time computed with the 3-sample CoG
C SVD3SampleELSTimeCalibrations This class defines the dbobject and the methods to access the SVD calibrations from the local runs providing the constants needed to correct the cluster time computed with the 3-sample ELS
C SVDCalibrationsBitmap Class for digital (0/1) calibration values per srtip
C SVDCalibrationsScalar< T > Template class for scalar (one per side) calibrations
C SVDCalibrationsVector< T > Template class for vector (one per strip) calibrations
C SVDChargeSimCal Simulation calibration parameters
C SVDChargeSimulationCalibrations This class defines the dbobject and the methods to access SVD simulation calibrations; coupling constants and Geant4 electron weight
► C SVDClusterCharge Abstract Class representing the SVD cluster charge
C SVDELS3Charge Derived Class representing the SVD cluster charge computed with the ELS3 algorithm
C SVDMaxSampleCharge Derived Class representing the SVD cluster charge computed summing the max sample of each strip
C SVDSumSamplesCharge Derived Class representing the SVD cluster charge computed summing the samples of each strip
C SVDClusterCuts Clustering parameters
C SVDClustering This class defines the dbobject and the methods to access the calibration of the cluster reconstruction
► C SVDClusterPosition Abstract Class representing the SVD cluster position
C SVDCoGOnlyPosition Derived Class representing the SVD cluster position computed with the CoGOnly algorithm
C SVDOldDefaultPosition Derived Class representing the SVD cluster position computed with the old algorithm (up to release-05)
► C SVDClusterTime Abstract Class representing the SVD cluster time
C SVDCoG3Time Derived Class representing the SVD cluster time computed with the CoG3 algorithm
C SVDCoG6Time Derived Class representing the SVD cluster time computed with the CoG6 algorithm
C SVDELS3Time Derived Class representing the SVD cluster time computed with the ELS3 algorithm
C SVDCoGOnlyErrorScaleFactors This class defines the dbobject and the methods to access the scaling factors for the CoGOnly position algorithm
C SVDCoGOnlyPositionError This class defines the dbobject and the methods to access the SVD position error parameters and provide the position error for the CoGOnly algorithm
C SVDCoGTimeCalibrations This class defines the dbobject and the methods to access the SVD calibrations from the local runs providing the constants needed to correct the strip time computed with the CoG
C SVDCrossTalkStripsCalibrations This class defines the dbobject and the method to access strips which are masked at FADC level
C SVDDetectorConfigurationImporter This class import to the database the dbobjects SVDGlobalConfigParameters and SVDLocalConfigParameters
C SVDFADCMaskedStrips This class defines the dbobject and the method to access strips which are masked at FADC level
C SVDHitTimeSelection This class defines the dbobject and the methods to access the calibration of the cluster reconstruction
C SVDHotStripsCalibrations This class defines the wrapper to retrieve the list of the hot strips flagged offline
C SVDIgnoredStripsMap This class provides a list of ignored (=cold, hot or otherwise deffective) strips for the use in SVD data reconstruction
C SVDKalmanStepper Kalman stepper implementation for the SVD CKF
C SVDLocalCalibrationsImporter This class import to the database the dbobjects storing the SVD Local Calibrations
C SVDMaxSumAlgorithm Class implementing the MaxSum algorithm
C SVDMCClusterPositionFudgeFactor This class defines the dbobject and the methods to access the SVD cluster position fudge factors for the SVDClusterizer module
C SVDMCClusterTimeFudgeFactor This class defines the dbobject and the methods to access the SVD time fudge factors for MC reconstruction
C SVDModeByte Class to store SVD mode information
C SVDNoiseCalibrations This class defines the dbobject and the method to access SVD calibrations from the noise local runs
C SVDOccupancyCalibrations This class defines the dbobject and the method to access SVD calibrations from the noise local runs
C SVDOldDefaultErrorScaleFactors This class defines the dbobject and the methods to access the scaling factors for the OldDefault position algorithm
C SVDOnlineToOfflineMap This class implements the methods to map raw SVD hits to basf2 SVD hits
C SVDPedestalCalibrations This class defines the dbobject and the method to access SVD calibrations from the noise local runs
C SVDPosErrScaleFactors Scaling factors for the cluster position error
C SVDPulseShapeCalibrations This class defines the dbobject and the methods to access the SVD calibrations from the local runs providing the constants needed to calibrate the SVDShaperDigit : the charge, the ADC counts, the peaking time and the width
C SVDRecoChargeFactory Cluster Charge Factory Class
C SVDReconstructionBase Class to check whether the reconstruction algorithms are available or not
C SVDRecoPositionFactory Cluster Position Factory Class
C SVDRecoTimeFactory Cluster Time Factory Class
C SVDStripCalAmp Parameter of the APV pulse
C SVDStripNoiseMap Strip noise map
C SVDTriggerType Class to store Trigger Type information
C SVDWaveform The SVD waveform class
C SweepBoxImpl< ANewType, ABox > Function to add a new dimension to a box It sweeps the original box over a finite range in the new dimension
C SweepBoxImpl< ANewType, ABox< AOldTypes... > > Actual implementation pasting together the new dimension with the original box
C DataStore::SwitchableDataStoreContents Encapsulates DataStoreContents , but allows transparently switching between different versions ('DataStore IDs')
C SZLine A line in the sz space
► C T
C AImpactSweeped< T, AImpact > Takes a basic object and sweeps it by some d0 range in the y direction
C APhi0Sweeped< T, APhi0 > Takes a basic object and sweeps it by some angle phi0 range a around the origin
C OffOrigin< T > Takes a basic object and passively moves it to any origin All subordinary coordinates have to be interpreted relative to this origin
C WithWeightedItems< T, AItem > A mixin class to attach a set of weighted items to a class
C T0Correction Class for T0 Correction
► C T1
C ax_type2< T1, T2 >
► C T2
C ax_type< T1, T2 >
C ax_type2< T1, T2 >
C YScanner::Table A table of equidistant entries
C YScanner::TableEntry Table entry
C CurlingTrackCandSplitterModule::TaggedUVPos Struct for easier handling of getting U- & V-position of SpacePoints and some difficulties that arise within this task
► C Task
► C LSFTask
C GenerateSimTask
► C LSFMemoryIntensiveTask
C CKFResultFilterTeacherTask
C ResultRecordingTask
C SplitNMergeSimTask
C ValidationAndOptimisationTask
C SummaryTask
► C LSFTask
C GenerateSimTask
► C LSFMemoryIntensiveTask
C CKFResultFilterTeacherTask
C CKFStateFilterTeacherTask
C ResultRecordingTask
C SplitNMergeSimTask
C StateRecordingTask
C ValidationAndOptimisationTask
C SummaryTask
► C LSFTask
C GenerateSimTask
► C LSFMemoryIntensiveTask
C CKFResultFilterTeacherTask
C CKFStateFilterTeacherTask
C ResultRecordingTask
C SplitNMergeSimTask
C StateRecordingTask
C ValidationAndOptimisationTask
C SummaryTask
C tau_encoder
C TauEncoder Encoder/decoder for neural network tau values
► C TBase
C ax_name_container< TBase >
C TRGTOPDQMModule::tcEcl
C AnalyzingAlgorithmBase< DataType, TCInfoType, VectorType >::TcPair Minimal struct for keeping track which tc is which
C TCType Small class for classifying types of reconstructed track candidates
► C TDatabasePDG
C EvtGenDatabasePDG Replacement for TDatabasePDG that is filled from EvtGen's evt.pdl
► C TDCCountTranslatorBase Base class for translation of Drift Time into Drift Length
C RealisticTDCCountTranslator Translator mirroring the realistic Digitization
► C Teacher Abstract base class of all Teachers Each MVA library has its own implementation of this class, so all libraries can be accessed via this common interface
C RegressionTeacher< FastBDTTeacher, RegressionFastBDTOptions >
C CombinationTeacher Teacher for the Combination MVA method
C FANNTeacher Teacher for the FANN MVA method
C FastBDTTeacher Teacher for the FastBDT MVA method
C ONNXTeacher Teacher for the ONNX MVA method
C PDFTeacher Teacher for the PDF MVA method
C PythonTeacher Teacher for the Python MVA method
C RegressionTeacher< BaseClassifierTeacher, RegressionClassifierOptions > Core class for the training of regression methods based on binary classifiers
C ReweighterTeacher Teacher for the Reweighter MVA method
► C TMVATeacher Teacher for the TMVA MVA method
C TMVATeacherClassification Teacher for the TMVA Classification MVA method
C TMVATeacherMulticlass Teacher for the TMVA Multiclass MVA method
C TMVATeacherRegression Teacher for the TMVA Regression MVA method
C TrivialTeacher Teacher for the Trivial MVA method
C TEclEnergyHit Define class TEclEnergyHit
C Teegg C++ Interface for the Fortran generator TEEGG
C TempDirCreator Changes working directory into a newly created directory, and removes it (and contents) on destruction
C TOPTemplateFitter::TemplateParameters Parameters of the template function
C Term
C tessellatedSolidStr Structure which holds apexes of the tessellation volumes
► C Test
C BeamSpotTest
C ChargedParticleIdentificatorTest Test the MVA-based charged PID
C CollectorTFInfoTest Set up a few arrays and objects in the datastore
C BitStreamTest Declare BitStream test
C ECLBaseCompressTest Declare ECLBaseCompress test
C ECLDCTCompressTest Declare ECLDCTCompress test
C ECLDeltaCompressTest Declare ECLDeltaCompress test
C ECLWaveformsTest Declare ECLWaveforms test
C ECLCalDigitTest Set up a few arrays and objects in the datastore
C ECLChargedPIDTest Test the ECL charged PID
C ECLClusterTest Test class for the Track object
C ECLDigitTest Set up a few arrays and objects in the datastore
C ECLHitAssignmentTest Set up a few arrays and objects in the datastore
C ECLHitTest Set up a few arrays and objects in the datastore
C ECLShowerTest Set up a few arrays and objects in the datastore
C ECLSimHitTest Set up a few arrays and objects in the datastore
C EventLevelTrackingInfoTest Unit tests for the event level tracking information
C EventLevelTriggerTimeInfoTest Unit tests for the event level trigger time information
C EvtBCLFFTest The fixture for testing the EvtBCLFF
C FilterIDTest Set up a few arrays and objects in the datastore
C FullSecIDTest Testing everything from FullSecID
C GlobalLabelTest Test fixture
C HitPatternCDCTest Unit tests for the CDC hit Patterns
C HitPatternVXDTest
C KLMMuidLikelihoodTest Test class for the KLMMuidLikelihood object
C KlIdTest Test class for the KlId object
C MapHelperFunctionsTest Function object that implements cosecans(x) == 1/cos(x) by tan(x) / sin(x)
C MuidBuilderTest Test for the MuidBuilder class, using the payloads in the default Global Tag
C PIDPriorsTest
C ParticleGunTest The fixture for testing the Particlegun
C RecoTrackTest Test class for the RecoTrack object
C SVDVariableTest Text fixture for SVD variables
C SandBox4TestingTest Testing autoAssignment of vectors for functions
C SectorTest Set up a few arrays and objects in the datastore
C DBRepresentationOfSoftwareTriggerCutTest Class to test the db representation of the cuts
C SoftwareTriggerCutTest Base class for the cut tests
C SoftwareTriggerDBHandlerTest Class to test the down- and upload of trigger cuts to the DB
C SpacePointTest Set up a few arrays and objects in the datastore
C SpacePointTrackCandTest Test class for the SpacePointTrackCand class
C LogMessageTest Test fixture to be able to check the contents and types of emitted log messages in detail
► C TestWithGearbox This class provides a test fixture managing the opening and closing of the Gearbox with the default geometry file
► C TrackFindingCDCTestWithTopology This class provides the declaration of the common test fixture to all test of the track finding in the CDC code
C DISABLED_Long_TrackFindingCDCTestWithTopology Equivalent to
C TrackFindingCDCTestWithSimpleSimulation Equivalent to
C SecondaryWireNeighborhoodTest
C TrackFindingCDCTestRootification< T >
C ThreeHitFiltersTest Set up a few arrays and objects in the datastore
C TrackFitResultTest Set up a few arrays and objects in the datastore
C TrackIsoScoreCalculatorTest Test the calculation of the track helix-based isolation score per particle
C TrackTest Test class for the Track object
C TwoHitFiltersTest Set up a few arrays and objects in the datastore
C V0FitterTest Set up a few arrays and objects in the datastore
C V0Test Set up a few arrays and objects in the datastore
C VariablesOnTTree Test for VariablesTTree
C eventShapeCoreAlgorithmTest
C CellularAutomatonTest Test class demonstrating the behavior of The Cellular Automaton and the PathCollectorRecursive
C DirectedNodeNetworkTest Test class demonstrating the behavior of TCNetworkContainer
C HopfieldNetworkTest Test of HopfieldNetwork Class
C ObserverCheckMCPurityTest Test class for SelectionVariableFactory object
C OverlapMatrixCreatorTest Test the overlap-matrix creator using known input
C OverlapNetworkTest Test OverlapNetwork Class
C PurityCalculatorToolsTest Class for testing the purity calculator tools (i.e
C DecorrelationMatrixTest Test Class
C MinMaxCollectorTest Test class for these new and shiny two-hit-filters
C ObserversTest Test class for testing and developing new Observers
C FilterTest Test class for Filter object
C FourHitFilterTest Test class for these new and shiny two-hit-filters
C ThreeHitFilterTest Test class for these new and shiny two-hit-filters
C TrackletFilterTest Test class for these new and shiny two-hit-filters
C TwoHitFilterTest Test class for these new and shiny two-hit-filters
► C TestCase
C Test_Machine
C TestUtils_getiov
C TestUtils_topological_sort
C Test_Prompt
C Test_Prompt
► C HLTZMQTestCase
C DistributorTestCase
C HistogramStopTestCase
C HistogramTestCase
C DyingHLTTestCase
C HLTTestCase
► C WorkerTestCase
C DyingWorkerTestCase
C NormalWorkerTestCase
► C BaseCollectorTestCase
C CollectorTestCase
C FinalCollectorTestCase
► C TestCase
C SVDVariablesToStorageModuleTests
C TestAllParticleCombiner
C AwesomeExamplesTest
C ExamplesTest
C TestParticleCombiner
C TestCopyLists
C SetModuleParameters
C SteeringFileTest
C TestBasf2Utils
C TestChargedCluster
C TestClusterControlDrmaa
C TestComparison
C TestGetComparison
C TestEmbedding
C TestFillReadArray
C TestGTForwarding
C TestIntervalOfValidity
C TestIoVSet
C TestMbcEff
C TestMultiplePython
C Test
C TestParticleExtractorFromROE
C TestParticleLoader
C TestPyTorch
C TestQuantityExtract
C TestNewMCDecayFinder
C TestMergeStaging
C TestStdCharged
C TestStdHyperons
C TestStdPhotons
C TestStdPi0s
C TestStdV0
C TestSysVar
C ValidationTest
C TestValidationMetadataSetter
C ValidationFunctionstTest
C ValidationScriptTest
C TestVariableCollections
C MetavariableDataTypeTest
C TestVariableUtilities
C TestWriteONNX
C TolerateMissingKeyFormatterTest
C TestTreeFits
C TestTreeFits
C TestTreeFits
C TestTreeFits
C TestTreeFits
C TestTreeFits
C TestTreeFits
C TestTreeFits
C TestTreeFits
C TestTreeFits
C TestTreeFits
C TestTreeFits
C TestTreeFits
C TestingPayloadEntry
C TestingPayloadStorage Class to store and retrieve temporary payloads
C TestParticleFactory This is a class, which generates DataStore particles, according to the provided decay string e.g
C TestSpacePoint Helper struct for SpacePoint Tests
► C TEveElement
C EveTower Handles selection of individual ECLClusters (getting them out of TEve is hard)
► C TEveMagField
C EveVisBField Provide magnetic field values for TEveTrackPropagator
C LogMessage::TextHasher Helper struct to hash and compare messages only by log level and message content
C TfDataBasf2
C TfDataBasf2Stub
► C TGGroupFrame
C MultilineWidget Widget which contains the dynamic amount of TGLabel objects
► C TGHtml
C InfoWidget Text-based info viewer showing DataStore contents
► C TGMainFrame
C EclFrame Root TGMainFrame that contains multiple widgets that display the ECLSimHit 's w.r.t
► C TH2Poly
C ARICHAerogelHist Base class for geometry parameters
C ARICHChannelHist ARICH histogram with HAPD plane 3 options for bin segmentation are available type 0 - one bin per HAPD, type 1 - one bin per channel, type 2 - one bin per APD chip HAPD numbering is 1-420 (software numbering), channel is ASIC channel, APD is ASIC channel / 36
C ThreeHitFilters The class 'ThreeHitFilters ' bundles filter methods using 3 hits which are stored in B2Vector3Ds
C ThreeHitVariables Class that allows the calculation of simple variables to estimate the quality of a triplet of hits
C ThreeVector
C Thrust Class to calculate the thrust axis
C ARICHGeoAerogelPlane::tilestr Struct to hold individual aerogel tile parameters
C hitXP::timeCompare This structure allows to compare times of 2 hitXP point input (first hit, second hit) output (boolean: true if time of the hit1< time of hit2)
C TimeDigitizer Time digitization of simulated hits in a single electronic channel
C TimeExtractionUtils Helper class to perform all kind of track extrapolations using the methods from arXiv:0810.2241
C GlobalLabel::TimeInterval Struct to hold intervals of validity
C TimeItResult Class to capture the time a repeated execution took
C TOPDigitizerModule::TimeOffset Utility structure for time offset
C TRGTOPTRD2TTSConverterModule::timeOrder
C Timer Small helper class that prints its lifetime when destroyed
C TOPBunchFinderModule::TimeSeed Structure to hold the time seed from a chosen detector component
C TimeWalkCalibration Class for Time walk calibration
C TMatrixConversion Convert between TMatrix and CovarianceMatrix representations
► C TMemberInspector
C HtmlClassInspector Pass to TObject::ShowMembers() to get tabular view of object data
► C TMessage
C InMessage Reusable Message class derived from TMessage (for reading only)
► C TNamed
C KLMChannelMapValue< unsigned int >
C KLMChannelMapValue< T > KLM channel map
► C MergeableNamed Abstract base class for objects that can be merged but also named
C MilleData Mergeable class holding list of so far opened mille binaries and providing the binaries
C MonitoringObject MonitoringObject is a basic object to hold data for the run-dependency monitoring Run summary TCanvases and monitoring variables
C RunRange Mergeable object holding (unique) set of (exp,run) pairs
C TNiel TNiel - the class providing values for NIEL factors
► C TObject
C Bitstream< TSFOutputBus >
C Bitstream< T2DOutputBus >
C Bitstream< NNBus >
C Bitstream< DNNBus >
C Bitstream< signalBus >
C Bitstream< MergerBus >
► C RelationsInterface< TObject >
C FBDTClassifier< 9 >
► C PXD2TrackBase< Belle2::PXD::Track_t >
C PXD2TrackEvent Class PXD2TrackEvent : Event data container for performance and calibration studies
C ARICHAeroHit Datastore class that holds information on track parameters at the entrance in aerogel
C ARICHHit Datastore class that holds photon hits. Input to the reconstruction
C ARICHInfo Datastore class to keep ARICH event information e.g. trigger type
C ARICHLikelihood This is a class to store ARICH likelihoods in the datastore
C ARICHPhoton Struct for ARICH reconstructed photon (hit related to track) information
C ARICHTrack Datastore class that holds position and momentum information of tracks that hit ARICH
C AWESOMESimHit A Geant4 simulated hit for the AWESOME detector
C BKLMHit1d Store one reconstructed BKLM 1D hit as a ROOT object
C BKLMTrack Store one BKLM Track as a ROOT object
C BelleTrkExtra Class stores mdst_trk_fit information for each track
C BremHit A bremsstrahlung hit that correlates an ECLCluster with a RecoTrack
C Btube For each MCParticle with hits in the CDC , this class stores some summarising information on those hits
C CDCDedxHit Class to store CDC hit information needed for dedx
C CDCDedxLikelihood Container for likelihoods obtained by the CDC dE/dx PID (CDCDedxPIDModule )
C CDCDedxTrack Debug output for CDCDedxPID module
C CDCRawHit The CDCRawHit (suppressed mode) class
C CDCRawHitWaveForm The CDCRawHitWaveForm (Full output mode) class
C CDCTrigger3DFinderInfo Extra info for analysis of the 3DFinder of the CDC trigger
C CDCTriggerFinderClone Additional information from the 2D finder unpacker of the CDC trigger
C CDCTriggerHoughCluster Cluster created by the Hough finder of the CDC trigger
C CDCTriggerSegmentHit Combination of several CDCHits to a track segment hit for the trigger
C Cluster Class to collect log likelihoods from Clusters from ECL and KLM aimed for output to mdst includes functions to return combined likelihood probability
C ContinuumSuppression This is a class for collecting variables used in continuum suppression
C CsiDigiHit Class to store Csi digitized hits (output of CsIDigitizer) relation to CsiHit filled in beast/csi/modules/src/CsIDigitizerModule.cc
► C DigitBase A common base for subdetector Digits
C ARICHDigit ARICHDigit class for storing photon hit information
C CDCHit Class containing the result of the unpacker in raw data and the result of the digitizer in simulation
C KLMDigit KLM digit (class representing a digitized hit in RPCs or scintillators)
C PXDDigit The PXD digit class
C SVDShaperDigit The SVD ShaperDigit class
C TOPDigit Class to store TOP digitized hits (output of TOPDigitizer or raw data unpacker) relations to TOPSimHits, MCParticles
C DirectedNodeNetworkContainer The Container stores the output produced by the SegmentNetworkProducerModule
C ECLCalDigit Class to store calibrated ECLDigits: ECLCalDigits
C ECLCluster ECL cluster data
C ECLConnectedRegion Class to store connected regions (CRs)
C ECLDebugHit Class to store the average of ECLSimHit on crystals for debug only input for digitization module (ECLDigitizer)
C ECLDigit Class to store ECL digitized hits (output of ECLDigi) relation to ECLHit filled in ecl/modules/eclDigitizer/src/ECLDigitizerModule.cc
► C ECLDsp Class to store ECL ShaperDSP waveform ADC data
C ECLDspWithExtraMCInfo Class to store ECL ShaperDSP waveform ADC data and additional information for ML studies
C ECLEnergyCloseToTrack Class to store energy information for ECL hits closest to a track
C ECLHitAssignment Example Detector
C ECLLocalMaximum Class to store local maxima (LM)
C ECLPidLikelihood Container for likelihoods with ECL PID (ECLChargedPIDModule )
C ECLPureCsIInfo Class to store ECL crystal type relation to ECLDigit for the simulation pure CsI upgrade option filled in ecl/modules/eclDigitizer/src/ECLDigitizerPureCsIModule.cc
C ECLShower Class to store ECL Showers
C ECLTrig Class to store ECLTrig , still need to be study relation to ECLHit filled in ecl/modules/eclDigitizer/src/ECLDigitizerModule.cc and ecl/modules/eclUnpacker/ECLUnpacker.cc
C ECLTriggerCell ECL Trigger cells
C EKLMAlignmentHit This dataobject is used only for EKLM alignment
C EventKinematics Class for collecting variables related to the global kinematics of the event
C EventShapeContainer Class for collecting the basic objects related to the event shape
C ExtHit Store one Ext hit as a ROOT object
C FBDTClassifier< Ndims > FastBDT as RelationsObject to make it storable and accessible on/via the DataStore
C FlavorTaggerInfo This class stores the relevant information for the TagV vertex fit, extracted mainly from the Flavor Tagging Module
C FlavorTaggerInfoMap This class stores the Flavor Tagger information for a specific method and particle filled in the Flavor Tagger Module
C Helix This class represents an ideal helix in perigee parameterization
C KLMCluster KLM cluster data
C KLMClusterShape Variable for KLM cluster shape analysis
C KLMDigitEventInfo Class to store debugging information from the unpacker (event based)
C KLMDigitRaw Class to store the raw words from the unpacker, digit-by-digit
C KLMHit2d KLM 2d hit
C KLMMuidHit Store one muon-identification hit in the KLM as a ROOT object
C KLMMuidLikelihood Class to store the likelihoods from KLM with additional information related to the extrapolation
C KLMMuonIDDNNInputVariable KLM MuonID DNN input variables datastore object to store the input variables for retraining KLMMuonIDDNNExpertModule
C KLMScintillatorFirmwareFitResult FPGA fit simulation data
C KLMTrack Store one KLM Track as a ROOT object
C KLMTrgFittedTrack Store KLM TRG track information as a ROOT object
C KLMTrgSummary Store KLM TRG track information as a ROOT object
C Kink Object holding information for Kinks
C KlId Klong identification (KlId ) datastore object to store results from KlId calculations
► C MCParticle A Class to store the Monte Carlo particle information
C MCParticleGraph::GraphParticle Class to represent Particle data in graph
C MCParticleTrajectory Class to save the full simulated trajectory of a particle
C OverlapNetwork Hold information about overlap of SpacePointTrackCand
C PIDLikelihood Class to collect log likelihoods from TOP, ARICH, dEdx, ECL and KLM aimed for output to mdst includes functions to return combined likelihood probability
C PXD2TrackBase< T > Class PXD2TrackBase : Event data container for performance and calibration studies
C PXDCluster The PXD Cluster class This class stores all information about reconstructed PXD clusters The position error matrix has the form ((m_uSigma^2, m_uvRho * m_uSigma * m_vSigma), (m_uvRho * m_uSigma * m_vSigma, m_vSigma^2)) The correlation coefficient is derived from the shape of the cluster
C PXDEnergyDepositionEvent Class PXDEnergyDepositionEvent : PXDSimHit data container for background studies
C PXDNeutronFluxEvent Class PXDNeutronFluxEvent : PXDTrueHit data container for background studies
C PXDOccupancyEvent Class PXDOccupancyEvent : PXDCluster data container for background studies
C PXDRawAdc The PXD Raw Adc class This class stores information about Raw Adc for Pedestals
C PXDRawHit The PXD Raw Hit class This class stores information about PXD Pixel hits and makes them available in a root tree
C PXDRawROIs The PXD Raw ROIs class This class stores information about the ROIs processed by ONSEN and makes them available in a root tree
C Particle Class to store reconstructed particles
C ROIid ROIid stores the U and V ids and the sensor id of the Region Of Interest
C RecoHitInformation This class stores additional information to every CDC/SVD/PXD hit stored in a RecoTrack
C RecoTrack This is the Reconstruction Event-Data Model Track
C RestOfEvent This is a general purpose class for collecting reconstructed MDST data objects that are not used in reconstruction of given Particle – referred also as Rest Of the Event
C SVDCluster The SVD Cluster class This class stores all information about reconstructed SVD clusters
C SVDDAQDiagnostic Class to store SVD DAQ diagnostic information
C SVDEnergyDepositionEvent Class SVDEnergyDepositionEvent : SVDSimHit data container for background studies
C SVDNeutronFluxEvent Class SVDNeutronFluxEvent : SVDTrueHit data container for background studies
C SVDOccupancyEvent Class SVDOccupancyEvent : SVDCluster data container for background studies
C SVDRecoDigit The SVD RecoDigit class
C SVDRecoTimeBase The SVD RecoTimeBase class
C SVDTransparentDigit The SVD digit class
► C Sector Sector is a central part of storing information for VXD trackFinders
C ActivatedSector ActivatedSector is carrying the dynamic part of a Sector
C SectorFriendship SectorFriendship is carrying the link between parent sector and a connected sector (socalled Friendsector)
C SimClockState Simulated hardware clock state
► C SimHitBase Class SimHitBase - A common base for subdetector SimHits
C ARICHSimHit Class ARICHSimHit - Geant4 simulated hit for ARICH
C BeamabortHit ClassBeamabortHit - digitization simulated hit for the Beamabort detector
C BeamabortSimHit ClassBeamabortSimHit - Geant4 simulated hit for the Beamabort crystal in beast
C BgoHit ClassBgoHit - Geant4 ulated hit for the Bgo crystal in beast
C BgoSimHit ClassBgoSimHit - Geant4 simulated hit for the Bgo crystal in beast
C CDCSimHit Example Detector
C CLAWSSimHit Class CLAWSSimHit - Geant4 simulated hit for the CLAWS detector
C ClawHit ClassClawHit - digitization simulated hit for the Claw detector
C ClawSimHit ClassClawSimHit - Geant4 simulated hit for the Claw crystal in beast
C ClawsHit ClassClawsHit - digitization simulated hit for the Claws detector
C CsiHit Class to store simulated hits which equate to average of CsiSimHit on crystals Input for digitization module (CsiDigitizer)
C CsiHit_v2 ClassCsiHit_v2 - Geant4 simulated hits in CsI crystals in BEAST
C CsiSimHit ClassCsiSimHit - Geant4 simulated hits in CsI crystals in BEAST
C DosiHit ClassDosiHit - Geant4 ulated hit for the Dosi crystal in beast
C DosiSimHit ClassDosiSimHit - Geant4 simulated hit for the Dosi crystal in beast
C ECLHit Class to store simulated hits which equate to average of ECLSImHit on crystals input for digitization module (ECLDigitizer)
C ECLSimHit ClassECLSimHit - Geant4 simulated hit for the ECL
C FANGSHit ClassFANGSHit - digitization simulated hit for the FANGS detector
C FANGSSimHit Class FANGSSimHit - Geant4 simulated hit for the FANGS detector
C HE3G4TrackInfo Class HE3G4TrackInfo - Geant4 simulated hit for the Microtpc detector
C He3MCParticle Class He3MCParticle - Geant4 simulated hit for the Microtpc detector
C He3tubeHit ClassHe3Hit - digitization simulated hit for the He3tube detector
C He3tubeSimHit ClassHe3tubeSimHit - Geant4 simulated hit for the He3tube detector
C IRSimHit Class for saving raw hit data of the IR
C KLMSimHit KLM simulation hit
C MicrotpcDataHit ClassMicrotpcDataHit - digitization simulated datahit for the Microtpc detector
C MicrotpcHit ClassMicrotpcHit - digitization simulated hit for the Microtpc detector
C MicrotpcMetaEDataHit ClassMicrotpcDataHit - digitization simulated datahit for the Microtpc detector
C MicrotpcMetaHit ClassMicrotpcMetaHit - digitization simulated metahit for the Microtpc detector
C MicrotpcRecoTrack ClassMicrotpcRecoTrack - fit tracks after the digitization
C MicrotpcSimHit ClassMicrotpcSimHit - Geant4 simulated hit for the Microtpc detector
C PindiodeHit ClassPindiodeHit - digitization simulated hit for the Pindiode detector
C PindiodeSimHit ClassPindiodeSimHit - Geant4 simulated hit for the Pindiode crystal in beast
C PlumeHit ClassPlumeHit - digitization simulated hit for the Microtpc detector
C PlumeSimHit Class PlumeSimHit - Geant4 simulated hit for the PLUME detector
C QcsmonitorHit ClassQcsmonitorHit - digitization simulated hit for the Qcsmonitor detector
C QcsmonitorSimHit ClassQcsmonitorSimHit - Geant4 simulated hit for the Qcsmonitor crystal in beast
C SADMetaHit ClassSADMetaHit - digitization simulated metahit for the SAD detector
C SrsensorSimHit ClassSrsensorSimHit - Geant4 simulated hit for the Srsensor detector
C TOPSimHit Class to store simulated hits of Cherenkov photons on PMT's input for digitization module (TOPDigitizer)
C TPCG4TrackInfo Class TPCG4TrackInfo - Geant4 simulated hit for the Microtpc detector
C TPCSimHit ClassTPCSimHit - Geant4 simulated hit for the TPC crystal in beast
C TpcMCParticle Class TpcMCParticle - Geant4 simulated hit for the Microtpc detector
► C VXDSimHit Class VXDSimHit - Geant4 simulated hit for the VXD
C PXDSimHit Class PXDSimHit - Geant4 simulated hit for the PXD
C SVDSimHit Class SVDSimHit - Geant4 simulated hit for the SVD
C SoftwareTriggerResult Dataobject to store the results of the cut calculations performed by the SoftwareTriggerModule
► C SpacePoint SpacePoint typically is build from 1 PXDCluster or 1-2 SVDClusters
C SecMapTrainerHit Simple Hit class used for sectorMap-training
C SpacePointTrackCand Storage for (VXD ) SpacePoint-based track candidates
C StringWrapper This class is a wrapper for strings, such as MCDecayStrings, to allow them to be associated with particles via a relation
C TOPAsicMask Class to store bit fields of masked ASICs, as reported in raw data
C TOPAssociatedPDF Class to store analytic PDF associated with a photon
C TOPBarHit Class to store track parameters of incoming MC particles relation to MCParticle filled in top/simulation/src/SensitiveBar.cc
C TOPInterimFEInfo Class to store debug info of raw data in Interim FE format
C TOPLikelihood Class to store TOP log likelihoods (output of TOPReconstructor)
C TOPLikelihoodScanResult Class to store the result of the TOP LL scan (output of TOPLLScanner)
C TOPPDFCollection Class to store analytical PDF relation from Tracks filled top/modules/TOPPDFDebugger/src/TOPPDFDebuggerModule.cc
C TOPPixelLikelihood Class to store pixel-by-pixel likelihoods for a track relation from Tracks filled in top/modules/TOPPDFDebugger/src/TOPPDFDebuggerModule.cc
C TOPProductionEventDebug Class to store debugging information about the event headers in the by the TOP production debugging raw data format one of these should be available per boardstack per event
C TOPProductionHitDebug Class to store debugging information about the hit headers in the TOP production debugging raw data format
C TOPPull Class to store photon pull in respect to PDF used in reconstruction
C TOPRawDigit Class to store unpacked raw data (hits in feature-extraction format) It provides also calculation of 50% CFD leading and falling edge times and errors
C TOPRawWaveform Class to store raw data waveforms
C TOPRecBunch Class to store results of TOPBunchFinder
C TOPSimCalPulse Calibration pulse time and amplitude generated by TOPCalPulseGenerator
C TOPSimPhoton Class to store Cherenkov photons at emission and at detection relation to TOPSimHit filled in top/simulation/src/SensitivePMT.cc
C TOPSlowData Class to store slow data unpacked from raw data
C TOPTemplateFitResult Class to store template fit result from feature extraction data
C TOPTimeZero Class to store T0 information
C TOPTriggerDigit Class to store trigger time stamps
C TRGECLCluster Example Detector
C TRGGRLInnerTrack Class for neutral ECL cluster in TRGGRL
C TRGGRLMATCH Class for CDC2D-ECL Matching in TRGGRL
C TRGGRLMATCHKLM Class for CDC2D-KLM Matching in TRGGRL
C TRGGRLPHOTON Class for neutral ECL cluster in TRGGRL
C TRGGRLShortTrack Class for neutral ECL cluster in TRGGRL
C TRGSummary Trigger Summary Information input bits input bits from subdetectors ftdl (Final Trigger Decision Logic) bits output bits of trigger logic psnm (Prescale and Mask) bits prescaled ftdl bits timType types of trigger timing source defined in b2tt firmware
C TRGTOPCombinedT0Decision Example Detector
C TRGTOPSlotTiming Example Detector
C TRGTOPTimeStamp Example Detector
C TRGTOPTimeStampsSlot Example Detector
C TRGTOPTimingISim Example Detector
C TRGTOPTimingISimSlot Example Detector
C TRGTOPUnpackerStore Example Detector
C TRGTOPWaveFormTimeStamp Example Detector
C TRGTOPWaveFormTimeStampsSlot Example Detector
C TRGTiming Trigger Timing Information for a fired bit
C TagVertex TagVertex data object: contains Btag Vertex and DeltaT
C TauPairDecay Class for collecting variables related to tau-taubar MC decay process
C Track Class that bundles various TrackFitResults
C TrackClusterSeparation Store one Track-KLMCluster separation as a ROOT object
C StoreWrapper< T > This template functions as a wrapper for objects that do not inherit from TObject to be put on the DataStore
C TrackFitResult Values of the result of a track fit with a given particle hypothesis
► C V0 Object holding information for V0s
C V0ValidationVertex Class which stores some additional information on V0 vertices
C VXDDedxLikelihood Container for likelihoods obtained by the VXD dE/dx PID (VXDDedxPIDModule )
C VXDDedxTrack Debug output for VXDDedxPID module
► C VXDIntercept VXDIntercept stores the U,V coordinates and uncertainties of the intersection of a track with a VXD sensor
C PXDIntercept PXDIntercept stores the U,V coordinates and uncertainties of the intersection of a track with an PXD sensor
C SVDIntercept SVDIntercept stores the U,V coordinates and uncertainties of the intersection of a track with an SVD sensor
► C VXDTrueHit Class VXDTrueHit - Records of tracks that either enter or leave the sensitive volume
C PXDTrueHit Class PXDTrueHit - Records of tracks that either enter or leave the sensitive volume
C SVDTrueHit Class SVDTrueHit - Records of tracks that either enter or leave the sensitive volume
C SVDAPVHistograms< TH1F >
C SVDCalibrationsBase< SVDCalibrationsScalar< SVDCoGCalibrationFunction > >
C SVDCalibrationsBase< SVDCalibrationsScalar< SVDChargeSimCal > >
C SVDCalibrationsBase< SVDCalibrationsScalar< SVDClusterCuts > >
C SVDCalibrationsBase< SVDCalibrationsScalar< SVDPosErrScaleFactors > >
C SVDCalibrationsBase< SVDCalibrationsScalar< SVDPositionErrorFunction > >
C SVDCalibrationsBase< SVDCalibrationsBitmap >
C SVDCalibrationsBase< SVDCalibrationsScalar< SVDHitTimeSelectionFunction > >
C SVDCalibrationsBase< SVDCalibrationsScalar< SVDMCFudgeFactorFunction > >
C SVDCalibrationsBase< SVDCalibrationsScalar< float > >
C SVDCalibrationsBase< SVDCalibrationsVector< float > >
C SVDCalibrationsBase< SVDCalibrationsVector< SVDStripCalAmp > >
C SVDHistograms< TH1F >
C SVDHistograms< TH2F >
C BEvent The Class for Masterclass event parameters
C BParticle The Class for Masterclass particle information This class provides the data structure of the particle that are used by Belle II Masterclass application
C ARICHAeroTilesInfo The Class for ARICH aerogel tiles properties for even reconstruction
C ARICHAerogelInfo The Class for ARICH Aerogel Parameters
C ARICHAerogelMap Map of the Aerogel placement
C ARICHAerogelRayleighScatteringFit The Class for ARICH aerogel Rayleigh scattering fit parameters
C ARICHAsicChannelMask ARICH Channel Mask
C ARICHAsicInfo Tested ASIC chips
C ARICHB2LinkInfo List of Belle2Link boards
C ARICHBadChannels ARICH bad channels
C ARICHBiasCablesMapping The Class for ARICH mapping of bias cables to modules
C ARICHBiasChannelsMapping This class provides ARICH mapping of HAPD modules to bias power supply channels
C ARICHBiasCrateCableMapping This class provides ARICH bias voltages at gain 40
C ARICHBiasVoltages The Class for ARICH bias voltages at gain 40
C ARICHCableInfo List of cables
C ARICHChannelMapping The Class for ARICH HAPD channel mapping
C ARICHChannelMask The Class for ARICH HAPD channel mask
C ARICHComponentTest Test of the ARICH component
C ARICHCopperMapping The Class for ARICH mapping of merger to copper boards
C ARICHFEBoardInfo Front End Electronics Boards
C ARICHFebTest ARICH FEB test data
C ARICHFirmware ARICH firmware
► C ARICHGeoBase Base class for geometry parameters
C ARICHAeroTilesAlignment Alignment parameters for aerogel tiles
C ARICHGeoAerogelPlane Geometry parameters of HAPD
C ARICHGeoCablesEnvelope Geometry parameters of cable envelope
C ARICHGeoCooling Geometry parameters of cooling system
C ARICHGeoDetectorPlane Geometry parameters of ARICH photon detector plane
C ARICHGeoFEBCooling Geometry parameters of Cooling System - version2 (v2)
C ARICHGeoGlobalDisplacement Global displacement parameters for ARICH
C ARICHGeoHAPD Geometry parameters of HAPD
C ARICHGeoMasterVolume Geometry parameters of ARICH Master volume (envelope)
C ARICHGeoMerger Geometry parameters of Merger PCB
C ARICHGeoMergerCooling Geometry parameters of Merger Cooling System - version2 (v2)
C ARICHGeoMirrorDisplacement Mirror displacement parameters for ARICH
C ARICHGeoMirrors Geometry parameters of HAPD
C ARICHGeoSupport Geometry parameters of ARICH support structures and neutron shield
C ARICHGeometryConfig The Class for ARICH Geometry Parameters
C ARICHGlobalAlignment Geometry parameters of ARICH Master volume (envelope)
C ARICHMirrorAlignment Mirror alignment parameters for ARICH
C ARICHPositionElement Position element for ARICH
C ARICHHapdChipInfo Contains manufacturer data of one of the 4 photo sensors chips
C ARICHHapdInfo Contains manufacturer data of the photo sensor - HAPD
C ARICHHapdMask ARICH HAPD Sensor Mask: map of operational/nonoperational HAPDs : one bit per sensor
C ARICHHapdQA Contains manufacturer data of the photo sensor - HAPD
C ARICHHapdQE Contains manufacturer data of the photo sensor - HAPD
C ARICHHighVoltageConfig Configuration parameters of the High Voltage Channel
C ARICHHvCablesMapping The Class for ARICH mapping of bias cables to modules
C ARICHHvChannelsMapping The Class for ARICH mapping of bias power supply channels to modules
C ARICHHvCrateCableMapping The Class for ARICH bias voltages at gain 40
C ARICHMagnetTest Contains fractions of dead times measured in a magnet
C ARICHMergerInfo List of MergerBoards
C ARICHMergerMap Mapping of the merger board to the detector
C ARICHMergerMapping The Class for ARICH mapping of modules to merger boards
C ARICHMirrorInfo List of MergerBoards
C ARICHMirrorMap Mapping of the mirrors on the detector
C ARICHModuleTest ARICH module test data
C ARICHModulesInfo The Class for information on HAPD modules installed in ARICH
C ARICHRawDigit Class of ARICH raw digits
C ARICHReconstructionPar The Class for ARICH reconstruction parameters
C ARICHSensorModuleInfo Sensor-module information
C ARICHSensorModuleMap Mapping of the sensor-board connections to the detector
C ARICHSimulationPar The Class for ARICH simulation parameters
C ARICHThParam ARICHThParam class for storing photon hit information
C BKLMAlignment Class to store BKLM alignment data in the database
C BKLMGeometryPar The Class for BKLM geometry
C BKLMSimulationPar Provides BKLM simulation parameters
C BeamBackHit Class BeamBackHit - Stores hits from beam backgound simulation
C BeamSpot This class contains the beam spot position and size modeled as a gaussian distribution in space
C BeamabortGeo Geometry parameters of Beamabort
C BinnedEventT0 Database object for storing a binned EventT0 coming from the trigger
C Bitstream< SignalBus > Class to hold one clock cycle of raw bit content
C BrowsableWrapper A wrapper for browsable objects to enable automatic redrawing
C BunchStructure Class to store the fill pattern of colliding bunches
C CDCADCDeltaPedestals Database object for ADC pedestals
C CDCAlphaScaleFactorForAsymmetry Database object for scale factors on alpha for CDC hit charge asymmetry
C CDCBadBoards Database object for bad boards
C CDCBadWires Database object for bad wires
C CDCChannelMap Database object of CDC channel map
C CDCCorrToThresholds Database object for correcting a simple threshold model in MC
C CDCCrossTalkLibrary Database object for ASIC crosstalk library
C CDCDedx1DCell DE/dx wire gain calibration constants
C CDCDedx2DCell DE/dx wire gain calibration constants
C CDCDedxADCNonLinearity DE/dx electronic ADC non-linearity correction for highly ionising particles (used in offline hadron saturation calibration) parameters are for X vs Y relation and sep for inner and outer layer vector array 0,1 for inner and 2,3 for outer layers
C CDCDedxBadWires DE/dx wire gain calibration constants
C CDCDedxCosineCor DE/dx wire gain calibration constants
C CDCDedxCosineEdge DE/dx special large cosine calibration to fix bending shoulder at large costh
C CDCDedxHadronCor DE/dx hadron saturation parameterization constants
C CDCDedxInjectionTime DE/dx injection time calibration constants
C CDCDedxMeanPars DE/dx mean (curve versus beta-gamma) parameterization constants
C CDCDedxMomentumCor DE/dx wire gain calibration constants
C CDCDedxRunGain DE/dx run gain calibration constants
C CDCDedxScaleFactor DE/dx run gain calibration constants
C CDCDedxSigmaPars DE/dx sigma (versus beta-gamma) parameterization constants
C CDCDedxWireGain DE/dx wire gain calibration constants
C CDCDisplacement Database object for displacement of sense wire position
C CDCEDepToADCConversions Database object for energy-deposit to ADC-count conversion
C CDCFEEParams Database object for FEE params
C CDCFEElectronics Database object for Fron-endt electronics params
C CDCFudgeFactorsForSigma Database object for fudge factors for CDC space resol
C CDCGeometry The Class for CDC geometry
C CDCGeometry::Cover Cover structure geometry parameters
C CDCGeometry::Cover2 Cover2 structure geometry parameters
C CDCGeometry::EndPlate Endplate geometry parameters
C CDCGeometry::EndPlateLayer Endplate layer geometry parameters
C CDCGeometry::FieldLayer Field layer geometry parameters
C CDCGeometry::Frontend Frontend layer geometry parameters
C CDCGeometry::InnerWall Inner wall geometry parameters
C CDCGeometry::MotherVolume Mother volume geometry parameters
C CDCGeometry::NeutronShield Neutron shield geometry parameters
C CDCGeometry::OuterWall Outer wall geometry parameters
C CDCGeometry::Rib Rib structure geometry parameters
C CDCGeometry::Rib2 Rib2 structure geometry parameters
C CDCGeometry::Rib3 Rib3 structure geometry parameters
C CDCGeometry::Rib4 Rib4 structure geometry parameters
C CDCGeometry::Rib5 Rib5 structure geometry parameters
C CDCGeometry::SenseLayer Sense layer geometry parameters
C CDCPropSpeeds Database object for signal propagation speed along the wire
C CDCSpaceResols Database object for space resolutions
C CDCTimeWalks Database object for time-walk
C CDCTimeZeros Database object for timing offset (t0)
C CDCTrigger2DConfig The payload class for delay of GDL input bit
C CDCTriggerDeadch The payload class for delay of GDL input bit
C CDCTriggerMLP Class to keep all parameters of an expert MLP for the neuro trigger
C CDCTriggerMLPData Struct for training data of a single MLP for the neuro trigger
C CDCTriggerMLPInput Class to hold some intermediate information for the monitoring of the neurotrigger
C CDCTriggerNeuroConfig The payload class for all CDC Neurotrigger information
C CDCTriggerPlane Database object for timing offset (t0)
C CDCTriggerTSFConfig The payload class for TSF run-dependent parameter
C CDCWireHitRequirements Database object containing cut values to filter CDCWireHits
C CDCXtRelations Database object for xt-relations
C CDClayerTimeCut Database object for timing offset (t0)
C CKFParameters The payload containing all parameters for the PXD and SVD CKF
C COILGeometryPar The Class for COIL geometry parameters
C CaveSimHit ClassCaveSimHit - Geant4 simulated hit for the Cave detector
C ChargedPidMVAWeights Class to contain the payload of MVA weightfiles needed for charged particle identification
C CkfToPXDFiltersSetting The payload containing
C CollisionAxisCMS This class contains the measured values of the orientation of the collision axis in the CM system obtained by pure Lorentz boost angleXZ = atan(pHERcms.X / pHERcms.Z) angleYZ = atan(pHERcms.Y / pHERcms.Z) where pHERcms is HER momentum in CM system obtained by boost
C CollisionBoostVector This class contains the measured average boost vector vec(beta) = (beta_x, beta_y, beta_z) = vec(p_e+e-)/E_e+e- of the center-of-mass system in the lab frame and its uncertainty
C CollisionInvariantMass This class contains the measured average center-of-mass energy, which is equal to the invariant mass of the colliding beams, and its uncertainty
C DAFConfiguration The payload containing all the DAFParameters configuration, one for each different track fit option
C DAFParameters The payload containing the DAF parameters
► C DBObjCalibrationConstMapBase Base for calibration or alignment parameters identified by two unsigned shorts Typically first is some identifier of a sub-detector element (sensor, layer, wire, board...) and the second is number of parameter
C CDCAlignment CDC alignment constants
C CDCCalibration CDC alignment and calibration constants
C CDCLayerAlignment CDC layers alignment constants
C CDCMisalignment CDC misalignment constants
C VXDAlignment VXD alignment (and maybe some calibration) parameters
C DBRepresentationOfSoftwareTriggerCut Class to handle storing SoftwareTriggerCuts in the database
C DQMFileMetaData Metadata information about a DQM file
C DatabaseRepresentationOfWeightfile Database representation of a Weightfile object
C DisplayData Add custom information to the display
C ECLAutoCovariance Covariance matrices for offline ECL waveform fit
C ECLBeamBackgroundStudy Flag for beam background study
C ECLCellIdMapping Class to store mapping between cell id and store array positions
C ECLChannelMap DB object to store correspondence table of type (Crate id, ShaperDSP id, Channel id) <-> (ECL CellID)
C ECLChargedPIDMVAWeights Class to contain payload of everything needed for MVA based charged particle identification
C ECLChargedPIDPhasespaceBinning Class to store the N dimensional phasespace binning of the MVA categorical training
C ECLChargedPIDPhasespaceCategory Stores all required information for the ECLChargedPIDMVA for a phasespace category
C ECLChargedPidPDFs Class representing the DB payload w/ information about ECL PDF parameters for a set of particle hypotheses 'signed pdgId' values, i.e
► C ECLCrystalCalib General DB object to store one calibration number per ECL crystal
C ECLCrystalLocalRunCalib ECLCrystalLocalRunCalib is designed to store results of the ECL local run calibration to database
C ECLCrystalsShapeAndPosition Crystal shapes and positions
C ECLDigitEnergyConstants Energy calibration constants per digit
C ECLDigitTimeConstants Time and time resolution calibration constants per digit
C ECLDigitWaveformParameters DB object to store photon, hadron and diode shape parameters
C ECLDigitWaveformParametersForMC DB object to store photon, hadron and diode shape parameters used in simulations
C ECLDspData This object contains ECL DSP coefs – electromagnetic calorimeter digital signal processing coefficients
C ECLHadronComponentEmissionFunction Hadron Component Emission Function for hadron pulse shape simulations
C ECLLeakageCorrections DB object to store leakage corrections, including nCrys dependence
C ECLLocalRunCalibRef ECLLocalRunCalibRef is designed to store reference marks to database for ECL local run calibration
C ECLLookupTable Class for a lookup table
C ECLNoiseData Container for constant matrix used to generate electronic noise
C ECLPhotonEnergyResolution Class to hold the information ECL energy resolution derived from PERC
C ECLReferenceCrystalPerCrateCalib General DB object to store one reference crystal per per ECL crate for calibration purposes
C ECLShowerCorrectorLeakageCorrection Class to hold the information for the ECL shower leakage corrections
C ECLShowerEnergyCorrectionTemporary Class to hold the information for the ECL shower energy corrections This is a temporary class as there is no information about phi dependence
C ECLShowerShapeSecondMomentCorrection Corrections to the second moment shower shape
C ECLTRGInformation Class to store information about ECL trigger cells (TCs)
C ECLTimeWalkCorrection This object contain parameters of the Time-Walk correction function of the ECL
C ECLTrackClusterMatchingParameterizations Class to hold the parameterizations of the RMS for the difference in polar and azimuthal angle between tracks and ECL clusters
C ECLTrackClusterMatchingThresholds Class to hold the matching thresholds for the track-ECLCluster matching
C ECLWFAlgoParams Container for constant parameters used in waveform fits
C ECLWaveformData ECLWaveformData - container for inverse covariant matrix and shape parameters for time and amplitude fit of ecl crystal waveform
C ECLWaveforms Class to store ECL waveforms for entire calorimeter
C ECLnOptimal DB object to store the optimal number of crystals to be used in a cluster energy sum, and the corresponding corrections for bias and contained (raw) energy
C EKLMAlignment Class to store EKLM alignment data in the database
C EKLMElementNumbers EKLM element numbers
► C EKLMGeometry Class to store EKLM geometry data in the database
C GeometryData EKLM geometry data
C EKLMGeometry::ElementPosition Position information for the elements of detector
C EKLMGeometry::EndcapStructureGeometry Endcap srtucture geometry parameters
C EKLMGeometry::PlasticSheetGeometry Plastic sheet geometry data
C EKLMGeometry::Point 2D point
C EKLMGeometry::SectorSupportGeometry Sector support geometry data
C EKLMGeometry::SegmentSupportGeometry Segment support geometry data
C EKLMGeometry::SegmentSupportPosition Segment support position
C EKLMGeometry::ShieldDetailGeometry Shield layer detail geometry data
C EKLMGeometry::ShieldGeometry Shield layer geometry data
C EKLMGeometry::StripGeometry Strip geometry data
C EKLMSegmentAlignment Class to store EKLM alignment data in the database
C EveTower Handles selection of individual ECLClusters (getting them out of TEve is hard)
C EventExtraInfo Class to stores ExtraInfo of the whole event
C EventLevelClusteringInfo ECL/KLM clustering event level information:
C EventLevelTrackingInfo Tracking-related info on event-level, for example number of unassigned measurements
C EventLevelTriggerTimeInfo Storage element for information from the Trigger Timing Distribution (TTD) and EventT0-related information
C EventLimit This dataobject is used by EventLimiter module to set event limit based on the value from the database
C EventMetaData Store event, run, and experiment numbers
C EventT0 Storage element for the eventwise T0 estimation
C EventsOfDoomParameters DBObject containing parameters used in EventsOfDoomBuster module
C FileMetaData Metadata information about a file
► C FilterBase FilterBase is the baseClass for filters applied on (chains of) spacepoints
C AlwaysYesFilter AlwaysYesFilter is a simple filter saying always yes, which is meant for testing purposes
C FilterInfo Helper class to store the information for a Filter
C GRLMLP Class to keep all parameters of an expert MLP for the neuro trigger
C GRLMLPData Struct for training data of a single MLP for the neuro trigger
C GeoComponent Describe one component of the Geometry
C GeoConfiguration Configuration of the geometry
C GeoMaterial Class to represent a material information in the Database
C GeoMaterialComponent Component of a material
C GeoMaterialProperty Property of a material
C GeoOpticalSurface Represent an optical finish of a surface
C HardwareClockSettings Database object containing the nominal accelerator RF value and the prescales to derive the clock frequencies of the sub-detectors
C HeavyMetalShieldGeometryPar The Class for VXD Heavy Metal Shield
► C IRGeoBase Base class for IR geometry parameters
C BeamPipeGeo Geometry parameters of BeamPipe
C CryostatGeo Geometry parameters of Cryostat
C FarBeamLineGeo Geometry parameters of far beam line
► C IntraRunDependency Base class for handling changing conditions during a run
C EventDependency Class for handling changing conditions as a function of event number
C KLMAlignmentData KLM Alignment data
C KLMChannelStatus KLM channel status
C KLMElectronicsChannel BKLM electronics channel
C KLMElectronicsMap BKLM electronics map
C KLMLikelihoodParameters Database object used to store the parameters for KLM likelihood computation
C KLMReconstructionParameters Class to store KLM reconstruction parameters in the database
C KLMScintillatorDigitizationParameters Class to store KLM scintillator simulation parameters in the database
C KLMScintillatorFEEData EKLM channel data
C KLMScintillatorFEEParameters Class to store EKLM alignment data in the database
C KLMScintillatorFirmware KLM scintillator firmware
C KLMStripEfficiency DBObject used to store the efficiencies of KLM strips
C KLMTimeCableDelay Class to store BKLM delay time coused by cable in the database
C KLMTimeConstants Class to store KLM constants related to time
C KLMTimeConversion KLM time conversion
C KLMTimeResolution Class to store KLM time resolution in the database
C KLMTimeWindow DBObject containing KLM time window parameters used in KLMReconstructor module
C KLMTriggerParameters DBObject containing parameters used in KLMTrigger module
C KinkFinderParameters The payload containing the parameters for the kinkFinder
► C MCInitialParticles This class contains the initial state for the given event
C BeamParameters This class contains the nominal beam parameters and the parameters used for smearing of the primary vertex and the beam energy and momentum
C MagneticField Magnetic field map
► C Mergeable Abstract base class for objects that can be merged
C BackgroundInfo This class stores the information about what background was mixed or overlaid
C BackgroundMetaData Metadata information about the beam background file
C MapMergeable< T > Wrap an STL map to make it mergeable
C ProcessStatistics Class to collect call statistics for all modules
C RootMergeable< T > Wrap a root histogram or TNtuple to make it mergeable
C SetMergeable< T > Wrap an STL set to make it mergeable
C MergedEventConsistency Mark if we want to merge the DataStore of a combination of events or not
C MyDBPayloadClass Class containing all the parameters needed to create the geometry and suitable to save into a ROOT file to be used from the Database
C NeuroTriggerParameters
C NoKickCuts This class is an auxiliary class that implement methods to access to a single cut, used in NoKickRTSel class
C NoKickRTSel This class implement some methods useful for the application of cuts evaluated in NoKickCutsEval module
C ObserverInfo Helper class that stores the information an Observer stores: i.e
C OnlineEventT0 Storage element for the eventwise T0 estimation computed on HLT
C PIDCalibrationWeight Class for handling the PID calibration weight matrix
C PIDDetectorWeights Class for handling the PID weights per detector, used to calculate the track helix isolation score per particle
C PIDNeuralNetworkParameters Class for handling the parameters for the neural-network PID
C PIDPriors A database class to hold the prior probability for the particle identification
C PXDClusterChargeMapPar The payload class for PXD cluster charge calibrations
C PXDClusterOffsetPar The class for PXD cluster position offset payload
C PXDClusterPositionErrorPar The payload class for PXD cluster position error
C PXDClusterPositionEstimatorPar The class for PXD cluster position lookup table payload
C PXDClusterShapeClassifierPar The class for PXD cluster shape classifier payload
C PXDClusterShapeIndexPar The class for PXD cluster shape index payload
C PXDDAQStatus The PXD DAQ Status class
C PXDDHHFirmwareVersionPar The payload stores the firmware version from the DHH, which has influence on the structure and content of the RawPXD package
C PXDDeadPixelPar The payload telling which PXD pixel is dead (=Readout system does not receive signals)
C PXDGainMapPar The payload class for PXD gain corrections
C PXDGatedModeInfo The PXD Gated Info Class
C PXDInjectionBGTiming The PXDInjectionBGTiming class
C PXDMaskedPixelPar The payload telling which PXD pixel to mask (ignore)
C PXDOccupancyInfoPar The payload collecting some meta information from running the masking algorithm
C ParticleExtraInfoMap Internal class to store string -> index maps for extra info stored in Particle
C ParticleList ParticleList is a container class that stores a collection of Particle objects
C ParticleWeightingLookUpTable Class for handling LookUp tables
C PedeSteering Class representing Millepede steering
C Ph1bpipeSimHit ClassPh1bpipeSimHit - Geant4 simulated hit for the Ph1bpipe detector
C Ph1sustrSimHit ClassPh1sustrSimHit - Geant4 simulated hit for the Ph1sustr detector
C ProfileInfo Store execution time and memory usage
C ROICalculationParameters The payload containing all PXD ROI parameters
C ROISimulationParameters The payload containing all PXD ROI parameters
C ROIpayload ROIpayload TODO: Better explanation, Is there a reason to inherit from TObject and not Relationsobject here?
► C RawDataBlock The RawDataBlock class Base class for rawdata handling
► C RawCOPPER The Raw COPPER class This class stores data received by COPPER via belle2linkt Data from all detectors except PXD are stored in this class
C RawARICH The Raw ARICH class Class for RawCOPPER class data taken by ARICH Currently, this class is almost same as RawCOPPER class
C RawCDC The Raw CDC class Class for RawCOPPER class data taken by CDC Currently, this class is almost same as RawCOPPER class
C RawECL The Raw ECL class Class for RawCOPPER class data taken by ECL Currently, this class is almost same as RawCOPPER class
C RawKLM The Raw KLM class Class for RawCOPPER class data taken by KLM
C RawSVD The Raw SVD class Class for RawCOPPER class data taken by SVD Currently, this class is almost same as RawCOPPER class
C RawTOP The Raw TOP class Class for RawCOPPER class data taken by TOP Currently, this class is almost same as RawCOPPER class
C RawTRG The Raw TOP class Class for RawCOPPER class data taken by TOP Currently, this class is almost same as RawCOPPER class
C RawFTSW The Raw FTSW class
C RawTLU The Raw TLU class Class for data from DAQ PC for TLU(Trigger Logic Unit) It is supposed to be used only in the DESY beam test
C RawPXD The Raw PXD class
C RelationContainer Class to store relations between StoreArrays in the DataStore
C RelationElement Class to store a single element of a relation
C RunInfo Database object for Run Information
C STRGeometryPar The Class for STR geometry
C SVDAPVHistograms< H > Template class for the APV Histograms
C SVDAbsoluteClusterTimeShift This class store the shift of the cluster time w.r.t a full calibration
C SVDCalibrationsBase< T > Base class for calibrations classes
C SVDClusterTimeShifter This class store the shift in svd time w.r.t
C SVDCoGCalibrationFunction Class to contain the CoG Time calibrations
C SVDCoolingPipesPar The Class for SVD Cooling Pipes
C SVDDQMPlotsConfiguration This class handle DQM plots configuration: additional histograms (Charge, SNR, Time ), 3Samples flag, etc..
C SVDEndmountPar The Class for SVD Support Rib Endmounts
C SVDEndringsPar The Class for SVD Endring
C SVDEndringsTypePar The Class for SVD Endring Type
C SVDEventInfo Stores SVDModeByte object with Trigger time, DAQ mode, Run type & Event type!
C SVDEventT0Configuration This class store the configuration of the selections applied on the tracks used to compute the SVD EventT0
C SVDGlobalConfigParameters This class defines the payload which stores to the central DB the SVD global configuring parameters, and the methods to import and retrieve these parameters
C SVDHistograms< H > Template class for SVd histograms
C SVDHitTimeSelectionFunction Class to contain the cut on svd hit time at SP creation step
C SVDLocalConfigParameters This class defines the payload which stores to the central DB the SVD local configuring parameters, and the methods to import and retrieve these parameters
C SVDLocalRunBadStrips This class defines the dbobject and the method to access the information on bad strips flagged during local runs
C SVDMCFudgeFactorFunction Class to contain the MC fudge factor formulae
C SVDPositionErrorFunction Class to contain the Cluster Position Error Formulae
C SVDRecoConfiguration This class store the reconstruction configuration of SVD
C SVDSpacePointSNRFractionSelector Class to contain the cut on SVDSpacePoint
C SVDSummaryPlots Class to summarize SVD quantities per sensor and side
C SVDSupportBoxPar The Class for SVD Support Box
C SVDSupportRibsPar The Class for SVD Support Ribs (one layer)
C SVDSupportTabPar The Class for SVD Support Rib Tab
C SVDTimeGroupingConfiguration This class store the reconstruction configuration of SVDTimeGrouping module
C SVDTimeGroupingParameters Structure containing the relevant information of SVDTimeGrouping module
C SectorMapComparer A root tool that compares two Sectormaps (local root files) and produces some statistics output
C SectorMapConfig Simple struct containing all the configuration data needed for the SecMapTrainer
C ServiceGapsMaterialsCdcArichTopPar The Class for Service Materials between CDC and ECL, ARICH and TOP, TOP and ECL
C ServiceGapsMaterialsEclPar The Class for Service Materials between barrel and endcap of ECL
C ServiceGapsMaterialsPar The Class for services materials geometry
C ServiceGapsMomVolPar The class for the mother volume of the Service Materials
C SndHdrTemp
C SoftwareTriggerVariables Storable object for the variables calculated in the SoftwareTriggerModule
C SoftwareTriggerMenu Class to handle storing the trigger menu in the database
C SpacePointInfo Helper class to store the SpacePoint information as coding convention prohibits to use the SpacePoint class here
C TOPASICChannel Calibration constants of a singe ASIC channel: pedestals, gains and time axis
C TOPASICGains Calibration constants of a single ASIC window: gains
C TOPASICPedestals Calibration constants of a single ASIC window: pedestals
C TOPCalAsicShift Calibration constants for ASIC shifts of all 16 modules
C TOPCalChannelMask Channel status for all 512 channels of 16 modules
C TOPCalChannelNoise R.m.s
C TOPCalChannelPulseHeight Pulse height parameterizations for all 512 channels of 16 modules
C TOPCalChannelRQE Class to store relative quantum efficiency of channels w.r.t initial one measured in PMT QA QE is expected to decrease during the experiment due to aging induced by acuumulated charge
C TOPCalChannelT0 Channel T0 calibration constants for all 512 channels of 16 modules
C TOPCalChannelThreshold Value of the threshold (in ADC counts) used for the pulse identification, for all 512 channels of 16 modules
C TOPCalChannelThresholdEff Class to store the threshold efficiency (i.e
C TOPCalCommonT0 Common T0 calibration constant
C TOPCalEventT0Offset Class to store the calibrated EventT0 offsets of other detector components The offsets are measured relative to TOP EventT0 (e.g CDC - TOP etc)
C TOPCalFillPatternOffset Class to store the offset of reconstructed fill pattern
C TOPCalIntegratedCharge Class to store integrated charge per channel
C TOPCalModuleAlignment Alignment constants for all 16 modules
C TOPCalModuleT0 Module T0 calibration constants for all 16 modules
C TOPCalPhotonYields Class to store photon pixel yields for PMT ageing studies, and equalized alpha ratios for finding optically decoupled PMT's
C TOPCalTimeWalk Calibration constants for time-walk correction and for tuning of electronic time resolution in digitization
C TOPCalTimebase Sample time calibration constants for all channels
C TOPChannelMap Map of pixels and channels within the carrier board
C TOPFrontEndMap Mapping of a boardstack number within a module to SCROD and COPPER/Finesse
C TOPFrontEndSetting Front-end settings: storage depths, lookback, readout windows etc
► C TOPGeoBase Base class for geometry parameters
► C TOPGeoBarSegment Geometry parameters of a quartz bar segment
C TOPGeoMirrorSegment Geometry parameters of a mirror segment
C TOPGeoPrism Geometry parameters of prism
C TOPGeoColdPlate Geometry parameters of cold plate (simplified)
C TOPGeoEndPlate Geometry parameters of forward end plate (simplified)
C TOPGeoFrontEnd Geometry parameters of board stack (front-end electronic module)
C TOPGeoHoneycombPanel Geometry parameters of honeycomb panel
C TOPGeoModule Geometry parameters of a module (optical components + positioning)
C TOPGeoModuleDisplacement Displacement parameters of a TOP module
C TOPGeoPMT Geometry parameters of MCP-PMT
C TOPGeoPMTArray Geometry parameters of MCP-PMT array
C TOPGeoPMTArrayDisplacement Displacement parameters of MCP-PMT array
C TOPGeoPrismEnclosure Geometry parameters of prism enclosure (simplified)
C TOPGeoQBB Geometry parameters of Quartz Bar Box (mother class)
C TOPGeoSideRails Geometry parameters of side rails (simplified)
C TOPGeometry Geometry parameters of TOP
C TOPNominalQE Nominal quantum efficiency of PMT
C TOPNominalTDC Nominal time-to-digit conversion parameters (simplified model)
C TOPNominalTTS Nominal time transition spread of PMT
C TOPWavelengthFilter Bulk transmittance of wavelength filter
C TOPPmtGainPar Parameterized PMT gain (from laser testing at Nagoya)
C TOPPmtInstallation PMT position within a module
C TOPPmtObsoleteData PMT specs from Hamamatsu
C TOPPmtQE Nagoya measurements of quantum efficiency
C TOPPmtTTSHisto Raw measurements of TTS (histograms) for each PMT pixel
C TOPPmtTTSPar Parameterized TTS for each PMT pixel
C TOPSampleTimes Calibration constants of a singe ASIC channel: time axis (sample times)
C TOPSignalShape Normalized shape of single photon pulse (waveform) Pulse must be positive
C TOPTriggerMCInfo Class to store Monte Carlo information useful for trigger studies
C TRGCDCETFUnpackerStore Example Detector
C TRGCDCT3DUnpackerStore Example Detector
C TRGCDCTSFUnpackerStore Example Detector
C TRGECLBGTCHit Example Detector
C TRGECLBadRun Raw TC result nefor digitizing
C TRGECLDigi Digitize result
C TRGECLDigi0 Raw TC result nefor digitizing
C TRGECLDigi0MC Example Detector
C TRGECLETMPara Raw TC result nefor digitizing
C TRGECLETMParameters DB object to store parameters used in ETM
C TRGECLFAMAna Digitize result
C TRGECLFAMPara Raw TC result nefor digitizing
C TRGECLHit Example Detector
C TRGECLHitMC Example Detector
C TRGECLTMMPara Raw TC result nefor digitizing
C TRGECLTiming Digitize result
C TRGECLTrg Example Detector
C TRGECLUnpackerEvtStore Example Detector
C TRGECLUnpackerStore Example Detector
C TRGECLUnpackerSumStore Example Detector
C TRGECLWaveform Digitize result
C TRGGDLDBAlgs The payload class for GDL algorithm
C TRGGDLDBBadrun The payload class for GDL badrun
C TRGGDLDBDelay The payload class for delay of GDL input bit
C TRGGDLDBFTDLBits The payload class for FTDL output bit
C TRGGDLDBInputBits The payload class for GDL input bit
C TRGGDLDBPrescales The payload class for GDL psnm
C TRGGDLDBUnpacker The payload class for PXD cluster charge calibrations
C TRGGDLDST
C TRGGDLResults
C TRGGDLUnpackerStore Example Detector
C TRGGRLConfig The payload class for GRL parameters
C TRGGRLInfo Class to store TRGGRL TSIM info
C TRGGRLUnpackerStore Example Detector
C TTDOffsets This class contains information to correct the information obtained from the TTD (simple offsets)
C TestCalibMean Test DBObject
C TestCalibObject Test DBObject
C TestChunkData Storable object which can be filled with random chunk data of a certain size
C ThicknessDensityPar The class for the thicknesses and the density of gap element cell
C TrackFitMomentumRange The payload containing the momentum threshold to disable the particle hypothesis in the track fit
C TrackFlippingCuts The payload containing the cuts for 2 mva based filters to decide whether a RecoTrack should be flipped or not
C TrackingMVAFilterParameters Class for the MVA filter payloads
C TrgEclDigitizer FAM module
C TrgEclFAMFit FAM module
C VXDAlignmentPar The Class for VXD Alignment payload
C VXDBoxPositionsPar The Class for VXD doc box envelope
C VXDBoxTypesPar The Class for VXD doc box
► C VXDGeoComponentPar The Class for VXD geometry component
C VXDGeoSensorPar The Class for VXD Sensor payload
C VXDGeoLadderPar The Class for VXD Ladder payload
C VXDGeoPlacementPar The Class for VXD placement payload
C VXDGeoRadiationSensorsPar The Class for VXD Radiation Sensor parameters
C VXDGeoRadiationSensorsPositionPar The Class for VXD Radiation Sensor Position parameters
C VXDGeoSensorPlacementPar The Class for VXD Sensor Placement payload
► C VXDGeometryPar The Class for VXD geometry
C PXDGeometryPar The Class for VXD geometry
C SVDGeometryPar The Class for VXD geometry
C VXDGlobalPar The Class for VXD global parameter payload
C VXDHalfShellPar The Class for VXD half shell payload
C VXDPolyConePar The Class for VXD PolyCone, possibly with coutouts
C VXDPolyConePlanePar The Class for VXD Polycone Plane
► C VXDRotationSolidPar The Class for VXD Envelope parameters
C VXDEnvelopePar The Class for VXD Envelope parameters
► C VXDSensorInfoBasePar Namespace to provide code needed by both Vertex Detectors, PXD and SVD
C PXDSensorInfoPar The Class for VXD geometry
C SVDSensorInfoPar The Class for VXD geometry
C VXDServiceGeometryPar The Class for VXD service geometry
C VXDSlotsPar The Class for Slot types
C WireID Class to identify a wire inside the CDC
C XmlFile DB object which stores whole xml
C EmptyGlobalParamSet Object representing no parameters
► C dEdxPDFs Base class for holding the dE/dx PDFs
C CDCdEdxPDFs Specialized class for holding the CDC dE/dx PDFs
C PXDdEdxPDFs Specialized class for holding the PXD dE/dx PDFs
C SVDdEdxPDFs Specialized class for holding the SVD dE/dx PDFs
► C hitXP This class collects some information of a TrueHit, using SVDCLuster and MCParticle information too
C hitXPDerivate This class is the derivate of HitXP, and complete it with a constructor that use all other complex types (classes) of basf2
C ZMQLogger::toJSON Visitor Helper for converting a variant value into a JSON string
C TokenCast< Desired_t > Generic template for TokenCast<T>
C TokenCast< double > Double specialization of TokenCast<T> the decimal point is set to '
C TokenCast< int > Integer specialization of TokenCast<T>
C TokenCast< ModuleID_t > ModuleID_t specialization of TokenCast<T> the decimal point is set to '
C TOPDatabaseImporter TOP database importer
C TOPGeometryPar Singleton class for TOP Geometry Parameters
C TOPPulseHeightPar Struct holding the pulse height parameterizations for the TOP counter
C TOPRecoManager Singleton class providing pre-constructed reconstruction objects
C TOPTemplateFitter Class to perform template fit on TOP waveform data Minimzation method is described here http://wwwa1.kph.uni-mainz.de/Vorlesungen/SS11/Statistik/
C TOPTrack Reconstructed track at TOP
C TOPTree Structure of a flat ntuple
C TouschekReaderTURTLE Class to read Touschek files and store their content in a MCParticle graph
C Findlet< AIOTypes >::ToVectorImpl< T > Forward a range of mutable objects
C Findlet< AIOTypes >::ToVectorImpl< const T > Specialisation to only forward a range for immutable types
► C TParticlePDG
C EvtGenParticlePDG Helper class for setting additional TParticlePDG members and storing the ones it doesn't have yet
► C TQObject
C BrowsableWrapper A wrapper for browsable objects to enable automatic redrawing
C DisplayUI Control TEve browser user interface
C SplitGLView Responsible for arranging the GL viewers and providing related functionality
C Track Track parameters (neglecting curvature)
C Track Track parameters (neglecting curvature)
C Track Track parameters (neglecting curvature)
C track_maker_t
C TOPTrack::TrackAngles Sine and cosine of track polar and azimuthal angles at assumed photon emission
C TrackBase_t< TTrackCluster > Struct to hold variables from a track which contains a vector of data type like TrackCluster
C TrackBuilder TrackBuilder class to create the Track/TrackFitResult mdst output from the RecoTrack
C TrackCluster_t Struct to hold variables for track clusters
► C TrackerAlgorithmBase< ContainerType, ValidatorType > Base class for TrackerAlgorithms. shall allow a common base for algorithms like the cellular automaton
C CellularAutomaton< ContainerType, ValidatorType > The CellularAutomaton class This class serves as a functor for the algorithm itself
► C TrackerAlgorithmBase< Belle2::DirectedNodeNetwork< Belle2::Segment< Belle2::TrackNode >, Belle2::CACell >, Belle2::CAValidator< Belle2::CACell > >
C CellularAutomaton< Belle2::DirectedNodeNetwork< Belle2::Segment< Belle2::TrackNode >, Belle2::CACell >, Belle2::CAValidator< Belle2::CACell > >
C TrackExtrapolateG4e Geant4e-based track extrapolation
C TrackFitter Algorithm class to handle the fitting of RecoTrack objects
C TrackHit Structure for track parameters at ARICH
C TrackHit Structure for track parameters at TOP
C Const::TrackingDetectors A class that defines the valid set of tracking detectors
C TrackingValidationResult
C TrackMatchLookUp Class to provide convenient methods to look up matching information between pattern recognition and Monte Carlo tracks
C TrackNode Minimal class to store combination of sector and spacePoint, since SpacePoint can not carry sectorConnection
C TrackPoint_t Struct to hold variables for intersection points
C TrackQualityTools Tools to apply post corrections to a track after finding
C TrackSelector Utility for the track selection - used in various calibration modules
C Trainer
► C TrainingRunMixin
C BackgroundClusterFilterTrainingRun
C FacetFilterTrainingRun
C FacetRelationFilterTrainingRun
C FeasibleAxialSegmentPairFilterTrainingRun
C FeasibleSegmentPairFilterTrainingRun
C FeasibleSegmentRelationFilterTrainingRun
C FeasibleTrackRelationFilterTrainingRun
C RealisticAxialSegmentPairFilterTrainingRun
C RealisticSegmentPairFilterTrainingRun
C RealisticSegmentPairRelationFilterTrainingRun
C RealisticSegmentRelationFilterTrainingRun
C RealisticTrackRelationFilterTrainingRun
C SegmentTrackFilterTrainingRun
C TrackFilterTrainingRun
► C TRandom
C RandomGenerator Fast Random number Generator using on xorshift1024* [arXiv:1402.6246]
C TRandomWrapper Wrap TRandom to be usable as a uniform random number generator with STL algorithms like std::shuffle
► C TransformData Transformation data
C TransformDataGlobalAligned Transformation data (global, aligned): singleton version
C ARICHHitRateCounter::TreeStruct Tree structure
C CDCHitRateCounter::TreeStruct Tree structure
C ECLHitRateCounter::TreeStruct Tree structure
C KLMHitRateCounter::TreeStruct Tree data structure
C PXDHitRateCounter::TreeStruct Tree structure
C SVDHitRateCounter::TreeStruct Tree structure
C TOPHitRateCounter::TreeStruct Tree structure
C TRG2DFinderTrack TRG 2DFinder Track
C TRGArea2D A class to represent an 2D area
C TrgBit A general interface to get a trigger response
C TRGBitStream A class to represent a bit stream
► C TRGBoard A class to represent a trigger board
C TRGCDCEventTimeFinder A class of TRGCDC Event Time Finder
C TRGCDCFrontEnd A class to represent a CDC front-end board
C TRGCDCMerger A class to represent a CDC merger board
C TRGCDCTrackSegmentFinder Class of TrackSegmentFinder in TRGCDC
C TRGCDCTracker2D A class to represent a CDC 2D tracker board
C TRGCDC The instance of TRGCDC is a singleton
► C TRGCDCCell A class to represent a wire in CDC
C TRGCDCSegment A class to represent a wire in CDC
C TRGCDCWire A class to represent a wire in CDC
► C TRGCDCCellHit A class to represent a wire hit in CDC
C TRGCDCSegmentHit A class to represent a track segment hit in CDC
C TRGCDCWireHit A class to represent a wire hit in CDC
C TRGCDCEventTime A class of TRGCDC Event Time
► C TRGCDCFitter A class to fit a TRGCDCTrackBase object
C TRGCDCCircleFitter A class to fit a TTrackBase object to a circle
C TRGCDCFitter3D A class to fit tracks in 3D
C TRGCDCHelix TRGCDCHelix parameter class
C TRGCDCHough3DFinder Class of TRGCDCHough3DFinder
C TRGCDCHoughFinder A class to find tracks using Hough algorithm
► C TRGCDCHoughPlaneBase A class to represent a Hough parameter plane
► C TRGCDCHoughPlane A class to represent a Hough parameter plane
C TRGCDCHoughPlaneMulti A class to represent a Hough parameter plane
C TRGCDCHoughPlaneMulti2 A class to represent a Hough parameter plane
C TRGCDCHoughPlaneBoolean A class to represent a Hough parameter plane
► C TRGCDCHoughTransformation An abstract class to represent a Hough transformation
C TRGCDCHoughTransformationCircle A class to represent circle Hough transformation
C TRGCDCJLUT A class to use LUTs for TRGCDC
C TRGCDCJSignal A class to use Signals for TRGCDC 3D tracker
C TRGCDCJSignalData A class to hold common data for JSignals
C TRGCDCLink A class to relate TRGCDCCellHit and TRGCDCTrack objects
► C TRGCDCLpar TRGCDCLpar class
C TRGCDCLpav TRGCDCLpav class
C TRGCDCLUT A class to use LUTs for TRGCDC
C TRGCDCPeakFinder A class to find peaks in Hough Plane
C TRGCDCPerfectFinder A class to find 2D tracks using MC information
C TRGCDCRelation A class to represent a wire in CDC
► C TRGCDCTrackBase A class to represent a track object in TRGCDC
C TRGCDCCircle A class to represent a circle
C TRGCDCTrack A class to represent a reconstructed charged track in TRGCDC
C TRGCDCTrackMC A class to represent a GEN_HEPEVT particle in tracking
C TRGCDCWireHitMC A class to represent a MC wire hit in CDC
C TRGChannel A class to represent a serial link between trigger hardware modules
C TRGClock A class to represent a digitized signal. Unit is nano second
C TRGDebug A class for debugging of TSIM
C TrgEclBeamBKG A Class of ECL Trigger clustering
C TrgEclBhabha A Class of ECL Trigger clustering
C TrgEclCluster A Class of ECL Trigger clustering
C TrgEclDataBase Class TrgEclDataBase ;
C TrgEclDatabaseImporter Database importer of TRGECL
C TrgEclMapping A class of TC Mapping
C TrgEclMaster ETM class
C TrgEclTiming A Class of ECL Trigger clustering
C TRGGDL The instance of TRGGDL is a singleton
C TRGGRL Class for TRGGRL
C TRGGRLMatch A class to represent a matching candidate in TRGGRL A matching candidate consists of a TRGCDCTrack and TRGECLCluster
C TRGNeuroTrack TRG Neuro track
► C TRGOpticalLink A class to represent a serial link between trigger modules
C TRGOpticalLinkFrontEnd A class to represent a serial link between trigger modules
C TRGPoint2D A class to represent a point in 2D
C TRGSignal A class to represent a digitized signal. Unit is nano second
C TRGState A class to represent a state of multi bits
C TRGTime A class to represent a signal timing in the trigger system
C TRGUtilities A class to provide TRG utility functions
C triangle_t Struct for a triangle
C triangle_t Triangle structure
C TriangularInterpolation The TriangularInterpolation class
► C true_type
C DetectPropertyImpl< ToVoid< AToPredicate< Ts... > >, AToPredicate, Ts... > Implementation of the detection idiom - specialisation for the detected case
C all_same< > The all_same struct is meant to check that all the types in a template pack are of the same type
C all_same< T > The all_same struct is meant to check that all the types in a template pack are of the same type
C TrueHitInfo Helper struct that holds information that is needed for the registration of the relation between SpacePoint and TrueHit
► C Ts...
C VisitOverload< Ts > Helper struct for the C++17 std::visit overload pattern to allow simple use of variants
C CDCTriggerNeuroDQMModule::TSLine
C CDCTriggerNeuroDQMOnlineModule::TSLine
C ARICHGeoSupport::tube Struct to hold tube parameters
► C tuple
C spacePoint Just a small proto-container storing coordinates
C TupleGenerateImpl< AGenerator, AIndexSequence > Apply the template function F to each element of the index sequence
C TupleGenerateImpl< AGenerator, std::index_sequence< Is... > > Specialisation for concrete indices
C TwoHitFilters The class 'TwoHitFilters ' bundles filter methods using 2 hits which are stored in B2Vector3Ds
C TwoHitInBoxAlgorithm< AHitInBoxAlgorithm, AnotherHitInBoxAlgorithm > Predicate class to check for the containment of items in a hough space part with two algorithms
C TwoHitVariables Class that allows the calculation of simple variables to check whether a combination of two hits should be used or discarded in tracking
C TwoTimes Structure to hold calpulse raw times expressed in samples since sample 0 of window 0
C TwoVector
C Type< T > Converts a template argument into a string for corresponding Python type
C Type< bool > Converts a template argument into a string for corresponding Python type
C Type< boost::variant< Types... > > Converts a template argument into a string for corresponding Python type
C Type< double > Converts a template argument into a string for corresponding Python type
C Type< float > Converts a template argument into a string for corresponding Python type
C Type< int > Converts a template argument into a string for corresponding Python type
C Type< std::map< A, B > > Converts a template argument into a string for corresponding Python type
C Type< std::optional< T > > Converts a template argument into a string for corresponding Python type
C Type< std::set< T > > Convert a templeate argument into a string for corresponding Python type
C Type< std::shared_ptr< Path > > Some modules take a path as argument so let's add this as well
C Type< std::string > Converts a template argument into a string for corresponding Python type
C Type< std::tuple< Types... > > Converts a template argument into a string for corresponding Python type
C Type< std::vector< T > > Converts a template argument into a string for corresponding Python type
C Type< unsigned int > Converts a template argument into a string for corresponding Python type
C Type< unsigned long int > Converts a template argument into a string for corresponding Python type
C type_container< T1 >
C ax_name_container_base< T2 >::type_wrap< T, N >
C UncertainHelix A general helix class including a covariance matrix
C UncertainParameterLine2D A parameter line including including an line covariance matrix which is interpreted as located in the support point
C UncertainParametersUtil< T, AEParameters > Utility struct to instantiate a couple of helper function related to a set of uncertain parameters
► C UncertainParametersUtil< HelixUtil, EHelixParameter >
C HelixUtil Utility struct for functions and types related to the helix parameters
► C UncertainParametersUtil< LineUtil, ELineParameter >
C LineUtil Utility struct for functions and types related to the line parameters
► C UncertainParametersUtil< PerigeeUtil, EPerigeeParameter >
C PerigeeUtil Utility struct for functions and types related to the perigee parameters
► C UncertainParametersUtil< SZUtil, ESZParameter >
C SZUtil Utility struct for functions and types related to the sz plane parameters
C UncertainPerigeeCircle Adds an uncertainty matrix to the circle in perigee parameterisation
C UncertainSZLine A line in sz where s is the transverse travel distance as seen in the xy projection with uncertainties in the slope and intercept of the line
C TOPGeoPrism::UnfoldedWindow Unfolded prism exit window
C Unit The Unit class
C UnknownPars Structure including all variables of interest with uncertainties from boot-strap
C UnknowSpline Spline with uncertainty obtained from the boot-strap replicas
C UnknowVar Variable with uncertainty from boot-strap replicas
► C Unpickler
C PickleModule.Unpickler
C UpperBoundedSet< SupType > Represents an upper bounded set of arithmetic types
C InfoWidget::URI Parsed URI
C UseReferenceFrame< T > A template class to apply the reference frame
C Utility Wrapper class for some utility functions
C V0Fitter V0Fitter class to create V0 mdst's from reconstructed tracks
C V0ValidationPlots
C ValidationRoot
C ValidationTreeStruct Calibration validation tree structure
► C Value
C __CompilationDbNode
► C ValueError
C CreationError
C InterpretError
► C Manager::VarBase Base class for information common to all types of variables
C Manager::MetaVar A variable taking string arguments returning a variable
C Manager::ParameterVar A variable taking additional floating-point arguments to influence the behaviour
C Manager::Var A variable returning a floating-point value for a given Particle
► C Variable Base class representing a generic variable
C BinnedVariable A variable with binning information
C TypedVariable A variable with a specified data type
► C Variable
C RealVariable
C ScalarVariable
C VectorVariable
► C VariableExtractor Class to extract individual variables
C ClusterInfoExtractor Class to extract info from individual clusters and combine for SPTC
C EventInfoExtractor Class to extract results from qualityEstimation
C FlipRecoTrackExtractor Class to extract results from qualityEstimation
C FlipRecoTrackExtractor2nd Class to extract results from qualityEstimation
C HitInfoExtractor Class to extract info from individual clusters and combine for SPTC
C QEResultsExtractor Class to extract results from qualityEstimation
C RecoTrackExtractor Class to extract results from qualityEstimation
C SubRecoTrackExtractor Class to extract results from qualityEstimation
C VariableFormulaConstructor Struct to construct new variable function objects from a name or a double value or to apply operations on these variable function objects
C VariablesTTree< filterLeaves > Dump on a TTree the values of all the variables in a filter
► C VariablesTTree<> Defines the interface using an empty template pack
C VariablesTTree< Filter< Variable, other ... > > Specialization for a simple filter
C VariablesTTree< Filter< binaryOperator, Filter< argsA ... >, Filter< argsB ... >, other ... > > Specialization for binary operators acting on a filter
C VariablesTTree< Filter< unaryOperator, Filter< args ... >, other ... > > Specialization for unary operators acting on a filter
C VariableTBranch< Variable > This class contains
C VariadicType< T, Types > Recursively convert multiple types to type names (used for tuples)
C VariadicType< T > Recursively convert multiple types to type names (used for tuples)
C VarNames< AObject > Class that specifies the names of the variables
► C VarNames< AFilter::Object >
C FilterVarNames< AFilter > Vehicle class to transport the variable names
► C VarNames< BaseCDCPathFilter::Object >
C CDCPathBasicVarNames Vehicle class to transport the variable names
C CDCPathTruthVarNames Vehicle class to transport the variable names
C CDCfromEclPathTruthVarNames Vehicle class to transport the variable names
► C VarNames< BaseCDCStateFilter::Object >
C CDCStateBasicVarNames Vehicle class to transport the variable names
C CDCStateTruthVarNames Vehicle class to transport the variable names
C CDCfromEclStateTruthVarNames Vehicle class to transport the variable names
► C VarNames< BasePXDStateFilter::Object >
C PXDStateBasicVarNames Vehicle class to transport the variable names
C PXDStateTruthVarNames Vehicle class to transport the variable names
► C VarNames< BaseSegmentTrackFilter::Object >
C SegmentTrackTruthVarNames Vehicle class to transport the variable names
C SegmentTrackVarNames Vehicle class to transport the variable names
► C VarNames< BaseStereoHitFilter::Object >
C StereoHitTruthVarNames Vehicle class to transport the variable names
C StereoHitVarNames Vehicle class to transport the variable names
► C VarNames< BaseSVDStateFilter::Object >
C SVDStateBasicVarNames Vehicle class to transport the variable names
C SVDStateTruthVarNames Vehicle class to transport the variable names
C SVDStateVarNames Vehicle class to transport the variable names
► C VarNames< CDCAxialSegmentPair >
C BasicAxialSegmentPairVarNames Vehicle class to transport the variable names
C FitAxialSegmentPairVarNames Vehicle class to transport the variable names
C FitlessAxialSegmentPairVarNames Vehicle class to transport the variable names
C HitGapAxialSegmentPairVarNames Vehicle class to transport the variable names
C TruthAxialSegmentPairVarNames Vehicle class to transport the variable names
► C VarNames< CDCSegment2D >
C AdvancedSegmentVarNames Vehicle class to transport the variable names
C BasicSegmentVarNames Vehicle class to transport the variable names
C TruthSegmentVarNames Vehicle class to transport the variable names
► C VarNames< CDCSegmentPair >
C BasicSegmentPairVarNames Vehicle class to transport the variable names
C FitSegmentPairVarNames Vehicle class to transport the variable names
C FitlessSegmentPairVarNames Vehicle class to transport the variable names
C HitGapSegmentPairVarNames Vehicle class to transport the variable names
C TrailSegmentPairVarNames Vehicle class to transport the variable names
C TruthSegmentPairVarNames Vehicle class to transport the variable names
► C VarNames< CDCTrack >
C BasicTrackVarSetNames Vehicle class to transport the variable names
C BestMatchedTruthVarNames Vehicle class to transport the variable names
C TruthTrackVarNames Vehicle class to transport the variable names
► C VarNames< CDCWireHit >
C CDCWireHitVarNames Vehicle class to transport the variable names
► C VarNames< CDCWireHitCluster >
C BasicClusterVarNames Vehicle class to transport the variable names
C BkgTruthClusterVarNames Vehicle class to transport the variable names
► C VarNames< CKFToPXDResult >
C PXDResultTruthVarNames Vehicle class to transport the variable names
C PXDResultVarNames Vehicle class to transport the variable names
► C VarNames< CKFToSVDResult >
C RelationSVDResultVarNames Vehicle class to transport the variable names
C SVDResultTruthVarNames Vehicle class to transport the variable names
C SVDResultVarNames Vehicle class to transport the variable names
► C VarNames< const CDCFacet >
C BasicFacetVarNames Vehicle class to transport the variable names
C BendFacetVarNames Vehicle class to transport the variable names
C FitFacetVarNames Vehicle class to transport the variable names
C FitlessFacetVarNames Vehicle class to transport the variable names
► C VarNames< Relation< const CDCFacet > >
C BasicFacetRelationVarNames Vehicle class to transport the variable names
C BendFacetRelationVarNames Vehicle class to transport the variable names
C FitFacetRelationVarNames Vehicle class to transport the variable names
► C VarNames< Relation< const CDCSegment2D > >
C BasicSegmentRelationVarNames Vehicle class to transport the variable names
C FitSegmentRelationVarNames Vehicle class to transport the variable names
C FitlessSegmentRelationVarNames Vehicle class to transport the variable names
C HitGapSegmentRelationVarNames Vehicle class to transport the variable names
► C VarNames< Relation< const CDCSegmentPair > >
C BasicSegmentPairRelationVarNames Vehicle class to transport the variable names
C FitSegmentPairRelationVarNames Vehicle class to transport the variable names
C TruthSegmentPairRelationVarNames Vehicle class to transport the variable names
► C VarNames< Relation< const CDCTrack > >
C BasicTrackRelationVarNames Vehicle class to transport the variable names
C FitTrackRelationVarNames Vehicle class to transport the variable names
C HitGapTrackRelationVarNames Class vehicle to transport the variable names
C ECLChargedPidPDFs::VarTransfoSettings Class to hold parameters needed to perform pre-processing of input variables (e.g., gaussianisation, decorrelation) to build a multi-dimensional likelihood model
C VCDWriter
► C vector< T > STL class
► C CDCSegment< CDCFacet >
C CDCFacetSegment A segment consisting of adjacent facets
► C CDCSegment< CDCRLWireHit >
C CDCRLWireHitSegment A segment consisting of two dimensional reconstructed hits
► C CDCSegment< CDCRecoHit2D >
C CDCSegment2D A reconstructed sequence of two dimensional hits in one super layer
► C CDCSegment< CDCRecoHit3D >
C CDCSegment3D A segment consisting of three dimensional reconstructed hits
► C CDCSegment< CDCTangent >
C CDCTangentSegment A segment consisting of adjacent tangents
► C CDCSegment< const CDCWireHit * >
C CDCWireHitSegment A segment consisting of two dimensional reconstructed hits
C SensorTraversal Class to keep track of the traversal of the sensitive volume for one track
C TRGCDCEventTimeFinder A class of TRGCDC Event Time Finder
C TRGCDCFrontEnd A class to represent a CDC front-end board
C TRGCDCLayer A class to represent a cell layer
C TRGCDCMerger A class to represent a CDC merger board
C TRGCDCTrackSegmentFinder Class of TrackSegmentFinder in TRGCDC
C TRGCDCTracker2D A class to represent a CDC 2D tracker board
C TRGSignalBundle A class to represent a bundle of SignalVectors
C TRGSignalVector A class to represent a bundle of digitized signals
C CDCSegment< T > A sequence of hits limited to one superlayer
C CDCTrack Class representing a sequence of three dimensional reconstructed hits
C CDCWireHitCluster An aggregation of CDCWireHits
► C vector< T > STL class
C CDCSegment< CDCFacet >
C CDCSegment< CDCRLWireHit >
C CDCSegment< CDCRecoHit2D >
C CDCSegment< CDCRecoHit3D >
C CDCSegment< CDCTangent >
C CDCSegment< const CDCWireHit * >
C SensorTraversal Class to keep track of the traversal of the sensitive volume for one track
C TRGCDCEventTimeFinder A class of TRGCDC Event Time Finder
C TRGCDCFrontEnd A class to represent a CDC front-end board
C TRGCDCLayer A class to represent a cell layer
C TRGCDCMerger A class to represent a CDC merger board
C TRGCDCTrackSegmentFinder Class of TrackSegmentFinder in TRGCDC
C TRGCDCTracker2D A class to represent a CDC 2D tracker board
C TRGSignalBundle A class to represent a bundle of SignalVectors
C TRGSignalVector A class to represent a bundle of digitized signals
C CDCSegment< T > A sequence of hits limited to one superlayer
C CDCTrack Class representing a sequence of three dimensional reconstructed hits
C CDCWireHitCluster An aggregation of CDCWireHits
C Vector2D A two dimensional vector which is equipped with functions for correct handling
of orientation related issues in addition to the expected vector methods
C Vector3D A three dimensional vector
C vector_t Struct for a three vector
C VectorVar Structure to store all bootstrap replicas
C VerbosityClass< Verbosity > Should behave differently for different verbosity-levels given - class
C VertexVector Need this container for exception-safe cleanup, GFRave's interface isn't exception-safe as is
C Visitor< operation > This is a class template which takes a template class operation as template argument
C VisualRepMap Defines a bidirectional (many to many) mapping between TObjects in DataStore and their visual representation
C vlistentry_t
C Void Functor returning void from an arbitrary objects
C VoidMetaInfo The most CPU efficient MetaInfo for the DirectedNode-requirements (even if useless)
► C VoidObserver The most CPU efficient Observer for the VXDTF filter tools (even if useless)
C CountAcceptRejectObserver This observer does simply count the number of times, the attached SelectionVariable was accepted or rejected
C CountAcceptedRejectedMCParticleObserver This observer identifies the McParticles responsible for creating underlying clusters for given spacePoints and counts how often a particle type was accepted and how often it was rejected
C CountBadCaseObserver This observer does simply count the number of times, the attached Filter resulted in isinf or isnan
C CountUsedObserver This observer does simply count the number of times, the attached SelectionVariable was used
C InfoObserver This observer does simply print the name of the SelectionVariable and the result of its value-function as a Warning
C ProvideBasicInfoObserver This observer combines all the easy-to-get info retrievable by observers and prints it to screen
C VectorOfObservers< FilterType > WARNING TODO:
C Observer This observer does simply count the number of times, the attached Filter was used
C ResultsObserver Takes result, prints it and stores it to lastResult
C ResultsObserver Takes result, prints it and stores it to lastResult
C ResultsObserver Takes result, prints it and stores it to lastResult
C CountingObserver This observer does simply count the number of times, the attached Filter was used
C ErrorObserver This observer does simply print the name of the SelectionVariable and the result of its value-function as an Error
C InfoObserver This observer does simply print the name of the SelectionVariable and the result of its value-function as a Warning
C VectorOfObservers< FilterType > This observer does simply collect other observers which are to be executed during the call of the corresponding notify function(s)
C VolumeNumbers Volume numbers
C VxdCdcMergerValidationPlots
C Const::VXDDetectors A class that defines the valid set of VXD detectors
C VXDElectronDeposit Packed class to represent energy deposit along a path in electrons
► C VXDGeoComponent Class holding all parameters for an VXD geometry component
C VXDGeoSensor Struct holding all parameters for a completeVXD Sensor
C VXDGeoLadder Struct containing all parameters of one ladder
C VXDGeoPlacement Class holding all parameters to place a VXD geometry subcomponent
C VXDGeoSensorPlacement Struct holding the information where a sensor should be placed inside the ladder
C VXDHoughState Simple container for hit information to be used during intercept finding
C VxdID Class to uniquely identify a any structure of the PXD and SVD
C VXDInterceptor< aIntercept > This Class implements the interceptor of the SVD tracks on the PXD layers
C VXDMomentumEnergyEstimator
C VXDMomentumEstimation< ClusterType > Class doing the momentum estimation from dEdX for SVDClusters and PXDClusters
C VXDMomentumEstimationTools< ClusterType > Tools needed for the VXD momentum estimation to, e.g
C VXDTFFilters< point_t > Class that contains all the static sectors to which the filters are attached
C ScriptStatus.waiting
C WaveFitter Waveform fitter class
C WaveGenerator Waveform generator This is a functor to calculate APV samples from waveform
C ARICHGeoSupport::wedge Struct to hold wedge parameters
C WeightedRelationUtil< AFrom, ATo > Utility structure with functions related to weighted relations
C Weightfile Serializes all information about a training into an xml tree
C PIDDetectorWeights::WeightsTable Nested class acting as a container the per-detector weights
C width_t Bit widths for the prefix coding to encode integers which are mainly concentrated around zero and probability density are decreasing for large absolute values
C NDFinder::WireInfo Collection of the hit information needed for the hit representations
C WireLine A three dimensional limited line represented by its closest approach to the z-axes (reference position ) and its skew parameter
C WireNeighborKind Type for the neighbor relationship from one wire to another
► C WithParamInterface
C SecondaryWireNeighborhoodTest
C WrapArray2D< T > Class to replace POD 2D array to save stack usage since it just allocates memory dynamically
► C Writer
C FileWriter< Fifo >
C FileWriter< TCPSocket >
C BufferedWriter
C FileWriter< FD >
C StreamSizeCounter
C WrongRLColorMap
C XHitFilterFactory< PointType > The factory serves as an interface between all x-hit-filters and a user only knowing their name (in string), but not their type
C XT Class to perform fitting for each xt function
C CDCCrossTalkAdderModule::XTalkInfo Structure for saving the x-talk information
C CDCDigitizerModule::XTalkInfo Structure for saving the x-talk information
C XTCalibration Class to perform xt calibration for drift chamber
C XTFunction Class to perform fitting for each xt function
C XY Point
C xy_t A simple 2d vector structure
C ZMQAddressUtils Summary of some address helpers
C ZMQClient A helper class for communicating over ZMQ. Includes a multicast and (if needed) also a data socket
► C ZMQLogger Base class for the ZMQ connection to help monitor and log certain values
► C ZMQConnection Base class for every connection with virtual functions to be implemented:
► C ZMQConnectionOverSocket Specialized connection over a ZMQ socket
C ZMQConfirmedInput Input part of a confirmed connection
C ZMQConfirmedOutput Output part of a confirmed connection
C ZMQLoadBalancedInput Input part of a load-balanced connection
C ZMQLoadBalancedOutput Output part of a load-balanced connection
C ZMQRawInput Input connection allowing to speak with non-zmq sockets via a ZMQ_STREAM socket
C ZMQRawOutput Output connection to speak to non-zmq sockets via a ZMQ_STREAM socket
C ZMQSimpleConnection Connection type to be used for answering simple requests, e.g
C ZMQDataAndROIOutput Helper connection hosting both a normal raw and a ROI output and sending to both at the same time
► C ZMQHistoServerToFileOutput Output histograms into a ROOT file and shared memory after merging
C ZMQHistogramOutput< ZMQHistoServerToFileOutput >
► C ZMQHistoServerToRawOutput Same as ZMQHistoServerToZMQOutput just send uncompressed to a raw output
C ZMQHistogramOutput< ZMQHistoServerToRawOutput >
► C ZMQHistoServerToZMQOutput Send the histograms as compressed byte stream via a ZMQConfirmedOutput connection after merging with all the properties of a normal confirmed output
C ZMQHistogramOutput< ZMQHistoServerToZMQOutput >
C ZMQNullConnection Connection doing just nothing: without the capability to pull, send or receive. Useful for template interfaces
C ZMQROIOutput Dedicated output to send ROI messages to the PXD ONSEN system
C ZMQMessageFactory Helper class for creating new ID/No-ID messages
C ZMQMessageHelper Internal helper for creating ZMQ messages (should not be used otherwise)
C ZMQModuleMessage< AMessageFrameNumber > A general message with as many parts as given as template argument
► C ZMQModuleMessage< 3 >
C ZMQNoIdMessage A message without an associated socket ID. Is used in most cases
► C ZMQModuleMessage< 4 >
C ZMQIdMessage A message with the socket ID. Needed in input<->worker communication
C ZMQParent A helper class for creating ZMQ sockets keeping track of the ZMQ context and terminating it if needed
C ZMQStandardApp< AInputConnection, AOutputConnection > Generic base class for all standalone ZMQ applications
► C ZMQStandardApp< ZMQConfirmedInput, ZMQConfirmedOutput >
C ZMQProxyCollector Special collector app: receive messages on the input reacting with a confirmation message and sends them out via a confirmed connection to ready workers
► C ZMQStandardApp< ZMQConfirmedInput, ZMQDataAndROIOutput >
C ZMQFinalCollectorWithROI Special form of the ZMQFinalCollector for sending out the additional data message to a ROI receiver
► C ZMQStandardApp< ZMQConfirmedInput, ZMQHistoServerToFile >
C ZMQHistogramToFileServer Final histogram app: receive histogram messages from all clients and react with a confirmation message
► C ZMQStandardApp< ZMQConfirmedInput, ZMQHistoServerToRaw >
C ZMQHistogramToRawServer Non-Final histogram app: receive histogram messages from all clients and react with a confirmation message
► C ZMQStandardApp< ZMQConfirmedInput, ZMQHistoServerToZMQ >
C ZMQHistogramToZMQServer Non-Final histogram app: receive histogram messages from all clients and react with a confirmation message
► C ZMQStandardApp< ZMQConfirmedInput, ZMQLoadBalancedOutput >
C ZMQCollector Normal collector app: receive messages on the input reacting with a confirmation message and sends them out via a load-balanced connection to ready workers
► C ZMQStandardApp< ZMQConfirmedInput, ZMQNullConnection >
C ZMQAcceptor App to only send a confirmation on every incoming message - behaves the same as the input of a (final)collector (but without an output)
► C ZMQStandardApp< ZMQConfirmedInput, ZMQRawOutput >
C ZMQFinalCollector Final collector app: receive messages on the input reacting with a confirmation message and sends them out via a raw connection (e.g
► C ZMQStandardApp< ZMQLoadBalancedInput, ZMQConfirmedOutput >
C ZMQWorker App to mimick a basf2-worker by accepting an incoming message with a ready message and sending it out via the output - requiring a confirmation message from the next step
► C ZMQStandardApp< ZMQLoadBalancedInput, ZMQNullConnection >
C ZMQReadySender App to only send a ready on every incoming message - behaves the same as the input of a worker (but without an output)
► C ZMQStandardApp< ZMQLoadBalancedInput, ZMQRawOutput >
C ZMQOutputAdapter Special collector app for translating between ZMQ and raw connections: send ready messages (like a typical worker) on the input and send all received events to the raw connection at output
► C ZMQStandardApp< ZMQRawInput, ZMQConfirmedOutput >
C ZMQInputAdapter
► C ZMQStandardApp< ZMQRawInput, ZMQLoadBalancedOutput >
C ZMQDistributor Standard distributor app: receive data via a raw connection (e.g
C zr_t Simple struct with z and r coordinates