ECCE @ EIC Software
Reference for
ECCE @ EIC
simulation and reconstruction software on GitHub
|
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 |
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:
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.
To ensure consistent computations and results the following guidelines must be followed when handling physical quantities with units:
double momentum = 100.0; // momentum is stored as native unit GeV double momentumInMeV = 10.0; // would be 0.01 in native units
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.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; // 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().x() / 1_mm; double pt_in_TeV = trackPars.momentum().pT() / 1_TeV;
constexpr double Acts::UnitConstants::C = 1.602176634e19 |
constexpr double Acts::UnitConstants::cm = 10.0 |
Definition at line 92 of file Units.hpp.
View newest version in sPHENIX GitHub at line 92 of file Units.hpp
Referenced by PHTpcResiduals::addTrackState(), PHTpcResiduals::calculateTpcResiduals(), Acts::DD4hepLayerBuilder::centralLayers(), Acts::DD4hepLayerBuilder::convertTransform(), PHSiliconTpcTrackMatching::correctTpcClusterZ(), PHActsVertexFitter::createActsSvtxVertex(), Acts::DD4hepLayerBuilder::createSensitiveSurface(), PHActsToSvtxTracks::createSvtxTrack(), Acts::DD4hepLayerBuilder::endcapLayers(), DSTEmulator::evaluate_tracks(), ActsEvaluator::evaluateTrackFits(), ActsEvaluator::fillG4Particle(), ActsTransformations::fillSvtxTrackStates(), PHActsVertexFinder::fillVertexMap(), PHActsInitialVertexFinder::fillVertexMap(), ActsTransformations::getGlobalPosition(), ActsEvaluator::getGlobalTruthHit(), PHActsSiliconSeeding::getMvtxSpacePoints(), PHActsTrkFitter::getSourceLinks(), PHActsInitialVertexFinder::getTrackPointers(), PHActsVertexPropagator::getVertex(), PHActsTrackProjection::getVertex(), PHActsTrkFitter::loopTracks(), PHActsTrackProjection::makeCaloSurfacePtrs(), MakeActsGeometry::makeMmMapPairs(), PHTpcResiduals::makeSourceLink(), PHActsSiliconSeeding::makeSvtxTracks(), PHActsVertexFitter::makeTrackParam(), PHActsTrackProjection::makeTrackParams(), PHTpcResiduals::makeTrackParams(), PHTpcClusterMover::process_event(), PHTpcResiduals::propagateTrackState(), ActsTransformations::rotateActsCovToSvtxTrack(), ActsTransformations::rotateSvtxTrackCovToActs(), PHActsVertexPropagator::updateSvtxTrack(), PHActsTrkFitter::updateSvtxTrack(), PHActsVertexFitter::updateSvtxVertex(), and Acts::volumeBuilder_dd4hep().
Definition at line 101 of file Units.hpp.
View newest version in sPHENIX GitHub at line 101 of file Units.hpp
Referenced by PHActsVertexFitter::createActsSvtxVertex(), PHActsVertexFinder::fillVertexMap(), PHActsInitialVertexFinder::fillVertexMap(), PHActsSiliconSeeding::getMvtxSpacePoints(), PHActsTrkFitter::getSourceLinks(), PHTpcResiduals::makeSourceLink(), ActsTransformations::rotateActsCovToSvtxTrack(), ActsTransformations::rotateSvtxTrackCovToActs(), and PHActsVertexFitter::updateSvtxVertex().
constexpr double Acts::UnitConstants::degree = 0.017453292519943295 |
constexpr double Acts::UnitConstants::e = 1.0 |
Definition at line 135 of file Units.hpp.
View newest version in sPHENIX GitHub at line 135 of file Units.hpp
Referenced by ActsFatras::findCharge(), PHActsInitialVertexFinder::getTrackPointers(), PHActsVertexFitter::makeTrackParam(), PHTpcResiduals::makeTrackParams(), FW::CsvParticleReader::read(), FW::TrackFinderPerformanceWriter::Impl::write(), FW::CsvParticleWriter::writeT(), and FW::RootParticleWriter::writeT().
constexpr double Acts::UnitConstants::eV = 1e-9 |
constexpr double Acts::UnitConstants::fm = 1e-12 |
Definition at line 87 of file Units.hpp.
View newest version in sPHENIX GitHub at line 87 of file Units.hpp
Referenced by G4EmModelActivator::ActivatePAI(), G4VMultipleScattering::AddEmModel(), G4VEmProcess::AddEmModel(), Acts::Test::BOOST_AUTO_TEST_CASE(), G4hPairProductionModel::ComputeDMicroscopicCrossSection(), G4MuPairProductionModel::ComputeDMicroscopicCrossSection(), MuCrossSections::CRP_Mephi(), G4VEnergyLossProcess::GetDEDXDispersion(), G4ExcitedXiConstructor::GetMass(), G4ePolarizedBremsstrahlung::InitialiseEnergyLossProcess(), G4LDMBremsstrahlung::InitialiseEnergyLossProcess(), G4hPairProduction::InitialiseEnergyLossProcess(), G4hBremsstrahlung::InitialiseEnergyLossProcess(), G4ePairProduction::InitialiseEnergyLossProcess(), G4MuPairProduction::InitialiseEnergyLossProcess(), G4eBremsstrahlung::InitialiseEnergyLossProcess(), G4MuBremsstrahlung::InitialiseEnergyLossProcess(), Acts::Test::make_trackstate(), G4EmConfigurator::PrepareModels(), and G4WentzelOKandVIxSection::SampleSingleScattering().
constexpr double Acts::UnitConstants::fs = 1e-15 * s |
Definition at line 109 of file Units.hpp.
View newest version in sPHENIX GitHub at line 109 of file Units.hpp
Referenced by G4INCL::Nucleus::computeOneNucleonRecoilKinematics(), G4CascadeFinalStateAlgorithm::Configure(), G4INCL::Nucleus::decayInsideDeltas(), G4INCL::Nucleus::decayInsideStrangeParticles(), G4INCL::Nucleus::decayOutgoingDeltas(), G4INCL::Nucleus::decayOutgoingNeutralKaon(), G4INCL::Nucleus::decayOutgoingPionResonances(), G4INCL::Nucleus::decayOutgoingSigmaZero(), FileFound(), PHGenFit2::Track::get_chi2(), PHGenFit::Track::get_chi2(), PHGenFit2::Track::get_ndf(), PHGenFit::Track::get_ndf(), G4INCL::IChannel::getFinalState(), G4INCL::IAvatar::getFinalState(), main(), G4INCL::INCL::makeCompoundNucleus(), and PHRaveVertexing::TranslateSvtxToGenFitTrack().
constexpr double Acts::UnitConstants::g = 1.0 / 1.782662e-24 |
Definition at line 132 of file Units.hpp.
View newest version in sPHENIX GitHub at line 132 of file Units.hpp
Referenced by __attribute__(), G4ESTARStopping::AddData(), CCalMaterialFactory::addElement(), G4Element::AddIsotope(), RE06DetectorConstruction::AddMaterial(), G4GMocrenFileSceneHandler::AddSolid(), G4GDMLReadMaterials::AtomRead(), G4GDMLWriteMaterials::AtomWrite(), PHG4GDMLWriteMaterials::AtomWrite(), G4RDeIonisationSpectrum::AverageEnergy(), Acts::Test::BOOST_AUTO_TEST_CASE(), ExN04CalorimeterROGeometry::Build(), PHG4TTLDetector::BuildBarrelTTL(), G4NistElementBuilder::BuildElement(), G4PenelopeRayleighModel::BuildFormFactorTable(), PHG4TTLDetector::BuildForwardTTL(), G4tgbMaterialMixtureByVolume::BuildG4Material(), G4tgbMaterialMixtureByWeight::BuildG4Material(), G4tgbMaterialMixtureByNoAtoms::BuildG4Material(), CML2AccSaturn::buildMaterial_Kapton(), CML2AccSaturn::buildMaterial_SSteel(), CML2Acc1::buildMaterial_SSteel1(), CML2AccSaturn::buildMaterial_WNICU(), CML2AccSaturn::buildMaterial_XC10(), PHG4CylinderStripDetector::BuildMaterials(), DicomDetectorConstruction::BuildMaterialWithChangingDensity(), G4IonStoppingData::BuildPhysicsVector(), G4PenelopeBremsstrahlungFS::BuildScaledXSTable(), G4UnitDefinition::BuildUnitsTable(), G4PenelopeBremsstrahlungAngular::CalculateEffectiveZ(), G4ErrorFreeTrajState::CalculateEffectiveZandA(), VertexFitFunc::calcValGradHessian(), CellParameterisation::CellParameterisation(), G4ProductionCutsTable::CheckMaterialInfo(), G03ColorReader::ColorRead(), G03ColorWriter::ColorWrite(), G4EmCalculator::ComputeCrossSectionPerAtom(), G4AtimaEnergyLossModel::ComputeDEDXPerVolume(), G4TablesForExtrapolator::ComputeElectronDEDX(), G4TablesForExtrapolator::ComputeMuonDEDX(), G4TablesForExtrapolator::ComputeProtonDEDX(), GFlashSamplingShowerParameterisation::ComputeZAX0EFFetc(), Construct(), Materials::Construct(), H02DetectorConstruction::Construct(), G4MIRDLeftLegBone::Construct(), G4MIRDLiver::Construct(), G4MIRDRightKidney::Construct(), G4MIRDRightScapula::Construct(), G4MIRDBrain::Construct(), G4MIRDHeart::Construct(), G4MIRDLeftAdrenal::Construct(), G4MIRDLeftArmBone::Construct(), G4MIRDLeftClavicle::Construct(), G4MIRDLeftKidney::Construct(), G4MIRDLeftLeg::Construct(), G4MIRDLeftLung::Construct(), G4MIRDLeftOvary::Construct(), G4MIRDLeftTeste::Construct(), G4MIRDLeftScapula::Construct(), G4MIRDLowerLargeIntestine::Construct(), G4MIRDMaleGenitalia::Construct(), G4MIRDPelvis::Construct(), G4MIRDRightAdrenal::Construct(), G4MIRDRightClavicle::Construct(), G4MIRDRightLeg::Construct(), G4MIRDRightLegBone::Construct(), MyMaterials::Construct(), QMaterials::Construct(), G4MIRDSkull::Construct(), G4MIRDSmallIntestine::Construct(), G4MIRDThyroid::Construct(), G4MIRDUpperLargeIntestine::Construct(), B03DetectorConstruction::Construct(), G4MIRDHead::Construct(), G4MIRDLeftBreast::Construct(), RE01DetectorConstruction::Construct(), G4MIRDMiddleLowerSpine::Construct(), G4MIRDPancreas::Construct(), G4MIRDRibCage::Construct(), G4MIRDRightBreast::Construct(), G4MIRDRightLung::Construct(), G4MIRDRightOvary::Construct(), G4MIRDRightTeste::Construct(), G4MIRDSpleen::Construct(), G4MIRDStomach::Construct(), G4MIRDThymus::Construct(), G4MIRDTrunk::Construct(), G4MIRDUpperSpine::Construct(), G4MIRDUterus::Construct(), ExP02DetectorConstruction::Construct(), G4MIRDRightArmBone::Construct(), G4MIRDUrinaryBladder::Construct(), B01DetectorConstruction::Construct(), B02DetectorConstruction::Construct(), GeometryConstruction::Construct(), OpNoviceDetectorConstruction::Construct(), ExN01DetectorConstruction::Construct(), STCyclotronDetectorConstruction::Construct(), eRositaDetectorConstruction::Construct(), ExN02DetectorConstruction::Construct(), ExP01DetectorConstruction::Construct(), CML2Ph_BoxInBox::Construct(), XrayTelDetectorConstruction::Construct(), GammaKnifeDetectorConstruction::ConstructBeamLine(), XrayTelDetectorConstruction::ConstructFocalPlane(), DetectorConstruction::ConstructMaterials(), PHG4ECAPToFDetector::ConstructMe(), PHG4TRDDetector::ConstructMe(), PHG4BbcDetector::ConstructMe(), G4EmDNAChemistry::ConstructMolecule(), G4EmDNAChemistry_option1::ConstructMolecule(), G4EmDNAChemistry_option2::ConstructMolecule(), UltraDetectorConstruction::ConstructTableMaterials(), XrayTelDetectorConstruction::ConstructTelescope(), PHG4ForwardHcalDetector::ConstructTower(), G4VRangeToEnergyConverter::Convert(), MuCrossSections::CR_PerAtom(), PHG4MicromegasDetector::create_materials(), F04Materials::CreateMaterials(), WLSMaterials::CreateMaterials(), XrayFluoNistMaterials::CreateMaterials(), G4EzWorld::CreateWorld(), csz__huft_build(), G4HumanPhantomMaterial::DefineMaterials(), ExN04DetectorConstruction::DefineMaterials(), BrachyMaterial::DefineMaterials(), RE05DetectorConstruction::DefineMaterials(), B3DetectorConstruction::DefineMaterials(), ElectronBenchmarkDetector::DefineMaterials(), GB03DetectorConstruction::DefineMaterials(), B4cDetectorConstruction::DefineMaterials(), B4dDetectorConstruction::DefineMaterials(), RE06DetectorConstruction::DefineMaterials(), B4DetectorConstruction::DefineMaterials(), FFDetectorConstruction::DefineMaterials(), doiPETDetectorConstruction::DefineMaterials(), DetectorConstruction::DefineMaterials(), RMC01DetectorConstruction::DefineMaterials(), LXeDetectorConstruction::DefineMaterials(), G4EicDircDetector::DefineMaterials(), F02DetectorConstruction::DefineMaterials(), F01DetectorConstruction::DefineMaterials(), PHG4Reco::DefineMaterials(), F03DetectorConstruction::DefineMaterials(), ExN03DetectorConstruction::DefineMaterials(), PurgMagDetectorConstruction::DefineMaterials(), GammaRayTelDetectorConstruction::DefineMaterials(), G4DamagedDeoxyribose::Definition(), G4DamagedAdenine::Definition(), G4H3O::Definition(), G4Electron_aq::Definition(), G4H2::Definition(), G4H2O::Definition(), G4H2O2::Definition(), G4Hydrogen::Definition(), G4OH::Definition(), G4DamagedGuanine::Definition(), G4DamagedThymine::Definition(), G4DamagedCytosine::Definition(), G4Deoxyribose::Definition(), G4Phosphate::Definition(), G4Adenine::Definition(), G4Guanine::Definition(), G4Thymine::Definition(), G4Cytosine::Definition(), G4ModifiedHistone::Definition(), G4Histone::Definition(), EICG4dRICHAerogel::Density(), EICG4dRICHAerogel::density2refIndex(), G4AdjointhIonisationModel::DiffCrossSectionPerAtomPrimToSecond(), G4AtimaFluctuations::Dispersion(), G4GDMLReadMaterials::DRead(), G4EmSaturation::DumpBirksCoefficients(), G4tgbGeometryDumper::DumpElement(), G4NistMaterialBuilder::DumpElm(), G4tgbGeometryDumper::DumpIsotope(), G4tgbGeometryDumper::DumpMaterial(), G4NistMaterialBuilder::DumpMix(), G4GDMLWriteMaterials::DWrite(), PHG4GDMLWriteMaterials::DWrite(), EicFRichDetector::element_material(), HistoManager::EndOfRun(), FCALMaterialConsultant::FCALMaterialConsultant(), CCalMaterialFactory::findMaterial(), G4DNAElectronHoleRecombination::FindReactant(), G4Element::G4Element(), G4gsmate(), G4gsmixt(), G4Material::G4Material(), G4mplIonisationModel::G4mplIonisationModel(), G4mplIonisationWithDeltaModel::G4mplIonisationWithDeltaModel(), G4tgrElementSimple::G4tgrElementSimple(), G4tgrIsotope::G4tgrIsotope(), G4tgrMaterialMixture::G4tgrMaterialMixture(), G4tgrMaterialSimple::G4tgrMaterialSimple(), kdfinder::get_track_color(), PHG4CrystalCalorimeterDetector::GetCarbonFiber(), PHG4HybridHomogeneousCalorimeterDetector::GetCarbonFiber(), PHG4BarrelEcalDetector::GetCarbonFiber(), PHG4LFHcalDetector::GetCoatingMaterial(), PHG4ForwardEcalDetector::GetCoatingMaterial(), GVFlashShowerParameterisation::GetEffA(), G3EleTable::GetEle(), G4PAIxSection::GetElectronRange(), G4QAOLowEnergyLoss::GetOscillatorEnergy(), PHG4ForwardDualReadoutDetector::GetPMMAMaterial(), PHG4ForwardDualReadoutDetector::GetQuartzMaterial(), PHG4BarrelEcalDetector::GetSciGlass(), PHG4LFHcalDetector::GetScintillatorMaterial(), PHG4HybridHomogeneousCalorimeterDetector::GetScintillatorMaterial(), PHG4ForwardDualReadoutDetector::GetScintillatorMaterial(), PHG4ForwardEcalDetector::GetScintillatorMaterial(), HadrontherapyInteractionParameters::GetStoppingTable(), PHG4HybridHomogeneousCalorimeterDetector::GetTedlarMaterial(), PHG4HybridHomogeneousCalorimeterDetector::GetVM2000Material(), PHG4ForwardEcalDetector::GetWLSFiberFEMCMaterial(), PHG4LFHcalDetector::GetWLSFiberMaterial(), kdfinder::CircleFit< T >::GradientHessian(), G4NistMaterialBuilder::HepAndNuclearMaterials(), DicomDetectorConstruction::InitialisationOfMaterials(), Materials::Initialise(), G03DetectorConstruction::ListOfMaterials(), G02DetectorConstruction::ListOfMaterials(), G4MuonVDNuclearModel::MakeSamplingTable(), EICG4LumiDetector::MakeTower(), EICG4ZDCStructure::Materials(), MCGIDI_energy_parseGeneralEvaporationFromTOM(), NeuronLoadDataFile::NeuralNetworkDATAfile(), operator<<(), kdfinder::Helix< T >::pathLengths(), G4IonDEDXHandler::PrintDEDXTable(), G4IonParametrisedLossModel::PrintDEDXTable(), G4RDeIonisationSpectrum::Probability(), G4ErrorFreeTrajState::PropagateErrorMSC(), ptwXY_groupThreeFunctions(), ptwXY_groupTwoFunctions(), ptwXY_unitbaseInterpolate(), CCalVisualisable::readFile(), CCalMaterialFactory::readMaterials(), DicomPartialDetectorConstruction::ReadVoxelDensitiesPartial(), G4PropagatorInField::ReportLoopingParticle(), G4VEmissionProbability::SampleEnergy(), G4RDeIonisationSpectrum::SampleEnergy(), G4ViewParameters::SceneModifyingCommands(), PHG4SectorSubsystem::set_geometry(), PHG4RICHSubsystem::set_RICH_geometry(), CCalVisualisable::setColor(), CCalVisualisable::setColorGreen(), LaserDrivenBeamLine::SetDefaultDimensions(), Collimator50BeamLine::SetDefaultDimensions(), Collimator40BeamLine::SetDefaultDimensions(), Collimator70BeamLine::SetDefaultDimensions(), Collimator60BeamLine::SetDefaultDimensions(), Collimator80BeamLine::SetDefaultDimensions(), Collimator100BeamLine::SetDefaultDimensions(), PassiveCarbonBeamLine::SetDefaultDimensions(), TrentoPassiveProtonBeamLine::SetDefaultDimensions(), PassiveProtonBeamLine::SetDefaultDimensions(), PHGeomTGeo::SetGeometry(), GFlashHomoShowerParameterisation::SetMaterial(), DicomIntersectVolume::SetNewValue(), EICG4dRICHAerogel::setOpticalParams(), EICG4dRICHGas::setOpticalParams(), G4INCL::PhaseSpaceGenerator::setPhaseSpaceGenerator(), HepTool::Evaluator::setSystemOfUnits(), G4ModelingParameters::SetVisibleDensity(), G4ViewParameters::SetVisibleDensity(), kdfinder::CircleFit< T >::SigmaWithLargeCircleOption(), G3toG4DetectorConstruction::SimpleConstruct(), NeuronLoadDataFile::SingleNeuronSWCfile(), G4hNuclearStoppingModel::StoppingPower(), G4ProductionCutsTable::StoreMaterialInfo(), STCyclotronDetectorConstruction::UpdateFoilMaterial(), and STCyclotronDetectorConstruction::UpdateMaterial().
constexpr double Acts::UnitConstants::Gauss = 1e-4 * T |
constexpr double Acts::UnitConstants::GeV = 1.0 |
Definition at line 124 of file Units.hpp.
View newest version in sPHENIX GitHub at line 124 of file Units.hpp
Referenced by main(), FW::Pythia8Generator::Pythia8Generator(), FW::CsvParticleReader::read(), FW::CsvPlanarClusterReader::read(), FW::TrackFinderPerformanceWriter::Impl::write(), FW::CsvParticleWriter::writeT(), FW::RootSimHitWriter::writeT(), FW::RootParticleWriter::writeT(), and FW::CsvPlanarClusterWriter::writeT().
constexpr double Acts::UnitConstants::h = 3600.0 * s |
Definition at line 115 of file Units.hpp.
View newest version in sPHENIX GitHub at line 115 of file Units.hpp
Referenced by __attribute__(), G4MagInt_Driver::AccurateAdvance(), CylindricalHough::addHits(), G4MagHelicalStepper::AdvanceHelix(), G4TransitionRadiation::AngleIntegralDistribution(), G4ForwardXrayTR::AngleSum(), G4PreCompoundEmission::AngularDistribution(), boost::python::detail::proxy_helper< Container, DerivedPolicies, ContainerElement, Index >::base_get_item_(), BOOST_AUTO_TEST_CASE(), Acts::Test::BOOST_AUTO_TEST_CASE(), TpcSpaceChargeMatrixInversion::calculate_distortions(), CylinderKalman::calculate_dxda(), HelixKalmanFilter::calculate_dxda(), G4SPSEneDistribution::CalculateBbodySpectrum(), compareHitHistograms(), G4ChipsProtonInelasticXS::CrossSectionFormula(), G4ChipsHyperonInelasticXS::CrossSectionFormula(), G4ChipsKaonMinusInelasticXS::CrossSectionFormula(), G4ChipsPionMinusInelasticXS::CrossSectionFormula(), G4ChipsKaonPlusInelasticXS::CrossSectionFormula(), G4ChipsNeutronInelasticXS::CrossSectionFormula(), G4ChipsPionPlusInelasticXS::CrossSectionFormula(), csz__huft_build(), csz__Inflate(), oncsSub_idfnalmwpc::decode(), oncsSub_idfnalmwpcv2::decode(), G4ModifiedMidpoint::DoStep(), G4GeomTools::EllipticConeLateralArea(), HadrontherapyEventAction::EndOfEventAction(), G4TransitionRadiation::EnergyIntegralDistribution(), G4ForwardXrayTR::EnergySum(), QAG4SimulationIntt::evaluate_clusters(), QAG4SimulationMvtx::evaluate_clusters(), QAG4SimulationMicromegas::evaluate_clusters(), QAG4SimulationTpc::evaluate_clusters(), QAG4SimulationMicromegas::evaluate_hits(), G4ecpssrBaseKxsModel::ExpIntFunction(), G4ecpssrBaseLixsModel::ExpIntFunction(), PHG4OuterHcalSteppingAction::FieldChecker(), sPHENIXTracker::finalize(), sPHENIXTrackerTpc::finalize(), sPHENIXSeedFinder::finalize(), HelixHough::findHelices(), sPHENIXTrackerTpc::findTracksByCombinatorialKalman(), sPHENIXTrackerTpc::findTracksBySegments(), sPHENIXTracker::findTracksBySegments(), sPHENIXSeedFinder::findTracksBySegments(), SimpleTrack3D::fit_track(), ZHough_Cylindrical::fitTrack(), VtxTrackFinder::fitTrack(), ThreeHitSeedGrower::fitTrack(), NHitSeedFinder::fitTrack(), FourHitSeedFinder::fitTrack(), sPHENIXTrackerTpc::fitTrack(), sPHENIXTracker::fitTrack(), sPHENIXSeedFinder::fitTrack(), FourHitSeedFinder::fitTrackLine(), CLHEP::HepStat::flatToGaussian(), Acts::Test::SurfaceArrayFixture::fullPhiTestSurfacesBRL(), Acts::Test::SurfaceArrayCreatorFixture::fullPhiTestSurfacesBRL(), Acts::Test::LayerCreatorFixture::fullPhiTestSurfacesBRL(), Acts::Test::SurfaceArrayCreatorFixture::fullPhiTestSurfacesEC(), G4VisCommandSceneAddLogo::G4Logo::G4Logo(), MyGamma::GamCf(), G4Abla::gcf(), gen_bitlen(), G4SPSPosDistribution::GeneratePointsOnSurface(), PHG4CylinderGeom_Spacalv3::get_max_lightguide_height(), PHTpcTrackFollower::get_projected_coordinate(), EMField::GetFieldValue(), G4PhotoNuclearCrossSection::GetFunctions(), G4CrystalUnitCell::GetIntSp2(), G4CrystalUnitCell::GetRecIntSp2(), hash(), HepPolyhedronEllipticalCone::HepPolyhedronEllipticalCone(), QAG4SimulationUpsilon::Init(), QAG4SimulationVertex::Init(), QAG4SimulationCalorimeter::Init(), QAG4SimulationTracking::Init(), QAG4SimulationKFParticle::Init(), QAG4SimulationCalorimeterSum::Init(), QAG4SimulationCalorimeter::Init_G4Hit(), QAG4SimulationJet::Init_Spectrum(), QAG4SimulationCalorimeter::Init_Tower(), QAG4SimulationJet::Init_TruthMatching(), TPCIntegratedCharge::InitRun(), QAG4SimulationMvtx::InitRun(), QAG4SimulationIntt::InitRun(), QAG4SimulationMicromegas::InitRun(), QAG4SimulationTpc::InitRun(), TPCDataStreamEmulator::InitRun(), PHG4ScoringManager::InitRun(), TPCFEETestRecov1::InitRun(), JetHepMCLoader::InitRun(), G4TransitionRadiation::IntegralOverAngle(), G4TransitionRadiation::IntegralOverEnergy(), intersect_circles(), CylindricalHough::intersect_circles(), Acts::DefaultExtension::k(), Acts::detail::stepper_extension_list_impl< N >::k(), Acts::DenseEnvironmentExtension::k(), PHG4Utils::lines_intersect(), lookup(), main(), kdfinder::make_triplets(), Acts::Test::SurfaceArrayCreatorFixture::makeBarrelStagger(), Acts::Test::LayerCreatorFixture::makeBarrelStagger(), PHG4ScoringManager::makeScoringHistograms(), EICG4LumiDetector::MakeTower(), nlohmann::detail::dtoa_impl::diyfp::mul(), half::negInf(), nf_exponentialIntegral(), G4MagInt_Driver::OneGoodStep(), std::hash< std::array< T, N > >::operator()(), std::hash< nlohmann::json >::operator()(), half::operator-(), G4PenelopeComptonModel::OscillatorTotalCrossSection(), half::posInf(), QAG4SimulationCalorimeter::process_event_Cluster(), QAG4SimulationCalorimeter::process_event_G4Hit(), QAG4SimulationCalorimeter::process_event_Tower(), CellularAutomaton_v1::process_single_track(), CellularAutomaton_v1::process_single_triplet(), sPHENIXTracker::projectToLayer(), sPHENIXSeedFinder::projectToLayer(), prt_canvasAdd(), prt_drawDigi(), prt_fitslices(), prt_save(), prt_smooth(), ptwXY_groupThreeFunctions(), half::qNan(), field_utils::relativeError2(), remove_bad_hits(), Fun4AllHistoManager::Reset(), G4PreCompoundEmission::rho(), half::round(), G4LivermoreGammaConversionModelRC::SampleSecondaries(), F04FocusSolenoid::SetHalf(), G4INCL::Particle::setHelicity(), G4LogicalCrystalVolume::SetMillerOrientation(), G4VisCommandSceneAddLogo::SetNewValue(), RMC01DetectorConstruction::SetSensitiveVolumeHeight(), G4ViewParameters::SetXGeometryString(), half::sNan(), TpcSpaceChargeReconstructionHelper::split(), Acts::StraightLineStepper::step(), Acts::EigenStepper< bfield_t, extensionlist_t, auctioneer_t >::step(), Acts::AtlasStepper< ConstantBField >::step(), G4HelixExplicitEuler::Stepper(), G4RKG3_Stepper::Stepper(), G4MagHelicalStepper::Stepper(), Acts::DefaultExtension::transportMatrix(), Acts::DenseEnvironmentExtension::transportMatrix(), CylinderKalman::updateIntersection(), HelixKalmanFilter::updateIntersection(), HelixHough::vote(), HelixHough::vote_pairs(), HelixHough::vote_z(), and Acts::RiddersPropagator< propagator_t >::wiggleDimension().
constexpr double Acts::UnitConstants::keV = 1e-6 |
constexpr double Acts::UnitConstants::kg = 1.0 / 1.782662e-27 |
constexpr double Acts::UnitConstants::kGauss = 1e-1 * T |
constexpr double Acts::UnitConstants::km = 1e6 |
constexpr double Acts::UnitConstants::m = 1e3 |
constexpr double Acts::UnitConstants::MeV = 1e-3 |
Definition at line 123 of file Units.hpp.
View newest version in sPHENIX GitHub at line 123 of file Units.hpp
Referenced by ActsFatras::findMass(), and Acts::Test::MaterialScattering::operator()().
constexpr double Acts::UnitConstants::min = 60.0 * s |
constexpr double Acts::UnitConstants::mm = 1.0 |
Definition at line 91 of file Units.hpp.
View newest version in sPHENIX GitHub at line 91 of file Units.hpp
Referenced by Acts::IntegrationTest::atlasBField(), FW::CsvParticleReader::read(), FW::CsvPlanarClusterReader::read(), FW::Options::readPythia8Options(), FW::TrackFinderPerformanceWriter::Impl::write(), FW::CsvParticleWriter::writeT(), FW::RootSimHitWriter::writeT(), FW::RootParticleWriter::writeT(), and FW::CsvPlanarClusterWriter::writeT().
constexpr double Acts::UnitConstants::mrad = 1e-3 |
constexpr double Acts::UnitConstants::ms = 1e-3 * s |
constexpr double Acts::UnitConstants::nm = 1e-6 |
constexpr double Acts::UnitConstants::ns = 1e-9 * s |
Definition at line 111 of file Units.hpp.
View newest version in sPHENIX GitHub at line 111 of file Units.hpp
Referenced by PHActsInitialVertexFinder::getTrackPointers(), PHActsTrkFitter::loopTracks(), PHActsVertexFitter::makeTrackParam(), PHActsTrackProjection::makeTrackParams(), PHTpcResiduals::makeTrackParams(), FW::CsvParticleReader::read(), FW::CsvPlanarClusterReader::read(), FW::Options::readPythia8Options(), FW::TrackFinderPerformanceWriter::Impl::write(), FW::CsvParticleWriter::writeT(), FW::RootSimHitWriter::writeT(), FW::RootParticleWriter::writeT(), FW::CsvPlanarClusterWriter::writeT(), and FW::RootPlanarClusterWriter::writeT().
constexpr double Acts::UnitConstants::pm = 1e-9 |
Definition at line 88 of file Units.hpp.
View newest version in sPHENIX GitHub at line 88 of file Units.hpp
Referenced by G4EmCalculator::ActiveForParticle(), G4ITStepProcessor::ActiveOnlyITProcess(), G4RunManagerKernel::ConfirmCoupledTransportation(), PhysicsListEMstd::ConstructProcess(), G4ITStepProcessor::DealWithSecondaries(), G4LossTableManager::DumpHtml(), G4EmModelActivator::FindOrAddProcess(), G4MuNeutrinoNucleusTotXsc::GetIsoCrossSection(), G4SteppingManager::GetProcessNumber(), G4SteppingManager::InvokeAlongStepDoItProcs(), G4SteppingManager::InvokeAtRestDoItProcs(), G4SteppingManager::InvokePSDIP(), G4VMultipleScattering::PreparePhysicsTable(), G4VEnergyLossProcess::PreparePhysicsTable(), ptwXY_createGaussianCenteredSigma1(), G4PersistencyCenter::RegisterPersistencyManager(), G4LatticeManager::Reset(), G4PersistencyCenter::SelectSystem(), G4PersistencyCenter::SetPersistencyManager(), G4WorkerRunManagerKernel::SetupShadowProcess(), G4RunManagerKernel::SetupShadowProcess(), PHG4RICHSteppingAction::UserSteppingAction(), and LXeSteppingAction::UserSteppingAction().
constexpr double Acts::UnitConstants::ps = 1e-12 * s |
Definition at line 110 of file Units.hpp.
View newest version in sPHENIX GitHub at line 110 of file Units.hpp
Referenced by FW::DigitizationAlgorithm::execute().
constexpr double Acts::UnitConstants::rad = 1.0 |
constexpr double Acts::UnitConstants::s = 299792458000.0 |
constexpr double Acts::UnitConstants::T = 0.000299792458 |
Definition at line 138 of file Units.hpp.
View newest version in sPHENIX GitHub at line 138 of file Units.hpp
Referenced by Acts::IntegrationTest::atlasBField(), Acts::IntegrationTest::BOOST_DATA_TEST_CASE(), and main().
constexpr double Acts::UnitConstants::TeV = 1e3 |
constexpr double Acts::UnitConstants::u = 0.93149410242 |
Definition at line 127 of file Units.hpp.
View newest version in sPHENIX GitHub at line 127 of file Units.hpp
Referenced by Histo::Add1D(), FW::Options::addRandomNumbersOptions(), G4ExtrudedSolid::ApproxSurfaceNormal(), dfe::FlatSet< T, Compare, Container >::at(), FW::RootVertexAndTracksReader::availableEvents(), FW::RootMaterialTrackReader::availableEvents(), FW::EventGenerator::availableEvents(), cheprep::BHepRepWriter::BHepRepWriter(), CLHEP::HepLorentzVector::boost(), Acts::Test::BOOST_AUTO_TEST_CASE(), BOOST_AUTO_TEST_CASE(), Acts::Test::BOOST_DATA_TEST_CASE(), BOOST_DATA_TEST_CASE(), Acts::Test::BOOST_FIXTURE_TEST_CASE(), nlohmann::detail::binary_writer< BasicJsonType, CharType >::calc_bson_entry_header_size(), FW::Obj::calculateBezierPoint(), Acts::PassiveLayerBuilder::centralLayers(), Acts::AnnulusBounds::closestOnSegment(), G4GeomTools::ClosestPointOnSegment(), Acts::BoundaryCheck::computeClosestPointOnPolygon(), Acts::computeEnergyLossBethe(), G4PhysicsVector::ComputeSecondDerivatives(), PHG4HcalDetector::ConstructMe(), dfe::FlatSet< T, Compare, Container >::contains(), nlohmann::detail::serializer< BasicJsonType >::count_digits(), G4GenericTrap::CreatePolyhedron(), Acts::CartesianSegmentation::createSegmentationSurfaces(), G4ChipsKaonMinusInelasticXS::CrossSectionFormula(), G4ChipsPionMinusInelasticXS::CrossSectionFormula(), G4ChipsKaonPlusInelasticXS::CrossSectionFormula(), G4ChipsPionPlusInelasticXS::CrossSectionFormula(), csz__huft_build(), nlohmann::detail::serializer< BasicJsonType >::decode(), G4EquilibriumEvaporator::deExcite(), Acts::deriveEnergyLossBetheQOverP(), FW::determineEventFilesRange(), FW::Sequencer::determineEventsRange(), G4OpBoundaryProcess::DielectricLUTDAVIS(), G4TriangularFacet::Distance(), G4GeomTools::DistancePointSegment(), G4TwistBoxSide::DistanceToSurface(), G4TwistTrapAlphaSide::DistanceToSurface(), G4TwistTrapParallelSide::DistanceToSurface(), nlohmann::detail::serializer< BasicJsonType >::dump_escaped(), Acts::ElementFraction::ElementFraction(), Acts::MultiIndex< uint64_t, 12, 12, 16, 8, 16 >::Encode(), Acts::PassiveLayerBuilder::endcapLayers(), G4EqEMFieldWithSpin::EvaluateRhsGivenB(), G4RepleteEofM::EvaluateRhsGivenB(), G4EqEMFieldWithEDM::EvaluateRhsGivenB(), G4Mag_SpinEqRhs::EvaluateRhsGivenB(), FW::FatrasAlgorithm< simulator_t >::execute(), Acts::detail::grid_helper_impl< 0u >::exteriorBinIndices(), nlohmann::detail::wide_string_input_helper< WideStringType, T >::fill_buffer(), nlohmann::detail::wide_string_input_helper< WideStringType, 2 >::fill_buffer(), G4PhysicsVector::FillSecondDerivatives(), dfe::FlatSet< T, Compare, Container >::find(), CLHEP::RandStudentT::fire(), PHTimeStamp::formatTimeString(), G4JpegCoder::ForwardDCT(), G4DataInterpolation::G4DataInterpolation(), G4RandomDirection(), G4NuclNuclDiffuseElastic::GammaLess(), G4NuclNuclDiffuseElastic::GammaMore(), ActsFatras::detail::GeneralMixture::gaussmix(), G4INCL::Random::gaussWithMemory(), CLHEP::RandChiSquare::genChiSquare(), G4RDGenerator2BN::Generate2BN(), CLHEP::RandGamma::genGamma(), nlohmann::detail::lexer< BasicJsonType >::get_codepoint(), PHGenFitTrkFitter::get_rotation_matrix(), Acts::detail::grid_helper_impl< 0u >::getAxes(), Acts::detail::grid_helper_impl< 0u >::getBinCenter(), G4EMDissociationCrossSection::GetCrossSectionForProjectile(), G4TwistBoxSide::GetFacets(), G4TwistTrapParallelSide::GetFacets(), G4TwistTrapAlphaSide::GetFacets(), 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(), G4TwistBoxSide::GetNormal(), G4TwistTrapAlphaSide::GetNormal(), G4TwistTrapParallelSide::GetNormal(), G4TriangularFacet::GetPointOnFace(), G4Polyhedra::GetPointOnPlane(), G4VTwistedFaceted::GetPointOnSurface(), G4GenericTrap::GetPointOnSurface(), G4Trd::GetPointOnSurface(), G4Para::GetPointOnSurface(), G4Trap::GetPointOnSurface(), G4OpBoundaryProcess::GetReflectivity(), 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(), FW::identifyContributingParticles(), FW::TruthFitTrack::identifyMajorityParticle(), G4PolarizedPairProductionCrossSection::Initialize(), G4PolarizedBremsstrahlungCrossSection::Initialize(), G4NucleiModel::initializeCascad(), G4TriangularFacet::Intersect(), Acts::LineSurface::intersectionEstimate(), Acts::detail::grid_helper_impl< 0u >::isInside(), lgam(), main(), Acts::HierarchicalGeometryContainer< value_t >::makeHighestLevelMask(), Acts::MultiIndex< uint64_t, 12, 12, 16, 8, 16 >::makeLastDescendant(), Acts::HierarchicalGeometryContainer< value_t >::makeLeadingLevelsMask(), Acts::MultiIndex< uint64_t, 12, 12, 16, 8, 16 >::makeNextSibling(), PHGenFitTrkFitter::MakeSvtxTrack(), G4JpegCoder::makeYCC(), Acts::MultiIndex< uint64_t, 12, 12, 16, 8, 16 >::mask(), Acts::MaterialComposition::MaterialComposition(), Acts::BinnedSurfaceMaterial::materialProperties(), Acts::ProtoLayer::measure(), Acts::Test::CylindricalTrackingGeometry::modulePositionsCylinder(), nlohmann::detail::dtoa_impl::diyfp::mul(), CLHEP::Hep3Vector::negativeInfinity(), Acts::detail::grid_helper_impl< 0u >::neighborHoodIndices(), Acts::Legacy::AtlasSeedfinder< SpacePoint >::newOneSeedWithCurvaturesComparison(), nlohmann::detail::dtoa_impl::diyfp::normalize(), G4GenericTrap::NormalToPlane(), dfe::io_dsv_impl::NamedTupleDsvReader< Delimiter, NamedTuple >::num_records(), CLHEP::HepJamesRandom::operator unsigned int(), ActsFatras::BetheHeitler::operator()(), FW::Pythia8Generator::operator()(), FW::ParametricProcessGenerator::operator()(), nlohmann::detail::binary_reader< BasicJsonType, SAX >::parse_cbor_internal(), kdfinder::Helix< T >::pathLength(), PHG4TrackFastSim::PHG4HitToMeasurementCylinder(), B0TrackFastSim::PHG4HitToMeasurementCylinder(), PHG4TrackFastSim::PHG4HitToMeasurementVerticalPlane(), B0TrackFastSim::PHG4HitToMeasurementVerticalPlane(), DetectorConstruction::PlaceWithDirectMatrix(), DetectorConstruction::PlaceWithInverseMatrix(), PHGenFit::PlanarMeasurement::PlanarMeasurement(), G4RDModifiedTsai::PolarAngle(), Acts::SurfaceArray::SurfaceGridLookup< Axes >::populateNeighborCache(), G4LowEnergyGammaConversion::PostStepDoIt(), G4GammaConversionToMuons::PostStepDoIt(), G4TwistBoxSide::ProjectPoint(), G4TwistTrapParallelSide::ProjectPoint(), G4TwistTrapAlphaSide::ProjectPoint(), ptwXY_LogLogToLinLin(), ActsFatras::LandauDistribution::quantile(), G4DNACPA100IonisationModel::RandomizeEjectedElectronEnergyFromCompositionSampling(), CLHEP::HepRotation::rectify(), ActsFatras::Simulator< charged_selector_t, charged_simulator_t, neutral_selector_t, neutral_simulator_t >::renumberTailParticleIds(), kdfinder::rnd_gauss(), G4UrbanMscModel::SampleCosineTheta(), G4UrbanAdjointMscModel::SampleCosineTheta(), G4ModifiedTsai::SampleCosTheta(), G4Generator2BN::SampleDirection(), G4UrbanMscModel::SampleDisplacementNew(), G4UrbanAdjointMscModel::SampleDisplacementNew(), G4BoldyshevTripletModel::SampleSecondaries(), G4LivermoreGammaConversionModelRC::SampleSecondaries(), G4LivermoreNuclearGammaConversionModel::SampleSecondaries(), G4AdjointBremsstrahlungModel::SampleSecondaries(), G4LivermoreGammaConversionModel::SampleSecondaries(), nlohmann::detail::lexer< BasicJsonType >::scan_string(), FW::selectLayer(), FW::selectVolume(), ActsFatras::detail::GeneralMixture::semigauss(), CLHEP::HepRotation::set(), Histo::SetHisto1D(), Acts::MultiIndex< uint64_t, 12, 12, 16, 8, 16 >::shift(), CLHEP::RandStudentT::shoot(), ActsFatras::Simulator< charged_selector_t, charged_simulator_t, neutral_selector_t, neutral_simulator_t >::simulate(), G4ExtrudedSolid::SurfaceNormal(), CLHEP::RandLandau::transform(), dfe::io_dsv_impl::DsvWriter< Delimiter >::write(), FW::TrackFinderPerformanceWriter::Impl::write(), nlohmann::detail::binary_writer< BasicJsonType, CharType >::write_bson_entry_header(), cheprep::BHepRepWriter::writeReal(), and Acts::MultiIndex< uint64_t, 12, 12, 16, 8, 16 >::Zeros().
constexpr double Acts::UnitConstants::um = 1e-3 |
Definition at line 89 of file Units.hpp.
View newest version in sPHENIX GitHub at line 89 of file Units.hpp
Referenced by PHActsInitialVertexFinder::getTrackPointers(), and PHActsTrkFitter::setDefaultCovariance().