EIC Software
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Groups Pages
Acts::UnitConstants Namespace Reference

Variables

constexpr double fm = 1e-12
 
constexpr double pm = 1e-9
 
constexpr double um = 1e-3
 
constexpr double nm = 1e-6
 
constexpr double mm = 1.0
 
constexpr double cm = 10.0
 
constexpr double m = 1e3
 
constexpr double km = 1e6
 
constexpr double mm2 = mm * mm
 
constexpr double cm2 = cm * cm
 
constexpr double m2 = m * m
 
constexpr double mm3 = mm * mm * mm
 
constexpr double cm3 = cm * cm * cm
 
constexpr double m3 = m * m * m
 
constexpr double s = 299792458000.0
 
constexpr double fs = 1e-15 * s
 
constexpr double ps = 1e-12 * s
 
constexpr double ns = 1e-9 * s
 
constexpr double us = 1e-6 * s
 
constexpr double ms = 1e-3 * s
 
constexpr double min = 60.0 * s
 
constexpr double h = 3600.0 * s
 
constexpr double mrad = 1e-3
 
constexpr double rad = 1.0
 
constexpr double degree = 0.017453292519943295
 
constexpr double eV = 1e-9
 
constexpr double keV = 1e-6
 
constexpr double MeV = 1e-3
 
constexpr double GeV = 1.0
 
constexpr double TeV = 1e3
 
constexpr double u = 0.93149410242
 
constexpr double g = 1.0 / 1.782662e-24
 
constexpr double kg = 1.0 / 1.782662e-27
 
constexpr double e = 1.0
 
constexpr double C = 1.602176634e19
 
constexpr double T = 0.000299792458
 
constexpr double Gauss = 1e-4 * T
 
constexpr double kGauss = 1e-1 * T
 
constexpr double mol = 1.0
 

Detailed Description

Unit definitions and conversions.

All physical quantities have both a numerical value and a unit. For the computations we always choose a particular unit so we only need to consider the numerical values as such. The chosen base unit for a particular physical quantity, e.g. length, time, or energy, within this code base is called the native unit.

Here, the following native units are used:

  • Length is expressed in mm.
  • Time is expressed in [speed-of-light * time] == mm. A consequence of this choice is that the speed-of-light expressed in native units is 1.
  • Angles are expressed in radian.
  • Energy, mass, and momentum are all expressed in GeV (consistent with a speed-of-light == 1).
  • Electric charge is expressed in e, i.e. units of the elementary charge.
  • The magnetic field is expressed in GeV/(e*mm). The magnetic field connects momentum to length, e.g. in SI units the radius of a charged particle trajectory in a constant magnetic field is given by

    radius = - (momentum / charge) / magnetic-field
    

    With the chosen magnetic field unit the expression above stays the same and no additional conversion factors are necessary.

  • Amount of substance is expressed in mol.

To ensure consistent computations and results the following guidelines must be followed when handling physical quantities with units:

  • All unqualified numerical values, i.e. without a unit, are assumed to be expressed in the relevant native unit, e.g. mm for lengths or GeV for energy/momentum.
  • If a variable stores a physical quantity in a specific unit that is not the native unit, clearly mark this in the variable, i.e.
    double momentum = 100.0; // momentum is stored as native unit GeV
    double momentumInMeV = 10.0; // would be 0.01 in native units
    
  • All input values must be given as numerical_value * unit_constant or equivalently using the unit literals as value_unit. The resulting unqualified numerical value will be automatically converted to the native unit.
  • To output an unqualified numerical value in the native units as a numerical value in a specific unit divide by the unit constants as numerical_value / unit_constant or using the unit literals as value / 1_unit.

Examples:

#include "Acts/include/Utilities/Units.hpp"
using namespace Acts::UnitLiterals;

// define input values w/ units (via unit constants)
double width    = 12 * Acts::UnitConstants::mm;
double mmuon    = 105.7 * Acts::UnitConstants::MeV;
// define input values w/ units (via unit user literals)
double length   = 23_cm;
double time     = 1214.2_ns;
double angle    = 123_degree;
double momentum = 2.5_TeV;
double mass     = 511_keV;
double velocity = 345_m / 1_s;
double bfield   = 3.9_T;
double density  = 1_mol / 1_cm3;

// convert output values (via unit constants)
doube t_in_ns    = trackPars.time() / Acts::UnitConstants::ns;
// convert output values (via unit user literals)
double x_in_mm   = trackPars.position()[ePos0] / 1_mm;
double p_in_TeV = trackPars.absoluteMomentum() / 1_TeV;

Variable Documentation

constexpr double Acts::UnitConstants::cm = 10.0

Definition at line 94 of file Units.hpp.

View newest version in sPHENIX GitHub at line 94 of file Units.hpp

Referenced by PHG4MicromegasDetector::add_geometry_node(), EICG4LumiDetector::AddExitWindowForV3(), PHG4EICMvtxDetector::AddGeometryNode(), PHG4MvtxDetector::AddGeometryNode(), PHG4InttDetector::AddGeometryNode(), PHG4TpcEndCapDetector::AddLayer(), PHG4Sector::Sector_Geometry::AddLayers_AeroGel_ePHENIX(), PHG4Sector::Sector_Geometry::AddLayers_HBD_GEM(), PHG4Sector::Sector_Geometry::AddLayers_HBD_Readout(), AddLayers_MiniTPCDrift(), EICG4LumiDetector::AddLumiMag_MagCore(), EICG4LumiDetector::AddLumiWindow(), EICG4LumiDetector::AddRecCone(), PHTpcResiduals::addTrackState(), PHG4TruthTrackingAction::AddVertex(), PHG4TpcDirectLaser::AppendLaserTrack(), PHG4TTLDetector::BuildBarrelTTL(), PHG4TTLDetector::BuildForwardTTL(), PHG4TTLSteppingAction::CalculateSensorHitIndices(), PHTpcResiduals::calculateTpcResiduals(), Cell::Cell(), Acts::DD4hepLayerBuilder::centralLayers(), Acts::DD4hepVolumeBuilder::centralVolumes(), Collimator::Collimator(), PHG4OuterHcalDetector::ConsistencyCheck(), PHG4InnerHcalDetector::ConsistencyCheck(), PHG4FullProjTiltedSpacalDetector::Construct_AzimuthalSeg(), PHG4FullProjSpacalDetector::Construct_AzimuthalSeg(), PHG4SpacalDetector::Construct_AzimuthalSeg(), PHG4SpacalDetector::Construct_Fiber(), PHG4FullProjSpacalDetector::Construct_Fibers(), PHG4FullProjTiltedSpacalDetector::Construct_Fibers(), PHG4FullProjSpacalDetector::Construct_Fibers_SameLengthFiberPerTower(), PHG4FullProjTiltedSpacalDetector::Construct_Fibers_SameLengthFiberPerTower(), ePHENIXRICH::ePHENIXRICHConstruction::Construct_HBD(), PHG4FullProjTiltedSpacalDetector::Construct_LightGuide(), PHG4MicromegasDetector::construct_micromegas(), PHG4Sector::PHG4SectorConstructor::Construct_Sectors(), PHG4FullProjTiltedSpacalDetector::Construct_Tower(), PHG4FullProjSpacalDetector::Construct_Tower(), PHG4TpcEndCapDetector::ConstructElectronics(), PHG4TpcEndCapDetector::ConstructEndCapAssembly(), EicToyModel::ConstructG4World(), PHG4InnerHcalDetector::ConstructHcalScintillatorAssembly(), PHG4OuterHcalDetector::ConstructHcalScintillatorAssembly(), PHG4InnerHcalDetector::ConstructHcalSingleScintillators(), PHG4OuterHcalDetector::ConstructHcalSingleScintillators(), PHG4InttDetector::ConstructIntt(), G4Example01Detector::ConstructMe(), EICG4RPDetector::ConstructMe(), PHG4TRDDetector::ConstructMe(), G4Example02Detector::ConstructMe(), PHG4PSTOFDetector::ConstructMe(), PHG4ECAPToFDetector::ConstructMe(), G4JLeicDIRCDetector::ConstructMe(), G4JLeicVTXDetector::ConstructMe(), EICG4ZDCDetector::ConstructMe(), PHG4BeamlineMagnetDetector::ConstructMe(), G4Example03Detector::ConstructMe(), EICG4B0Detector::ConstructMe(), EICG4BwdDetector::ConstructMe(), EICG4dRICHDetector::ConstructMe(), EicFRichDetector::ConstructMe(), PHG4BlockDetector::ConstructMe(), PHG4ConeDetector::ConstructMe(), PHG4CylinderDetector::ConstructMe(), EICG4B0ECALDetector::ConstructMe(), PHG4CylinderStripDetector::ConstructMe(), G4JLeicBeamLineMagnetDetector::ConstructMe(), BeamLineMagnetDetector::ConstructMe(), PHG4FCalDetector::ConstructMe(), PHG4EPDDetector::ConstructMe(), PHG4BbcDetector::ConstructMe(), PHG4TpcEndCapDetector::ConstructMe(), PHG4ZDCDetector::ConstructMe(), PHG4TpcDetector::ConstructMe(), PHG4HcalDetector::ConstructMe(), G4LmonDetector::ConstructMe(), PHG4BackwardHcalDetector::ConstructMe(), PHG4ForwardHcalDetector::ConstructMe(), PHG4ProjCrystalCalorimeterDetector::ConstructMe(), PHG4CrystalCalorimeterDetector::ConstructMe(), PHG4LFHcalDetector::ConstructMe(), PHG4InnerHcalDetector::ConstructMe(), PHG4ForwardEcalDetector::ConstructMe(), PHG4OuterHcalDetector::ConstructMe(), PHG4BarrelEcalDetector::ConstructMe(), PHG4SpacalDetector::ConstructMe(), EICG4LumiDetector::ConstructMe(), PHG4ProjCrystalCalorimeterDetector::ConstructProjectiveCrystals(), PHG4HybridHomogeneousCalorimeterDetector::ConstructSupportFrame(), EICG4BwdDetector::ConstructTower(), PHG4BackwardHcalDetector::ConstructTower(), PHG4ForwardHcalDetector::ConstructTower(), EICG4B0ECALDetector::ConstructTower(), PHG4LFHcalDetector::ConstructTower(), PHG4CrystalCalorimeterDetector::ConstructTower(), PHG4HybridHomogeneousCalorimeterDetector::ConstructTower(), PHG4ForwardEcalDetector::ConstructTower(), PHG4TpcDetector::ConstructTpcCageVolume(), PHG4TpcDetector::ConstructTpcExternalSupports(), PHG4TpcDetector::ConstructTpcGasVolume(), PHG4TpcEndCapDetector::ConstructWagonWheel(), Acts::DD4hepVolumeBuilder::convertTransform(), Acts::DD4hepLayerBuilder::convertTransform(), PHSiliconTpcTrackMatching::correctTpcClusterZ(), PHActsVertexFitter::createActsSvtxVertex(), Acts::DD4hepLayerBuilder::createSensitiveSurface(), PHActsToSvtxTracks::createSvtxTrack(), OpTable::CrystalTable(), PHG4HybridHomogeneousCalorimeterDetector::CrystalTable(), CTTLSetup(), G4EicDircDetector::DefineMaterials(), PHG4Reco::DefineMaterials(), DRCALOInit(), EEMCInit(), EHCALInit(), EICG4B0ECALSteppingAction::EICG4B0ECALSteppingAction(), EICG4B0SteppingAction::EICG4B0SteppingAction(), EICG4BwdSteppingAction::EICG4BwdSteppingAction(), EICG4LumiSteppingAction::EICG4LumiSteppingAction(), Acts::DD4hepLayerBuilder::endcapLayers(), ETTLSetup(), DSTEmulator::evaluate_tracks(), ActsEvaluator::evaluateTrackFits(), ExitWindowV2::ExitWindowV2(), PHG4OuterHcalSteppingAction::FieldChecker(), ActsEvaluator::fillG4Particle(), ActsTransformations::fillSvtxTrackStates(), PHActsVertexFinder::fillVertexMap(), PHActsInitialVertexFinder::fillVertexMap(), EICG4B0ECALSteppingAction::FindTowerIndexFromPosition(), EICG4BwdSteppingAction::FindTowerIndexFromPosition(), EICG4B0SteppingAction::FindTowerIndexFromPosition(), FSTSetup(), FTTLSetup(), PHHepMCGenHelper::generate_vertx_with_bunch_interaction(), PHG4PrimaryGeneratorAction::GeneratePrimaries(), genfit::Field::get(), ALICEKF::get_Bz(), PHSimpleKFProp::get_Bz(), PHFieldBeast::GetFieldValue(), PHField3DCartesian::GetFieldValue(), PHG4OuterHcalField::GetFieldValue(), PHG4BarrelEcalDetector::GetGlassTrap(), PHG4BarrelEcalDetector::GetGlassTrapSubtract(), ActsTransformations::getGlobalPosition(), ActsEvaluator::getGlobalTruthHit(), PHG4CylinderStripDetector::GetHollowBar(), PHActsSiliconSeeding::getMvtxSpacePoints(), G4Pythia6Decayer::GetParticlePosition(), PHG4LFHcalDetector::GetScintillatorMaterial(), PHG4ForwardEcalDetector::GetScintillatorMaterial(), PHActsTrkFitter::getSourceLinks(), PHActsInitialVertexFinder::getTrackPointers(), PHActsVertexPropagator::getVertex(), PHActsTrackProjection::getVertex(), PHG4OuterHcalSteppingAction::Init(), EICG4dRICHSteppingAction::InitHit(), PHG4Reco::InitRun(), ActsExamples::HepMC3Event::lengthUnit(), LFHCALInit(), PHActsTrkFitter::loopTracks(), Magnet::Magnet(), main(), make_barrel_layer(), make_barrel_layer_LYSO_basic(), make_barrel_pixel_layer(), make_forward_station(), make_forward_station_basic(), make_LANL_FST_station(), PHActsTrackProjection::makeCaloSurfacePtrs(), PHG4RICHSteppingAction::MakeHit(), MakeActsGeometry::makeMmMapPairs(), PHG4ScoringManager::makeScoringHistograms(), PHTpcResiduals::makeSourceLink(), PHActsSiliconSeeding::makeSvtxTracks(), PHActsVertexFitter::makeTrackParam(), PHActsTrackProjection::makeTrackParams(), PHTpcResiduals::makeTrackParams(), PHG4mRICHDetector::mRichParameter::mRichParameter(), EICG4BwdDetector::ParseParametersFromTable(), PHG4BackwardHcalDetector::ParseParametersFromTable(), PHG4EICForwardEcalDetector::ParseParametersFromTable(), PHG4ForwardHcalDetector::ParseParametersFromTable(), EICG4B0ECALDetector::ParseParametersFromTable(), PHG4LFHcalDetector::ParseParametersFromTable(), PHG4CrystalCalorimeterDetector::ParseParametersFromTable(), PHG4HybridHomogeneousCalorimeterDetector::ParseParametersFromTable(), PHG4BarrelEcalDetector::ParseParametersFromTable(), PHG4ForwardDualReadoutDetector::ParseParametersFromTable(), PHG4ForwardEcalDetector::ParseParametersFromTable(), PHField2D::PHField2D(), PHField3DCartesian::PHField3DCartesian(), PHField3DCylindrical::PHField3DCylindrical(), PHFieldCleo::PHFieldCleo(), PHG4CEmcTestBeamSubsystem::PHG4CEmcTestBeamSubsystem(), PHG4CylinderSteppingAction::PHG4CylinderSteppingAction(), PHG4CylinderStripSteppingAction::PHG4CylinderStripSteppingAction(), PHG4ECAPToFSteppingAction::PHG4ECAPToFSteppingAction(), PHG4EICMvtxDetector::PHG4EICMvtxDetector(), PHG4InnerHcalSteppingAction::PHG4InnerHcalSteppingAction(), PHG4InttSteppingAction::PHG4InttSteppingAction(), PHG4MvtxDetector::PHG4MvtxDetector(), PHG4TRDSteppingAction::PHG4TRDSteppingAction(), EtmDetector::PlaceG4Volume(), EICG4BwdDetector::PlaceTower(), EICG4B0ECALDetector::PlaceTower(), PHG4OuterHcalDetector::Print(), PHField2D::print_map(), PHField3DCylindrical::print_map(), FieldMapReadBack::PrintField(), PHTpcClusterMover::process_event(), PHTpcResiduals::propagateTrackState(), FairDbTableProxy::Query(), FairDbTableProxy::QueryOverlayCreationDate(), RawTowerBuilderDRCALO::ReadGeometryFromTable(), B0RawTowerBuilderByHitIndex::ReadGeometryFromTable(), BwdRawTowerBuilderByHitIndex::ReadGeometryFromTable(), EicToyModel::RebuildCrack(), ActsExamples::DD4hep::DD4hepDetectorHelper::rectangleDigiModule(), det::utils::rectangleDigiModuleXZ(), ActsTransformations::rotateActsCovToSvtxTrack(), ActsTransformations::rotateSvtxTrackCovToActs(), PHG4FPbScDetector::set_Place(), ePHENIXRICH::RICH_Geometry::SetDefault(), PHG4Sector::Sector_Geometry::SetDefault(), G4EicDircSubsystem::SetDefaultParameters(), PHG4TTLSubsystem::SetDefaultParameters(), FieldMapReadBack::SetFieldPoint(), PHG4HcalDetector::SetLength(), EICG4dRICHAerogel::setOpticalParams(), EICG4dRICHFilter::setOpticalParams(), EICG4dRICHGas::setOpticalParams(), PHG4CEmcTestBeamSubsystem::SetPlace(), PHG4CEmcTestBeamSubsystem::SetPlaceZ(), PHG4HcalDetector::SetPosition(), PHG4HcalDetector::SetRadius(), PHG4HcalDetector::SetScintWidth(), PHG4HcalDetector::SetThickness(), PHG4SteppingAction::StoreLocalCoordinate(), ActsExamples::DD4hep::DD4hepDetectorHelper::trapezoidalDigiModule(), det::utils::trapezoidalDigiModuleXZ(), ePHENIXRICH::RICH_Geometry::Unit_cm(), PHG4Sector::Sector_Geometry::Unit_cm(), PHActsVertexPropagator::updateSvtxTrack(), PHActsTrkFitter::updateSvtxTrack(), PHActsVertexFitter::updateSvtxVertex(), PHG4FPbScSteppingAction::UserSteppingAction(), G4Example01SteppingAction::UserSteppingAction(), PHG4MvtxSteppingAction::UserSteppingAction(), PHG4ConeSteppingAction::UserSteppingAction(), PHG4SectorSteppingAction::UserSteppingAction(), PHG4EnvelopeSteppingAction::UserSteppingAction(), PHG4EICMvtxSteppingAction::UserSteppingAction(), PHG4TpcSteppingAction::UserSteppingAction(), G4LBLVtxSteppingAction::UserSteppingAction(), G4Example03SteppingAction::UserSteppingAction(), PHG4PSTOFSteppingAction::UserSteppingAction(), G4JLeicVTXSteppingAction::UserSteppingAction(), G4JLeicDIRCSteppingAction::UserSteppingAction(), PHG4FPbScRegionSteppingAction::UserSteppingAction(), G4JLeicBeamLineMagnetSteppingAction::UserSteppingAction(), G4Example02SteppingAction::UserSteppingAction(), PHG4InttSteppingAction::UserSteppingAction(), PHG4CylinderStripSteppingAction::UserSteppingAction(), AllSiliconTrackerSteppingAction::UserSteppingAction(), BeastMagnetSteppingAction::UserSteppingAction(), PHG4EPDSteppingAction::UserSteppingAction(), PHG4OuterHcalSteppingAction::UserSteppingAction(), AllSi_Al_support_SteppingAction::UserSteppingAction(), PHG4BlockSteppingAction::UserSteppingAction(), PHG4HcalSteppingAction::UserSteppingAction(), PHG4InnerHcalSteppingAction::UserSteppingAction(), PHG4CEmcTestBeamSteppingAction::UserSteppingAction(), EicFRichSteppingAction::UserSteppingAction(), GdmlImportDetectorSteppingAction::UserSteppingAction(), PHG4BarrelEcalSteppingAction::UserSteppingAction(), EICG4dRICHSteppingAction::UserSteppingAction(), BeamLineMagnetSteppingAction::UserSteppingAction(), PHG4BbcSteppingAction::UserSteppingAction(), EICG4ZDCSteppingAction::UserSteppingAction(), PHG4ForwardDualReadoutSteppingAction::UserSteppingAction(), PHG4CrystalCalorimeterSteppingAction::UserSteppingAction(), PHG4LFHcalSteppingAction::UserSteppingAction(), PHG4ForwardEcalSteppingAction::UserSteppingAction(), PHG4ECAPToFSteppingAction::UserSteppingAction(), PHG4BackwardHcalSteppingAction::UserSteppingAction(), PHG4mRICHSteppingAction::UserSteppingAction(), PHG4TpcEndCapSteppingAction::UserSteppingAction(), PHG4HybridHomogeneousCalorimeterSteppingAction::UserSteppingAction(), EICG4RPSteppingAction::UserSteppingAction(), PHG4CylinderSteppingAction::UserSteppingAction(), PHG4ForwardHcalSteppingAction::UserSteppingAction(), PHG4TRDSteppingAction::UserSteppingAction(), PHG4ZDCSteppingAction::UserSteppingAction(), G4EicDircSteppingAction::UserSteppingAction(), EICG4B0ECALSteppingAction::UserSteppingAction(), PHG4MicromegasSteppingAction::UserSteppingAction(), EICG4B0SteppingAction::UserSteppingAction(), EICG4BwdSteppingAction::UserSteppingAction(), EICG4LumiSteppingAction::UserSteppingAction(), PHG4SpacalSteppingAction::UserSteppingAction(), PHG4TTLSteppingAction::UserSteppingAction(), and Acts::volumeBuilder_dd4hep().

constexpr double Acts::UnitConstants::cm3 = cm * cm * cm

Definition at line 107 of file Units.hpp.

View newest version in sPHENIX GitHub at line 107 of file Units.hpp

Referenced by PHG4TTLDetector::BuildBarrelTTL(), PHG4TTLDetector::BuildForwardTTL(), PHG4CylinderStripDetector::BuildMaterials(), Cell::Cell(), PHG4FullProjTiltedSpacalDetector::Construct_Tower(), PHG4TRDDetector::ConstructMe(), PHG4ECAPToFDetector::ConstructMe(), PHG4BbcDetector::ConstructMe(), PHG4ForwardHcalDetector::ConstructTower(), PHG4MicromegasDetector::create_materials(), G4EicDircDetector::DefineMaterials(), PHG4Reco::DefineMaterials(), EICG4dRICHAerogel::Density(), EICG4dRICHAerogel::density2refIndex(), PHG4GDMLWriteMaterials::DWrite(), EicFRichDetector::element_material(), PHG4CrystalCalorimeterDetector::GetCarbonFiber(), PHG4HybridHomogeneousCalorimeterDetector::GetCarbonFiber(), PHG4BarrelEcalDetector::GetCarbonFiber(), PHG4LFHcalDetector::GetCoatingMaterial(), PHG4ForwardEcalDetector::GetCoatingMaterial(), PHG4ForwardDualReadoutDetector::GetPMMAMaterial(), PHG4ForwardDualReadoutDetector::GetQuartzMaterial(), PHG4BarrelEcalDetector::GetSciGlass(), PHG4LFHcalDetector::GetScintillatorMaterial(), PHG4HybridHomogeneousCalorimeterDetector::GetScintillatorMaterial(), PHG4ForwardDualReadoutDetector::GetScintillatorMaterial(), PHG4ForwardEcalDetector::GetScintillatorMaterial(), PHG4HybridHomogeneousCalorimeterDetector::GetTedlarMaterial(), PHG4HybridHomogeneousCalorimeterDetector::GetVM2000Material(), PHG4ForwardEcalDetector::GetWLSFiberFEMCMaterial(), PHG4LFHcalDetector::GetWLSFiberMaterial(), EICG4LumiDetector::MakeTower(), EICG4ZDCStructure::Materials(), PHG4InnerHcalDetector::Print(), EICG4dRICHAerogel::setOpticalParams(), and EICG4dRICHGas::setOpticalParams().

constexpr double Acts::UnitConstants::degree = 0.017453292519943295
constexpr double Acts::UnitConstants::e = 1.0

Definition at line 137 of file Units.hpp.

View newest version in sPHENIX GitHub at line 137 of file Units.hpp

Referenced by MultiArray< TVector3 >::Add(), PHG4ScintillatorSlatv1::add_edep(), tetgenmesh::add_steinerpt_in_segment(), ActsExamples::Options::addDD4hepOptions(), AddFlowToParent(), CylindricalHough::addHits(), AddLayers_MiniTPCDrift(), Fun4AllEventOutStream::AddPacketRange(), AnalyticFieldModel::AnalyticFieldModel(), nlohmann::detail::dtoa_impl::append_exponent(), Input::ApplyEICBeamParameter(), Input::ApplysPHENIXBeamParameter(), Acts::Test::approximatelyEqual(), BECAL_Towers(), Fun4AllServer::BeginRun(), GPUTPCTrackParam::BetheBlochGeant(), BOOST_AUTO_TEST_CASE(), Acts::Test::Layers::BOOST_AUTO_TEST_CASE(), Acts::Test::BOOST_AUTO_TEST_CASE(), Acts::Test::BOOST_DATA_TEST_CASE(), Acts::Test::BOOST_FIXTURE_TEST_CASE(), BuildJLEIC_0_1(), BuildMatrixDetector_0_1_FF(), genfit::calcAverageState(), Acts::detail::calcPerpendicularProjection(), FairGeoMedium::calcRadiationLength(), TrKalmanFilter::CalculateProcessNoise(), PHG4TTLSteppingAction::CalculateSensorHitIndices(), GFDaf::calcWeights(), genfit::DAF::calcWeights(), genfit::AbsKalmanFitter::canIgnoreWeights(), CEMC_Towers(), CharmJetClassification_Plots(), CharmTagPlots(), PHG4HcalCellReco::CheckEnergy(), PHG4BlockCellReco::CheckEnergy(), PHG4CylinderCellReco::CheckEnergy(), PHG4ForwardCalCellReco::CheckEnergy(), PHG4FullProjSpacalCellReco::CheckEnergy(), checkErrorPropagation(), checkExtrapolateBy(), checkExtrapolateToCylinder(), checkExtrapolateToLine(), checkExtrapolateToPoint(), checkExtrapolateToSphere(), GFWirepointHitPolicy::checkPlane(), GFWireHitPolicy::checkPlane(), checkStopAtBoundary(), Acts::BinningData::checkSubStructure(), lit::ChiSq(), PgPostBankBackupManager::CleanTable(), MvtxClusterizer::ClusterMvtx(), CMDistortionReco(), CMDistortionRecoCart(), CMDistortionRecoPhiR(), Acts::collectCompounds_dd4hep(), Acts::collectLayers_dd4hep(), Acts::collectSubDetectors_dd4hep(), Acts::collectVolumes_dd4hep(), PgPostBankBackupManager::commit(), PgPostBankBackupManager::commitAllBankfromTFile(), FairGeoNode::compare(), compareForthBackExtrapolation(), compareForthBackJacNoise(), erhic::ParticleMCbase::ComputeEventDependentQuantities(), computeHermesPhiH(), Config(), Acts::Test::consistencyCheck(), Acts::GenericCuboidVolumeBounds::construct(), gbl::GblTrajectory::construct(), ePHENIXRICH::ePHENIXRICHConstruction::Construct_HBD(), ConvertEgTypeToMeshType(), RawClusterBuilderFwd::CorrectPhi(), kdfinder::TVector< T >::cosTheta(), Acts::AtlasStepper< bfield_t >::covarianceTransport(), create_element(), CreateBoundaryLayer(), CreateBoundaryLayerDivide(), RawTowerBuilder::CreateNodes(), Acts::Sycl::createSeedsForGroupSycl(), Acts::DD4hepLayerBuilder::createSensitiveSurface(), CTTLSetup(), G4EicDircDetector::DefineMaterials(), PHG4Reco::DefineMaterials(), GFWirepointHitPolicy::detPlane(), GFWireHitPolicy::detPlane(), GFPseudoSpacepointWireHitPolicy::detPlane(), DISJacquetBlondel(), genfit::EventDisplay::drawEvent(), Fun4AllEventOutStream::DropPacketRange(), A_Event::dumpErrorBlock(), FourHitSeedFinder::dzdlError(), eASTInitialization::eASTInitialization(), eASTPhysicsList::eASTPhysicsList(), EHCAL_Towers(), EICPhysicsList::EICPhysicsList(), RawTowerBuilder::EminCut(), HcalRawTowerBuilder::EminCut(), RawTowerBuilderDRCALO::EminCut(), RawTowerBuilderByHitIndex::EminCut(), B0RawTowerBuilderByHitIndex::EminCut(), BwdRawTowerBuilderByHitIndex::EminCut(), RawTowerBuilderByHitIndexBECAL::EminCut(), RawTowerBuilderByHitIndexLHCal::EminCut(), EICG4ZDCRawTowerBuilderByHitIndex::EminCut(), dfe::SmallVector< T, N, Allocator >::emplace(), LiteCaloEval::End(), Fun4AllServer::End(), Fun4AllServer::EndRun(), ETTLSetup(), PHG4IonGun::ExcitEnergy(), PndGFTrackToPndTrackConvertorTask::Exec(), FairMCStack::Exec(), Acts::Polyhedron::extent(), erhic::LogReaderPepsi::Extract(), Acts::SinglyCharged::extractCharge(), Acts::SinglyCharged::extractMomentum(), genfit::RKTrackRep::extrapolateToCone(), PHGenFit::extrapolateToCylinder(), PHGenFit::Track::extrapolateToCylinder(), PHGenFit2::Track::extrapolateToCylinder(), PHGenFit::Track::extrapolateToLine(), PHGenFit2::Track::extrapolateToLine(), PHGenFit::Track::extrapolateToPlane(), PHGenFit2::Track::extrapolateToPlane(), PHGenFit::Track::extrapolateToPoint(), PHGenFit2::Track::extrapolateToPoint(), boost::array< T, 0 >::failed_rangecheck(), FGEM_FastSim_Reco(), FHCAL_Towers(), eicpy.qaplots.TrackHists::fill(), JetEvaluator::fillOutputNtuples(), CaloEvaluator::fillOutputNtuples(), SvtxEvaluator::fillOutputNtuples(), GPUTPCTrackParam::Filter(), ActsFatras::findCharge(), FindPeriodicNodes(), genfit::GFRaveVertexFactory::findVertices(), PndRecoDafFit::Fit(), PndRecoKalmanFit::Fit(), gbl::GblTrajectory::fit(), GFKalman::fittingPass(), genfit::KalmanFitter::fitTrack(), PHTimer::Frequency::Frequency(), FairGeaneUtil::FromMarsToSC(), FairGeaneUtil::FromMarsToSD(), FairGeaneUtil::FromPtToSC(), FairGeaneUtil::FromPtToSD(), FairGeaneUtil::FromSCToMars(), FairGeaneUtil::FromSCToPt(), FairGeaneUtil::FromSCToSD(), FairGeaneUtil::FromSD1ToSD2(), FairGeaneUtil::FromSDToPt(), FairGeaneUtil::FromSDToSC(), FSTSetup(), FTTLSetup(), Fun4All_G4_Babar(), Fun4All_G4_Beast(), Fun4All_G4_CEMC(), Fun4All_G4_Cleo(), Fun4All_G4_EICDetector(), Fun4All_G4_FastMom_GEM(), Fun4All_G4_FastMom_GEM_RICH(), Fun4All_G4_FEMC(), Fun4All_G4_FHCAL(), Fun4All_G4_HCALIN(), Fun4All_G4_HCALOUT(), Fun4All_G4_JLeic(), Fun4All_G4_Momentum(), Fun4All_G4_Momentum_Projection(), Fun4All_G4_Momentum_Projection_Calorimeters(), Fun4All_G4_Momentum_Projection_Detectors(), Fun4All_G4_simple_hadron_GEM(), Fun4All_G4_simplified_v2_DIRC_barrel_GEM(), Fun4All_G4_sPHENIX(), Fun4All_G4_Tracking(), Fun4All_Generator_Display(), PHTruthClustering::G4ClusterSize(), SvtxTruthEval::G4ClusterSize(), GenfitTrack2PndTrack(), MultiArray< TVector3 >::Get(), erhic::ParticleMCbase::Get4VectorInHadronBosonFrame(), FastJetAlgo::get_jets(), CylinderGeom_Mvtx::get_pixel_from_local_coords(), genfit::RKTrackRep::getBackwardJacobianAndNoise(), genfit::KalmanFitterInfo::getClosestMeasurementOnPlane(), FROG::GetConnection(), RunToTimePg::GetConnection(), EmcCluster::GetCorrPos(), GPUTPCTrackParam::GetDCAPoint(), EmcCluster::GetECoreCorrected(), genfit::KalmanFitterInfo::getFittedState(), ActsFatras::detail::GeneralMixture::getGaussmix(), EmcCluster::GetGlobalPos(), GFDafHit::getMeasurement(), genfit::AbsKalmanFitter::getMeasurements(), EmcCluster::GetMoments(), testEventiterator::getNextEvent(), listEventiterator::getNextEvent(), EmcCluster::GetProb(), MultiArray< TVector3 >::GetPtr(), CbmMCTrack::GetRapidity(), Stopwatch::GetRealTime(), genfit::KalmanFitterInfo::getResidual(), RunToTimePg::getRunNumber(), GPUTPCTrackParam::GetS(), genfit::GblFitter::getScattererFromMatList(), getScattererFromMatList(), RunToTimePg::getTime(), genfit::Track::getTOF(), genfit::Track::getTrackLen(), PHActsInitialVertexFinder::getTrackPointers(), half::half(), halfToFloat(), HCALInner_Towers(), HCALOuter_Towers(), tetgenmesh::hilbert_init(), erhic::Pid::Info(), DSTEmulator::Init(), PgPostBankBackupLog::Init(), QAG4SimulationJet::Init_Spectrum(), QAG4SimulationEicCalorimeter::Init_Tower(), QAG4SimulationCalorimeter::Init_Tower(), initELut(), Acts::Sycl::QueueWrapper::initialize(), initializeeventqa(), RawTowerBuilder::InitRun(), RawClusterBuilderGraph::InitRun(), PHG4ParticleGeneratorD0::InitRun(), PHG4PileupGenerator::InitRun(), RawClusterBuilderTemplate::InitRun(), RawClusterBuilderFwd::InitRun(), HcalRawTowerBuilder::InitRun(), RawTowerDeadTowerInterp::InitRun(), TPCIntegratedCharge::InitRun(), PHG4CentralityReco::InitRun(), PHG4BlockCellReco::InitRun(), EICG4ZDCRawTowerBuilderByHitIndex::InitRun(), RawTowerBuilderByHitIndex::InitRun(), PHG4CylinderCellReco::InitRun(), RawTowerBuilderByHitIndexLHCal::InitRun(), RawTowerZDCCalibration::InitRun(), BwdRawTowerBuilderByHitIndex::InitRun(), RawTowerBuilderByHitIndexBECAL::InitRun(), B0RawTowerBuilderByHitIndex::InitRun(), RawTowerBuilderDRCALO::InitRun(), RawTowerCalibration::InitRun(), RawClusterBuilderTopo::InitRun(), RawTowerDigitizer::InitRun(), RawTowerZDCDigitizer::InitRun(), QAG4SimulationIntt::InitRun(), QAG4SimulationMvtx::InitRun(), RawClusterBuilderHelper::InitRun(), RawDigitBuilderTTL::InitRun(), RawTowerCombiner::InitRun(), Acts::ConeSurface::intersectionSolver(), genfit::tools::invertMatrix(), GFTools::invertMatrix(), half::isDenormalized(), half::isFinite(), half::isInfinity(), half::isNan(), half::isNormalized(), LSLTrackRep::Jacobian(), KaonIDStudy(), kill_trailing(), PHTruthClustering::line_circle_intersection(), SvtxTruthEval::line_circle_intersection(), PgPostBankBackupLog::Log(), main(), make_barrel_pixel_layer(), ActsFatras::detail::make_error_code(), ActsFatras::make_error_code(), Acts::make_error_code(), make_forward_station_basic(), make_GEM_barrel_section(), make_LANL_FST_station(), makeGeom(), genfit::EventDisplay::makeLines(), PHActsVertexFitter::makeTrackParam(), PHTpcResiduals::makeTrackParams(), SvtxClusterEval::max_truth_particle_by_cluster_energy(), SvtxHitEval::max_truth_particle_by_energy(), SvtxClusterEval::max_truth_particle_by_energy(), CaloRawTowerEval::max_truth_primary_shower_by_energy(), CaloRawClusterEval::max_truth_primary_shower_by_energy(), BEmcRec::Momenta(), MoveDescendantsToParent(), MovePointCircle(), MovePointPowerSeries2(), MultiArray< TVector3 >::MultiArray(), FairRKPropagator::OneStepRungeKutta(), operator==(), Acts::Surface::operator==(), ParseArguments(), FourHitSeedFinder::phiError(), erhic::Forester::Plant(), PndPidProbability::PndPidProbability(), BEmcRec::PredictEnergyParam(), BEmcRec::PredictEnergyProb(), genfit::KalmanFitterRefTrack::prepareTrack(), CaloEvaluator::printOutputInfo(), RawTowerBuilder::process_event(), RawClusterBuilderGraph::process_event(), PHG4ParticleGeneratorD0::process_event(), RawClusterBuilderTemplate::process_event(), RawClusterBuilderFwd::process_event(), HcalRawTowerBuilder::process_event(), QAG4SimulationUpsilon::process_event(), TPCIntegratedCharge::process_event(), PHG4FullProjSpacalCellReco::process_event(), G4SnglTree::process_event(), PHG4SimpleEventGenerator::process_event(), G4SnglNtuple::process_event(), RawClusterBuilderHelper::process_event(), LiteCaloEval::process_event(), PHG4Reco::process_event(), Fun4AllServer::process_event(), RawTowerCombiner::process_event(), QAG4SimulationEicCalorimeter::process_event_Cluster(), QAG4SimulationCalorimeter::process_event_Cluster(), QAG4SimulationCalorimeterSum::process_event_Cluster(), QAG4SimulationEicCalorimeterSum::process_event_Cluster(), QAG4SimulationEicCalorimeter::process_event_G4Hit(), QAG4SimulationCalorimeter::process_event_G4Hit(), QAG4SimulationEicCalorimeter::process_event_Tower(), QAG4SimulationCalorimeter::process_event_Tower(), QAG4SimulationCalorimeterSum::process_event_TrackProj(), QAG4SimulationEicCalorimeterSum::process_event_TrackProj(), QAG4SimulationJet::process_TruthMatching(), GFDaf::processTrack(), PHGenFit::Fitter::processTrack(), genfit::KalmanFitterRefTrack::processTrackPoint(), genfit::KalmanFitterRefTrack::processTrackPointSqrt(), genfit::KalmanFitterRefTrack::processTrackWithRep(), genfit::KalmanFitter::processTrackWithRep(), genfit::DAF::processTrackWithRep(), genfit::GFGbl::processTrackWithRep(), genfit::GblFitter::processTrackWithRep(), genfit::MeasurementProducer< hit_T, measurement_T >::produce(), GFRecoHitProducer< hit_T, recoHit_T >::produce(), FairGeanePro::Propagate(), Acts::RiddersPropagator< propagator_t >::propagate(), pwithpF(), erhic::Pythia6::Pythia6(), tetgenmesh::qualitystatistics(), boost::array< T, N >::rangecheck(), ActsExamples::CsvParticleReader::read(), tetgenmesh::recoverdelaunay(), Fun4AllServer::registerSubsystem(), ALICEKF::repairCovariance(), genfit::RKTrackRep::RKPropagate(), GPUTPCTrackParam::Rotate(), half::round(), Fun4AllHepMCPileupInputManager::run(), Fun4AllDstPileupInputManager::run(), Fun4AllSingleDstPileupInputManager::run(), Acts::Test::runTest(), mesh_t::save(), SaveElmergrid(), MultiArray< TVector3 >::Set(), RawClusterBuilderHelper::set_agg_e(), SvtxTrack_v1::set_cal_cluster_e(), SvtxTrack_v2::set_cal_cluster_e(), PHG4Particlev2::set_e(), ParticleFlowElementv1::set_e(), Jetv1::set_e(), G4RootHitContainer::set_eion(), G4RootScintillatorSlatContainer::set_eion(), G4RootScintillatorTowerContainer::set_eion(), RawTowerZDCv1::set_energy(), RawTowerv1::set_energy(), G4RootRawTowerContainer::set_etotal(), G4RootHitContainer::set_etotal(), G4RootScintillatorSlatContainer::set_etotal(), G4RootScintillatorTowerContainer::set_etotal(), PHG4Particlev3::set_ExcitEnergy(), RawClusterBuilderHelper::set_seed_e(), RawClusterBuilderGraph::set_threshold_energy(), RawClusterBuilderFwd::set_threshold_energy(), RawClusterBuilderTemplate::set_threshold_energy(), PHG4ParticleGeneratorVectorMeson::set_upsilon_1s(), PHG4ParticleGeneratorVectorMeson::set_upsilon_2s(), PHG4ParticleGeneratorVectorMeson::set_upsilon_3s(), CbmRichRingLight::SetABCDEF(), FairGeoMedium::setCerenkovPar(), PHG4InttDigitizer::SetDefaultParameters(), PHG4TpcSubsystem::SetDefaultParameters(), PHG4InttSubsystem::SetDefaultParameters(), PHG4TpcEndCapSubsystem::SetDefaultParameters(), HcalRawTowerBuilder::SetDefaultParameters(), PHG4TTLSubsystem::SetDefaultParameters(), erhic::ParticleMCbase::SetE(), erhic::EventPythia::SetEBrems(), mesh_t::setEdgeArray(), mesh_t::setElementArray(), erhic::EventMC::SetELeptonInNuclearFrame(), CbmRichRing::SetEPar(), erhic::EventMC::SetEScatteredInNuclearFrame(), erhic::ParticleMCbase::SetEvent(), ReadEICFiles::SetFirstEntry(), FairIon::SetParams(), genfit::KalmanFitterInfo::setWeights(), Acts::SinglyCharged::SinglyCharged(), Smear::Detector::Smear(), tetgenmesh::smoothpoint(), Acts::EigenStepper< bfield_t, extensionlist_t, auctioneer_t >::step(), Acts::Frustum< value_t, DIM, SIDES >::svg(), testEventiterator::testEventiterator(), Acts::Test::testJacobianToGlobal(), nlohmann::detail::to_json(), Acts::SurfaceArray::toStream(), FairGeanePro::Track2ToLine(), FairGeanePro::Track3ToLine(), FairGeanePro::Track3ToPoint(), Tracking_Reco(), TrackingServiceCone(), TrackingServiceCylinder(), PHGenFitTrkProp::TrackPropPatRec(), CbmRichRingFitterEllipseTau::TransformEllipse(), GPUTPCTrackParam::TransportToX(), genfit::Track::udpateSeed(), kdfinder::TVector< T >::unit(), PHGenFit2::Track::updateOneMeasurementKalman(), PHGenFit::Track::updateOneMeasurementKalman(), Acts::volumeBuilder_dd4hep(), ActsExamples::TrackFinderPerformanceWriter::Impl::write(), ActsExamples::CsvParticleWriter::writeT(), and ActsExamples::RootParticleWriter::writeT().

constexpr double Acts::UnitConstants::fm = 1e-12

Definition at line 89 of file Units.hpp.

View newest version in sPHENIX GitHub at line 89 of file Units.hpp

Referenced by Acts::Test::BOOST_AUTO_TEST_CASE(), and Acts::Test::fillTrackState().

constexpr double Acts::UnitConstants::fs = 1e-15 * s
constexpr double Acts::UnitConstants::g = 1.0 / 1.782662e-24

Definition at line 134 of file Units.hpp.

View newest version in sPHENIX GitHub at line 134 of file Units.hpp

Referenced by ActsExamples::SteppingAction::UserSteppingAction().

constexpr double Acts::UnitConstants::Gauss = 1e-4 * T

Definition at line 141 of file Units.hpp.

View newest version in sPHENIX GitHub at line 141 of file Units.hpp

constexpr double Acts::UnitConstants::GeV = 1.0

Definition at line 126 of file Units.hpp.

View newest version in sPHENIX GitHub at line 126 of file Units.hpp

Referenced by PHG4TruthTrackingAction::AddParticle(), G4EicDircDetector::ConstructMe(), eASTProtonPhysics::ConstructProcess(), eASTHyperonPhysics::ConstructProcess(), eASTPionPhysics::ConstructProcess(), eASTKaonPhysics::ConstructProcess(), ProtonPhysics::ConstructProcess(), eASTNeutronPhysics::ConstructProcess(), HyperonPhysics::ConstructProcess(), NeutronPhysics::ConstructProcess(), KaonPhysics::ConstructProcess(), PionPhysics::ConstructProcess(), eASTGammaLeptoNuclearPhysics::ConstructProcess(), GammaLeptoNuclearPhysics::ConstructProcess(), eASTIonPhysics::ConstructProcess(), IonPhysics::ConstructProcess(), G4EicDircDetector::DefineMaterials(), eASTPrimaryGeneratorAction::eASTPrimaryGeneratorAction(), PHG4PrimaryGeneratorAction::GeneratePrimaries(), PHG4ParticleGeneratorBase::get_mass(), G4Pythia6Decayer::GetParticleMomentum(), PHG4SteppingAction::GetScintLightYield(), PHG4SteppingAction::GetVisibleEnergyDeposition(), G4Pythia6Decayer::ImportDecayProducts(), main(), PHG4RICHSteppingAction::MakeHit(), eASTHepMC3Interface::MakeParticle(), ActsExamples::HepMC3Event::momentumUnit(), PHG4IonGun::Print(), ActsExamples::Pythia8Generator::Pythia8Generator(), ActsExamples::CsvParticleReader::read(), ActsExamples::CsvPlanarClusterReader::read(), PHG4FPbScSteppingAction::UserSteppingAction(), PHG4FCalSteppingAction::UserSteppingAction(), PHG4ConeSteppingAction::UserSteppingAction(), G4Example01SteppingAction::UserSteppingAction(), PHG4EnvelopeSteppingAction::UserSteppingAction(), PHG4SectorSteppingAction::UserSteppingAction(), PHG4EICMvtxSteppingAction::UserSteppingAction(), PHG4MvtxSteppingAction::UserSteppingAction(), PHG4TpcSteppingAction::UserSteppingAction(), PHG4FPbScRegionSteppingAction::UserSteppingAction(), G4Example03SteppingAction::UserSteppingAction(), G4JLeicBeamLineMagnetSteppingAction::UserSteppingAction(), G4JLeicDIRCSteppingAction::UserSteppingAction(), G4JLeicVTXSteppingAction::UserSteppingAction(), PHG4PSTOFSteppingAction::UserSteppingAction(), G4LBLVtxSteppingAction::UserSteppingAction(), G4Example02SteppingAction::UserSteppingAction(), PHG4BlockSteppingAction::UserSteppingAction(), PHG4InnerHcalSteppingAction::UserSteppingAction(), PHG4CEmcTestBeamSteppingAction::UserSteppingAction(), GdmlImportDetectorSteppingAction::UserSteppingAction(), PHG4OuterHcalSteppingAction::UserSteppingAction(), PHG4EPDSteppingAction::UserSteppingAction(), PHG4InttSteppingAction::UserSteppingAction(), AllSiliconTrackerSteppingAction::UserSteppingAction(), EicFRichSteppingAction::UserSteppingAction(), AllSi_Al_support_SteppingAction::UserSteppingAction(), PHG4HcalSteppingAction::UserSteppingAction(), PHG4CylinderStripSteppingAction::UserSteppingAction(), BeastMagnetSteppingAction::UserSteppingAction(), PHG4BarrelEcalSteppingAction::UserSteppingAction(), EICG4dRICHSteppingAction::UserSteppingAction(), EICG4ZDCSteppingAction::UserSteppingAction(), BeamLineMagnetSteppingAction::UserSteppingAction(), PHG4BbcSteppingAction::UserSteppingAction(), PHG4BackwardHcalSteppingAction::UserSteppingAction(), PHG4mRICHSteppingAction::UserSteppingAction(), PHG4HybridHomogeneousCalorimeterSteppingAction::UserSteppingAction(), PHG4ForwardDualReadoutSteppingAction::UserSteppingAction(), PHG4ForwardEcalSteppingAction::UserSteppingAction(), PHG4CrystalCalorimeterSteppingAction::UserSteppingAction(), PHG4TpcEndCapSteppingAction::UserSteppingAction(), PHG4ECAPToFSteppingAction::UserSteppingAction(), PHG4LFHcalSteppingAction::UserSteppingAction(), EICG4RPSteppingAction::UserSteppingAction(), PHG4ForwardHcalSteppingAction::UserSteppingAction(), PHG4CylinderSteppingAction::UserSteppingAction(), PHG4TRDSteppingAction::UserSteppingAction(), PHG4ZDCSteppingAction::UserSteppingAction(), G4EicDircSteppingAction::UserSteppingAction(), EICG4B0ECALSteppingAction::UserSteppingAction(), PHG4MicromegasSteppingAction::UserSteppingAction(), EICG4B0SteppingAction::UserSteppingAction(), EICG4BwdSteppingAction::UserSteppingAction(), EICG4LumiSteppingAction::UserSteppingAction(), PHG4SpacalSteppingAction::UserSteppingAction(), PHG4TTLSteppingAction::UserSteppingAction(), ActsExamples::TrackFinderPerformanceWriter::Impl::write(), ActsExamples::CsvParticleWriter::writeT(), ActsExamples::RootSimHitWriter::writeT(), ActsExamples::RootParticleWriter::writeT(), and ActsExamples::CsvPlanarClusterWriter::writeT().

constexpr double Acts::UnitConstants::h = 3600.0 * s

Definition at line 117 of file Units.hpp.

View newest version in sPHENIX GitHub at line 117 of file Units.hpp

Referenced by __attribute__(), Nystrom::adaptiveStep(), CylindricalHough::addHits(), BOOST_AUTO_TEST_CASE(), Acts::Test::BOOST_AUTO_TEST_CASE(), erhic::Pythia6EventBuilder::BuildEvent(), erhic::LeptonKinematicsComputer::Calculate(), TpcSpaceChargeMatrixInversion::calculate_distortions(), CylinderKalman::calculate_dxda(), HelixKalmanFilter::calculate_dxda(), compareHitHistograms(), erhic::DoubleAngleComputer::ComputeQuarkAngle(), CbmHistManager::Create1(), CbmHistManager::Create2(), Acts::Sycl::createSeedsForGroupSycl(), oncsSub_idfnalmwpc::decode(), oncsSub_idfnalmwpcv2::decode(), CbmRichGeoTest::DrawHist(), QAG4SimulationIntt::evaluate_clusters(), QAG4SimulationMvtx::evaluate_clusters(), QAG4SimulationMicromegas::evaluate_clusters(), QAG4SimulationTpc::evaluate_clusters(), QAG4SimulationMicromegas::evaluate_hits(), PHG4OuterHcalSteppingAction::FieldChecker(), sPHENIXTracker::finalize(), sPHENIXTrackerTpc::finalize(), sPHENIXSeedFinder::finalize(), HelixHough::findHelices(), sPHENIXTrackerTpc::findTracksByCombinatorialKalman(), sPHENIXTrackerTpc::findTracksBySegments(), sPHENIXTracker::findTracksBySegments(), sPHENIXSeedFinder::findTracksBySegments(), erhic::EventFromAsciiFactory< T >::FinishEvent(), PrimSelector::FinishTask(), SimpleTrack3D::fit_track(), ZHough_Cylindrical::fitTrack(), VtxTrackFinder::fitTrack(), ThreeHitSeedGrower::fitTrack(), NHitSeedFinder::fitTrack(), FourHitSeedFinder::fitTrack(), sPHENIXTrackerTpc::fitTrack(), sPHENIXTracker::fitTrack(), sPHENIXSeedFinder::fitTrack(), FourHitSeedFinder::fitTrackLine(), Acts::Test::SurfaceArrayFixture::fullPhiTestSurfacesBRL(), Acts::Test::SurfaceArrayCreatorFixture::fullPhiTestSurfacesBRL(), Acts::Test::LayerCreatorFixture::fullPhiTestSurfacesBRL(), Acts::Test::SurfaceArrayCreatorFixture::fullPhiTestSurfacesEC(), PHG4CylinderGeom_Spacalv3::get_max_lightguide_height(), PHTpcTrackFollower::get_projected_coordinate(), CbmRichRingFinderHoughSimd::HoughTransformReconstruction(), QAG4SimulationUpsilon::Init(), QAExample::Init(), QAG4SimulationVertex::Init(), QAG4SimulationEicCalorimeter::Init(), QAG4SimulationCalorimeter::Init(), QAG4SimulationTracking::Init(), QAG4SimulationKFParticle::Init(), QAG4SimulationEicCalorimeterSum::Init(), QAG4SimulationCalorimeterSum::Init(), QAG4SimulationCalorimeter::Init_G4Hit(), QAG4SimulationEicCalorimeter::Init_G4Hit(), QAG4SimulationJet::Init_Spectrum(), QAG4SimulationCalorimeter::Init_Tower(), QAG4SimulationEicCalorimeter::Init_Tower(), QAG4SimulationJet::Init_TruthMatching(), TrKalmanFilter::InitializeRungeKuttaFrames(), TPCIntegratedCharge::InitRun(), QAG4SimulationIntt::InitRun(), QAG4SimulationMvtx::InitRun(), QAG4SimulationMicromegas::InitRun(), QAG4SimulationTpc::InitRun(), TPCDataStreamEmulator::InitRun(), PHG4ScoringManager::InitRun(), TPCFEETestRecov1::InitRun(), JetHepMCLoader::InitRun(), intersect_circles(), CylindricalHough::intersect_circles(), CbmRichRingFitterEllipseTau::Jacobi(), LSLTrackRep::Jacobian(), Acts::DefaultExtension::k(), Acts::detail::stepper_extension_list_impl< N >::k(), Acts::DenseEnvironmentExtension::k(), PHG4Utils::lines_intersect(), main(), kdfinder::make_triplets(), Acts::Test::SurfaceArrayCreatorFixture::makeBarrelStagger(), Acts::Test::LayerCreatorFixture::makeBarrelStagger(), PHG4ScoringManager::makeScoringHistograms(), EICG4LumiDetector::MakeTower(), MovePointPowerSeries2(), nlohmann::detail::dtoa_impl::diyfp::mul(), half::negInf(), FairRKPropagator::OneStepRungeKutta(), std::hash< std::array< T, N > >::operator()(), std::hash< nlohmann::json >::operator()(), half::operator-(), half::posInf(), QAG4SimulationCalorimeter::process_event_Cluster(), QAG4SimulationEicCalorimeter::process_event_Cluster(), QAG4SimulationCalorimeter::process_event_G4Hit(), QAG4SimulationEicCalorimeter::process_event_G4Hit(), QAG4SimulationEicCalorimeter::process_event_Tower(), QAG4SimulationCalorimeter::process_event_Tower(), CellularAutomaton_v1::process_single_track(), CellularAutomaton_v1::process_single_triplet(), sPHENIXTracker::projectToLayer(), sPHENIXSeedFinder::projectToLayer(), Nystrom::propagate(), half::qNan(), rad_length(), remove_bad_hits(), Fun4AllHistoManager::Reset(), half::round(), half::sNan(), TpcSpaceChargeReconstructionHelper::split(), Nystrom::step(), Acts::StraightLineStepper::step(), Acts::EigenStepper< bfield_t, extensionlist_t, auctioneer_t >::step(), Acts::AtlasStepper< bfield_t >::step(), trackProximity(), Acts::DefaultExtension::transportMatrix(), Acts::DenseEnvironmentExtension::transportMatrix(), CylinderKalman::updateIntersection(), HelixKalmanFilter::updateIntersection(), HelixHough::vote(), HelixHough::vote_pairs(), HelixHough::vote_z(), VstRadLength(), and Acts::RiddersPropagator< propagator_t >::wiggleDimension().

constexpr double Acts::UnitConstants::keV = 1e-6

Definition at line 124 of file Units.hpp.

View newest version in sPHENIX GitHub at line 124 of file Units.hpp

Referenced by PHG4LFHcalDetector::GetScintillatorMaterial(), and PHG4ForwardEcalDetector::GetScintillatorMaterial().

constexpr double Acts::UnitConstants::kg = 1.0 / 1.782662e-27

Definition at line 135 of file Units.hpp.

View newest version in sPHENIX GitHub at line 135 of file Units.hpp

Referenced by PHG4Reco::DefineMaterials().

constexpr double Acts::UnitConstants::kGauss = 1e-1 * T

Definition at line 142 of file Units.hpp.

View newest version in sPHENIX GitHub at line 142 of file Units.hpp

constexpr double Acts::UnitConstants::km = 1e6

Definition at line 96 of file Units.hpp.

View newest version in sPHENIX GitHub at line 96 of file Units.hpp

constexpr double Acts::UnitConstants::m = 1e3

Definition at line 95 of file Units.hpp.

View newest version in sPHENIX GitHub at line 95 of file Units.hpp

Referenced by HelixKalman::addHit(), HelixKalmanFilter::addHit(), genfit::KalmanFitterInfo::addMeasurementsOnPlane(), PHG4TruthTrackingAction::AddParticle(), PHPy8ParticleTrigger::Apply(), Acts::bitsetToMatrix(), Acts::Test::BOOST_AUTO_TEST_CASE(), BOOST_DATA_TEST_CASE(), KFParticle_eventReconstruction::buildChain(), CylinderKalman::calculateMeasurements(), HelixKalmanFilter::calculateMeasurements(), GFDaf::calcWeights(), genfit::Track::checkConsistency(), Rossegger::CheckZeroes(), PHTruthTrackSeeding::circleFitSeed(), PHActsSiliconSeeding::circleFitSeed(), CloneMeshes(), CMDistortionAnalysis(), CMDistortionAnalysisCart(), CMDistortionAnalysisPhiR(), eASTDetectorConstruction::Construct(), G4EicDircDetector::ConstructMe(), genfit::SpacepointMeasurement::constructMeasurementsOnPlane(), genfit::Track::constructTrackCand(), Fun4AllOscarInputManager::ConvertFromOscar(), Fun4AllHepMCInputManager::ConvertFromOscar(), CreateBoundaryLayer(), CreateDualGraph(), CreateInverseTopology(), CreateKnotsExtruded(), Acts::Sycl::createSeedsForGroupSycl(), Packet_starscaler::decode(), G4EicDircDetector::DefineMaterials(), PHG4Reco::DefineMaterials(), dmatrix(), Acts::Frustum< value_t, DIM, SIDES >::draw(), genfit::EventDisplay::drawEvent(), CbmRichGeoTest::DrawH1andFit(), CbmRichGeoTest::DrawH3(), CbmRichEventDisplay::DrawOnePmtPlane(), Packet_gl1_evclocks::dump(), Packet_gl1p::dump(), Packet_gl1::dump(), Rossegger::Er(), Rossegger::Er_(), Extract_ATHENA_gdml(), Rossegger::Ez(), Rossegger::Ez_(), Acts::fieldMapperXYZ(), eicpy.qaplots.TrackHists::fill(), Rossegger::FindBetamn(), Gammaavectormeson::fourBodyDecay(), GFKalman::getChi2Hit(), PHG4SteppingAction::GetLightCorrection(), PHSimpleVertexFinder::getMedian(), PHSiliconTpcTrackMatching::getMedian(), FairGeoSet::getModule(), PHG4ForwardDualReadoutDetector::GetPMMAMaterial(), GFTrack::getResiduals(), PHG4ForwardDualReadoutDetector::GetScintillatorMaterial(), GFTools::getSmoothedChiSqu(), PHG4TpcCentralMembrane::getStripeID(), PHG4ForwardEcalDetector::GetWLSFiberFEMCMaterial(), PHG4LFHcalDetector::GetWLSFiberMaterial(), nlohmann::detail::dtoa_impl::grisu2_digit_gen(), half::half(), halfToFloat(), hijfst_(), imatrix(), Acts::detail::make_projection_matrix< columns, i, N...>::init(), HcalRawTowerBuilder::InitRun(), half::isDenormalized(), half::isInfinity(), half::isNan(), Rossegger::LoadZeroes(), main(), nanoflann::PooledAllocator::malloc(), matrix(), MirrorMeshes(), ActsFatras::BetheBloch::operator()(), Gammaavectormeson::pickwEgamq2(), Rossegger::PrecalcDerivedConstants(), Rossegger::PrecalcFreeConstants(), GFBookkeeping::Print(), eASTMagneticFieldMap::PrintFieldValue(), PHHepMCParticleSelectorDecayProductChain::process_event(), ReadEICFiles::process_event(), PHG4SimpleEventGenerator::process_event(), CellularAutomaton_v1::process_single_track(), CellularAutomaton_v1::process_single_triplet(), GFKalman::processHit(), genfit::KalmanFitterRefTrack::processTrackPoint(), genfit::KalmanFitterRefTrack::processTrackPointSqrt(), twoPhotonLuminosity::radmul(), FairGeoSet::read(), FairDetParAsciiFileIo::readComment(), FairGenericParAsciiFileIo::readData(), Rossegger::Rmn(), Rossegger::Rmn1(), Rossegger::Rmn2(), Rossegger::SaveZeroes(), PHSiliconTruthTrackSeeding::set_min_momentum(), PHTruthTrackSeeding::set_min_momentum(), PHG4CylinderCellGeom_Spacalv1::set_tower_z_ID_eta_bin_map(), nBodyPhaseSpaceGen::setDecay(), point_t::setEdgeIndex(), surface_t::setEdgeIndex(), surface_t::setElementIndex(), PndStack::SetGeneratorFlags(), FairGeoSet::setMasterNodes(), Pythia6::SetMDCY(), Pythia6::SetMDME(), genfit::KalmanFitterInfo::setMeasurementsOnPlane(), Pythia6::SetMSTJ(), element_t::setNodeIndex(), FairIon::SetParams(), edge_t::setPointIndex(), edge_t::setSurfaceIndex(), PndTrackCand::setTrackSeed(), Acts::EventDataView3DTest::testMultiTrajectory(), tetrahedralize(), tofBarrel::tof(), genfit::TrackPoint::TrackPoint(), and tetgenmesh::unifysegments().

constexpr double Acts::UnitConstants::m2 = m * m
constexpr double Acts::UnitConstants::m3 = m * m * m

Definition at line 108 of file Units.hpp.

View newest version in sPHENIX GitHub at line 108 of file Units.hpp

Referenced by PHG4Reco::DefineMaterials(), and FairGeanePro::Track3ToPoint().

constexpr double Acts::UnitConstants::min = 60.0 * s

Definition at line 116 of file Units.hpp.

View newest version in sPHENIX GitHub at line 116 of file Units.hpp

constexpr double Acts::UnitConstants::mm = 1.0

Definition at line 93 of file Units.hpp.

View newest version in sPHENIX GitHub at line 93 of file Units.hpp

Referenced by MatchCandidateGroup::AddCandidate(), ActsExamples::Options::addDD4hepOptions(), AddLayers_MiniTPCDrift(), MatchCandidate::Ambiguity(), Acts::IntegrationTest::atlasBField(), PHG4GDMLWriteParamvol::Box_dimensionsWrite(), PHG4GDMLWriteSolids::BoxWrite(), PHG4TTLDetector::BuildBarrelTTL(), ActsExamples::Generic::buildDetector(), PHG4TTLDetector::BuildForwardTTL(), ActsExamples::TGeo::buildTGeoDetector(), PHG4TTLSteppingAction::CalculateSensorHitIndices(), HoughTree::CheckCell(), PHG4GDMLWriteParamvol::Cone_dimensionsWrite(), PHG4GDMLWriteSolids::ConeWrite(), PHG4EPDDetector::construct_block(), PHG4MicromegasDetector::construct_micromegas(), PHG4InnerHcalDetector::ConstructHcalSingleScintillators(), PHG4OuterHcalDetector::ConstructHcalSingleScintillators(), EICG4ZDCDetector::ConstructMe(), PHG4BeamlineMagnetDetector::ConstructMe(), PHG4EnvelopeDetector::ConstructMe(), EicFRichDetector::ConstructMe(), PHG4CylinderStripDetector::ConstructMe(), G4JLeicBeamLineMagnetDetector::ConstructMe(), PHG4ZDCDetector::ConstructMe(), PHG4ProjCrystalCalorimeterDetector::ConstructProjectiveCrystals(), PHG4LFHcalDetector::ConstructTower(), PHG4CrystalCalorimeterDetector::ConstructTower(), PHG4HybridHomogeneousCalorimeterDetector::ConstructTower(), PHG4ForwardDualReadoutDetector::ConstructTower(), PHG4ForwardEcalDetector::ConstructTower(), create_element(), EicMagneticFieldFromGradients::CreateYokeVolumes(), EicMagneticField::CreateYokeVolumes(), CTTLSetup(), PHG4GDMLWriteSolids::CutTubeWrite(), G4EicDircDetector::DefineMaterials(), eASTPhysicsList::eASTPhysicsList(), EICPhysicsList::EICPhysicsList(), PHG4GDMLWriteSolids::ElconeWrite(), PHG4GDMLWriteParamvol::Ellipsoid_dimensionsWrite(), PHG4GDMLWriteSolids::EllipsoidWrite(), PHG4GDMLWriteSolids::EltubeWrite(), ETTLSetup(), ExitWindowV2::ExitWindowV2(), PHG4ProjCrystalCalorimeterDetector::Fill4x4Unit(), PHG4ProjCrystalCalorimeterDetector::FillSpecialUnit(), FSTSetup(), FTTLSetup(), G4TBMagneticFieldSetup::G4TBMagneticFieldSetup(), eASTHepMC3Interface::GeneratePrimaryVertex(), PHG4GDMLWriteSolids::GenTrapWrite(), MatchCandidate::GetAliveMemberCount(), PHG4ProjCrystalCalorimeterDetector::GetCarbonFiberAdjustments(), PHG4ProjCrystalCalorimeterDetector::GetCarbonFiberSpacing(), EicMagneticFieldFromGradients::GetFieldSumValue(), EicMagneticField::GetFieldSumValue(), MatchCandidate::GetFirstAliveMember(), PHG4CylinderStripDetector::GetHollowBar(), HoughNodeGroup::GetMember(), PHG4ForwardDualReadoutDetector::GetQuartzMaterial(), PHG4mRICHDetector::LensPar::GetSagita(), PHG4LFHcalDetector::GetScintillatorMaterial(), PHG4ForwardDualReadoutDetector::GetScintillatorMaterial(), PHG4ForwardEcalDetector::GetScintillatorMaterial(), MatchCandidate::GetSelMember(), PHG4ForwardEcalDetector::GetWLSFiberFEMCMaterial(), PHG4LFHcalDetector::GetWLSFiberMaterial(), PHG4GDMLWriteParamvol::Hype_dimensionsWrite(), PHG4GDMLWriteSolids::HypeWrite(), EicMagneticFieldFromGradients::InitializeFieldGradients(), EicMagneticField::InitializeFieldMaps(), MatchCandidate::IsSubset(), HoughTree::IsSubset(), HoughTree::LaunchPatternFinder(), ActsExamples::HepMC3Event::lengthUnit(), PHG4mRICHDetector::LensPar::LensPar(), main(), make_barrel_pixel_layer(), make_forward_station_basic(), make_GEM_barrel_section(), make_LANL_FST_station(), EICG4LumiDetector::MakeTower(), Micromegas(), PHG4mRICHDetector::mRichParameter::mRichParameter(), OpDet::OpDet(), PHG4GDMLWriteParamvol::Orb_dimensionsWrite(), PHG4GDMLWriteSolids::OrbWrite(), PHG4GDMLWriteParamvol::Para_dimensionsWrite(), PHG4GDMLWriteSolids::ParaboloidWrite(), PHG4GDMLWriteSolids::ParaWrite(), PHG4CEmcTestBeamDetector::PHG4CEmcTestBeamDetector(), PHG4CylinderStripDetector::PHG4CylinderStripDetector(), PHG4EICMvtxDetector::PHG4EICMvtxDetector(), PHG4ForwardEcalDetector::PHG4ForwardEcalDetector(), PHG4MvtxDetector::PHG4MvtxDetector(), PndPidCorrelator::PndPidCorrelator(), PHG4GDMLWriteDefine::Position_vectorWrite(), BeamLineMagnetDetector::PostConstruction(), ActsExamples::CsvParticleReader::read(), ActsExamples::CsvPlanarClusterReader::read(), ActsExamples::Options::readBField(), ActsExamples::Options::readPythia8Options(), MatchCandidate::ResetMemberPtr(), FwdHoughTree::ResolveAmbiguitiesNg(), ActsExamples::RootBFieldWriter< bfield_t >::run(), PHG4GDMLWriteSolids::RZPointWrite(), EICPhysicsList::SetCuts(), MatchCandidate::SetInactive(), G4TBMagneticFieldSetup::SetStepper(), FwdHoughTree::SetupKalmanFilter(), eASTPhysicsList::SetupProcesses(), MatchCandidate::ShapeItUpForInspection(), MatchCandidate::SiamGroupCandidate(), PHG4GDMLWriteParamvol::Sphere_dimensionsWrite(), PHG4GDMLWriteSolids::SphereWrite(), surface(), PHG4GDMLWriteParamvol::Torus_dimensionsWrite(), PHG4GDMLWriteSolids::TorusWrite(), PHG4GDMLWriteParamvol::Trap_dimensionsWrite(), PHG4GDMLWriteSolids::TrapWrite(), PHG4GDMLWriteParamvol::Trd_dimensionsWrite(), PHG4GDMLWriteSolids::TrdWrite(), PHG4GDMLWriteParamvol::Tube_dimensionsWrite(), PHG4GDMLWriteSolids::TubeWrite(), PHG4GDMLWriteSolids::TwistedboxWrite(), PHG4GDMLWriteSolids::TwistedtrapWrite(), PHG4GDMLWriteSolids::TwistedtrdWrite(), PHG4GDMLWriteSolids::TwistedtubsWrite(), ActsExamples::SteppingAction::UserSteppingAction(), ActsExamples::TrackFinderPerformanceWriter::Impl::write(), ActsExamples::BField::writeField(), ActsExamples::CsvParticleWriter::writeT(), ActsExamples::RootParticleWriter::writeT(), ActsExamples::RootSimHitWriter::writeT(), ActsExamples::CsvPlanarClusterWriter::writeT(), PHG4GDMLWriteSolids::XtruWrite(), and PHG4GDMLWriteSolids::ZplaneWrite().

constexpr double Acts::UnitConstants::mm2 = mm * mm

Definition at line 102 of file Units.hpp.

View newest version in sPHENIX GitHub at line 102 of file Units.hpp

Referenced by PHG4mRICHDetector::LensPar::GetSagita().

constexpr double Acts::UnitConstants::mm3 = mm * mm * mm

Definition at line 106 of file Units.hpp.

View newest version in sPHENIX GitHub at line 106 of file Units.hpp

Referenced by PHG4mRICHDetector::LensPar::GetSagita(), and ActsExamples::SteppingAction::UserSteppingAction().

constexpr double Acts::UnitConstants::mol = 1.0

Definition at line 144 of file Units.hpp.

View newest version in sPHENIX GitHub at line 144 of file Units.hpp

constexpr double Acts::UnitConstants::mrad = 1e-3

Definition at line 119 of file Units.hpp.

View newest version in sPHENIX GitHub at line 119 of file Units.hpp

constexpr double Acts::UnitConstants::ms = 1e-3 * s

Definition at line 115 of file Units.hpp.

View newest version in sPHENIX GitHub at line 115 of file Units.hpp

Referenced by tetgenmesh::meshcoarsening(), tetgenmesh::recoverboundary(), and PHRaveVertexing::TranslateSvtxToGenFitTrack().

constexpr double Acts::UnitConstants::pm = 1e-9

Definition at line 90 of file Units.hpp.

View newest version in sPHENIX GitHub at line 90 of file Units.hpp

Referenced by FairGeoNode::calcModuleTransform(), TrKalmanFilter::CalculateHMatrix(), InitPlugin(), and PHG4RICHSteppingAction::UserSteppingAction().

constexpr double Acts::UnitConstants::ps = 1e-12 * s

Definition at line 112 of file Units.hpp.

View newest version in sPHENIX GitHub at line 112 of file Units.hpp

Referenced by Acts::Test::BOOST_AUTO_TEST_CASE(), and ActsExamples::DigitizationAlgorithm::execute().

constexpr double Acts::UnitConstants::rad = 1.0

Definition at line 120 of file Units.hpp.

View newest version in sPHENIX GitHub at line 120 of file Units.hpp

Referenced by PHG4EICMvtxDetector::AddGeometryNode(), PHG4MvtxDetector::AddGeometryNode(), PHG4InttDetector::AddGeometryNode(), PHG4mRICHDetector::build_mRICH_wall_eside_proj(), PHG4OuterHcalDetector::CheckTiltAngle(), PHG4InnerHcalDetector::CheckTiltAngle(), PHG4FullProjTiltedSpacalDetector::Construct_AzimuthalSeg(), PHG4FullProjSpacalDetector::Construct_AzimuthalSeg(), PHG4FullProjTiltedSpacalDetector::Construct_LightGuide(), PHG4FullProjTiltedSpacalDetector::Construct_Tower(), PHG4FullProjSpacalDetector::Construct_Tower(), PHG4OuterHcalDetector::ConstructHcalSingleScintillators(), PHG4InnerHcalDetector::ConstructInnerHcal(), PHG4InttDetector::ConstructIntt(), G4Example01Detector::ConstructMe(), EICG4RPDetector::ConstructMe(), G4Example02Detector::ConstructMe(), EICG4ZDCDetector::ConstructMe(), G4Example03Detector::ConstructMe(), PHG4CEmcTestBeamDetector::ConstructMe(), G4EicDircDetector::ConstructMe(), EICG4LumiDetector::ConstructMe(), PHG4OuterHcalDetector::ConstructOuterHcal(), PHG4ProjCrystalCalorimeterDetector::ConstructProjectiveCrystals(), PHG4InnerHcalDetector::ConstructScintillatorBox(), PHG4OuterHcalDetector::ConstructScintillatorBox(), PHG4InnerHcalDetector::ConstructSteelPlate(), PHG4OuterHcalDetector::ConstructSteelPlate(), PHG4HybridHomogeneousCalorimeterDetector::ConstructSupportFrame(), PHG4ForwardDualReadoutDetector::ConstructTower(), PHG4ForwardDualReadoutDetector::ConstructTowerFCStyle(), PHG4CEmcTestBeamDetector::ConstructTowerVolume(), create_element(), CreateKnotsExtruded(), CylinderCoordinates(), CylindricalCoordinateCurve(), ExitWindowV2::ExitWindowV2(), PHG4ProjCrystalCalorimeterDetector::Fill4x4Unit(), PHG4ProjCrystalCalorimeterDetector::FillSpecialUnit(), TrkrClusterv1::getPhiError(), TrkrClusterv2::getPhiError(), PHG4ForwardHcalDetector::ParseParametersFromTable(), PHG4EICForwardEcalDetector::ParseParametersFromTable(), PHG4BackwardHcalDetector::ParseParametersFromTable(), PHG4LFHcalDetector::ParseParametersFromTable(), PHG4CrystalCalorimeterDetector::ParseParametersFromTable(), PHG4HybridHomogeneousCalorimeterDetector::ParseParametersFromTable(), PHG4ForwardEcalDetector::ParseParametersFromTable(), PHG4OuterHcalDetector::SetTiltViaNcross(), and PHG4InnerHcalDetector::SetTiltViaNcross().

constexpr double Acts::UnitConstants::s = 299792458000.0

Definition at line 110 of file Units.hpp.

View newest version in sPHENIX GitHub at line 110 of file Units.hpp

Referenced by AddFlowToParent(), CylindricalHough::addHits(), AddLayers_MiniTPCDrift(), ALICEKF::ALICEKalmanFilter(), dfe::SmallVector< T, N, Allocator >::allocate_storage(), approx(), Acts::Test::BOOST_AUTO_TEST_CASE(), BOOST_DATA_TEST_CASE(), mesh_t::boundingBox(), erhic::Pythia6EventBuilder::BuildEvent(), HelixKalman::calculate_dAdAp(), HelixKalmanFilter::calculate_dAdAp(), CylinderKalman::calculate_dxda(), HelixKalmanFilter::calculate_dxda(), HelixHoughFuncs_v1::calculate_dzdl_range(), HelixDCAFunc::calcValGradHessian(), erhic::JacquetBlondelComputer::ComputeX(), erhic::DoubleAngleComputer::ComputeX(), oamlBuffer::connect_aml(), FairGeoInterface::connectInput(), tetgenmesh::constraineddelaunay(), nlohmann::detail::external_constructor< value_t::string >::construct(), PHG4FullProjTiltedSpacalDetector::Construct_AzimuthalSeg(), PHG4Sector::PHG4SectorConstructor::Construct_Sectors(), ConvertEgTypeToMeshType(), Smear::Acceptance::CustomCut::CustomCut(), kdfinder::Helix< T >::cx(), kdfinder::Helix< T >::cy(), oncsSub_idcaenv1742::decode(), oncsSub_idtpcfeev1::decode(), oncsSub_idfnalmwpc::decode(), oncsSub_idfnalmwpcv2::decode(), FairGeoRotation::diff2(), DISJacquetBlondel(), Acts::FiniteStateMachine< fsm2, states::Disconnected, states::Connected >::dispatch(), GFDetPlane::distance(), CbmRichGeoTest::DrawH1andFit(), CbmRichGeoTest::DrawH3(), oncsSub_iddigitizerv1::dump(), Packet_iddigitizerv2::dump(), oncsSub_idtpcfeev1::dump(), oncsSub_idtpcfeev2::dump(), nlohmann::basic_json::dump(), HelixHough::dzdlRange_sse(), nlohmann::json_pointer< BasicJsonType >::escape(), FairRegistry::FairRegistry(), tetgenmesh::farsdest(), tetgenmesh::farsorg(), Acts::Legacy::AtlasSeedfinder< SpacePoint >::fillSeeds(), kdfinder::find_vertex_seeds(), tetgenmesh::finddirection(), genfit::TGeoMaterialInterface::findNextBoundary(), erhic::EventFromAsciiFactory< T >::FinishEvent(), fit_all_update(), SimpleTrack3D::fit_track(), ZHough_Cylindrical::fitTrack(), VtxTrackFinder::fitTrack(), ThreeHitSeedGrower::fitTrack(), NHitSeedFinder::fitTrack(), FourHitSeedFinder::fitTrack(), sPHENIXTrackerTpc::fitTrack(), sPHENIXTracker::fitTrack(), sPHENIXSeedFinder::fitTrack(), msg_buffer::format(), kdfinder::Helix< T >::fudgePathLength(), PHG4Sector::Sector_Geometry::get_max_R(), PHTpcTrackFollower::get_projected_coordinate(), nlohmann::detail::binary_reader< BasicJsonType, SAX >::get_ubjson_value(), FairGeoNode::getCopyNo(), GPUTPCTrackParam::GetDCAPoint(), MakeActsGeometry::getInttKeyFromNode(), MakeActsGeometry::getMvtxKeyFromNode(), genfit::GblFitter::getScattererFromMatList(), getScattererFromMatList(), kdfinder::CircleFit< T >::GradientHessian(), halfToFloat(), EicTpcDigiHitProducer::HandleHit(), initializeeventqa(), initializepidqabook(), tetgenmesh::insertpoint(), oncsSub_idsis3300::iValue(), oncsSub_idsis3300r::iValue(), CbmRichRingFitterEllipseTau::Jacobi(), nanoflann::KDTreeEigenMatrixAdaptor< MatrixType, DIM, Distance >::kdtree_distance(), kill_trailing(), kill_trailingn(), tetgenmesh::locate(), main(), FairRegistry::Merge(), Acts::Legacy::AtlasSeedfinder< SpacePoint >::newOneSeed(), FairRegistry::FairRegistryKey::operator()(), Acts::KalmanFitter< propagator_t, updater_t, smoother_t, outlier_finder_t, calibrator_t >::Actor< source_link_t, parameters_t >::operator()(), operator<<(), FairRegistry::operator=(), operator>>(), CommandLineArguments::parse(), Smear::FormulaString::Parse(), nlohmann::detail::binary_reader< BasicJsonType, SAX >::parse_cbor_internal(), nlohmann::detail::binary_reader< BasicJsonType, SAX >::parse_msgpack_internal(), kdfinder::Helix< T >::pathLength(), kdfinder::Helix< T >::pathLengths(), PHRTreeSeeding::phiadd(), Piston(), FairGeoShapes::printPoints(), beamBeamSystem::probabilityOfPhotonBreakup(), RawClusterBuilderTopo::process_event(), Acts::FiniteStateMachine< fsm2, states::Disconnected, states::Connected >::process_event(), sPHENIXTracker::projectToLayer(), sPHENIXSeedFinder::projectToLayer(), Nystrom::propagate(), Acts::Propagator< stepper_t, navigator_t >::propagate_impl(), FairDbConfDialog::Query(), ActsExamples::RootMaterialTrackReader::read(), FairGeoSet::read(), FairDetParAsciiFileIo::readComment(), FairGenericParAsciiFileIo::readData(), FairGeoAsciiIo::readDetectorSetup(), Smear::ParticleID::ReadP(), FairGeoShapes::readPoints(), tetgenmesh::recoverboundary(), FairDbConf::RegistryToString(), half::round(), erhic::Pythia6::Run(), mesh_t::save(), FairGeoShapes::selectShape(), EICG4dRICHHit::set_hit_subtype_name(), EICG4dRICHHit::set_hit_type_name(), PHSimpleKFProp::set_max_window(), EICG4dRICHHit::set_particle_name(), EICG4dRICHHit::set_process(), FairGeoMedia::setAuthor(), FairParSet::setAuthor(), FairGeoSet::setAuthor(), FairDetParTSQLIo::setChanged(), FairGeoMedia::setDescription(), FairParSet::setDescription(), FairGeoSet::setDescription(), FieldMapReadBack::SetFieldPoint(), erhic::EventPythia::SetHardS(), pmonstate::setloopStatus(), PHHybridSeeding::setMinFitTrackSize(), G4TBMagneticFieldSetup::SetMinStep(), FairGeoSet::setModules(), FairGeoVolume::setMother(), FairGeoVolume::setName(), FairGeoNode::setName(), ReadEICFiles::SetNodeName(), PndTrackArrayMerger::SetOutputBranch(), PHG4Reco::SetPhysicsList(), FairRtdbRun::setRefRun(), FairGeoVolume::setShape(), FairGeoNode::setShape(), FairGeoSet::setShapes(), erhic::EventPythia::SetSigRadCor(), Acts::FiniteStateMachine< fsm2, states::Disconnected, states::Connected >::setState(), genfit::Track::setStateSeed(), mesh_t::setSurfaceArray(), PHG4PhenixDetector::SetWorldMaterial(), PHG4Reco::SetWorldMaterial(), PHG4PhenixDetector::SetWorldShape(), PHG4Reco::SetWorldShape(), Acts::MultiIndex< uint64_t, 12, 12, 16, 8, 16 >::shift(), kdfinder::CircleFit< T >::SigmaWithLargeCircleOption(), kdfinder::TrackCandidate< T >::sign(), tetgenmesh::stdissolve(), strptime(), nlohmann::detail::to_json(), parameterbase::toString(), oncsSub_idtpcfeev2::tpc_decode(), trackProximity(), tetgenmesh::tsbond(), tetgenmesh::tspivot(), tetgenmesh::tsspivot1(), CylinderKalman::updateIntersection(), HelixKalmanFilter::updateIntersection(), updatePad(), parameterlist::validationKey(), FairGeoShapes::writePoints(), PHG4InnerHcalDetector::x_at_y(), and PHG4OuterHcalDetector::x_at_y().

constexpr double Acts::UnitConstants::T = 0.000299792458
constexpr double Acts::UnitConstants::u = 0.93149410242

Definition at line 129 of file Units.hpp.

View newest version in sPHENIX GitHub at line 129 of file Units.hpp

Referenced by ActsExamples::Options::addRandomNumbersOptions(), dfe::FlatSet< T, Compare, Container >::at(), ActsExamples::RootMaterialTrackReader::availableEvents(), ActsExamples::EventGenerator::availableEvents(), Acts::Test::BOOST_AUTO_TEST_CASE(), BOOST_AUTO_TEST_CASE(), ActsFatras::BOOST_AUTO_TEST_CASE(), BOOST_DATA_TEST_CASE(), Acts::Test::BOOST_DATA_TEST_CASE(), Acts::Test::BOOST_FIXTURE_TEST_CASE(), genfit::EventDisplay::boxCreator(), nlohmann::detail::binary_writer< BasicJsonType, CharType >::calc_bson_entry_header_size(), Acts::PassiveLayerBuilder::centralLayers(), tetgenmesh::checkseg4encroach(), checkSetGetPosMom(), Acts::AnnulusBounds::closestOnSegment(), Acts::BoundaryCheck::computeClosestPointOnPolygon(), Acts::computeEnergyLossBethe(), PHG4HcalDetector::ConstructMe(), genfit::SpacepointMeasurement::constructMeasurementsOnPlane(), dfe::FlatSet< T, Compare, Container >::contains(), nlohmann::detail::serializer< BasicJsonType >::count_digits(), ExitWindowV2::CreateOutput(), Acts::CartesianSegmentation::createSegmentationSurfaces(), nlohmann::detail::serializer< BasicJsonType >::decode(), Acts::GeometryHierarchyMapJsonConverter< value_t >::decodeIdentifier(), Acts::deriveEnergyLossBetheQOverP(), ActsExamples::determineEventFilesRange(), ActsExamples::Sequencer::determineEventsRange(), genfit::EventDisplay::drawEvent(), nlohmann::detail::serializer< BasicJsonType >::dump_escaped(), Acts::ElementFraction::ElementFraction(), Acts::MultiIndex< uint64_t, 12, 12, 16, 8, 16 >::Encode(), Acts::PassiveLayerBuilder::endcapLayers(), ActsExamples::TruthVertexFinder::execute(), ActsExamples::FatrasAlgorithm< simulator_t >::execute(), Acts::detail::grid_helper_impl< 0u >::exteriorBinIndices(), GeaneTrackRep::extrapolate(), LSLTrackRep::extrapolate(), nlohmann::detail::wide_string_input_helper< WideStringType, T >::fill_buffer(), nlohmann::detail::wide_string_input_helper< WideStringType, 2 >::fill_buffer(), dfe::FlatSet< T, Compare, Container >::find(), Acts::GeometryHierarchyMap< value_t >::find(), PHTimeStamp::formatTimeString(), ActsFatras::detail::GeneralMixture::gaussmix(), nlohmann::detail::lexer< BasicJsonType >::get_codepoint(), PHGenFitTrkFitter::get_rotation_matrix(), Acts::detail::grid_helper_impl< 0u >::getAxes(), Acts::detail::grid_helper_impl< 0u >::getBinCenter(), erhic::ParticleMC::GetChild(), Acts::detail::grid_helper_impl< 0u >::getGlobalBin(), Acts::detail::grid_helper_impl< 0u >::getLocalBinIndices(), Acts::detail::grid_helper_impl< 0u >::getLowerLeftBinEdge(), Acts::detail::grid_helper_impl< 0u >::getLowerLeftBinIndices(), Acts::detail::grid_helper_impl< 0u >::getMax(), Acts::detail::grid_helper_impl< 0u >::getMin(), Acts::detail::grid_helper_impl< 0u >::getNBins(), Acts::detail::grid_helper_impl< 0u >::getUpperRightBinEdge(), Acts::detail::grid_helper_impl< 0u >::getUpperRightBinIndices(), Acts::detail::grid_helper_impl< 0u >::getWidth(), Acts::CylinderVolumeHelper::glueTrackingVolumes(), kdfinder::CircleFit< T >::GradientHessian(), ActsExamples::identifyContributingParticles(), ActsExamples::SimMultiTrajectory::identifyMajorityParticle(), incircleadapt(), Acts::LineSurface::intersect(), genfit::DetPlane::isInActive(), Acts::detail::grid_helper_impl< 0u >::isInside(), main(), Acts::GeometryHierarchyMap< SourceLinkSelectorCuts >::makeHighestLevelMask(), Acts::MultiIndex< uint64_t, 12, 12, 16, 8, 16 >::makeLastDescendant(), Acts::GeometryHierarchyMap< SourceLinkSelectorCuts >::makeLeadingLevelsMask(), Acts::MultiIndex< uint64_t, 12, 12, 16, 8, 16 >::makeNextSibling(), PHGenFitTrkFitter::MakeSvtxTrack(), Acts::MultiIndex< uint64_t, 12, 12, 16, 8, 16 >::mask(), Acts::MaterialComposition::MaterialComposition(), Acts::BinnedSurfaceMaterial::materialSlab(), Acts::Test::CylindricalTrackingGeometry::modulePositionsCylinder(), MovePointPowerSeries(), MovePointPowerSeries2(), nlohmann::detail::dtoa_impl::diyfp::mul(), Acts::detail::grid_helper_impl< 0u >::neighborHoodIndices(), Acts::Legacy::AtlasSeedfinder< SpacePoint >::newOneSeedWithCurvaturesComparison(), nlohmann::detail::dtoa_impl::diyfp::normalize(), dfe::io_dsv_impl::NamedTupleDsvReader< Delimiter, NamedTuple >::num_records(), ActsExamples::detail::PrimaryVertexIdGetter::operator()(), ActsFatras::BetheHeitler::operator()(), ActsExamples::detail::SecondaryVertexIdGetter::operator()(), ActsExamples::Pythia8Generator::operator()(), ActsExamples::ParametricParticleGenerator::operator()(), orient2dadapt(), orient3dadapt(), nlohmann::detail::binary_reader< BasicJsonType, SAX >::parse_cbor_internal(), kdfinder::Helix< T >::pathLength(), PHG4TrackFastSim::PHG4HitToMeasurementCylinder(), B0TrackFastSim::PHG4HitToMeasurementCylinder(), PHG4TrackFastSim::PHG4HitToMeasurementVerticalPlane(), B0TrackFastSim::PHG4HitToMeasurementVerticalPlane(), PHGenFit::PlanarMeasurement::PlanarMeasurement(), Acts::SurfaceArray::SurfaceGridLookup< Axes >::populateNeighborCache(), Gammagammasingle::pp1(), Gammagammasingle::pp2(), Nystrom::propagate(), Gammaavectormeson::pTgamma(), genfit::tools::QR(), ActsFatras::LandauDistribution::quantile(), ActsFatras::Simulator< charged_selector_t, charged_simulator_t, neutral_selector_t, neutral_simulator_t >::renumberTailParticleIds(), kdfinder::rnd_gauss(), nlohmann::detail::lexer< BasicJsonType >::scan_string(), ActsExamples::selectLayer(), ActsExamples::selectVolume(), ActsFatras::detail::GeneralMixture::semigauss(), GFDetPlane::set(), genfit::DetPlane::set(), erhic::EventPythia::SetHardU(), CbmStripHit::SetU(), GFDetPlane::setU(), genfit::DetPlane::setU(), GFDetPlane::setUV(), genfit::DetPlane::setUV(), Acts::MultiIndex< uint64_t, 12, 12, 16, 8, 16 >::shift(), ActsFatras::Simulator< charged_selector_t, charged_simulator_t, neutral_selector_t, neutral_simulator_t >::simulate(), tetgenmesh::suppressbdrysteinerpoint(), Acts::AccumulatedMaterialSlab::trackAverage(), dfe::io_dsv_impl::DsvWriter< Delimiter >::write(), ActsExamples::TrackFinderPerformanceWriter::Impl::write(), nlohmann::detail::binary_writer< BasicJsonType, CharType >::write_bson_entry_header(), and Acts::MultiIndex< uint64_t, 12, 12, 16, 8, 16 >::Zeros().

constexpr double Acts::UnitConstants::us = 1e-6 * s

Definition at line 114 of file Units.hpp.

View newest version in sPHENIX GitHub at line 114 of file Units.hpp

Referenced by Acts::MultiIndex< uint64_t, 12, 12, 16, 8, 16 >::Encode().