ECCE @ EIC Software
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Groups Pages
HelixHough_allButKappaRange_sse.cpp File Reference
#include "HelixHough.h"
#include "vector_math_inline.h"
#include <emmintrin.h>
#include <xmmintrin.h>
+ Include dependency graph for HelixHough_allButKappaRange_sse.cpp:

Go to the source code of this file.

Functions

static void __attribute__ ((always_inline)) calculate_phi_d(__m128 &k
 
 _vec_sin_cos_ps (phi, sn, cs)
 
 return (z-dzds *s1)
 

Variables

static const __m128 one_o_4 = {0.25,0.25,0.25,0.25}
 
static const __m128 two = {2., 2., 2., 2.}
 
static const __m128 one_o_100 = {0.01,0.01,0.01,0.01}
 
static const __m128 close_one = {0.999,0.999,0.999,0.999}
 
static const __m128 four = {4., 4., 4., 4.}
 
static const __m128 one_o_3 = {0.3333333333333333333, 0.3333333333333333333, 0.3333333333333333333, 0.3333333333333333333}
 
static const __m128 _3_o_20 = {0.15, 0.15, 0.15, 0.15}
 
static const __m128 _5_o_56 = {8.92857142857142877e-02, 8.92857142857142877e-02, 8.92857142857142877e-02, 8.92857142857142877e-02}
 
static const __m128 SIGNMASK = _mm_castsi128_ps(_mm_set1_epi32(0x80000000))
 
static const __m128 three_pi_over_two = {3.*0x1.921fb54442d1846ap0f, 3.*0x1.921fb54442d1846ap0f, 3.*0x1.921fb54442d1846ap0f, 3.*0x1.921fb54442d1846ap0f}
 
static void __m128 __m128 & Delta2
 
static void __m128 __m128
__m128 __m128 & 
ux = {0.,0.,0.,0.}
 
static void __m128 __m128
__m128 __m128 __m128 & 
uy = {0.,0.,0.,0.}
 
static void __m128 __m128
__m128 __m128 __m128 __m128 & 
x3
 
static void __m128 __m128
__m128 __m128 __m128 __m128
__m128 & 
y3
 
static void __m128 __m128
__m128 __m128 __m128 __m128
__m128 __m128 & 
phi_1 = _vec_atan2_ps(tmp5, tmp6)
 
static void __m128 __m128
__m128 __m128 __m128 __m128
__m128 __m128 __m128 & 
phi_2 = _vec_atan2_ps(tmp5, tmp6)
 
static void __m128 __m128
__m128 __m128 __m128 __m128
__m128 __m128 __m128 __m128 & 
d_1 = kd1
 
static void __m128 __m128
__m128 __m128 __m128 __m128
__m128 __m128 __m128 __m128
__m128 & 
d_2
 
__m128 k2 = _mm_mul_ps(k, k)
 
__m128 uscale2 = _mm_mul_ps(Delta2, k2)
 
__m128 uscale = _vec_sqrt_ps(uscale2)
 
__m128 tmp1 = _mm_mul_ps(k, y3)
 
__m128 tmp2 = _mm_mul_ps(uscale, uy)
 
__m128 tmp3 = _mm_mul_ps(k, x3)
 
__m128 tmp4 = _mm_mul_ps(uscale, ux)
 
__m128 tmp5 = _mm_add_ps(tmp1, tmp2)
 
__m128 tmp6 = _mm_add_ps(tmp3, tmp4)
 
__m128 kd1 = _mm_mul_ps(k2, tmp1)
 
__m128 k0val = _mm_mul_ps(x3, ux)
 
__m128 kd2 = _mm_sub_ps(kd1, tmp1)
 
static __m128 __m128 & z1
 
static __m128 __m128 __m128 & z2
 
static __m128 __m128 __m128
__m128 & 
k
 
 v = _mm_mul_ps(v, Delta)
 
__m128 one_o_v = _vec_rec_ps(v)
 
__m128 s = zero
 
__m128 temp1 = _mm_mul_ps(v, v)
 
__m128 temp2 = _mm_mul_ps(one_o_2, Delta)
 
__m128 s1 = _mm_xor_ps(tmp3, tmp2)
 
__m128 dz2 = _mm_sub_ps(z2, z1)
 
__m128 dzdl = _mm_div_ps(dz2, tmp1)
 
static __m128 __m128 & y
 
static __m128 __m128 __m128 & z
 
static __m128 __m128 __m128
__m128 __m128 & 
d
 
static __m128 __m128 __m128
__m128 __m128 __m128 & 
phi
 
__m128 dx = d*cs
 
__m128 dy = d*sn
 
__m128 Dx = dx - x
 
__m128 Dy = dy - y
 
__m128 Delta = _vec_sqrt_ps(Dx*Dx + Dy*Dy)
 
__m128 dzds = dzdl*_vec_rsqrt_ps(one - dzdl*dzdl)
 
static void __m128 val2
 
static void __m128 __m128 & min = _mm_xor_ps(tmp2, tmp3)
 
static void __m128 __m128 __m128 & max
 

Function Documentation

static void __attribute__ ( (always_inline)  )
inlinestatic
_vec_sin_cos_ps ( phi  ,
sn  ,
cs   
)
return ( z-dzds s1)

Referenced by dfe::Dispatcher::add(), G4GMocrenFileSceneHandler::AddDetector(), G4GMocrenFileSceneHandler::AddSolid(), AnalyzeSimpleTree::AnalyzeSimpleTree(), G4BasePhantomBuilder::BuildBrain(), G4BasePhantomBuilder::BuildHead(), G4BasePhantomBuilder::BuildHeart(), G4BasePhantomBuilder::BuildLeftAdrenal(), G4BasePhantomBuilder::BuildLeftArmBone(), G4BasePhantomBuilder::BuildLeftKidney(), G4BasePhantomBuilder::BuildLeftLeg(), G4BasePhantomBuilder::BuildLeftLegBone(), G4BasePhantomBuilder::BuildLeftLung(), G4BasePhantomBuilder::BuildLeftOvary(), G4BasePhantomBuilder::BuildLiver(), G4BasePhantomBuilder::BuildLowerLargeIntestine(), G4BasePhantomBuilder::BuildMiddleLowerSpine(), G4BasePhantomBuilder::BuildPancreas(), G4BasePhantomBuilder::BuildPelvis(), G4BasePhantomBuilder::BuildRibCage(), G4BasePhantomBuilder::BuildRightAdrenal(), G4BasePhantomBuilder::BuildRightArmBone(), G4BasePhantomBuilder::BuildRightKidney(), G4BasePhantomBuilder::BuildRightLeg(), G4BasePhantomBuilder::BuildRightLegBone(), G4BasePhantomBuilder::BuildRightLung(), G4BasePhantomBuilder::BuildRightOvary(), G4BasePhantomBuilder::BuildSkull(), G4BasePhantomBuilder::BuildSmallIntestine(), G4BasePhantomBuilder::BuildSpleen(), G4BasePhantomBuilder::BuildStomach(), G4BasePhantomBuilder::BuildThymus(), G4BasePhantomBuilder::BuildThyroid(), G4BasePhantomBuilder::BuildTrunk(), G4BasePhantomBuilder::BuildUpperLargeIntestine(), G4BasePhantomBuilder::BuildUpperSpine(), G4BasePhantomBuilder::BuildUrinaryBladder(), G4hhElastic::CalculateBQ(), G4hhElastic::CalculateBqQ12(), G4hhElastic::CalculateBqQ123(), G4hhElastic::CalculateBqQ13(), G4DataInterpolation::CorrelatedSearch(), G4SingleParticleSource::GeneratePrimaryVertex(), G4DELPHIMagField::GetFieldValue(), RawTowerv1::identify(), PHG4CylinderGeom::ImportParameters(), inflateCodesUsed(), inflateMark(), G4InitXscPAI::IntegralPAIdEdx(), G4InitXscPAI::IntegralPAIxSection(), g4mini::main(), g4vrmlview::main(), MySimpleTree::MySimpleTree(), pprocess(), prun(), MyTClonesArray::Reset(), MySimpleTree::Reset(), G4LivermoreComptonModifiedModel::SampleSecondaries(), G4AdjointPhotoElectricModel::SampleSecondaries(), G4LivermoreComptonModel::SampleSecondaries(), G4MicroElecElasticModel::SampleSecondaries(), G4MuElecElasticModel::SampleSecondaries(), G4LivermorePolarizedRayleighModel::SampleSecondaries(), G4PenelopeGammaConversionModel::SampleSecondaries(), G4LivermorePolarizedComptonModel::SampleSecondaries(), G4JAEAElasticScatteringModel::SampleSecondaries(), G4PenelopeRayleighModel::SampleSecondaries(), G4PenelopePhotoElectricModel::SampleSecondaries(), G4PenelopeBremsstrahlungModel::SampleSecondaries(), G4PenelopeIonisationModel::SampleSecondaries(), G4LowEPComptonModel::SampleSecondaries(), G4LowEPPolarizedComptonModel::SampleSecondaries(), G4VRML2FileViewer::SendViewParameters(), G4BasePhantomBuilder::SetModel(), G4FSALDormandPrince745::Stepper(), G4DormandPrinceRK56::Stepper(), G4DoLoMcPriRK34::Stepper(), G4TsitourasRK45::Stepper(), G4DormandPrinceRK78::Stepper(), G4BogackiShampine45::Stepper(), G4CashKarpRKF45::StepWithEst(), G4ParticleDefinition::~G4ParticleDefinition(), and MyTClonesArray::~MyTClonesArray().

Variable Documentation

const __m128 _3_o_20 = {0.15, 0.15, 0.15, 0.15}
static

Definition at line 17 of file HelixHough_allButKappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 17 of file HelixHough_allButKappaRange_sse.cpp

const __m128 _5_o_56 = {8.92857142857142877e-02, 8.92857142857142877e-02, 8.92857142857142877e-02, 8.92857142857142877e-02}
static

Definition at line 18 of file HelixHough_allButKappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 18 of file HelixHough_allButKappaRange_sse.cpp

const __m128 close_one = {0.999,0.999,0.999,0.999}
static

Definition at line 14 of file HelixHough_allButKappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 14 of file HelixHough_allButKappaRange_sse.cpp

__m128 __m128 __m128 __m128 __m128& d

Definition at line 155 of file HelixHough_allButKappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 155 of file HelixHough_allButKappaRange_sse.cpp

Referenced by __attribute__(), MyGamma::Abs(), EICG4dRICHDetector::ActivateVolumeTree(), MultiArray< TVector3 >::Add(), AddLayers_GEMDrift(), AddLayers_MiniTPCDrift(), Run::AddSecondaryTrack(), aiz(), ALICEKF::ALICEKalmanFilter(), AnalyticFieldModel::AnalyticFieldModel(), G4ForwardXrayTR::AngleDensity(), G4Tet::ApproxSurfaceNormal(), G4Trap::ApproxSurfaceNormal(), ar3jet(), G4ErrorSymMatrix::assign(), G4FissionBarrier::BarashenkovFissionBarrier(), G4AnalyticalPolSolver::BiquadRoots(), biz(), G4Voxelizer::BuildBitmasks(), KFParticle_eventReconstruction::buildChain(), calcta(), HelixKalman::calculate_dAdAp(), HelixKalmanFilter::calculate_dAdAp(), CylinderKalman::calculate_dxda(), HelixKalmanFilter::calculate_dxda(), HelixHoughFuncs_v1::calculate_dzdl_range(), HelixHoughFuncs_v1::calculate_phi_range(), G4hhElastic::CalculateBQ(), HelixDCAFunc::calcValGradHessian(), VertexFitFunc::calcValGradHessian(), calcxsection(), G4ViewParameters::CatmullRomCubicSplineInterpolation(), G4SynchrotronRadiation::Chebyshev(), G4BinaryCascade::CheckPauliPrinciple(), G4GeomTools::ClosestPointOnTriangle(), MyMollerBhabhaModel::ComputeDEDXPerVolume(), G4MollerBhabhaModel::ComputeDEDXPerVolume(), G4UrbanMscModel::ComputeTheta0(), G4UrbanAdjointMscModel::ComputeTheta0(), CML2Ph_BoxInBox::Construct(), Acts::GenericCuboidVolumeBounds::construct(), CLHEP::MixMaxRng::convert1double(), PHInitZVertexing::convertHelixCovarianceToEuclideanCovariance(), PHPatternReco::convertHelixCovarianceToEuclideanCovariance(), PHHoughSeeding::convertHelixCovarianceToEuclideanCovariance(), converttohepmc(), Acts::AtlasStepper< ConstantBField >::covarianceTransport(), DNAParser::CreateCutSolid(), G4BoundingEnvelope::CreateListOfPlanes(), G4GenericPolycone::CreatePolyhedron(), G4Polyhedra::CreatePolyhedron(), G4VSceneHandler::CreateSectionSolid(), G4Voxelizer::CreateSortedBoundary(), G4AdjointCrossSurfChecker::CrossingASphere(), G4ChipsAntiBaryonInelasticXS::CrossSectionFormula(), G4ChipsProtonInelasticXS::CrossSectionFormula(), G4ChipsHyperonInelasticXS::CrossSectionFormula(), G4ChipsKaonMinusInelasticXS::CrossSectionFormula(), G4ChipsPionMinusInelasticXS::CrossSectionFormula(), G4ChipsKaonPlusInelasticXS::CrossSectionFormula(), G4ChipsNeutronInelasticXS::CrossSectionFormula(), G4ChipsPionPlusInelasticXS::CrossSectionFormula(), csz__Inflate_codes(), G4AnalyticalPolSolver::CubicRoots(), CLHEP::DoubConv::d2x(), PHSimpleVertexFinder::dcaTwoLines(), oncsSub_iddrs4v1::decode(), oncsSub_idsrs_v01::decode(), oncsSub_idfnalmwpc::decode(), oncsSub_idfnalmwpcv2::decode(), oncsSub_iddreamv0::decode(), Acts::GenericCuboidVolumeBounds::decomposeToSurfaces(), G4HumanPhantomMaterial::DefineMaterials(), BrachyMaterial::DefineMaterials(), G4PhysicalVolumeModel::DescribeAndDescend(), RawTowerBuilder::Detector(), RawClusterBuilderGraph::Detector(), RawClusterBuilderTemplate::Detector(), RawClusterBuilderFwd::Detector(), HcalRawTowerBuilder::Detector(), PHG4MvtxHitReco::Detector(), RawTowerDeadTowerInterp::detector(), RawTowerDigitizer::Detector(), RawTowerZDCDigitizer::Detector(), PHG4ForwardCalCellReco::Detector(), RawTowerCalibration::Detector(), PHG4InttHitReco::Detector(), RawTowerZDCCalibration::Detector(), PHG4HcalCellReco::Detector(), BwdRawTowerBuilderByHitIndex::Detector(), RawTowerBuilderDRCALO::Detector(), B0RawTowerBuilderByHitIndex::Detector(), RawTowerBuilderByHitIndexBECAL::Detector(), RawTowerBuilderByHitIndexLHCal::Detector(), EICG4ZDCRawTowerBuilderByHitIndex::Detector(), RawTowerBuilderByHitIndex::Detector(), PHG4BlockCellReco::Detector(), PHG4InttDigitizer::Detector(), PHG4CylinderCellReco::Detector(), RawClusterBuilderHelper::Detector(), PHG4FullProjSpacalCellReco::Detector(), PHG4TpcDirectLaser::Detector(), PHG4TpcCentralMembrane::Detector(), PHG4TpcElectronDrift::Detector(), RawDigitBuilderTTL::Detector(), RawTowerCombiner::Detector(), G4TriangularFacet::Distance(), CLHEP::HepAxisAngle::distance(), CLHEP::HepEulerAngles::distance(), Acts::BoundaryCheck::distance(), G4VTwistSurface::DistanceToBoundary(), G4CutTubs::DistanceToIn(), G4Tubs::DistanceToIn(), G4Cons::DistanceToIn(), G4Sphere::DistanceToIn(), G4Trap::DistanceToIn(), G4GenericTrap::DistanceToOut(), G4Cons::DistanceToOut(), G4Sphere::DistanceToOut(), G4Trap::DistanceToOut(), G4TwistTubsSide::DistanceToSurface(), G4TwistTubsHypeSide::DistanceToSurface(), G4GenericTrap::DistToPlane(), G4GenericTrap::DistToTriangle(), doinstatescat(), dokinematics(), G4WorkerRunManager::DoWork(), G4eeCrossSections::DpOm(), G4eeCrossSections::DpPhi(), G4eeCrossSections::DpRho(), Acts::GenericCuboidVolumeBounds::draw(), Acts::AxisAlignedBoundingBox< entity_t, value_t, DIM >::draw(), CLHEP::DoubConv::dto2longs(), nlohmann::detail::serializer< BasicJsonType >::dump_float(), HelixHough::dzdlRange_sse(), G4Abla::ecoul(), eix(), eixint(), LiteCaloEval::End(), G4ChipsAntiBaryonInelasticXS::EquLinearFit(), G4PhotoNuclearCrossSection::EquLinearFit(), G4ChipsHyperonInelasticXS::EquLinearFit(), G4ChipsKaonMinusInelasticXS::EquLinearFit(), G4ChipsProtonInelasticXS::EquLinearFit(), G4ChipsPionMinusInelasticXS::EquLinearFit(), G4ChipsNeutronInelasticXS::EquLinearFit(), G4ChipsKaonPlusInelasticXS::EquLinearFit(), G4ChipsPionPlusInelasticXS::EquLinearFit(), expai(), expaid(), G4ecpssrBaseKxsModel::ExpIntFunction(), G4ecpssrBaseLixsModel::ExpIntFunction(), PHInitZVertexing::export_output(), PHPatternReco::export_output(), PHHoughSeeding::export_output(), G4PolyconeSide::Extent(), G4LivermoreGammaConversionModelRC::fbeta(), G4QuasiElRatios::FetchElTot(), CML2PrimaryGenerationAction::fillParticlesContainer(), sPHENIXTrackerTpc::finalize(), HelixHough::findSeededHelices(), G4Abla::fissionDistri(), fit_all_update(), ZHough_Cylindrical::fitTrack(), VtxTrackFinder::fitTrack(), ThreeHitSeedGrower::fitTrack(), NHitSeedFinder::fitTrack(), FourHitSeedFinder::fitTrack(), sPHENIXTrackerTpc::fitTrack(), sPHENIXTracker::fitTrack(), sPHENIXSeedFinder::fitTrack(), FourHitSeedFinder::fitTrackLine(), G4GenericMessenger::G4GenericMessenger(), G4VisCommandSceneAddLogo::G4Logo::G4Logo(), MyGamma::GamCf(), G4Abla::gcf(), CLHEP::RandGamma::genGamma(), RawTowerBuilderDRCALO::GeometryTableFile(), B0RawTowerBuilderByHitIndex::GeometryTableFile(), BwdRawTowerBuilderByHitIndex::GeometryTableFile(), RawTowerBuilderByHitIndexBECAL::GeometryTableFile(), RawTowerBuilderByHitIndexLHCal::GeometryTableFile(), RawTowerBuilderByHitIndex::GeometryTableFile(), EICG4ZDCRawTowerBuilderByHitIndex::GeometryTableFile(), MultiArray< TVector3 >::Get(), G4ParticleHPFFFissionFS::GetAFissionFragment(), G4VTwistSurface::GetBoundaryAtPZ(), Packet_A::getCheckSumStatus(), G4MultiUnion::GetCubicVolume(), G4VEnergyLossProcess::GetDEDXDispersion(), getdeltat(), G4NuclNuclDiffuseElastic::GetErfSer(), G4OpenGLFontBaseStore::GetFontInfo(), getinsudafast(), getinsudakov(), getinsudared(), getltimemax(), getmdmin(), getnatmdmin(), getneff(), getneffmax(), getpdf(), getpdfxintexact(), getpnorad1(), MultiArray< TVector3 >::GetPtr(), G4QuasiElRatios::GetQF2IN_Ratio(), getqvec(), getscatterer(), getsscat(), getsudakov(), gettemp(), gettempmax(), G4PhononDownconversion::GetTTDecayProb(), nlohmann::detail::dtoa_impl::grisu2_digit_gen(), hijwds(), CLHEP::Hep2Vector::howNear(), CLHEP::Hep3Vector::howNear(), i1mcry(), G4PolarizedBhabhaCrossSection::Initialize(), G4Trap::Inside(), insudaint(), G4TriangularFacet::Intersect(), intersect_circles(), CylindricalHough::intersect_circles(), G4VFacet::IsInside(), nanoflann::KDTreeEigenMatrixAdaptor< MatrixType, DIM, Distance >::kdtree_distance(), layerMaterial(), G4eIonisationParameters::LoadData(), G4RDeIonisationParameters::LoadData(), G4UImanager::Loop(), main(), makebranch(), HelixHough::makeClusters(), G4PhononDownconversion::MakeLTSecondaries(), makestrings_minl(), G4PhononDownconversion::MakeTTSecondaries(), max4(), md5_process(), medderiv(), medinit(), mednextevt(), MultiArray< TVector3 >::MultiArray(), CLHEP::Hep3Vector::negativeInfinity(), nf_exponentialIntegral(), npart(), nthick(), Acts::MaterialInteractor::operator()(), nanoflann::L1_Adaptor< T, DataSource, _DistanceType >::operator()(), nanoflann::L2_Adaptor< T, DataSource, _DistanceType >::operator()(), G4PenelopeComptonModel::OscillatorTotalCrossSection(), PHG4CylinderCellReco::OutputDetector(), kdfinder::Helix< T >::pathLength(), kdfinder::Helix< T >::pathLengths(), pdfint(), PHRTreeSeeding::phidiff(), PHIODataNode< T >::PHIODataNode(), HelixHough::phiRange_sse(), G4RDModifiedTsai::PolarAngle(), G4DataInterpolation::PolynomInterpolation(), sPHENIXTracker::projectToLayer(), sPHENIXSeedFinder::projectToLayer(), ptwXY_copyToC_XY(), ptwXY_setXYData(), py3ent(), py4ent(), pyalem(), pyangl(), pyapps(), pyboei(), pycell(), pycjdc(), pyclus(), pycteq(), pydecy(), pydisg(), pydocu(), pyedit(), pyeig4(), pyevnt(), pyevnw(), pyevol(), pyfint(), pygaga(), pygau2(), pygaus(), pygbeh(), pyggam(), pyglui(), pygram(), pygraw(), pygrvs(), pygrvv(), pygrvw(), pyhext(), pyhfth(), pyhggm(), pyhisspa(), pyi3au(), pyindf(), pyinom(), pyjmas(), pyjurf(), pykfin(), pyklim(), pykmap(), pyldcm(), pymass(), pymaxi(), pymign(), pymirm(), pymsin(), pymult(), pynjdc(), pynmes(), pyofsh(), pyoper(), pyp(), pypdel(), pypdfu(), pypdga(), pypdpi(), pypdpo(), pypdpr(), pypile(), pyplot(), pypole(), pyprep(), pyptdi(), pyptfs(), pyptis(), pyptmi(), pyradk(), pyrand(), pyreco(), pyremn(), pyresd(), pyrobo(), pyrvch(), pyrvg3(), pyrvgl(), pyrvgw(), pyrvi1(), pyrvi2(), pyrvi3(), pyrvne(), pyscat(), pysfdc(), pysghg(), pysgqc(), pysgsu(), pysgtc(), pysgwz(), pyshow(), pysigh(), pyslha(), pyspen(), pysphe(), pysspa(), pystat(), pystrf(), pytabu(), pytbdy(), pytest(), pythrg(), pythru(), pyuedc(), pywidt(), pyxtot(), G4AnalyticalPolSolver::QuadRoots(), G4AnalyticalPolSolver::QuarticRoots(), G4DataInterpolation::RationalPolInterpolation(), G4DCIOcatalog::RegisterDCIOmanager(), G4HCIOcatalog::RegisterEntry(), G4DCIOcatalog::RegisterEntry(), G4HCIOcatalog::RegisterHCIOmanager(), kdfinder::LinearFit< T >::rofunc(), GPUTPCTrackParam::Rotate(), TPCFEETestRecov1::roughZeroSuppression(), G4Scintillation::sample_time(), G4NeutrinoElectronCcModel::SampleCosCMS(), G4UrbanMscModel::SampleCosineTheta(), G4UrbanAdjointMscModel::SampleCosineTheta(), G4NeutrinoElectronNcModel::SampleElectronTkin(), G4WentzelVIModel::SampleScattering(), G4LivermoreGammaConversionModelRC::SampleSecondaries(), G4AdjointBremsstrahlungModel::SampleSecondaries(), G4PenelopeSamplingData::SampleValue(), serai(), seraid(), CLHEP::HepLorentzRotation::set(), MultiArray< TVector3 >::Set(), HcalRawTowerBuilder::set_cell_decal_factor(), EventEvaluator::set_depth_MCstack(), EventEvaluatorEIC::set_depth_MCstack(), PHG4GenHit::set_eloss(), PHG4GenHit::set_phi(), RawTowerZDCDigitizer::set_sipm_effective_pixel(), RawTowerDigitizer::set_sipm_effective_pixel(), PHG4GenHit::set_theta(), HcalRawTowerBuilder::set_tower_decal_factor(), HcalRawTowerBuilder::set_tower_decal_factor_real(), PHDataNode< PHDWORD >::setData(), LaserDrivenBeamLine::SetDefaultDimensions(), Collimator50BeamLine::SetDefaultDimensions(), Collimator80BeamLine::SetDefaultDimensions(), Collimator40BeamLine::SetDefaultDimensions(), Collimator70BeamLine::SetDefaultDimensions(), Collimator100BeamLine::SetDefaultDimensions(), Collimator60BeamLine::SetDefaultDimensions(), PassiveCarbonBeamLine::SetDefaultDimensions(), PassiveProtonBeamLine::SetDefaultDimensions(), G4INCL::ParticleSampler::setDensity(), G4INCL::Nucleus::setDensity(), G4VTwistSurface::Boundary::SetFields(), G4ILawTruncatedExp::SetMaximumDistance(), G4NavigationLogger::SetMinTriggerDistance(), G4VPrimitiveScorer::SetMultiFunctionalDetector(), G4INCL::Config::setNeutronHalo(), G4INCL::Config::setNeutronSkin(), G4LivermorePolarizedPhotoElectricGDModel::SetPhi(), RMC01DetectorConstruction::SetShieldingThickness(), CCalHit::setTimeSlice(), G4BulirschStoer::should_reject(), G4ElectroNuclearCrossSection::SolveTheEquation(), splitfncint(), EICG4ZDCRawTowerBuilderByHitIndex::SubDetector(), G4PAIySection::SumOverBordCerenkov(), G4PAIxSection::SumOverBordCerenkov(), G4PAIySection::SumOverBorder(), G4PAIxSection::SumOverBorder(), G4PAIySection::SumOverBorderdEdx(), G4PAIxSection::SumOverBorderdEdx(), G4PAIxSection::SumOverBordMM(), G4PAIySection::SumOverBordPlasmon(), G4PAIxSection::SumOverBordPlasmon(), G4PAIxSection::SumOverBordResonance(), G4Trap::SurfaceNormal(), G4Torus::TorusRootsJT(), G4ErrorMatrix::trace(), HepPolyhedron::Transform(), GPUTPCTrackParam::TransportToX(), CylinderKalman::updateIntersection(), HelixKalmanFilter::updateIntersection(), vegas(), wdsax(), G4Clebsch::WignerLittleD(), cheprep::BHepRepWriter::writeReal(), simpleRandom::xMD5Transform(), and xsecint().

d_1 = kd1

Definition at line 23 of file HelixHough_allButKappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 23 of file HelixHough_allButKappaRange_sse.cpp

d_2
Initial value:
{
__m128 k_inv = _vec_rec_ps(k)

Definition at line 24 of file HelixHough_allButKappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 24 of file HelixHough_allButKappaRange_sse.cpp

Referenced by HelixHough::dzdlRange_sse().

__m128 Delta = _vec_sqrt_ps(Dx*Dx + Dy*Dy)

Definition at line 164 of file HelixHough_allButKappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 164 of file HelixHough_allButKappaRange_sse.cpp

Referenced by G4FPYSamplingOps::ShiftParameters().

void __m128 __m128& Delta2

Definition at line 23 of file HelixHough_allButKappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 23 of file HelixHough_allButKappaRange_sse.cpp

Referenced by HelixHough::allButKappaRange_sse().

__m128 dx = d*cs

Definition at line 159 of file HelixHough_allButKappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 159 of file HelixHough_allButKappaRange_sse.cpp

Referenced by G4GaussLegendreQ::AccurateIntegral(), G4HepRepFileSceneHandler::AddSolid(), G4HepRepSceneHandler::AddSolid(), G4eIonisationSpectrum::AverageValue(), G4RDeIonisationSpectrum::AverageValue(), G4Physics2DVector::BicubicInterpolation(), G4Para::BoundingLimits(), G4ExtrudedSolid::BoundingLimits(), G4HadronCrossSections::CalcScatteringCrossSections(), HelixKalman::calculate_dAdAp(), HelixKalmanFilter::calculate_dAdAp(), HelixHoughFuncs_v1::calculate_dzdl_range(), G4EllipticalTube::CalculateExtent(), G4Para::CalculateExtent(), G4ExtrudedSolid::CalculateExtent(), HelixDCAFunc::calcValGradHessian(), kdfinder::CircleFit< T >::ChiSqr(), kdfinder::CircleFit< T >::CircleFitByChernovHoussam(), G4Analysis::ComputeEdges(), G4DrawVoxels::ComputeVoxelPolyhedra(), Acts::IntegrationTest::constant_field_propagation(), G4MIRDLiver::Construct(), G4MIRDLeftArmBone::Construct(), G4MIRDLeftLung::Construct(), G4MIRDLowerLargeIntestine::Construct(), G4MIRDPelvis::Construct(), G4MIRDSmallIntestine::Construct(), G4MIRDUpperLargeIntestine::Construct(), G4MIRDHead::Construct(), G4MIRDLeftBreast::Construct(), G4MIRDMiddleLowerSpine::Construct(), G4MIRDRibCage::Construct(), G4MIRDRightBreast::Construct(), G4MIRDRightLung::Construct(), G4MIRDTrunk::Construct(), G4MIRDUpperSpine::Construct(), G4MIRDRightArmBone::Construct(), G4EicDircDetector::ConstructMe(), TSDetectorConstruction::ConstructWorld(), BEmcRecCEMC::CorrectPosition(), HepGeom::Point3D< float >::distance2(), HepGeom::Point3D< double >::distance2(), G4Box::DistanceToIn(), G4Trd::DistanceToIn(), G4Para::DistanceToIn(), G4Trap::DistanceToIn(), G4Trd::DistanceToOut(), G4Para::DistanceToOut(), G4Trap::DistanceToOut(), HelixHough::dzdlRange_sse(), G4GDMLReadSolids::ElconeRead(), G4GDMLReadSolids::EltubeRead(), export_G4Transform3D(), G4JTPolynomialSolver::FindRoots(), fit_all_update(), 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(), G4RPGFragmentation::FragmentationIntegral(), kdfinder::Helix< T >::fudgePathLength(), G4VisCommandSceneAddLogo::G4Logo::G4Logo(), RE02PrimaryGeneratorAction::GeneratePrimaries(), PHG4TpcDistortion::get_x_distortion_cartesian(), G4hImpactIonisation::GetConstraints(), GPUTPCTrackParam::GetDCAPoint(), GPUTPCTrackParam::GetDist2(), GPUTPCTrackParam::GetDistXZ2(), G4PenelopeBremsstrahlungFS::GetMomentumIntegral(), mRICH::getNgamma(), ECCEmRICHFastPIDMap::getNgamma(), cheprep::DefaultHepRepPoint::getRho(), EmcCluster::GetSubClusters(), kdfinder::CircleFit< T >::GradientHessian(), hijcsc(), G4PenelopeRayleighModel::InitializeSamplingAlgorithm(), G4Trd::Inside(), G4Para::Inside(), G4Trap::Inside(), G4GaussChebyshevQ::Integral(), G4GaussLegendreQ::Integral(), G4INCL::IFunction1D::integrate(), G4LEPTSDiffXS::InterpolateCDXS(), G4eIonisationSpectrum::IntSpectrum(), G4RDeIonisationSpectrum::IntSpectrum(), PHG4Utils::line_and_rectangle_intersect(), LXeMainVolume::LXeMainVolume(), main(), G4Trd::MakePlanes(), G4MuonVDNuclearModel::MakeSamplingTable(), PHSimpleKFProp::MoveToFirstTPCCluster(), nf_Legendre_to_ptwXY(), CLHEP::Hep2Vector::operator Hep3Vector(), Acts::Test::MeasurementCreator::operator()(), G4INCL::InterpolationTable::operator()(), kdfinder::CircleFit< T >::OptimalRadius(), HepGeom::BasicVector3D< G4double >::orthogonal(), kdfinder::Helix< T >::pathLength(), kdfinder::Helix< T >::pathLengths(), G4PhotoElectricAngularGeneratorPolarized::PerpendicularVector(), BEmcRec::PredictEnergy(), BEmcRec::PredictEnergyParam(), BEmcRec::PredictEnergyProb(), PHG4BlockCellReco::process_event(), PHG4CylinderCellReco::process_event(), PHTpcTrackSeedCircleFit::process_event(), Acts::Legacy::AtlasSeedfinder< SpacePoint >::production3Sp(), ptwXY_div_s_ptwXY(), ptwXY_dullEdges(), ptwXY_exp_s(), ptwXY_fromUnitbase(), ptwXY_mul2_s_ptwXY(), ptwXY_thicken(), ptwXY_thicken_linear_dx(), ptwXY_toUnitbase(), pyboei(), pygamm(), pygrvd(), pygrvl(), pygrvm(), pygrvs(), pygrvv(), pyhigamm(), pymsin(), pyqqbh(), quench(), G4GaussLegendreQ::QuickIntegral(), CLHEP::HepRotation::rotate(), HepGeom::BasicVector3D< T >::rotateY(), HepGeom::BasicVector3D< T >::rotateZ(), G4IonCoulombCrossSection::SampleCosineTheta(), G4eIonisationSpectrum::SampleEnergy(), G4RDeIonisationSpectrum::SampleEnergy(), G4WentzelVIModel::SampleScattering(), PHG4ParticleGeneratorVectorMeson::set_decay_vertex_offset(), RawTowerGeomv2::set_size_x(), RawTowerZDCGeomv1::set_size_x(), RawTowerGeomv3::set_size_x(), ActsFatras::Particle::setDirection(), CML2Acc1::SetJawAperture(), CML2Acc2::SetJawAperture(), CML2AccSaturn::SetJawAperture(), G4RDPhotoElectricAngularGeneratorPolarized::SetPerpendicularVector(), G4LivermorePolarizedGammaConversionModel::SetPerpendicularVector(), G4LivermorePolarizedComptonModel::SetPerpendicularVector(), G4LivermorePolarizedPhotoElectricGDModel::SetPerpendicularVector(), G4LowEnergyPolarizedCompton::SetPerpendicularVector(), G4LowEPPolarizedComptonModel::SetPerpendicularVector(), PHG4EICForwardEcalDetector::SetTowerDimensions(), PHG4ForwardEcalDetector::SetTowerDimensions(), PHG4ForwardDualReadoutDetector::SetTowerDimensions(), G4Box::SetXHalfLength(), PHInitZVertexing::shift_coordinate_system(), PHPatternReco::shift_coordinate_system(), PHHoughSeeding::shift_coordinate_system(), kdfinder::CircleFit< T >::Sigma(), kdfinder::CircleFit< T >::SigmaWithLargeCircleOption(), G4Abla::spdef(), G4Trap::SurfaceNormal(), CLHEP::RandGaussQ::transformQuick(), GPUTPCTrackParam::TransportToX(), c2_quadratic_p< float_type >::value_with_derivatives(), vegas(), and G4EzVolume::VoxelizeIt().

__m128 dy = d*sn

Definition at line 160 of file HelixHough_allButKappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 160 of file HelixHough_allButKappaRange_sse.cpp

Referenced by G4HepRepFileSceneHandler::AddSolid(), G4HepRepSceneHandler::AddSolid(), G4Physics2DVector::BicubicInterpolation(), G4Para::BoundingLimits(), G4ExtrudedSolid::BoundingLimits(), G4HadronCrossSections::CalcScatteringCrossSections(), HelixKalman::calculate_dAdAp(), HelixKalmanFilter::calculate_dAdAp(), HelixHoughFuncs_v1::calculate_dzdl_range(), G4EllipticalTube::CalculateExtent(), G4Para::CalculateExtent(), G4ExtrudedSolid::CalculateExtent(), HelixDCAFunc::calcValGradHessian(), kdfinder::CircleFit< T >::ChiSqr(), kdfinder::CircleFit< T >::CircleFitByChernovHoussam(), G4DrawVoxels::ComputeVoxelPolyhedra(), Acts::IntegrationTest::constant_field_propagation(), G4MIRDLiver::Construct(), G4MIRDLeftLung::Construct(), G4MIRDLeftArmBone::Construct(), G4MIRDLowerLargeIntestine::Construct(), G4MIRDPelvis::Construct(), G4MIRDSmallIntestine::Construct(), G4MIRDUpperLargeIntestine::Construct(), G4MIRDHead::Construct(), G4MIRDLeftBreast::Construct(), G4MIRDMiddleLowerSpine::Construct(), G4MIRDRibCage::Construct(), G4MIRDRightBreast::Construct(), G4MIRDRightLung::Construct(), G4MIRDTrunk::Construct(), G4MIRDUpperSpine::Construct(), G4MIRDRightArmBone::Construct(), G4EicDircDetector::ConstructMe(), TSDetectorConstruction::ConstructWorld(), HepGeom::Point3D< float >::distance2(), HepGeom::Point3D< double >::distance2(), G4Box::DistanceToIn(), G4Trd::DistanceToIn(), G4Para::DistanceToIn(), G4Trap::DistanceToIn(), G4Trd::DistanceToOut(), G4Para::DistanceToOut(), G4Trap::DistanceToOut(), HelixHough::dzdlRange_sse(), G4GDMLReadSolids::ElconeRead(), G4GDMLReadSolids::EltubeRead(), export_G4Transform3D(), fit_all_update(), SimpleTrack3D::fit_track(), ZHough_Cylindrical::fitTrack(), VtxTrackFinder::fitTrack(), ThreeHitSeedGrower::fitTrack(), NHitSeedFinder::fitTrack(), FourHitSeedFinder::fitTrack(), sPHENIXTrackerTpc::fitTrack(), sPHENIXTracker::fitTrack(), sPHENIXSeedFinder::fitTrack(), FourHitSeedFinder::fitTrackLine(), kdfinder::Helix< T >::fudgePathLength(), G4VisCommandSceneAddLogo::G4Logo::G4Logo(), RE02PrimaryGeneratorAction::GeneratePrimaries(), PHG4TpcDistortion::get_y_distortion_cartesian(), GPUTPCTrackParam::GetDCAPoint(), GPUTPCTrackParam::GetDist2(), G4PenelopeBremsstrahlungFS::GetMomentumIntegral(), cheprep::DefaultHepRepPoint::getRho(), EmcCluster::GetSubClusters(), kdfinder::CircleFit< T >::GradientHessian(), hijcsc(), G4Trd::Inside(), G4Para::Inside(), G4Trap::Inside(), G4ExtrudedSolid::IsSameLine(), PHG4Utils::line_and_rectangle_intersect(), LXeMainVolume::LXeMainVolume(), main(), G4Trd::MakePlanes(), G4MuonVDNuclearModel::MakeSamplingTable(), PHSimpleKFProp::MoveToFirstTPCCluster(), CLHEP::Hep2Vector::operator Hep3Vector(), Acts::Test::MeasurementCreator::operator()(), kdfinder::CircleFit< T >::OptimalRadius(), HepGeom::BasicVector3D< G4double >::orthogonal(), kdfinder::Helix< T >::pathLength(), kdfinder::Helix< T >::pathLengths(), G4PhotoElectricAngularGeneratorPolarized::PerpendicularVector(), BEmcRec::PredictEnergy(), BEmcRec::PredictEnergyParam(), BEmcRec::PredictEnergyProb(), PHG4BlockCellReco::process_event(), PHG4CylinderCellReco::process_event(), PHTpcTrackSeedCircleFit::process_event(), Acts::Legacy::AtlasSeedfinder< SpacePoint >::production3Sp(), ptwXY_convolution(), ptwXY_exp_s(), pymsin(), pyplot(), quench(), CLHEP::HepRotation::rotate(), HepGeom::BasicVector3D< T >::rotateX(), HepGeom::BasicVector3D< T >::rotateZ(), G4WentzelVIModel::SampleScattering(), PHG4ParticleGeneratorVectorMeson::set_decay_vertex_offset(), RawTowerGeomv2::set_size_y(), RawTowerZDCGeomv1::set_size_y(), RawTowerGeomv3::set_size_y(), ActsFatras::Particle::setDirection(), CML2Acc1::SetJawAperture(), CML2Acc2::SetJawAperture(), CML2AccSaturn::SetJawAperture(), G4RDPhotoElectricAngularGeneratorPolarized::SetPerpendicularVector(), G4LivermorePolarizedComptonModel::SetPerpendicularVector(), G4LivermorePolarizedGammaConversionModel::SetPerpendicularVector(), G4LivermorePolarizedPhotoElectricGDModel::SetPerpendicularVector(), G4LowEnergyPolarizedCompton::SetPerpendicularVector(), G4LowEPPolarizedComptonModel::SetPerpendicularVector(), PHG4EICForwardEcalDetector::SetTowerDimensions(), PHG4ForwardEcalDetector::SetTowerDimensions(), PHG4ForwardDualReadoutDetector::SetTowerDimensions(), G4Box::SetYHalfLength(), PHInitZVertexing::shift_coordinate_system(), PHPatternReco::shift_coordinate_system(), PHHoughSeeding::shift_coordinate_system(), kdfinder::CircleFit< T >::Sigma(), kdfinder::CircleFit< T >::SigmaWithLargeCircleOption(), G4Trap::SurfaceNormal(), GPUTPCTrackParam::TransportToX(), PHG4ZDCSteppingAction::UserSteppingAction(), and G4EzVolume::VoxelizeIt().

__m128 dzds = dzdl*_vec_rsqrt_ps(one - dzdl*dzdl)

Definition at line 212 of file HelixHough_allButKappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 212 of file HelixHough_allButKappaRange_sse.cpp

const __m128 four = {4., 4., 4., 4.}
static

Definition at line 15 of file HelixHough_allButKappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 15 of file HelixHough_allButKappaRange_sse.cpp

Referenced by Acts::Test::BOOST_AUTO_TEST_CASE(), ludecy(), lustrf(), pydecy(), pyfscr(), pymihk(), pymirm(), pyprep(), pyreco(), and pystrf().

static __m128 __m128 __m128 __m128 & k
Initial value:
{
__m128 v = _mm_mul_ps(one_o_2, k)

Definition at line 92 of file HelixHough_allButKappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 92 of file HelixHough_allButKappaRange_sse.cpp

Referenced by __example_2.f__(), __example_3.f__(), EventAction::AddEdep(), G4MaterialPropertiesTable::AddEntry(), CylindricalHough::addHits(), G4MaterialPropertiesTable::AddProperty(), CLHEP::Ranlux64Engine::advance(), filter_msg_buffer::all_off(), filter_msg_buffer::all_on(), G4EnhancedVecAllocator< _Tp >::allocate(), G4VXTRenergyLoss::AngleXTRdEdx(), nlohmann::detail::dtoa_impl::append_exponent(), RecursiveMomentumContainer::append_list(), KFParticle_Tools::appendTracksToIntermediates(), PHPy8ParticleTrigger::Apply(), PHPy6ParticleTrigger::Apply(), G4EmBiasingManager::ApplyDirectionalSplitting(), G4EmBiasingManager::ApplyRangeCut(), G4EmBiasingManager::ApplyRussianRoulette(), G4EmBiasingManager::ApplySecondaryBiasing(), G4EmBiasingManager::ApplySplitting(), G4LowEIonFragmentation::ApplyYourself(), CexmcChargeExchangeProductionModel< OutputParticle >::ApplyYourself(), G4ParticleHPThermalScattering::ApplyYourself(), G4ExtrudedSolid::ApproxSurfaceNormal(), ar3jet(), arorie(), DetectorConstruction::AtomisticView(), atrobo(), attrad(), G4eBremsstrahlungSpectrum::AverageValue(), G4RDeBremsstrahlungSpectrum::AverageValue(), Acts::SolenoidBField::B_r(), Acts::SolenoidBField::B_z(), G4FissionBarrier::BarashenkovFissionBarrier(), G4Abla::barfit(), DetectorConstruction::BarycenterView(), EventAction::BeginOfEventAction(), G4hBetheBlochModel::BetheBlochFormula(), G4AnalyticalPolSolver::BiquadRoots(), HistoManager::Book(), RunAction::BookHisto(), Acts::Test::BOOST_AUTO_TEST_CASE(), G4Polyhedra::BoundingLimits(), G4Voxelizer::BuildBitmasks(), KFParticle_eventReconstruction::buildChain(), G4LossTableBuilder::BuildDEDXTable(), G4PenelopeRayleighModel::BuildFormFactorTable(), G4DNAModelInterface::BuildMaterialParticleModelTable(), KFParticle_Tools::buildMother(), G4PenelopeOscillatorManager::BuildOscillatorTable(), G4GammaGeneralProcess::BuildPhysicsTable(), G4LossTableBuilder::BuildRangeTable(), G4Voxelizer::BuildReduceVoxels(), G4Voxelizer::BuildReduceVoxels2(), G4AdjointCSManager::BuildTotalSigmaTables(), G4ConvergenceTester::calc_slope_fit(), HelixKalman::calculate_dAdAp(), HelixKalmanFilter::calculate_dAdAp(), HelixKalman::calculate_dApdp(), HelixKalmanFilter::calculate_dApdp(), CylinderKalman::calculate_dxda(), HelixKalmanFilter::calculate_dxda(), HelixHoughFuncs_v1::calculate_dzdl_range(), Packet_fvtx_dcm0::calculate_parity(), HelixHoughFuncs_v1::calculate_phi_range(), G4NeutronElectronElModel::CalculateAm(), G4AntiNuclElastic::CalculateAm(), G4NeutronElectronElXsc::CalculateAm(), G4DiffuseElasticV2::CalculateAm(), G4NuclNuclDiffuseElastic::CalculateAm(), G4DiffuseElastic::CalculateAm(), G4SPSEneDistribution::CalculateBbodySpectrum(), G4Radioactivation::CalculateChainsFromParent(), G4RadioactiveDecay::CalculateChainsFromParent(), G4ChipsAntiBaryonInelasticXS::CalculateCrossSection(), G4ChipsProtonInelasticXS::CalculateCrossSection(), G4ChipsKaonMinusInelasticXS::CalculateCrossSection(), G4ChipsHyperonInelasticXS::CalculateCrossSection(), G4ChipsPionMinusInelasticXS::CalculateCrossSection(), G4ChipsKaonPlusInelasticXS::CalculateCrossSection(), G4ChipsNeutronInelasticXS::CalculateCrossSection(), G4ChipsPionPlusInelasticXS::CalculateCrossSection(), G4RDGenerator2BN::Calculatedsdkdt(), G4Generator2BN::Calculatedsdkdt(), G4EllipticalTube::CalculateExtent(), G4Orb::CalculateExtent(), G4GenericPolycone::CalculateExtent(), G4BoundingEnvelope::CalculateExtent(), G4Polycone::CalculateExtent(), G4Polyhedra::CalculateExtent(), G4CutTubs::CalculateExtent(), G4EllipticalCone::CalculateExtent(), G4Tubs::CalculateExtent(), G4Torus::CalculateExtent(), G4ExtrudedSolid::CalculateExtent(), G4Cons::CalculateExtent(), G4TessellatedSolid::CalculateExtent(), sPHENIXTrackerTpc::calculateKappaTangents(), sPHENIXTracker::calculateKappaTangents(), sPHENIXSeedFinder::calculateKappaTangents(), G4DNAScreenedRutherfordElasticModel::CalculatePolynomial(), G4DNAUeharaScreenedRutherfordElasticModel::CalculatePolynomial(), G4GNASHTransitions::CalculateProbability(), CylinderKalman::calculateScatteringVariance(), HelixKalmanFilter::calculateScatteringVariance(), CexmcReconstructor::CalculateWeightedEPPosition(), HelixDCAFunc::calcValGradHessian(), FitNewton::ChiSquareGradHessian::calcValGradHessianThread1(), FitNewton::GaussianRegGradHessian::calcValGradHessianThread1(), CexmcEnergyDepositDigitizer::CexmcEnergyDepositDigitizer(), G4BoundingEnvelope::CheckBoundingPolygons(), G4Tet::CheckDegeneracy(), CexmcPhaseSpaceGenerator::CheckKinematics(), G4PVPlacement::CheckOverlaps(), CML2WorldConstruction::checkVolumeOverlap(), Rossegger::CheckZeroes(), cleanup(), G4PenelopeOscillatorManager::Clear(), G4Clebsch::ClebschGordanCoeff(), G4BoundingEnvelope::ClipEdgesByVoxel(), CMDistortionAnalysis(), CMDistortionAnalysisCart(), CMDistortionAnalysisPhiR(), CMDistortionReco(), CMDistortionRecoCart(), CMDistortionRecoPhiR(), G4UIGAG::CodeGenTclTree(), CexmcReconstructor::CollectEDInAdjacentCrystals(), compressevent(), nanoflann::KDTreeSingleIndexAdaptor< nanoflann::L2_Simple_Adaptor< double, kdfinder::KDPointCloud< double > >, kdfinder::KDPointCloud< double >, 3 >::computeBoundingBox(), G4eBremsstrahlungRelModel::ComputeBremLoss(), G4XrayRayleighModel::ComputeCrossSectionPerAtom(), G4mplIonisationModel::ComputeDEDXAhlen(), G4mplIonisationWithDeltaModel::ComputeDEDXAhlen(), G4ExtrudedSolid::ComputeLateralPlanes(), PDBlib::ComputeMatchEdepDNA(), G4SandiaTable::ComputeMatSandiaMatrix(), G4SandiaTable::ComputeMatSandiaMatrixPAI(), G4SandiaTable::ComputeMatTable(), G4IonisParamMat::ComputeMeanParameters(), PDBlib::ComputeNbNucleotidsPerStrand(), PDBlib::ComputeNucleotideBarycenters(), G4PhysicsVector::ComputeSecondDerivatives(), G4eBremsstrahlungRelModel::ComputeXSectionPerAtom(), G4UCNMaterialPropertiesTable::ConditionsValid(), H02DetectorConstruction::Construct(), F04ElementField::Construct(), XrayFluoPlaneDetectorConstruction::ConstructApparate(), XrayFluoDetectorConstruction::ConstructApparate(), DetectorConstruction::ConstructCalorimeter(), G4RDGenerator2BN::ConstructMajorantSurface(), G4Generator2BN::ConstructMajorantSurface(), PHG4EPDDetector::ConstructMe(), G4EicDircDetector::ConstructMe(), GammaRayTelDetectorConstruction::ConstructPayload(), PHG4ProjCrystalCalorimeterDetector::ConstructProjectiveCrystals(), TSDetectorConstruction::ConstructWorld(), oncsEvent::convert(), oncsSubevent::convert(), A_Event::convert(), Packet_A::convert(), converttohepmc(), Acts::ConvexPolygonBoundsBase::convex_impl(), G4DataInterpolation::CorrelatedSearch(), oncsSub_idtpcfeev2::crc16(), create_element(), G4ProcessManager::CreateGPILvectors(), G4BoundingEnvelope::CreateListOfEdges(), G4BoundingEnvelope::CreateListOfPlanes(), G4VTwistedFaceted::CreatePolyhedron(), G4TwistedTubs::CreatePolyhedron(), G4CutTubs::CreatePolyhedron(), G4TessellatedSolid::CreatePolyhedron(), HepPolyhedron::createPolyhedron(), G4TessellatedSolid::CreateVertexList(), csz__huft_build(), csz__Inflate_block(), csz__Inflate_codes(), csz__Inflate_dynamic(), csz__Inflate_stored(), G4AnalyticalPolSolver::CubicRoots(), G4DataInterpolation::CubicSplineInterpolation(), CLHEP::DoubConv::d2x(), G4EnhancedVecAllocator< _Tp >::deallocate(), G4FermiPhaseSpaceDecay::Decay(), oncsSub_id4evt::decode(), oncsSub_id2evt::decode(), Packet_id2evt::decode(), Packet_id4evt::decode(), Packet_gl1psum::decode(), Packet_iddigitizerv2::decode(), oncsSub_iduppetdata_v104::decode(), oncsSub_idbspetdata::decode(), oncsSub_idrcpetdata::decode(), oncsSub_iduppetdata::decode(), Packet_gl1_evclocks::decode(), Packet_cdevir::decode(), Packet_cdevwcm::decode(), Packet_cdevmadch::decode(), Packet_cdevbpm::decode(), Packet_cdevdvm::decode(), Packet_hbd_fpgashort::decode(), Packet_cdevpoltarget::decode(), Packet_hbd_fpga::decode(), Packet_cdevbuckets::decode(), oncsSub_iddreamv0::decode(), Packet_cdevring::decode(), Packet_fvtx_dcm0::decode(), Packet_cdevringnopol::decode(), Packet_gl1p::decode(), Packet_id4scaler::decode(), Packet_cdevpolarimeter::decode(), Packet_gl1::decode(), decode_idhammond(), Packet_fvtx_dcm0::decode_misc(), G4VFieldModel::DescribeYourselfTo(), CexmcScenePrimitives::DescribeYourselfTo(), G4ErrorMatrix::dfact_matrix(), G4ErrorMatrix::dfinv_matrix(), G4DNABornIonisationModel1::DifferentialCrossSection(), G4DNABornIonisationModel2::DifferentialCrossSection(), G4DNAEmfietzoglouIonisationModel::DifferentialCrossSection(), G4DNACPA100IonisationModel::DifferentialCrossSection(), G4MicroElecInelasticModel::DifferentialCrossSection(), G4MuElecInelasticModel::DifferentialCrossSection(), G4DNARuddIonisationModel::DifferentialCrossSection(), CexmcTrackPointsDigitizer::Digitize(), CexmcEnergyDepositDigitizer::Digitize(), oncsSub_iddigitizerv1::digitizer_decode(), G4Abla::direct(), G4VTwistSurface::DistanceToIn(), G4Tet::DistanceToOut(), G4TwistBoxSide::DistanceToSurface(), G4TwistTrapAlphaSide::DistanceToSurface(), G4TwistTrapParallelSide::DistanceToSurface(), G4TwistTubsSide::DistanceToSurface(), nanoflann::KDTreeSingleIndexAdaptor< nanoflann::L2_Simple_Adaptor< double, kdfinder::KDPointCloud< double > >, kdfinder::KDPointCloud< double >, 3 >::divideTree(), dofistatescat(), doinstatescat(), dokinematics(), G4ScreenedCoulombClassicalKinematics::DoScreeningComputation(), oncsSub_iduppetparams::dump(), Packet_gl1_evclocks::dump(), oncsSub_idfnalmwpc::dump(), oncsSub_idfnalmwpcv2::dump(), Packet_gl1p::dump(), G4FermiFragmentsPoolVI::Dump(), Packet_id4scaler::dump(), G4PenelopeOscillatorManager::Dump(), Packet_gl1::dump(), G4EmModelManager::DumpModelList(), G4PolarizationTransition::DumpTransitionData(), HelixHough::dzdlRange_sse(), ei(), eix(), eixint(), G4hImpactIonisation::ElectronicLossFluctuation(), TrackerSD::EndOfEvent(), HadrontherapyEventAction::EndOfEventAction(), CCalEventAction::EndOfEventAction(), EventAction::EndOfEventAction(), CexmcEventAction::EndOfEventAction(), RE06RunAction::EndOfRunAction(), Rossegger::Ephi(), Rossegger::Ephi_(), expai(), expaid(), G4BulirschStoer::extrapolate(), Acts::fieldMapperXYZ(), PHG4ProjCrystalCalorimeterDetector::Fill4x4Unit(), CLHEP::DoubConv::fill_byte_order(), TrackFastSimEval::fill_track_tree(), KFParticle_nTuple::fillBranch(), G4EmModelManager::FillDEDXVector(), G4EmModelManager::FillLambdaVector(), KFParticle_DST::fillParticleNode_Particle(), KFParticle_DST::fillParticleNode_Track(), G4PhysicsVector::FillSecondDerivatives(), PHG4ProjCrystalCalorimeterDetector::FillSpecialUnit(), DicomRunAction::FillString(), B01RunAction::FillString(), B03RunAction::FillString(), B02RunAction::FillString(), G4CascadeFinalStateAlgorithm::FillUsingKopylov(), filter_msg_buffer::filter_msg_buffer(), PHInitZVertexing::find_track_candidates_z_init(), PHPatternReco::find_track_candidates_z_init(), kdfinder::find_vertex_seeds(), Rossegger::FindMunk(), HepPolyhedron::FindNodeNormal(), G4DNASmoluchowskiReactionModel::FindReaction(), FourHitSeedFinder::findTracks_3_4(), sPHENIXTrackerTpc::findTracksBySegments(), sPHENIXTracker::findTracksBySegments(), sPHENIXSeedFinder::findTracksBySegments(), CLHEP::RandGamma::fire(), fit_all_update(), PHInitZVertexing::fit_vertex(), PHPatternReco::fit_vertex(), ZHough_Cylindrical::fitTrack(), VtxTrackFinder::fitTrack(), ThreeHitSeedGrower::fitTrack(), NHitSeedFinder::fitTrack(), FourHitSeedFinder::fitTrack(), sPHENIXTrackerTpc::fitTrack(), sPHENIXTracker::fitTrack(), sPHENIXSeedFinder::fitTrack(), FourHitSeedFinder::fitTrackLine(), Run::FlowInCavity(), PHCASeeding::FollowBiLinks(), nlohmann::detail::dtoa_impl::format_buffer(), G4ecpssrBaseKxsModel::FunctionFK(), G4ecpssrBaseLixsModel::FunctionFL1(), G4ecpssrBaseLixsModel::FunctionFL2(), G3fillParams(), G4BulirschStoer::G4BulirschStoer(), G4DataInterpolation::G4DataInterpolation(), G4ErrorMatrix::G4ErrorMatrix(), G4GaussHermiteQ::G4GaussHermiteQ(), G4GaussJacobiQ::G4GaussJacobiQ(), G4GaussLaguerreQ::G4GaussLaguerreQ(), G4GaussLegendreQ::G4GaussLegendreQ(), G4GenericTrap::G4GenericTrap(), G4HumanPhantomAnalysisManager::G4HumanPhantomAnalysisManager(), G4KDTree::G4KDTree(), G4LatticeLogical::G4LatticeLogical(), G4RandomRadiusInRing(), G4RPGNucleonInelastic::G4RPGNucleonInelastic(), G4RPGPionInelastic::G4RPGPionInelastic(), G4INCL::PhaseSpaceKopylov::generate(), generate_distortion_map(), G4SPSEneDistribution::GenerateBremEnergies(), G4PolarizationTransition::GenerateGammaCosTheta(), G4PolarizationTransition::GenerateGammaPhi(), G4HadPhaseSpaceKopylov::GenerateMultiBody(), genevent(), nlohmann::detail::dtoa_impl::get_cached_power_for_binary_exponent(), G4VXTRenergyLoss::GetAngleVector(), GetAngularGaps(), G4CrystalExtension::GetCijkl(), G4HCtable::GetCollectionID(), G4DCtable::GetCollectionID(), G4NuclNuclDiffuseElastic::GetCoulombElasticXsc(), G4DiffuseElastic::GetCoulombElasticXsc(), G4NuclNuclDiffuseElastic::GetCoulombIntegralXsc(), G4DiffuseElastic::GetCoulombIntegralXsc(), G4NuclNuclDiffuseElastic::GetCoulombTotalXsc(), G4DiffuseElastic::GetCoulombTotalXsc(), GPUTPCTrackParam::GetDCAPoint(), getdeltat(), G4hhElastic::GetdsdtF13qQG(), G4hhElastic::GetF1(), G4hhElastic::GetF1qQgG(), G4hhElastic::GetF2(), G4hhElastic::GetF2qQgG(), G4hhElastic::GetF3(), G4hhElastic::GetF3qQgG(), HepPolyhedron::GetFacet(), G4TwistTrapFlatSide::GetFacets(), G4TwistTubsFlatSide::GetFacets(), G4TwistTubsSide::GetFacets(), G4TwistBoxSide::GetFacets(), G4TwistTrapParallelSide::GetFacets(), G4TwistTubsHypeSide::GetFacets(), G4TwistTrapAlphaSide::GetFacets(), PHField3DCartesian::GetFieldValue(), G4OpenGLFontBaseStore::GetFontInfo(), G4RPGNucleonInelastic::GetFSPartTypesForT0(), G4RPGNucleonInelastic::GetFSPartTypesForT1(), G4RPGPionInelastic::GetFSPartTypesForT12(), G4RPGPionInelastic::GetFSPartTypesForT32(), G4PhotoNuclearCrossSection::GetFunctions(), G4ElectroNuclearCrossSection::GetFunctions(), G4Abla::gethyperbinding(), G4PSNofSecondary3D::GetIndex(), G4PSNofStep3D::GetIndex(), G4PSTermination3D::GetIndex(), G4PSPopulation3D::GetIndex(), G4PSStepChecker3D::GetIndex(), G4PSEnergyDeposit3D::GetIndex(), G4PSNofCollision3D::GetIndex(), G4PSPassageCellCurrent3D::GetIndex(), G4PSTrackCounter3D::GetIndex(), G4PSDoseDeposit3D::GetIndex(), G4PSCellCharge3D::GetIndex(), G4PSMinKinEAtGeneration3D::GetIndex(), G4PSTrackLength3D::GetIndex(), G4PSPassageTrackLength3D::GetIndex(), G4PSPassageCellFlux3D::GetIndex(), G4PSCellFlux3D::GetIndex(), G4PSFlatSurfaceCurrent3D::GetIndex(), G4PSCylinderSurfaceFlux3D::GetIndex(), G4PSCylinderSurfaceCurrent3D::GetIndex(), G4PSFlatSurfaceFlux3D::GetIndex(), G4PSSphereSurfaceFlux3D::GetIndex(), G4PSSphereSurfaceCurrent3D::GetIndex(), HadrontherapyRBEAccumulable::GetIndex(), G4CrystalUnitCell::GetIntSp2(), G4RDVeLowEnergyLoss::GetLossWithFluct(), getmass(), G4RPGNucleonInelastic::GetMultiplicityT0(), G4RPGNucleonInelastic::GetMultiplicityT1(), G4RPGPionInelastic::GetMultiplicityT12(), G4RPGPionInelastic::GetMultiplicityT32(), getnewmass(), HepPolyhedron::GetNextVertex(), GetNormalizedAngularRange(), RE06Run::GetParaValue(), G4PenelopeRayleighModel::GetPMaxTable(), getpnorad1(), G4BooleanSolid::GetPointOnSurface(), G4EllipticalTube::GetPointOnSurface(), G4Ellipsoid::GetPointOnSurface(), G4Trd::GetPointOnSurface(), G4Para::GetPointOnSurface(), G4EllipticalCone::GetPointOnSurface(), G4Trap::GetPointOnSurface(), PhysicsList::GetProcess(), G4ProcessManager::GetProcess(), getqvec(), G4CrystalUnitCell::GetRecIntSp2(), G4ScoringCylinder::GetRZPhi(), GPUTPCTrackParam::GetS(), UltraFresnelLens::GetSagita(), PHG4mRICHDetector::LensPar::GetSagita(), gridBoxFactory(), nlohmann::detail::dtoa_impl::grisu2_digit_gen(), guout(), gutrak(), gutrev(), HepPolyhedron::HepPolyhedron(), HepPolyhedronCons::HepPolyhedronCons(), HepPolyhedronEllipticalCone::HepPolyhedronEllipticalCone(), HepPolyhedronHype::HepPolyhedronHype(), HepPolyhedronParaboloid::HepPolyhedronParaboloid(), hiboost(), hijcsc(), hijfrg(), hijhrd(), hijing(), hirobo(), G4InitXscPAI::ImPartDielectricConst(), G4PAIySection::ImPartDielectricConst(), G4PAIxSection::ImPartDielectricConst(), HadrontherapyRBE::Index(), HadrontherapyMatrix::Index(), init(), G4ParticleHPFFFissionFS::Init(), G4PAIPhotData::Initialise(), G4FermiFragmentsPoolVI::Initialise(), G4PAIModelData::Initialise(), G4EmModelManager::Initialise(), G4VAtomDeexcitation::InitialiseAtomicDeexcitation(), G4NuMuNucleusCcModel::InitialiseModel(), G4NuMuNucleusNcModel::InitialiseModel(), G4ElasticHadrNucleusHE::InitialiseModel(), ExN04CalorimeterSD::Initialize(), RE05CalorimeterSD::Initialize(), RE01CalorimeterSD::Initialize(), CexmcEnergyDepositDigitizer::InitializeData(), G4PenelopeRayleighModel::InitializeSamplingAlgorithm(), initpythia(), PHG4TpcCentralMembrane::InitRun(), G4PAIySection::IntegralCerenkov(), G4PAIxSection::IntegralCerenkov(), G4InitXscPAI::IntegralCherenkov(), G4PAIxSection::IntegralMM(), G4InitXscPAI::IntegralPAIdEdx(), G4InitXscPAI::IntegralPAIxSection(), G4PAIxSection::IntegralPAIxSection(), G4PAIySection::IntegralPAIySection(), G4InitXscPAI::IntegralPlasmon(), G4PAIySection::IntegralPlasmon(), G4PAIxSection::IntegralPlasmon(), G4PAIxSection::IntegralResonance(), G4ParticleHPLegendreStore::Integrate(), G4BogackiShampine45::InterpolateHigh(), G4UCNMicroRoughnessHelper::IntIminus(), G4eBremsstrahlungSpectrum::IntSpectrum(), G4RDeBremsstrahlungSpectrum::IntSpectrum(), G4ErrorSymMatrix::invertBunchKaufman(), HepPolyhedron::InvertFacets(), CexmcProductionModel::IsGoodCandidateForAngularRange(), isprimhadron(), isprimstring(), issecstring(), oncsSub_iddreamv0::iValue(), Packet_id4scaler::iValue(), jewel(), G4HadronPhysicsQGS_BIC::Kaon(), G4HadronPhysicsFTF_BIC::Kaon(), G4HadronPhysicsShieldingLEND::Kaon(), G4HadronPhysicsShielding::Kaon(), G4HadronPhysicsFTFP_BERT::Kaon(), G4HadronPhysicsINCLXX::Kaon(), nlohmann::detail::json_sax_dom_callback_parser< BasicJsonType >::key(), G4InitXscPAI::KillCloseIntervals(), G4QMDGroundStateNucleus::killCMMotionAndAngularM(), klu(), ksdet(), ksdetd(), ksdeth(), ksdetu(), ksmate(), ksmixt(), kspart(), ksposp(), kstmed(), ksvolu(), AnnularFieldSim::load_and_resample_spacecharge(), AnnularFieldSim::load_spacecharge(), G4ShellData::LoadData(), G4RDShellData::LoadData(), G4BremsstrahlungParameters::LoadData(), G4eIonisationParameters::LoadData(), G4RDeIonisationParameters::LoadData(), G4RDBremsstrahlungParameters::LoadData(), G4FluoData::LoadData(), G4RDFluoData::LoadData(), G4ShellEMDataSet::LoadData(), G4AugerData::LoadData(), G4RDAugerData::LoadData(), G4RDVCrossSectionHandler::LoadData(), G4VCrossSectionHandler::LoadData(), XrayFluoDataSet::LoadData(), AnnularFieldSim::loadField(), G4ShellEMDataSet::LoadNonLogData(), G4VCrossSectionHandler::LoadNonLogData(), G4EMDataSet::LoadNonLogData(), XrayFluoSiLiDetectorType::LoadResponseData(), XrayFluoHPGeDetectorType::LoadResponseData(), G4RDVCrossSectionHandler::LoadShellData(), Rossegger::LoadZeroes(), G4DataInterpolation::LocateArgument(), lu1ent(), lu2ent(), lu3ent(), lu4ent(), luboei(), lucell(), luclus(), ludecy(), luedit(), lueevt(), luerrm(), luexec(), lufowo(), lugive(), luhepc(), luindf(), lujmas(), lujoin(), lulist(), luonia(), luprep(), lurobo(), lushow(), lusphe(), lustrf(), lutabu(), lutest(), luthru(), luxdif(), Packet_id4scaler::lValue(), LXeMainVolume::LXeMainVolume(), main(), makebranch(), makecascade(), makeinsplit(), G4Trap::MakePlanes(), makesplitting(), makestrings_minl(), makestrings_vac(), Acts::materialMapperXYZ(), Run::Merge(), DecayFinder::multiplyVectorByScalarAndSort(), CLHEP::Hep3Vector::negativeInfinity(), G4PAIySection::NormShift(), G4PAIxSection::NormShift(), G4MagInt_Driver::OneGoodStep(), G4ErrorMatrix::operator+=(), G4ErrorMatrix::operator-=(), operator<<(), G4ErrorMatrix::operator=(), HepPolyhedron::operator=(), G4MapCache< KEYTYPE, VALTYPE >::operator[](), G4QMDGroundStateNucleus::packNucleons(), parseArgs(), G4DNARuddIonisationModel::PartialCrossSection(), G4DNARuddIonisationExtendedModel::PartialCrossSection(), Run::ParticleCount(), G4LindhardRobinsonPartition::PartitionNIEL(), kdfinder::Helix< T >::pathLengths(), pevrec(), PHField3DCartesian::PHField3DCartesian(), HelixHough::phiRange_sse(), G4PhotoElectricAngularGeneratorPolarized::PhotoElectronGetMajorantSurfaceAandCParameters(), G4RDPhotoElectricAngularGeneratorPolarized::PhotoElectronGetMajorantSurfaceAandCParameters(), plu(), HepGeom::Plane3D< G4double >::point(), G4GeomTools::PointInPolygon(), G4RDGenerator2BN::PolarAngle(), G4DataInterpolation::PolynomInterpolation(), AnnularFieldSim::populate_highres_lookup(), G4LowEnergyPhotoElectric::PostStepDoIt(), pqdownheap(), Rossegger::PrecalcDerivedConstants(), G4PenelopeBremsstrahlungAngular::PrepareTables(), G4RDeIonisationParameters::PrintData(), G4eIonisationParameters::PrintData(), G4FluoData::PrintData(), G4RDFluoData::PrintData(), G4RDAugerData::PrintData(), G4AugerData::PrintData(), CexmcRunAction::PrintResults(), G4UCNMicroRoughnessHelper::ProbIminus(), PHTpcTracker::Process(), PHHybridSeeding::Process(), PHHepMCParticleSelectorDecayProductChain::process_event(), ParticleFlowReco::process_event(), PHGenFitTrackProjection::process_event(), CellularAutomaton_v1::process_single_track(), CellularAutomaton_v1::process_single_triplet(), HadrontherapyDetectorSD::ProcessHits(), sPHENIXTracker::projectToLayer(), sPHENIXSeedFinder::projectToLayer(), PHSimpleKFProp::PropagateTrack(), ptwXY_div_ptwXY(), ptwXY_mergeClosePoints(), py1ent(), py2ent(), py2frm(), py3ent(), py4ent(), py4frm(), py4jet(), py4jts(), py4jtw(), py6frm(), pyadsh(), pybesq(), pyboei(), pycba2(), pycbal(), pycell(), pyckbd(), pyclus(), pycmq2(), pyct5l(), pyct5m(), pycttr(), pydecy(), pydiff(), pydisg(), pydocu(), pyedit(), pyeevt(), pyerrm(), pyevnt(), pyevnw(), pyevol(), pyexec(), pyfowo(), pyfscr(), pygaga(), pygive(), pyhepc(), pyhidiff(), pyhiinki(), pyhimult(), pyhiremn(), pyhiresd(), pyhiscat(), pyhisspa(), pyhitest(), pyhithia(), pyinbm(), pyindf(), pyinki(), pyinom(), pyjmas(), pyjoin(), pyjurf(), pyk(), pyklim(), pyldcm(), pylist(), pymemx(), pymewt(), pymign(), pymihg(), pymihk(), pymirm(), pymult(), pyonia(), pyp(), pypdfu(), pyprep(), pyptfs(), pyptis(), pyptmi(), pyr(), pyreco(), pyremn(), pyresd(), pyrobo(), pyrvsf(), pyscat(), pyshow(), pysigh(), pyslha(), pysphe(), pysspa(), pystrf(), pytabu(), pytaud(), pytbdy(), pytest(), pythia(), pythru(), pyupev(), pyupin(), pyveto(), pyxdif(), G4AnalyticalPolSolver::QuarticRoots(), G4InuclSpecialFunctions::randomInuclPowers(), G4MuElecInelasticModel::RandomizeEjectedElectronDirection(), G4DNACPA100IonisationModel::RandomizeEjectedElectronDirection(), G4DNAPTBIonisationModel::RandomizeEjectedElectronDirection(), G4DNABornIonisationModel2::RandomizeEjectedElectronEnergy(), G4MuElecInelasticModel::RandomizeEjectedElectronEnergy(), G4DNAEmfietzoglouIonisationModel::RandomizeEjectedElectronEnergy(), G4DNABornIonisationModel1::RandomizeEjectedElectronEnergy(), G4MicroElecInelasticModel::RandomizeEjectedElectronEnergy(), G4DNACPA100IonisationModel::RandomizeEjectedElectronEnergy(), G4DNAPTBIonisationModel::RandomizeEjectedElectronEnergy(), G4DNAEmfietzoglouIonisationModel::RandomTransferedEnergy(), G4DNACPA100IonisationModel::RandomTransferedEnergy(), G4ScreeningMottCrossSection::RatioMottRutherfordCosT(), G4DataInterpolation::RationalPolInterpolation(), RE01CalorimeterSD::RE01CalorimeterSD(), Read(), XrayFluoRunAction::ReadData(), G4PenelopeBremsstrahlungAngular::ReadDataFile(), G4PenelopePhotoElectricModel::ReadDataFile(), DicomPhantomZSliceHeader::ReadDataFromFile(), CexmcSetup::ReadRightDetectors(), RecursiveMomentumContainer::RecursiveMomentumContainer(), G4HadronicProcessStore::RegisterInteraction(), CexmcRunManager::RegisterScenePrimitives(), G4GeomTools::RemoveRedundantVertices(), DetectorConstruction::ResiduesView(), G4Physics2DVector::Retrieve(), G4GMocrenIO::retrieveData4(), rlu(), Rossegger::Rnk(), HepPolyhedron::RotateAroundZ(), Run::Run(), FW::RootBFieldWriter< bfield_t >::run(), G4InitXscPAI::RutherfordIntegral(), G4PAIySection::RutherfordIntegral(), G4PAIxSection::RutherfordIntegral(), G4LEPTSDistribution::Sample(), G4Generator2BN::SampleDirection(), G4DNARuddAngle::SampleDirectionForShell(), G4DNABornAngle::SampleDirectionForShell(), G4UniversalFluctuation::SampleFluctuations(), G4PenelopeBremsstrahlungFS::SampleGammaEnergy(), G4PolarizationTransition::SampleGammaTransition(), G4XrayRayleighModel::SampleSecondaries(), G4DNARuddIonisationModel::SampleSecondaries(), G4DNARuddIonisationExtendedModel::SampleSecondaries(), G4LivermoreGammaConversionModelRC::SampleSecondaries(), G4DNABornExcitationModel1::SampleSecondaries(), G4DNABornIonisationModel2::SampleSecondaries(), G4DNABornIonisationModel1::SampleSecondaries(), G4DNABornExcitationModel2::SampleSecondaries(), G4DNAEmfietzoglouExcitationModel::SampleSecondaries(), G4DNAEmfietzoglouIonisationModel::SampleSecondaries(), G4DNATransformElectronModel::SampleSecondaries(), G4DNACPA100ExcitationModel::SampleSecondaries(), G4DNACPA100IonisationModel::SampleSecondaries(), G4MuElecInelasticModel::SampleSecondaries(), G4MicroElecInelasticModel::SampleSecondaries(), G4DNAPTBExcitationModel::SampleSecondaries(), G4DNAPTBIonisationModel::SampleSecondaries(), G4TDNAOneStepThermalizationModel< MODEL >::SampleSecondaries(), G4PenelopeSamplingData::SampleValue(), G4SandiaTable::SandiaMixing(), G4RDShellEMDataSet::SaveData(), G4MicroElecCrossSectionDataSet::SaveData(), G4MuElecCrossSectionDataSet::SaveData(), G4ShellEMDataSet::SaveData(), G4DNACrossSectionDataSet::SaveData(), G4CrossSectionDataSet::SaveData(), Rossegger::SaveZeroes(), G4DNAScreenedRutherfordElasticModel::ScreeningFactor(), G4DNAUeharaScreenedRutherfordElasticModel::ScreeningFactor(), kdfinder::LinearFit< T >::select(), G4RDVCrossSectionHandler::SelectRandomAtom(), G4VCrossSectionHandler::SelectRandomAtom(), G4PixeCrossSectionHandler::SelectRandomAtom(), G4RDVCrossSectionHandler::SelectRandomElement(), G4VCrossSectionHandler::SelectRandomElement(), G4PenelopePhotoElectricModel::SelectRandomShell(), G4ScreenedCoulombCrossSection::SelectRandomUnweightedTarget(), G4BulirschStoer::set_k_opt(), filter_msg_buffer::set_severity_below_threshold(), filter_msg_buffer::set_source(), filter_msg_buffer::set_type(), G4LogicalCrystalVolume::SetMillerOrientation(), G4VLongitudinalStringDecay::SetMinMasses(), G4VPrimitiveScorer::SetNijk(), CexmcPhaseSpaceGenerator::SetParticles(), G4LivermorePolarizedPhotoElectricGDModel::SetPhi(), CLHEP::MTwistEngine::setSeed(), CLHEP::HepJamesRandom::setSeed(), CexmcProductionModel::SetTriggeredAngularRanges(), G4EmCorrections::ShellCorrectionSTD(), G4ConvergenceTester::slope_fitting_function(), G4Torus::SolveNumericJT(), G4XTRRegularRadModel::SpectralXTRdEdx(), G4XTRTransparentRegRadModel::SpectralXTRdEdx(), G4RegularXTRadiator::SpectralXTRdEdx(), G4TransparentRegXTRadiator::SpectralXTRdEdx(), XTRTransparentRegRadModel::SpectralXTRdEdx(), G4PAIySection::SplainPAI(), G4PAIxSection::SplainPAI(), HadrontherapyMatrix::StoreDoseFluenceAscii(), HadrontherapyMatrix::StoreMatrix(), SubstractSolids(), EventAction::SumEnergy(), G4Tet::SurfaceNormal(), G4ExtrudedSolid::SurfaceNormal(), G4MicroElecElasticModel::Theta(), G4MuElecElasticModel::Theta(), G4DNAChampionElasticModel::Theta(), G4DNAIonElasticModel::Theta(), G4DNAELSEPAElasticModel::Theta(), G4DNACPA100ElasticModel::Theta(), tog4(), G4HumanPhantomRunAction::totalRunEnergyDeposit(), G4DNABornIonisationModel2::TransferedEnergy(), G4DNABornIonisationModel1::TransferedEnergy(), G4MicroElecInelasticModel::TransferedEnergy(), GPUTPCTrackParam::TransportToX(), G4BulirschStoer::try_step(), ugeom(), uginit(), uglast(), G4UIcommand::UnitsList(), CylinderKalman::updateIntersection(), HelixKalmanFilter::updateIntersection(), CexmcEventAction::UpdateRunHits(), PHG4CrystalCalorimeterSteppingAction::UserSteppingAction(), PHG4HybridHomogeneousCalorimeterSteppingAction::UserSteppingAction(), vegas(), w6j1(), G4Clebsch::Wigner6J(), G4Clebsch::WignerLittleD(), xsecint(), G4ElasticHadrNucleusHE::~G4ElasticHadrNucleusHE(), G4LossTableManager::~G4LossTableManager(), G4RDShellVacancy::~G4RDShellVacancy(), G4ShellVacancy::~G4ShellVacancy(), oncsSub_idfnalmwpc::~oncsSub_idfnalmwpc(), and RecursiveMomentumContainer::~RecursiveMomentumContainer().

k0val = _mm_mul_ps(x3, ux)

Definition at line 64 of file HelixHough_allButKappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 64 of file HelixHough_allButKappaRange_sse.cpp

__m128 k2 = _mm_mul_ps(k, k)

Definition at line 26 of file HelixHough_allButKappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 26 of file HelixHough_allButKappaRange_sse.cpp

Referenced by Acts::SolenoidBField::B_r(), Acts::SolenoidBField::B_z(), HelixKalman::calculate_dAdAp(), HelixKalmanFilter::calculate_dAdAp(), CylinderKalman::calculate_dxda(), HelixKalmanFilter::calculate_dxda(), G4RDGenerator2BN::Calculatedsdkdt(), G4Generator2BN::Calculatedsdkdt(), G4GenericPolycone::CalculateExtent(), G4Polycone::CalculateExtent(), G4GenericTrap::CalculateExtent(), GPUTPCTrackParam::CalculateFitParameters(), cg3(), G4Element::ComputeCoulombFactor(), G4SandiaTable::ComputeMatSandiaMatrixPAI(), G4SandiaTable::ComputeMatTable(), G4MuBremsstrahlungModel::ComputeMicroscopicCrossSection(), GFlashHomoShowerParameterisation::ComputeRadialParameters(), GFlashSamplingShowerParameterisation::ComputeRadialParameters(), G4MuBremsstrahlungModel::ComputMuBremLoss(), G4Tet::CreatePolyhedron(), G4PenelopeComptonModel::DifferentialCrossSection(), CLHEP::RanecuEngine::flat(), CLHEP::RanecuEngine::flatArray(), FW::RandomNumbers::generateSeed(), G4CrystalUnitCell::GetIntSp2(), HepPolyhedron::GetNextEdgeIndices(), G4CrystalUnitCell::GetRecIntSp2(), HepPolyhedronHype::HepPolyhedronHype(), HepPolyhedronParaboloid::HepPolyhedronParaboloid(), G4UCNMicroRoughnessHelper::IntIplus(), CLHEP::RanecuEngine::operator unsigned int(), pyqqbh(), pysugi(), G4DNAPTBIonisationModel::RandomizeEjectedElectronEnergyFromCumulated(), G4DNAEmfietzoglouIonisationModel::RandomTransferedEnergy(), G4DNACPA100IonisationModel::RandomTransferedEnergy(), rk4step(), HepPolyhedron::RotateEdge(), G4PolarizationTransition::SampleGammaTransition(), G4SandiaTable::SandiaIntervals(), HepPolyhedron::SetReferences(), HepPolyhedron::SetSideFacets(), G4UCNMaterialPropertiesTable::TransConditionsValid(), G4DNABornIonisationModel2::TransferedEnergy(), G4DNABornIonisationModel1::TransferedEnergy(), G4MicroElecInelasticModel::TransferedEnergy(), and w6j1().

kd1 = _mm_mul_ps(k2, tmp1)

Definition at line 60 of file HelixHough_allButKappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 60 of file HelixHough_allButKappaRange_sse.cpp

kd2 = _mm_sub_ps(kd1, tmp1)

Definition at line 68 of file HelixHough_allButKappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 68 of file HelixHough_allButKappaRange_sse.cpp

max
Initial value:
{
__m128 tmp1 = _mm_cmplt_ps(val1, val2)

Definition at line 219 of file HelixHough_allButKappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 219 of file HelixHough_allButKappaRange_sse.cpp

Referenced by __example_8.f__(), field_utils::absoluteError(), G4GHEKinematicsVector::Add(), G4RPGReaction::AddBlackTrackParticles(), G4PenelopeCrossSection::AddCrossSectionPoint(), G4UPiNuclearCrossSection::AddDataSet(), G4INCL::ProjectileRemnant::addMostDynamicalSpectators(), G4PenelopeCrossSection::AddShellCrossSectionPoint(), G4SolidExtentList::AddSurface(), G4ParticleHPFinalState::adjust_final_state(), Acts::adjustBinUtility(), AerogelInit(), G4NavigationLogger::AlongComputeStepLog(), G4Transportation::AlongStepDoIt(), G4CoupledTransportation::AlongStepDoIt(), G4VEnergyLossProcess::AlongStepDoIt(), G4CoupledTransportation::AlongStepGetPhysicalInteractionLength(), G4PreCompoundEmission::AngularDistribution(), G4Nucleus::AnnihilationEvaporationEffects(), G4ParticleHPCapture::ApplyYourself(), G4HadronElastic::ApplyYourself(), G4ChargeExchange::ApplyYourself(), G4NeutronRadCapture::ApplyYourself(), approx(), G4ChordFinder::ApproxCurvePointV(), G4ExtrudedSolid::ApproxSurfaceNormal(), arorie(), attrad(), G4eIonisationSpectrum::AverageEnergy(), G4RDeIonisationSpectrum::AverageEnergy(), G4eBremsstrahlungSpectrum::AverageEnergy(), G4RDeBremsstrahlungSpectrum::AverageEnergy(), G4EnergyLossForExtrapolator::AverageScatteringAngle(), G4eIonisationSpectrum::AverageValue(), G4RDeIonisationSpectrum::AverageValue(), G4eBremsstrahlungSpectrum::AverageValue(), G4RDeBremsstrahlungSpectrum::AverageValue(), B0ECAL_Clusters(), B0ECAL_Eval(), B0ECAL_Towers(), B0Tracking_Eval(), B0Tracking_Reco(), G4HadronBuilder::Barion(), Bbc_Reco(), BbcInit(), BECAL_Eval(), BECAL_Towers(), BECALInit(), G4ClippablePolygon::BehindOf(), G4AtimaEnergyLossModel::Bethek_dedx_e(), BGEM_Init(), Acts::CuboidVolumeBuilder::binningRange(), BMMGInit(), BMMGSetup(), BMMGT_Reco(), Acts::Test::BOOST_AUTO_TEST_CASE(), G4NucleiModel::boundaryTransition(), G4IntersectionSolid::BoundingLimits(), G4UnionSolid::BoundingLimits(), G4CutTubs::BoundingLimits(), G4Trd::BoundingLimits(), G4Para::BoundingLimits(), G4Cons::BoundingLimits(), G4ExtrudedSolid::BoundingLimits(), G4Sphere::BoundingLimits(), G4WilsonAblationModel::BreakItUp(), G4UnstableFragmentBreakUp::BreakUpChain(), BToFInit(), Build_G4_BTof(), G4Voxelizer::BuildBitmasks(), G4Voxelizer::BuildBoundaries(), G4Voxelizer::BuildBoundingBox(), G4AdjointCSManager::BuildCrossSectionsMatricesForAGivenModelAndElement(), G4AdjointCSManager::BuildCrossSectionsMatricesForAGivenModelAndMaterial(), G4PenelopeIonisationXSHandler::BuildDeltaTable(), G4Voxelizer::BuildEmpty(), G4VEnergyLossProcess::BuildLambdaTable(), G4VEmProcess::BuildLambdaTable(), Acts::TGeoLayerBuilder::buildLayers(), G4NeutronElasticXS::BuildPhysicsTable(), G4NeutronInelasticXS::BuildPhysicsTable(), G4ParticleInelasticXS::BuildPhysicsTable(), G4NeutronCaptureXS::BuildPhysicsTable(), G4hImpactIonisation::BuildPhysicsTable(), G4Voxelizer::BuildReduceVoxels(), G4Voxelizer::BuildReduceVoxels2(), G4SBBremTable::BuildSamplingTables(), DicomFileCT::BuildStructureIDs(), G4LossTableBuilder::BuildTableForModel(), G4Voxelizer::BuildVoxelLimits(), BWD_Clusters(), BWD_Eval(), BWD_Towers(), nlohmann::detail::binary_writer< BasicJsonType, CharType >::calc_bson_integer_size(), nlohmann::detail::binary_writer< BasicJsonType, CharType >::calc_bson_unsigned_size(), G4BulirschStoer::calc_h_opt(), G4ConvergenceTester::calc_slope_fit(), G4StatMFMicroCanonical::CalcEntropyOfCompoundNucleus(), G4StatMFMacroMultiNucleon::CalcMeanMultiplicity(), G4StatMFMicroPartition::CalcPartitionProbability(), G4StatMFMicroPartition::CalcPartitionTemperature(), G4StatMFMacroTemperature::CalcTemperature(), G4WeightWindowAlgorithm::Calculate(), G4IntersectionSolid::CalculateExtent(), G4UnionSolid::CalculateExtent(), G4RPGInelastic::CalculateMomenta(), G4PreCompoundTransitions::CalculateProbability(), G4SteppingManager::CalculateSafety(), G4ITStepProcessor::CalculateSafety(), G4StatMFMacroCanonical::CalculateTemperature(), Acts::AdaptiveMultiVertexFinder< vfitter_t, sfinder_t >::canRecoverFromNoCompatibleTracks(), Acts::AdaptiveMultiVertexFinder< vfitter_t, sfinder_t >::canRemoveNonCompatibleTrackFromSeedTracks(), G4RPGKMinusInelastic::Cascade(), G4RPGAntiLambdaInelastic::Cascade(), G4RPGAntiProtonInelastic::Cascade(), G4RPGAntiSigmaPlusInelastic::Cascade(), G4RPGSigmaPlusInelastic::Cascade(), G4RPGXiMinusInelastic::Cascade(), G4RPGAntiNeutronInelastic::Cascade(), G4RPGAntiOmegaMinusInelastic::Cascade(), G4RPGAntiSigmaMinusInelastic::Cascade(), G4RPGAntiXiMinusInelastic::Cascade(), G4RPGOmegaMinusInelastic::Cascade(), G4RPGAntiXiZeroInelastic::Cascade(), G4RPGKPlusInelastic::Cascade(), G4RPGKZeroInelastic::Cascade(), G4RPGLambdaInelastic::Cascade(), G4RPGSigmaMinusInelastic::Cascade(), G4RPGXiZeroInelastic::Cascade(), G4RPGAntiKZeroInelastic::Cascade(), CEmc(), CEmc_1DProjectiveSpacal(), CEmc_2DProjectiveSpacal(), CEMC_Cells(), CEMC_Clusters(), CEMC_Eval(), CEMC_QA(), CEMC_Towers(), CEmcAlbedoInit(), Acts::Extent::check(), G4BoundingEnvelope::CheckBoundingPolygons(), G4MolecularDissociationTable::CheckDataConsistency(), G4PVPlacement::CheckOverlaps(), G4Ellipsoid::CheckParameters(), G4GeomTools::CheckSnip(), G4DiffractiveSplitableHadron::ChooseStringEnds(), G4Nucleus::Cinema(), kdfinder::CircleFit< T >::CircleFitByChernovHoussam(), G4BoundingEnvelope::ClipEdgesByVoxel(), G4BoundingEnvelope::ClipVoxelByPlanes(), Acts::AnnulusBounds::closestOnSegment(), TPCFEETestRecov1::Clustering(), Acts::SurfaceArray::SurfaceGridLookup< Axes >::completeBinning(), compress2(), G4VEmAdjointModel::ComputeAdjointCrossSectionVectorPerAtomForScatProj(), G4VEmAdjointModel::ComputeAdjointCrossSectionVectorPerVolumeForScatProj(), XrayFluoMercuryDetectorConstruction::ComputeApparateParameters(), XrayFluoPlaneDetectorConstruction::ComputeApparateParameters(), XrayFluoDetectorConstruction::ComputeApparateParameters(), G4eBremsstrahlungRelModel::ComputeBremLoss(), G4ChatterjeeCrossSection::ComputeCrossSection(), G4KalbachCrossSection::ComputeCrossSection(), G4BoldyshevTripletModel::ComputeCrossSectionPerAtom(), G4LivermoreGammaConversionModel::ComputeCrossSectionPerAtom(), G4LivermorePhotoElectricModel::ComputeCrossSectionPerAtom(), G4LDMBremModel::ComputeCrossSectionPerAtom(), G4KleinNishinaCompton::ComputeCrossSectionPerAtom(), G4KleinNishinaModel::ComputeCrossSectionPerAtom(), G4BetheHeitlerModel::ComputeCrossSectionPerAtom(), G4eBremsstrahlungRelModel::ComputeCrossSectionPerAtom(), G4PairProductionRelModel::ComputeCrossSectionPerAtom(), G4MuPairProductionModel::ComputeCrossSectionPerAtom(), G4EmCalculator::ComputeCrossSectionPerAtom(), G4eplusTo3GammaOKVIModel::ComputeCrossSectionPerElectron(), G4eplusTo2GammaOKVIModel::ComputeCrossSectionPerElectron(), G4eeToTwoGammaModel::ComputeCrossSectionPerElectron(), G4mplIonisationWithDeltaModel::ComputeCrossSectionPerElectron(), G4MuBetheBlochModel::ComputeCrossSectionPerElectron(), G4PenelopeAnnihilationModel::ComputeCrossSectionPerElectron(), G4EmCalculator::ComputeCrossSectionPerShell(), G4EmCalculator::ComputeCrossSectionPerVolume(), G4ComponentBarNucleonNucleusXsc::ComputeCrossSections(), G4ComponentGGHadronNucleusXsc::ComputeCrossSections(), G4ComponentGGNuclNuclXsc::ComputeCrossSections(), G4mplIonisationWithDeltaModel::ComputeDEDXAhlen(), G4mplIonisationWithDeltaModel::ComputeDEDXPerVolume(), G4eBremsstrahlungRelModel::ComputeDEDXPerVolume(), G4AtimaEnergyLossModel::ComputeDEDXPerVolume(), G4MuPairProductionModel::ComputeDEDXPerVolume(), G4MollerBhabhaModel::ComputeDEDXPerVolume(), G4LindhardSorensenIonModel::ComputeDEDXPerVolume(), G4BetheBlochModel::ComputeDEDXPerVolume(), G4BraggIonModel::ComputeDEDXPerVolume(), G4BraggModel::ComputeDEDXPerVolume(), G4LDMBremModel::ComputeDMicroscopicCrossSection(), G4MuPairProductionModel::ComputeDMicroscopicCrossSection(), G4SeltzerBergerModel::ComputeDXSectionPerAtom(), G4eBremsstrahlungRelModel::ComputeDXSectionPerAtom(), G4PairProductionRelModel::ComputeDXSectionPerAtom(), G4WentzelOKandVIxSection::ComputeElectronCrossSection(), G4eplusTo3GammaOKVIModel::ComputeF(), G4eplusTo3GammaOKVIModel::ComputeFS(), DetectorConstruction::ComputeGeomParameters(), G4UrbanMscModel::ComputeGeomPathLength(), G4UrbanAdjointMscModel::ComputeGeomPathLength(), G4GoudsmitSaundersonMscModel::ComputeGeomPathLength(), GFlashSamplingShowerParameterisation::ComputeLongitudinalParameters(), G4SandiaTable::ComputeMatSandiaMatrix(), RMC01AnalysisManager::ComputeMeanEdepAndError(), G4KokoulinMuonNuclearXS::ComputeMicroscopicCrossSection(), G4MuPairProductionModel::ComputeMicroscopicCrossSection(), PDBlib::ComputeNucleotideBarycenters(), G4eBremParametrizedModel::ComputeParametrizedDXSectionPerAtom(), G4GEMProbabilityVI::ComputeProbability(), G4ComponentGGHadronNucleusXsc::ComputeQuasiElasticRatio(), G4eBremsstrahlungRelModel::ComputeRelDXSectionPerAtom(), G4PairProductionRelModel::ComputeRelDXSectionPerAtom(), G4PenelopeIonisationXSHandler::ComputeShellCrossSectionsElectron(), G4PenelopeIonisationXSHandler::ComputeShellCrossSectionsPositron(), G4PropagatorInField::ComputeStep(), G4PathFinder::ComputeStep(), G4GEMProbabilityVI::ComputeTotalProbability(), G4WentzelOKandVIxSection::ComputeTransportCrossSectionPerAtom(), G4LowEWentzelVIModel::ComputeTruePathLengthLimit(), G4WentzelVIModel::ComputeTruePathLengthLimit(), G4UrbanMscModel::ComputeTruePathLengthLimit(), G4UrbanAdjointMscModel::ComputeTruePathLengthLimit(), G4GoudsmitSaundersonMscModel::ComputeTruePathLengthLimit(), G4eBremsstrahlungRelModel::ComputeXSectionPerAtom(), G4PairProductionRelModel::ComputeXSectionPerAtom(), G4MuPairProductionModel::ComputMuPairLoss(), Acts::IntegrationTest::constant_field_propagation(), Acts::TGeoDetectorElement::construct(), G4MonopolePhysics::ConstructProcess(), G4EmExtraPhysics::ConstructProcess(), G4BinaryCascade::CorrectFinalPandE(), G4BetheBlochModel::CorrectionsAlongStep(), PHActsInitialVertexFinder::createCentroidMap(), Acts::SurfaceArrayCreator::createEquidistantAxis(), Acts::CylinderVolumeHelper::createGapTrackingVolume(), G4VLongitudinalStringDecay::CreatePartonPair(), G4TwistedTubs::CreatePolyhedron(), Acts::createProtoMaterial(), G4TessellatedSolid::CreateVertexList(), G4XPDGElastic::CrossSection(), G4PEEffectFluoModel::CrossSectionPerVolume(), G4PAIModelData::CrossSectionPerVolume(), G4VEmProcess::CrossSectionPerVolume(), G4GoudsmitSaundersonMscModel::CrossSectionPerVolume(), G4VEnergyLossProcess::CrossSectionPerVolume(), MuCrossSections::CRP_Mephi(), G4FermiPhaseSpaceDecay::Decay(), G4ICRU73QOModel::DEDXPerElement(), G4PAIModelData::DEDXPerVolume(), G4BinaryLightIonReaction::DeExciteSpectatorNucleus(), G4FissionParameters::DefineParameters(), G4hImpactIonisation::DeltaRaysEnergy(), G4INCL::DeuteronDensity::derivWavefunctionR(), G4VFieldModel::DescribeYourselfTo(), FW::determineEventFilesRange(), FW::Sequencer::determineEventsRange(), G4PenelopeComptonModel::DifferentialCrossSection(), G4ScreeningMottCrossSection::DifferentialXSection(), G4QGSMSplitableHadron::DiffractiveSplitUp(), G4PAIySection::DifPAIySection(), G4DiffractiveSplitableHadron::Diquark(), G4QGSMFragmentation::DiQuarkSplitup(), G4LundStringFragmentation::DiQuarkSplitup(), DIRCInit(), DIRCReco(), DIRCSetup(), G4GeomTools::DiskExtent(), DiskInit(), G4AtimaFluctuations::Dispersion(), G4PolyconeSide::DistanceAway(), Acts::RectangleBounds::distanceToBoundary(), Acts::AnnulusBounds::distanceToBoundary(), G4EllipticalTube::DistanceToIn(), G4Box::DistanceToIn(), G4Ellipsoid::DistanceToIn(), G4Tet::DistanceToIn(), G4CutTubs::DistanceToIn(), G4ExtrudedSolid::DistanceToIn(), G4Trd::DistanceToIn(), G4EllipticalCone::DistanceToIn(), G4Torus::DistanceToIn(), G4Para::DistanceToIn(), G4Trap::DistanceToIn(), G4EllipticalTube::DistanceToOut(), G4UnionSolid::DistanceToOut(), G4Ellipsoid::DistanceToOut(), G4ExtrudedSolid::DistanceToOut(), G4Trd::DistanceToOut(), G4Para::DistanceToOut(), G4Trap::DistanceToOut(), nanoflann::KDTreeSingleIndexAdaptor< nanoflann::L2_Simple_Adaptor< double, kdfinder::KDPointCloud< double > >, kdfinder::KDPointCloud< double >, 3 >::divideTree(), dokinematics(), G4PathFinder::DoNextLinearStep(), G4ITPathFinder::DoNextLinearStep(), G4ITStepProcessor::DoStepping(), Draw_ratio(), G4ScoreLogColorMap::DrawColorChartBar(), G4VScoreColorMap::DrawColorChartBar(), G4ScoreLogColorMap::DrawColorChartText(), G4VScoreColorMap::DrawColorChartText(), DRCALO_Towers(), DRCALOInit(), G4FermiFragmentsPoolVI::Dump(), G4EmModelManager::DumpModelList(), EEMC_Clusters(), EEMC_Eval(), EEMC_Towers(), EEMCH_Clusters(), EEMCH_Eval(), EEMCH_Towers(), EEMCHInit(), EEMCHSetup(), EEMCInit(), EEMCSetup(), G4ionEffectiveCharge::EffectiveCharge(), EGEM_Init(), EHCAL_Clusters(), EHCAL_Eval(), EHCAL_Towers(), EHCALInit(), ei(), G4PiData::ElasticXSection(), GFlashShowerModel::ElectronDoIt(), G4hImpactIonisation::ElectronicLossFluctuation(), G4BraggModel::ElectronicStoppingPower(), G4BraggIonModel::ElectronicStoppingPower(), G4GeomTools::EllipsePerimeter(), G4GeomTools::EllipticConeLateralArea(), G4GEMChannelVI::EmittedFragment(), G4EvaporationChannel::EmittedFragment(), Run::EndOfEvent(), ExGflashEventAction::EndOfEventAction(), G4BinaryLightIonReaction::EnergyAndMomentumCorrector(), G4AtimaFluctuations::EnergyTable_interpolate(), G4AtimaEnergyLossModel::EnergyTable_interpolate(), errorOf1DHistograms(), G4MultiLevelLocator::EstimateIntersectionPoint(), ETOF_Reco(), ETOFInit(), ETOFSetup(), G4Nucleus::EvaporationEffects(), G4eIonisationParameters::Excitation(), G4RDeIonisationParameters::Excitation(), FW::TrackSelector::execute(), FW::ParticleSelector::execute(), Acts::Extent::extend(), Acts::Polyhedron::extent(), G4MultiUnion::Extent(), G4PolyPhiFace::Extent(), G4VCrossSectionSource::FcrossX(), FEMC_Clusters(), FEMC_Eval(), FEMC_Towers(), FEMCInit(), FFR_Eval(), FGEM_Init(), FHCAL_Clusters(), FHCAL_Eval(), FHCAL_Towers(), FHCALInit(), G4INCL::NNToMissingStrangenessChannel::fillFinalState(), G4INCL::NpiToMissingStrangenessChannel::fillFinalState(), G4INCL::ElasticChannel::fillFinalState(), G4INCL::EventInfo::fillInverseKinematics(), G4EmModelManager::FillLambdaVector(), G4HadronicProcess::FillResult(), G4NuclearLevelData::FindLevel(), G4VEmissionProbability::FindRecoilExcitation(), G4JTPolynomialSolver::FindRoots(), G4BoundingEnvelope::FindScaleFactor(), G4StatMF::FindTemperatureOfBreakingChannel(), CLHEP::RandBreitWigner::fireM2(), G4CompetitiveFission::FissionAtomicNumber(), G4CompetitiveFission::FissionKineticEnergy(), Acts::FullBilloirVertexFitter< input_track_t, linearizer_t >::fit(), fjetrig(), PHTpcTrackFollower::followTrack(), G4RPGFragmentation::FragmentationIntegral(), FST_Init(), G4ArrowModel::G4ArrowModel(), G4BogackiShampine45::G4BogackiShampine45(), G4CashKarpRKF45::G4CashKarpRKF45(), G4ClassicalRK4::G4ClassicalRK4(), G4DensityEffectCalculator::G4DensityEffectCalculator(), G4DormandPrinceRK56::G4DormandPrinceRK56(), G4DormandPrinceRK78::G4DormandPrinceRK78(), G4DSTreader_EICDetector(), G4FSALBogackiShampine45::G4FSALBogackiShampine45(), G4GDecay3::G4GDecay3(), G4ImplicitEuler::G4ImplicitEuler(), G4IntersectingCone::G4IntersectingCone(), G4MuPairProductionModel::G4MuPairProductionModel(), G4PAIModelData::G4PAIModelData(), G4PAIPhotData::G4PAIPhotData(), G4Para::G4Para(), G4ParticleHPPartial::G4ParticleHPPartial(), G4ParticleHPVector::G4ParticleHPVector(), G4PropagatorInField::G4PropagatorInField(), G4QuadrangularFacet::G4QuadrangularFacet(), G4RandomPointOnEllipse(), G4RandomPointOnEllipsoid(), G4SimpleRunge::G4SimpleRunge(), G4Sphere::G4Sphere(), G4TriangularFacet::G4TriangularFacet(), G4TsitourasRK45::G4TsitourasRK45(), G4INCL::PhaseSpaceRauboldLynch::generate(), G4eeToHadronsModel::GenerateCMPhoton(), GFlashSamplingShowerParameterisation::GenerateEnergyProfile(), G4Clebsch::GenerateIso3(), G4RPGReaction::GenerateNBodyEvent(), G4RPGReaction::GenerateNBodyEventT(), GFlashSamplingShowerParameterisation::GenerateNSpotProfile(), generatez(), genevent(), PHG4CylinderGeom_Spacalv3::get_max_lightguide_height(), PHG4Sector::Sector_Geometry::get_max_R(), G4HadronCrossSections::GetCaptureCrossSection(), G4BCLateParticle::GetCollisions(), G4VXTRenergyLoss::GetComptonPerAtom(), G4ContinuousGainOfEnergy::GetContinuousStepLimit(), G4ParticleHPFissionData::GetCrossSection(), G4ParticleHPCaptureData::GetCrossSection(), G4ParticleHPElasticData::GetCrossSection(), G4ParticleHPInelasticData::GetCrossSection(), getdeltat(), G4PiNuclearCrossSection::GetElementCrossSection(), G4BGGPionElasticXS::GetElementCrossSection(), G4BGGPionInelasticXS::GetElementCrossSection(), G4HadronicProcess::GetElementCrossSection(), G4GEMChannelVI::GetEmissionProbability(), G4EvaporationChannel::GetEmissionProbability(), G4PhotonEvaporation::GetEmissionProbability(), ECCEhpDIRCFastPIDMap::getFastSmearLogLikelihood(), G4HadronCrossSections::GetFissionCrossSection(), G4ComponentGGHadronNucleusXsc::GetHNinelasticXsc(), G4ComponentGGHadronNucleusXsc::GetHNinelasticXscVU(), DrcPidFast::GetInfo(), getinsudared(), PHG4SteppingAction::GetLightCorrection(), G4RDVeLowEnergyLoss::GetLossWithFluct(), G4CutTubs::GetMaxMinZ(), G4ClippablePolygon::GetMaxPoint(), getmd(), getmdmax(), getmdmin(), G4ScreenedNuclearRecoil::GetMeanFreePath(), G4Accumulables::GetMergeFunction(), G4FTFParameters::GetMinMass(), Acts::FsmwMode1dFinder::getMode(), G4PenelopeBremsstrahlungFS::GetMomentumIntegral(), G4MuonMinusBoundDecay::GetMuonZeff(), getnewmass(), G4RPGInelastic::GetNormalizationConstant(), G4PairingCorrection::GetPairingCorrection(), G4ComponentGGHadronNucleusXsc::GetParticleBarCorIn(), G4ComponentGGHadronNucleusXsc::GetParticleBarCorTot(), G4VMscModel::GetParticleChangeForMSC(), getpdf(), getpdfxint(), G4Ellipsoid::GetPointOnSurface(), G4EllipticalCone::GetPointOnSurface(), G4TrajectoryDrawerUtils::GetPointsAndTimes(), getqvec(), G4ITNavigator2::GetRandomInCurrentVolume(), G4ComponentGGHadronNucleusXsc::GetRatioQE(), getspliti(), getsscat(), G4ParticleHPIsoData::GetXsec(), G4ParticleHPChannelList::GetXsec(), G4ParticleHPFissionBaseFS::GetXsec(), G4ParticleHPInelasticBaseFS::GetXsec(), G4ParticleHPInelasticCompFS::GetXsec(), G4ParticleHPChannel::GetXsec(), getxsecint(), gridBoxFactory(), nlohmann::detail::dtoa_impl::grisu2_digit_gen(), gustep(), gz_comp(), gz_load(), G4HadronNucleonXsc::HadronNucleonXscNS(), Acts::DiscTrapezoidBounds::halfPhiSector(), G4ParticleHPElementData::Harmonise(), G4ParticleHPChannel::Harmonise(), HCalInner(), HCALInner_Cells(), HCALInner_Clusters(), HCALInner_Eval(), HCALInner_QA(), HCALInner_Towers(), HCalInnerInit(), HCalOuter(), HCALOuter_Cells(), HCALOuter_Clusters(), HCALOuter_Eval(), HCALOuter_QA(), HCALOuter_Towers(), HCalOuterInit(), G4VhElectronicStoppingPower::HeEffChargeSquare(), G4BraggIonModel::HeEffChargeSquare(), hFarBwdBeamLineInit(), hFarBwdDefineDetectorsIP6(), hFarBwdDefineDetectorsIP8(), hFarBwdDefineMagnets(), hFarFwdBeamLineInit(), hFarFwdDefineBeamPipe(), hFarFwdDefineDetectorsIP6(), hFarFwdDefineDetectorsIP8(), hFarFwdDefineMagnets(), hijcsc(), hijing(), hijset(), hijsft(), hiptdi(), HTOF_Reco(), HTOFInit(), HTOFSetup(), PHActsSiliconSeeding::identifyBestSeed(), inflate_table(), G4ParticleHPContAngularPar::Init(), nanoflann::KNNResultSet< DistanceType, IndexType, CountType >::init(), G4PenelopeBremsstrahlungModel::Initialise(), G4PenelopeIonisationModel::Initialise(), G4WentzelVIModel::Initialise(), G4SeltzerBergerModel::Initialise(), G4MuPairProductionModel::Initialise(), G4HadronXSDataTable::Initialise(), G4EmModelManager::Initialise(), G4VAtomDeexcitation::InitialiseAtomicDeexcitation(), G4VEmModel::InitialiseElementSelectors(), G4ePairProduction::InitialiseEnergyLossProcess(), G4hhIonisation::InitialiseEnergyLossProcess(), G4mplIonisation::InitialiseEnergyLossProcess(), G4MuPairProduction::InitialiseEnergyLossProcess(), G4hIonisation::InitialiseEnergyLossProcess(), DetectorConstruction::InitialiseGeometryParameters(), G4LivermoreGammaConversionModel::InitialiseProbability(), G4CoulombScattering::InitialiseProcess(), G4PolarizedGammaConversion::InitialiseProcess(), G4GammaGeneralProcess::InitialiseProcess(), G4GammaConversion::InitialiseProcess(), G4FastPathHadronicCrossSection::fastPathEntry::Initialize(), G4INCL::NuclearPotential::NuclearPotentialIsospin::initialize(), G4VPreCompoundFragment::Initialize(), G4Orb::Initialize(), G4Tet::Initialize(), G4PenelopeBremsstrahlungFS::InitializeEnergySampling(), G4PenelopeRayleighModel::InitializeSamplingAlgorithm(), G4INCL::INCL::initMaxInteractionDistance(), initpythia(), G4SBBremTable::InitSamplingTables(), G4GoudsmitSaundersonTable::InitSCPCorrection(), G4INCL::INCL::initUniverseRadius(), InputRegister(), G4EllipticalTube::Inside(), Acts::AnnulusBounds::inside(), G4UnionSolid::Inside(), G4Box::Inside(), G4Ellipsoid::Inside(), G4Tet::Inside(), G4Trd::Inside(), G4ExtrudedSolid::Inside(), G4EllipticalCone::Inside(), G4Para::Inside(), G4Sphere::Inside(), G4Trap::Inside(), G4KineticTrack::IntegrandFunction1(), G4KineticTrack::IntegrandFunction2(), G4INCL::IFunction1D::integrate(), G4HETCFragment::IntegrateEmissionProbability(), G4PreCompoundFragment::IntegrateEmissionProbability(), G4VEmissionProbability::IntegrateProbability(), G4INCL::CrossSections::interactionDistanceKbarN(), G4INCL::CrossSections::interactionDistanceKN(), G4INCL::CrossSections::interactionDistanceNN(), G4INCL::CrossSections::interactionDistancePiN(), G4INCL::CrossSections::interactionDistanceYN(), G4UPiNuclearCrossSection::Interpolate(), Acts::LineSurface::intersectionEstimate(), G4eIonisationSpectrum::IntSpectrum(), G4RDeIonisationSpectrum::IntSpectrum(), G4eBremsstrahlungSpectrum::IntSpectrum(), G4RDeBremsstrahlungSpectrum::IntSpectrum(), G4hIonEffChargeSquare::IonEffChargeSquare(), KFParticle_Tools::isInRange(), G4ExtrudedSolid::IsSameLineSegment(), Jet_Eval(), Jet_FwdEval(), Jet_FwdReco(), Jet_QA(), Jet_Reco(), jetini(), Acts::JsonGeometryConverter::jsonToBinUtility(), Acts::JsonGeometryConverter::jsonToVolumeMaterial(), G4HETCAlpha::K(), G4HETCHe3::K(), G4HETCProton::K(), G4HETCTriton::K(), G4HETCDeuteron::K(), G4HETCNeutron::K(), G4INCL::NpiToSKChannel::KaonMomentum(), G4INCL::NKbToSpiChannel::KaonMomentum(), G4HadronNucleonXsc::KaonNucleonXscVG(), KFParticle_D0_Reco(), KFParticle_Lambdac_Reco(), KFParticle_Upsilon_Reco(), klu(), ksdet(), ksdetd(), ksdeth(), ksdetu(), ksmate(), ksmixt(), kspart(), ksposp(), kstmed(), ksvolu(), largeintersection(), Acts::LayerArrayCreator::layerArray(), G4LevelReader::LevelManager(), LFHCAL_Eval(), LFHCAL_Towers(), LFHCALInit(), G4IntersectingCone::LineHitsCone1(), G4IntersectingCone::LineHitsCone2(), G4AttValueFilterT< T, ConversionErrorPolicy >::LoadIntervalElement(), G4SBBremTable::LoadSamplingTables(), G4SBBremTable::LoadSTGrid(), G4GHEKinematicsVector::Lor(), lu1ent(), lu2ent(), lu3ent(), lu4ent(), luboei(), lucell(), luclus(), ludecy(), luedit(), lueevt(), luexec(), luindf(), lujmas(), lukfdi(), lulist(), luonia(), luprep(), luptdi(), luradk(), lushow(), lusphe(), lustrf(), lutabu(), lutest(), luupda(), lux3jt(), lux4jt(), luxjet(), luxkfl(), luxtot(), luzdis(), Magnet(), MagnetInit(), EmPlot::make_plot(), makebranch(), makeinsplit(), G4Trap::MakePlane(), Acts::mapMaterialPoints(), Acts::materialMapperRZ(), Acts::materialMapperXYZ(), G4INCL::Random::Adapter::max(), MCGIDI_particle_getInternalID(), MCGIDI_POPs_findParticleIndex(), Acts::ProtoLayer::measure(), MicromegasInit(), genericRICH::minP(), G4hCoulombScatteringModel::MinPrimaryEnergy(), G4eBremsstrahlungRelModel::MinPrimaryEnergy(), G4MuPairProductionModel::MinPrimaryEnergy(), G4eCoulombScatteringModel::MinPrimaryEnergy(), G4MuBremsstrahlungModel::MinPrimaryEnergy(), PHG4mRICHDetector::mRichParameter::mRichParameter(), mRICHReco(), Mvtx(), MvtxInit(), nthick(), G4RPGReaction::NuclearReaction(), G4ICRU49NuclearStoppingModel::NuclearStoppingPower(), G4MagInt_Driver::OneGoodStep(), G4INCL::NuclearDensityFunctions::ModifiedHarmonicOscillatorRP::operator()(), Acts::CKFSourceLinkSelector::operator()(), Acts::Test::MaterialScattering::operator()(), DicomVFileImage::operator+(), DicomPhantomZSliceHeader::operator+(), operator<<(), G4PenelopeComptonModel::OscillatorTotalCrossSection(), Acts::VolumeConfig::overlapsInR(), Acts::VolumeConfig::overlapsInZ(), G4PAIySection::PAIdNdxPlasmon(), G4BremsstrahlungParameters::Parameter(), G4eIonisationParameters::Parameter(), G4RDBremsstrahlungParameters::Parameter(), G4RDeIonisationParameters::Parameter(), G4INCL::ParticleEntryChannel::particleEnters(), ParticleFlow(), kdfinder::Helix< T >::pathLengths(), G4PreCompoundEmission::PerformEmission(), kdfinder::Helix< T >::period(), G4PhotoElectricAngularGeneratorPolarized::PhotoElectronGetMajorantSurfaceAandCParameters(), G4Vee2hadrons::PhysicsVector(), Pipe(), PipeInit(), Piston(), PistonInit(), Plot(), plu(), PlugDoorInit(), G4RPGInelastic::Pmltpc(), G4RDGenerator2BS::PolarAngle(), G4DipBustGenerator::PolarAngle(), G4HadronElasticProcess::PostStepDoIt(), G4LowEnergyGammaConversion::PostStepDoIt(), G4Cerenkov::PostStepDoIt(), G4eplusPolarizedAnnihilation::PostStepGetPhysicalInteractionLength(), G4ePolarizedIonisation::PostStepGetPhysicalInteractionLength(), G4PolarizedCompton::PostStepGetPhysicalInteractionLength(), G4GammaGeneralProcess::PostStepGetPhysicalInteractionLength(), G4VEmProcess::PostStepGetPhysicalInteractionLength(), G4VEnergyLossProcess::PostStepGetPhysicalInteractionLength(), G4eIonisationSpectrum::Probability(), G4RDeIonisationSpectrum::Probability(), G4eBremsstrahlungSpectrum::Probability(), G4RDeBremsstrahlungSpectrum::Probability(), G4PreCompoundIon::ProbabilityDistributionFunction(), G4GEMProbabilityVI::ProbabilityDistributionFunction(), PHSimpleVertexFinder::process_event(), prt_drawDigi(), prt_normalize(), prt_normalizeto(), py1ent(), py2ent(), py2frm(), py3ent(), py4ent(), py4frm(), py4jet(), py4jts(), py4jtw(), py6frm(), pyadsh(), pyalps(), pybesq(), pyboei(), pycell(), pyclus(), pycteq(), pydecy(), pydiff(), pydisg(), pydocu(), pyedit(), pyeevt(), pyevnt(), pyevnw(), pyevol(), pyexec(), pyfill(), pyfscr(), pygaga(), pygano(), pyggam(), pygvmd(), pyhfth(), pyhiklim(), pyhikmap(), pyhimaxi(), pyhimult(), pyhiovly(), pyhirand(), pyhiremn(), pyhiscat(), pyhisigh(), pyhisspa(), pyhistat(), pyhistfe(), pyhistfu(), pyhitest(), pyhithia(), pyhiwidt(), pyhixtot(), pyi3au(), pyinbm(), pyindf(), pyinki(), pyinpr(), pyjmas(), pyjurf(), pyk(), pykcut(), pykfdi(), pykfin(), pyklim(), pykmap(), pylist(), pylogo(), pymael(), pymass(), pymaxi(), pymign(), pymihg(), pymihk(), pymirm(), pymrun(), pymult(), pyofsh(), pyonia(), pyoper(), pyovly(), pyp(), pypdel(), pypdfl(), pypdfu(), pypdga(), pypdpi(), pypdpo(), pypdpr(), pypile(), pyplot(), pyprep(), pyptdi(), pyptfs(), pyptis(), pyptmi(), pyqqbh(), pyradk(), pyrand(), pyreco(), pyremn(), pyresd(), pyrnm3(), pyrnmq(), pyrset(), pyrvg1(), pyrvg2(), pyrvg3(), pyrvsb(), pyscat(), pysghg(), pysgqc(), pysgtc(), pysgwz(), pyshow(), pysigh(), pyslha(), pyspen(), pysphe(), pysspa(), pystat(), pystbh(), pystfe(), pystfu(), pystrf(), pysugi(), pytabu(), pytbdy(), pytest(), pythia(), pythrg(), pyupda(), pyupin(), pyveto(), pywidt(), pywidx(), pyx3jt(), pyx4jt(), pyxdif(), pyxjet(), pyxkfl(), pyxtee(), pyxtot(), pyzdis(), quench(), Acts::ProtoLayer::radialDistance(), G4UrbanMscModel::Randomizetlimit(), G4RPGStrangeProduction::ReactionStage(), G4RPGTwoCluster::ReactionStage(), G4RPGTwoBody::ReactionStage(), G4RPGFragmentation::ReactionStage(), G4PiData::ReactionXSection(), Acts::detail::recoverSpacePoint(), G4RPGFragmentation::ReduceEnergiesOfSecondaries(), Acts::TGeoLayerBuilder::registerSplit(), field_utils::relativeError2(), G4PathFinder::ReLocate(), G4ITPathFinder::ReLocate(), nlohmann::detail::serializer< BasicJsonType >::remove_sign(), G4GeomTools::RemoveRedundantVertices(), G4NavigationLogger::ReportOutsideMother(), CexmcPhysicsList< BasePhysics, StudiedPhysics, ProductionModel >::ResampleTrackLengthInTarget(), RICHInit(), RICHReco(), RICHSetup(), rkstepper(), rluset(), G4StatDouble::rms(), FW::RootMaterialDecorator::RootMaterialDecorator(), G4RPGReaction::Rotate(), TPCFEETestRecov1::roughZeroSuppression(), RWellInit(), G4VoxelSafety::SafetyForVoxelHeader(), G4ParticleHPIsotropic::Sample(), G4ParticleHPNBodyPhaseSpace::Sample(), G4ParticleHPKallbachMannSyst::Sample(), G4ParticleHPFissionSpectrum::Sample(), G4ParticleHPWattSpectrum::Sample(), G4ParticleHPSimpleEvapSpectrum::Sample(), G4ParticleHPLegendreStore::Sample(), G4ParticleHPContAngularPar::Sample(), G4ParticleHPVector::Sample(), G4VEmAdjointModel::SampleAdjSecEnergyFromCSMatrix(), G4UrbanMscModel::SampleCosineTheta(), G4DipBustGenerator::SampleCosTheta(), G4SauterGavrilaAngularDistribution::SampleDirection(), G4PenelopeBremsstrahlungAngular::SampleDirection(), G4Generator2BN::SampleDirection(), G4Generator2BS::SampleDirection(), G4ParticleHPLegendreStore::SampleDiscreteTwoBody(), G4ParticleHPLegendreStore::SampleElastic(), G4eIonisationSpectrum::SampleEnergy(), G4RDeIonisationSpectrum::SampleEnergy(), G4RDeBremsstrahlungSpectrum::SampleEnergy(), G4eBremsstrahlungSpectrum::SampleEnergy(), G4SBBremTable::SampleEnergyTransfer(), G4SeltzerBergerModel::SampleEnergyTransfer(), G4PenelopeIonisationModel::SampleFinalStateElectron(), G4PenelopeIonisationModel::SampleFinalStatePositron(), TPCDaqDefs::FEEv1::SampleFit_PowerLawDoubleExp(), G4PenelopeBremsstrahlungFS::SampleGammaEnergy(), G4HETCChargedFragment::SampleKineticEnergy(), G4HETCNeutron::SampleKineticEnergy(), G4EvaporationProbability::SampleKineticEnergy(), G4SampleResonance::SampleMass(), G4ParticleHPLegendreStore::SampleMax(), G4PAIModelData::SamplePostStepTransfer(), G4VScatteringCollision::SampleResonanceMass(), G4LEPTSIonisationModel::SampleSecondaries(), G4BoldyshevTripletModel::SampleSecondaries(), G4LivermoreGammaConversionModelRC::SampleSecondaries(), G4LivermoreNuclearGammaConversionModel::SampleSecondaries(), G4LivermorePolarizedGammaConversionModel::SampleSecondaries(), G4LivermoreGammaConversionModel::SampleSecondaries(), G4PenelopeAnnihilationModel::SampleSecondaries(), G4BetheHeitler5DModel::SampleSecondaries(), G4PenelopeGammaConversionModel::SampleSecondaries(), G4JAEAElasticScatteringModel::SampleSecondaries(), G4LDMBremModel::SampleSecondaries(), G4BetheHeitlerModel::SampleSecondaries(), G4SeltzerBergerModel::SampleSecondaries(), G4eplusTo2GammaOKVIModel::SampleSecondaries(), G4eBremsstrahlungRelModel::SampleSecondaries(), G4eSingleCoulombScatteringModel::SampleSecondaries(), G4hCoulombScatteringModel::SampleSecondaries(), G4IonCoulombScatteringModel::SampleSecondaries(), G4PairProductionRelModel::SampleSecondaries(), G4PenelopeComptonModel::SampleSecondaries(), G4MuPairProductionModel::SampleSecondaries(), G4eCoulombScatteringModel::SampleSecondaries(), G4WentzelOKandVIxSection::SampleSingleScattering(), G4GammaTransition::SampleTransition(), G4GoudsmitSaundersonTable::Sampling(), G4ParticleHPInelasticCompFS::SelectExitChannel(), G4EmElementSelector::SelectRandomAtom(), PHG4InputFilter::set_eta_range(), PHG4ParticleGenerator::set_eta_range(), PHG4ParticleGenerator_flat_pT::set_eta_range(), PHG4ParticleGeneratorD0::set_eta_range(), PHG4ParticleGeneratorVectorMeson::set_eta_range(), PHG4SimpleEventGenerator::set_eta_range(), PHG4InputFilter::set_etamax(), PHG4ParticleGenerator::set_mom_range(), PHG4ParticleGeneratorD0::set_mom_range(), PHG4ParticleGeneratorVectorMeson::set_mom_range(), PHG4SimpleEventGenerator::set_p_range(), PHG4ParticleGenerator::set_phi_range(), PHG4ParticleGenerator_flat_pT::set_phi_range(), PHG4SimpleEventGenerator::set_phi_range(), PHG4ParticleGenerator_flat_pT::set_pT_range(), PHG4ParticleGeneratorD0::set_pt_range(), PHG4ParticleGeneratorVectorMeson::set_pt_range(), PHG4SimpleEventGenerator::set_pt_range(), PHG4InputFilter::set_ptmax(), PHG4ParticleGeneratorD0::set_rapidity_range(), PHG4ParticleGeneratorVectorMeson::set_rapidity_range(), PHG4SimpleEventGenerator::set_theta_range(), PHG4ParticleGenerator_flat_pT::set_z_range(), PHG4ParticleGenerator::set_z_range(), G4Torus::SetAllParameters(), PHTrackSelector::SetChi2NDFHits(), G4RadioactiveDecayBase::SetDecayHalfAngle(), G4RadioactiveDecay::SetDecayHalfAngle(), G4FieldManager::SetDetectorField(), G4GeomTestVolume::SetErrorsThreshold(), eIDMLInterface::setEtaRange(), G4EmConfigurator::SetExtraEmModel(), sPHENIXTrackerTpc::setFastChi2Cut(), sPHENIXTracker::setFastChi2Cut(), sPHENIXSeedFinder::setFastChi2Cut(), G4GHEKinematicsVector::SetMassAndUpdate(), G4EmParameters::SetMaxEnergy(), G4BuffercoutDestination::SetMaxSize(), G4Voxelizer::SetMaxVoxels(), G4VLongitudinalStringDecay::SetMinMasses(), G4GHEKinematicsVector::SetMomentumAndUpdate(), CexmcProductionModelMessenger::SetNewValue(), CexmcEnergyDepositDigitizerMessenger::SetNewValue(), G4ExcitationHandler::SetParameters(), G4mplIonisationModel::SetParticle(), G4mplIonisationWithDeltaModel::SetParticle(), PHG4TpcDirectLaser::SetPhiStepping(), G3Division::SetRangeAndAxis(), ECCEmRICHFastPIDMap::setThetaAcceptanceMinMax(), PHG4TpcDirectLaser::SetThetaStepping(), G4TransportationLogger::SetThresholdTrials(), G4WentzelVIRelXSection::SetupKinematic(), G4WentzelOKandVIxSection::SetupKinematic(), PHG4ScoringManager::setVertexAcceptanceRange(), PHG4ScoringManager::setVertexHistRange(), G4AtimaEnergyLossModel::sezi_dedx_e(), CLHEP::RandBreitWigner::shootM2(), G4LatticeReader::SkipComments(), G4TrajectoryDrawerUtils::SliceLine(), G4RPGNeutronInelastic::SlowNeutron(), G4GeomTools::SphereExtent(), splitfncint(), G4MesonSplitter::SplitMeson(), Acts::EigenStepper< bfield_t, extensionlist_t, auctioneer_t >::step(), G4SteppingManager::Stepping(), G4BraggModel::StoppingPower(), G4BraggIonModel::StoppingPower(), G4QGSDiffractiveExcitation::String(), G4GHEKinematicsVector::Sub(), G4Torus::SurfaceNormal(), test(), Acts::IntegrationTest::to_cylinder(), TopoClusterReco(), Acts::RectangleBounds::toStream(), Acts::ConstrainedStep::toString(), G4PiData::TotalXSection(), TPC(), TPCInit(), Tracking_Eval(), Tracking_Reco(), TrackingServiceCone(), TrackingServiceCylinder(), TrackingServiceInit(), GPUTPCTrackParam::TransportToX(), TRD_Reco(), TRDInit(), TRDSetup(), G4BulirschStoer::try_step(), TTL_Init(), nlohmann::detail::binary_writer< BasicJsonType, CharType >::ubjson_prefix(), ugeom(), ulalps(), ulmass(), uncompress2(), G4DiffractiveExcitation::UnpackMeson(), G4EmConfigurator::UpdateModelEnergyRange(), Acts::detail::PointwiseMaterialInteraction::updateVariance(), CCalSteppingAction::UserSteppingAction(), G4EmSaturation::VisibleEnergyDeposition(), G4INCL::DeuteronDensity::wavefunctionR(), G4Clebsch::Weight(), WorldSize(), Acts::AxisAlignedBoundingBox< entity_t, value_t, DIM >::wrap(), Acts::detail::Axis< AxisType::Equidistant, bdt >::wrapBin(), Acts::detail::Axis< AxisType::Variable, bdt >::wrapBin(), FW::RootMaterialWriter::write(), nlohmann::detail::binary_writer< BasicJsonType, CharType >::write_bson_integer(), nlohmann::detail::binary_writer< BasicJsonType, CharType >::write_bson_unsigned(), nlohmann::detail::binary_writer< BasicJsonType, CharType >::write_cbor(), nlohmann::detail::binary_writer< BasicJsonType, CharType >::write_msgpack(), nlohmann::detail::binary_writer< BasicJsonType, CharType >::write_number_with_ubjson_prefix(), and xsecint().

min = _mm_xor_ps(tmp2, tmp3)

Definition at line 218 of file HelixHough_allButKappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 218 of file HelixHough_allButKappaRange_sse.cpp

Referenced by __example_6.f__(), __example_7.f__(), G4ParticleHPKallbachMannSyst::A(), G4RPGReaction::AddBlackTrackParticles(), G4AdjointCSMatrix::AddData(), G4EmDNAPhysicsActivator::AddElectronModels0(), G4EmDNAPhysicsActivator::AddGenericIonModels0(), Run::AddPhantomStep(), G4EmDNAPhysicsActivator::AddProtonModels0(), G4SolidExtentList::AddSurface(), G4AdjointPhotoElectricModel::AdjointCrossSection(), Acts::adjustBinUtility(), G4BFieldIntegrationDriver::AdvanceChordLimited(), G4VAtomDeexcitation::AlongStepDeexcitation(), G4NuclearStopping::AlongStepDoIt(), G4ContinuousGainOfEnergy::AlongStepDoIt(), G4VEnergyLossProcess::AlongStepDoIt(), G4VMultipleScattering::AlongStepDoIt(), G4Transportation::AlongStepGetPhysicalInteractionLength(), G4CoupledTransportation::AlongStepGetPhysicalInteractionLength(), G4VEnergyLossProcess::AlongStepGetPhysicalInteractionLength(), G4Nucleus::AnnihilationEvaporationEffects(), G4LightMedia::AntiLambdaExchange(), G4LightMedia::AntiNeutronExchange(), G4LightMedia::AntiOmegaMinusExchange(), G4LightMedia::AntiProtonExchange(), G4LightMedia::AntiSigmaMinusExchange(), G4LightMedia::AntiSigmaPlusExchange(), G4LightMedia::AntiXiMinusExchange(), G4LightMedia::AntiXiZeroExchange(), G4RPGAntiLambdaInelastic::ApplyYourself(), G4RPGAntiProtonInelastic::ApplyYourself(), G4RPGAntiSigmaPlusInelastic::ApplyYourself(), G4RPGAntiNeutronInelastic::ApplyYourself(), G4RPGAntiSigmaMinusInelastic::ApplyYourself(), G4RPGAntiOmegaMinusInelastic::ApplyYourself(), G4RPGAntiXiMinusInelastic::ApplyYourself(), G4RPGAntiXiZeroInelastic::ApplyYourself(), G4EmCaptureCascade::ApplyYourself(), approx(), G4CutTubs::ApproxSurfaceNormal(), ar3jet(), arorie(), attrad(), G4RDeIonisationSpectrum::AverageEnergy(), G4eIonisationSpectrum::AverageEnergy(), G4RDeBremsstrahlungSpectrum::AverageEnergy(), G4eBremsstrahlungSpectrum::AverageEnergy(), G4RDeBremsstrahlungSpectrum::AverageValue(), G4eBremsstrahlungSpectrum::AverageValue(), G4HadronBuilder::Barion(), BbcInit(), BECALInit(), G4AtimaEnergyLossModel::Bethek_dedx_e(), BMMGInit(), Acts::Test::BOOST_AUTO_TEST_CASE(), G4UnionSolid::BoundingLimits(), G4IntersectionSolid::BoundingLimits(), G4CutTubs::BoundingLimits(), G4Para::BoundingLimits(), G4Cons::BoundingLimits(), G4ExtrudedSolid::BoundingLimits(), G4Sphere::BoundingLimits(), G4WilsonAblationModel::BreakItUp(), BToFInit(), DicomFilePET::BuildActivities(), G4Voxelizer::BuildBitmasks(), G4Voxelizer::BuildBoundingBox(), G4AdjointCSManager::BuildCrossSectionsMatricesForAGivenModelAndElement(), G4AdjointCSManager::BuildCrossSectionsMatricesForAGivenModelAndMaterial(), G4VEmProcess::BuildLambdaTable(), G4LowEnergyBremsstrahlung::BuildLossTable(), DicomFileCT::BuildMaterials(), G4PenelopeOscillatorManager::BuildOscillatorTable(), G4NeutronInelasticXS::BuildPhysicsTable(), G4ParticleInelasticXS::BuildPhysicsTable(), G4NeutronElasticXS::BuildPhysicsTable(), G4NeutronCaptureXS::BuildPhysicsTable(), G4SBBremTable::BuildSamplingTables(), G4tgbVolume::BuildSolidForDivision(), DicomFileCT::BuildStructureIDs(), G4Voxelizer::BuildVoxelLimits(), nlohmann::detail::binary_writer< BasicJsonType, CharType >::calc_bson_integer_size(), G4BulirschStoer::calc_h_opt(), G4ConvergenceTester::calc_slope_fit(), G4IntersectionSolid::CalculateExtent(), G4UnionSolid::CalculateExtent(), G4RPGKMinusInelastic::Cascade(), G4RPGAntiLambdaInelastic::Cascade(), G4RPGAntiProtonInelastic::Cascade(), G4RPGAntiSigmaPlusInelastic::Cascade(), G4RPGSigmaPlusInelastic::Cascade(), G4RPGXiMinusInelastic::Cascade(), G4RPGAntiNeutronInelastic::Cascade(), G4RPGAntiOmegaMinusInelastic::Cascade(), G4RPGAntiSigmaMinusInelastic::Cascade(), G4RPGAntiXiMinusInelastic::Cascade(), G4RPGOmegaMinusInelastic::Cascade(), G4RPGAntiXiZeroInelastic::Cascade(), G4RPGKPlusInelastic::Cascade(), G4RPGKZeroInelastic::Cascade(), G4RPGLambdaInelastic::Cascade(), G4RPGSigmaMinusInelastic::Cascade(), G4RPGXiZeroInelastic::Cascade(), G4RPGAntiKZeroInelastic::Cascade(), CEmc(), CEmc_1DProjectiveSpacal(), CEmc_2DProjectiveSpacal(), CEmcAlbedoInit(), Acts::Extent::check(), G4HadronicProcess::CheckEnergyMomentumConservation(), G4PVPlacement::CheckOverlaps(), G4EllipticalTube::CheckParameters(), G4Ellipsoid::CheckParameters(), G4GeomTools::CheckSnip(), G4Fancy3DNucleus::ChoosePositions(), G4Nucleus::Cinema(), G4HadronicInteractionRegistry::Clean(), G4BoundingEnvelope::ClipEdgesByVoxel(), G4BoundingEnvelope::ClipVoxelByPlanes(), Acts::AnnulusBounds::closestOnSegment(), TPCFEETestRecov1::Clustering(), G4VEmAdjointModel::ComputeAdjointCrossSectionVectorPerAtomForScatProj(), G4VEmAdjointModel::ComputeAdjointCrossSectionVectorPerAtomForSecond(), G4VEmAdjointModel::ComputeAdjointCrossSectionVectorPerVolumeForScatProj(), G4VEmAdjointModel::ComputeAdjointCrossSectionVectorPerVolumeForSecond(), G4ChatterjeeCrossSection::ComputeCrossSection(), G4KalbachCrossSection::ComputeCrossSection(), G4BoldyshevTripletModel::ComputeCrossSectionPerAtom(), G4LivermoreGammaConversionModel::ComputeCrossSectionPerAtom(), G4LDMBremModel::ComputeCrossSectionPerAtom(), G4eBremsstrahlungRelModel::ComputeCrossSectionPerAtom(), G4eBremParametrizedModel::ComputeCrossSectionPerAtom(), G4PairProductionRelModel::ComputeCrossSectionPerAtom(), G4MuPairProductionModel::ComputeCrossSectionPerAtom(), G4MuBremsstrahlungModel::ComputeCrossSectionPerAtom(), G4IonParametrisedLossModel::ComputeCrossSectionPerAtom(), G4PolarizedMollerBhabhaModel::ComputeCrossSectionPerElectron(), G4AtimaEnergyLossModel::ComputeCrossSectionPerElectron(), G4MollerBhabhaModel::ComputeCrossSectionPerElectron(), G4mplIonisationWithDeltaModel::ComputeCrossSectionPerElectron(), G4LindhardSorensenIonModel::ComputeCrossSectionPerElectron(), G4BetheBlochModel::ComputeCrossSectionPerElectron(), G4ICRU73QOModel::ComputeCrossSectionPerElectron(), G4MuBetheBlochModel::ComputeCrossSectionPerElectron(), G4BraggIonModel::ComputeCrossSectionPerElectron(), G4BraggModel::ComputeCrossSectionPerElectron(), G4ComponentBarNucleonNucleusXsc::ComputeCrossSections(), G4ComponentGGHadronNucleusXsc::ComputeCrossSections(), G4ComponentGGNuclNuclXsc::ComputeCrossSections(), MyMollerBhabhaModel::ComputeDEDXPerVolume(), G4mplIonisationWithDeltaModel::ComputeDEDXPerVolume(), G4eBremsstrahlungRelModel::ComputeDEDXPerVolume(), G4eBremParametrizedModel::ComputeDEDXPerVolume(), G4PAIPhotModel::ComputeDEDXPerVolume(), G4PAIModel::ComputeDEDXPerVolume(), G4AtimaEnergyLossModel::ComputeDEDXPerVolume(), G4MollerBhabhaModel::ComputeDEDXPerVolume(), G4LindhardSorensenIonModel::ComputeDEDXPerVolume(), G4MuBremsstrahlungModel::ComputeDEDXPerVolume(), G4BetheBlochModel::ComputeDEDXPerVolume(), G4MuBetheBlochModel::ComputeDEDXPerVolume(), G4BraggIonModel::ComputeDEDXPerVolume(), G4LDMBremModel::ComputeDMicroscopicCrossSection(), G4SeltzerBergerModel::ComputeDXSectionPerAtom(), G4PairProductionRelModel::ComputeDXSectionPerAtom(), G4eplusTo3GammaOKVIModel::ComputeF(), G4UrbanMscModel::ComputeGeomPathLength(), G4UrbanAdjointMscModel::ComputeGeomPathLength(), G4GoudsmitSaundersonMscModel::ComputeGeomPathLength(), GFlashSamplingShowerParameterisation::ComputeLongitudinalParameters(), G4SandiaTable::ComputeMatSandiaMatrix(), G4WentzelOKandVIxSection::ComputeMaxElectronScattering(), G4NIELCalculator::ComputeNIEL(), G4PairProductionRelModel::ComputeRelDXSectionPerAtom(), G4ErrorPropagationNavigator::ComputeSafety(), G4VoxelSafety::ComputeSafety(), G4ErrorPropagationNavigator::ComputeStep(), G4PropagatorInField::ComputeStep(), G4PathFinder::ComputeStep(), G4Navigator::ComputeStep(), G4ReplicaNavigation::ComputeStep(), G4ITNavigator2::ComputeStep(), G4ITPathFinder::ComputeStep(), G4RegularNavigation::ComputeStepSkippingEqualMaterials(), G4LowEWentzelVIModel::ComputeTruePathLengthLimit(), G4WentzelVIModel::ComputeTruePathLengthLimit(), G4UrbanMscModel::ComputeTruePathLengthLimit(), G4UrbanAdjointMscModel::ComputeTruePathLengthLimit(), G4GoudsmitSaundersonMscModel::ComputeTruePathLengthLimit(), G4WentzelVIModel::ComputeTrueStepLength(), G4ParameterisedNavigation::ComputeVoxelSafety(), G4VoxelNavigation::ComputeVoxelSafety(), G4PairProductionRelModel::ComputeXSectionPerAtom(), G4MuPairProductionModel::ComputMuPairLoss(), Acts::TGeoDetectorElement::construct(), PHG4FullProjSpacalDetector::Construct_Fibers_SameLengthFiberPerTower(), PHG4FullProjTiltedSpacalDetector::Construct_Fibers_SameLengthFiberPerTower(), G4MonopolePhysics::ConstructProcess(), G4BetheBlochModel::CorrectionsAlongStep(), Acts::CylinderVolumeHelper::createGapTrackingVolume(), G4VLongitudinalStringDecay::CreatePartonPair(), Acts::createProtoMaterial(), G4LivermoreIonisationCrossSection::CrossSection(), G4PenelopeIonisationCrossSection::CrossSection(), G4PAIPhotModel::CrossSectionPerVolume(), G4PAIModel::CrossSectionPerVolume(), Acts::ATLASCuts< SpacePoint >::cutPerMiddleSP(), G4DNAMolecularDissociation::DecayIt(), G4ICRU73QOModel::DEDXPerElement(), G4FissionParameters::DefineParameters(), FW::determineEventFilesRange(), FW::Sequencer::determineEventsRange(), G4DiffractiveSplitableHadron::Diquark(), G4QGSMFragmentation::DiQuarkSplitup(), G4LundStringFragmentation::DiQuarkSplitup(), G4GeomTools::DiskExtent(), DiskInit(), G4AtimaFluctuations::Dispersion(), Acts::RectangleBounds::distanceToBoundary(), Acts::EllipseBounds::distanceToBoundary(), G4EllipticalTube::DistanceToIn(), G4Box::DistanceToIn(), G4UnionSolid::DistanceToIn(), G4IntersectionSolid::DistanceToIn(), G4Ellipsoid::DistanceToIn(), G4Tet::DistanceToIn(), G4Trap::DistanceToIn(), G4EllipticalTube::DistanceToOut(), G4Box::DistanceToOut(), G4IntersectionSolid::DistanceToOut(), G4SubtractionSolid::DistanceToOut(), G4Ellipsoid::DistanceToOut(), G4Tet::DistanceToOut(), G4CutTubs::DistanceToOut(), G4ExtrudedSolid::DistanceToOut(), G4EllipticalCone::DistanceToOut(), G4Sphere::DistanceToOut(), nanoflann::KDTreeSingleIndexAdaptor< nanoflann::L2_Simple_Adaptor< double, kdfinder::KDPointCloud< double > >, kdfinder::KDPointCloud< double >, 3 >::divideTree(), dofistatescat(), doinstatescat(), dokinematics(), G4PathFinder::DoNextCurvedStep(), G4ITPathFinder::DoNextCurvedStep(), G4PathFinder::DoNextLinearStep(), G4ITPathFinder::DoNextLinearStep(), G4ScreenedCoulombClassicalKinematics::DoScreeningComputation(), Draw_ratio(), G4ScoreLogColorMap::DrawColorChartBar(), G4VScoreColorMap::DrawColorChartBar(), G4ScoreLogColorMap::DrawColorChartText(), G4VScoreColorMap::DrawColorChartText(), G4EmModelManager::DumpModelList(), EEMCHInit(), EEMCInit(), EGEM_Init(), ei(), GFlashShowerModel::ElectronDoIt(), G4BraggModel::ElectronicStoppingPower(), G4BraggIonModel::ElectronicStoppingPower(), G4GeomTools::EllipsePerimeter(), G4GeomTools::EllipticConeLateralArea(), G4AtimaFluctuations::EnergyTable_interpolate(), G4AtimaEnergyLossModel::EnergyTable_interpolate(), errorOf1DHistograms(), G4RDRangeTest::Escape(), G4VSolid::EstimateSurfaceArea(), ETOFInit(), G4Nucleus::EvaporationEffects(), G4RDeIonisationParameters::Excitation(), G4eIonisationParameters::Excitation(), FW::TrackSelector::execute(), FW::ParticleSelector::execute(), Acts::Extent::extend(), Acts::Polyhedron::extent(), G4MultiUnion::Extent(), G4RPGInelastic::Factorial(), FEMCInit(), Acts::fieldMapperRZ(), G4INCL::NpiToMissingStrangenessChannel::fillFinalState(), G4INCL::NNToMissingStrangenessChannel::fillFinalState(), G4ElasticHadrNucleusHE::FillFq2(), G4MesonAbsorption::FindAndFillCluster(), G4PhysicsVector::FindLinearEnergy(), G4JTPolynomialSolver::FindRoots(), sPHENIXTrackerTpc::findTracksBySegments(), sPHENIXTracker::findTracksBySegments(), sPHENIXSeedFinder::findTracksBySegments(), G4PhysicsOrderedFreeVector::FindValueBinLocation(), FST_Init(), G3CalcParamsFn(), G4ArrowModel::G4ArrowModel(), G4IntersectingCone::G4IntersectingCone(), CLHEP::RandBinomial::genBinomial(), G4eeToHadronsModel::GenerateCMPhoton(), G4Clebsch::GenerateIso3(), G4RPGReaction::GenerateNBodyEvent(), G4RPGReaction::GenerateNBodyEventT(), GFlashHomoShowerParameterisation::GenerateRadius(), GFlashSamplingShowerParameterisation::GenerateRadius(), G4AntiNeutronAnnihilationAtRest::GenerateSecondaries(), G4ParticleHPVector::Get15percentBorder(), DNA::Penetration::Terrisol1990::Get3DStdDeviation(), kdfinder::get_track_color(), G4INCL::ClusteringModelIntercomparison::getCluster(), G4hImpactIonisation::GetConstraints(), G4ContinuousGainOfEnergy::GetContinuousStepLimit(), G4PenelopeIonisationCrossSection::GetCrossSection(), G4LivermoreIonisationCrossSection::GetCrossSection(), G4VEnergyLossProcess::GetDEDXDispersion(), G4LindhardSorensenData::GetDeltaL(), G4NeutronCaptureXS::GetElementCrossSection(), G4BGGNucleonElasticXS::GetElementCrossSection(), G4BGGNucleonInelasticXS::GetElementCrossSection(), G4BGGPionElasticXS::GetElementCrossSection(), G4BGGPionInelasticXS::GetElementCrossSection(), G4PhotonEvaporation::GetEmissionProbability(), G4OpBoundaryProcess::GetFacetNormal(), getinsudared(), PHG4SteppingAction::GetLightCorrection(), G4CutTubs::GetMaxMinZ(), G4ScreenedNuclearRecoil::GetMeanFreePath(), G4Accumulables::GetMergeFunction(), G4FTFParameters::GetMinMass(), G4ClippablePolygon::GetMinPoint(), G4PenelopeBremsstrahlungFS::GetMomentumIntegral(), G4MuonMinusBoundDecay::GetMuonZeff(), getnewmass(), G4RPGInelastic::GetNormalizationConstant(), G4ComponentGGHadronNucleusXsc::GetParticleBarCorIn(), G4ComponentGGHadronNucleusXsc::GetParticleBarCorTot(), G4VMscModel::GetParticleChangeForMSC(), getpdfxint(), PHG4TruthInfoContainer::GetPrimaryVertexIndex(), G4ITNavigator2::GetRandomInCurrentVolume(), G4AdjointComptonModel::GetSecondAdjEnergyMaxForScatProjToProjCase(), G4VEmAdjointModel::GetSecondAdjEnergyMaxForScatProjToProjCase(), getspliti(), CCaloSD::getStepInfo(), G4ParticleHPVector::GetXsec(), getxsecint(), G4ParticleHPPartial::GetY(), gridBoxFactory(), G4HadronNucleonXsc::HadronNucleonXscNS(), G4HadronNucleonXsc::HadronNucleonXscVU(), G4ElasticHadrNucleusHE::HadronNucleusQ2_2(), HCalInnerInit(), HCalOuterInit(), hFarBwdBeamLineInit(), hFarFwdBeamLineInit(), hijels(), hijing(), hijsft(), hiptdi(), HTOFInit(), inflate_table(), G4ClippablePolygon::InFrontOf(), init(), G4ParticleHPDeExGammas::Init(), G4ParticleHPContAngularPar::Init(), G4BoldyshevTripletModel::Initialise(), G4LivermoreGammaConversionModel::Initialise(), G4LivermorePhotoElectricModel::Initialise(), G4eeToHadronsModel::Initialise(), G4WentzelVIModel::Initialise(), G4FermiFragmentsPoolVI::Initialise(), G4SeltzerBergerModel::Initialise(), G4EmModelManager::Initialise(), G4BetheHeitlerModel::InitialiseElementData(), G4eBremsstrahlungRelModel::InitialiseElementData(), G4PairProductionRelModel::InitialiseElementData(), G4hhIonisation::InitialiseEnergyLossProcess(), G4mplIonisation::InitialiseEnergyLossProcess(), G4eBremsstrahlung::InitialiseEnergyLossProcess(), G4MuIonisation::InitialiseEnergyLossProcess(), G4hIonisation::InitialiseEnergyLossProcess(), G4ElasticHadrNucleusHE::InitialiseModel(), G4CoulombScattering::InitialiseProcess(), CCalEventAction::initialize(), G4FastPathHadronicCrossSection::fastPathEntry::Initialize(), G4Tet::Initialize(), G4hImpactIonisation::InitializeParametrisation(), G4PenelopeRayleighModel::InitializeSamplingAlgorithm(), G4GoudsmitSaundersonTable::InitSCPCorrection(), G4INCL::IFunction1D::integrate(), G4UPiNuclearCrossSection::Interpolate(), G4RDeBremsstrahlungSpectrum::IntSpectrum(), G4eBremsstrahlungSpectrum::IntSpectrum(), G4INCL::IFunction1D::inverseCDFTable(), G4NeutronCaptureXS::IsoCrossSection(), G4ExtrudedSolid::IsSameLineSegment(), jetini(), Acts::JsonGeometryConverter::jsonToBinUtility(), Acts::JsonGeometryConverter::jsonToVolumeMaterial(), G4INCL::NpiToSKChannel::KaonMomentum(), G4HadronNucleonXsc::KaonNucleonXscVG(), G4LightMedia::KaonPlusExchange(), G4LightMedia::KaonZeroShortExchange(), G4LightMedia::LambdaExchange(), Acts::LayerArrayCreator::layerArray(), G4LevelReader::LevelManager(), LFHCALInit(), G4IntersectingCone::LineHitsCone1(), G4IntersectingCone::LineHitsCone2(), G4AttValueFilterT< T, ConversionErrorPolicy >::LoadIntervalElement(), G4SBBremTable::LoadSamplingTables(), G4SBBremTable::LoadSTGrid(), G4EmCorrections::LShellCorrection(), lu3ent(), lu4ent(), luboei(), lucell(), luclus(), ludecy(), lueevt(), luexec(), luhepc(), luindf(), lujmas(), lukfdi(), lulist(), luradk(), lushow(), lusphe(), lustrf(), lutabu(), luthru(), luupda(), lux3jt(), lux4jt(), luxjet(), luxtot(), luzdis(), MagnetInit(), main(), EmPlot::make_plot(), makebranch(), makesplitting(), Acts::mapMaterialPoints(), G4AtimaEnergyLossModel::MaxSecondaryEnergy(), G4BetheBlochModel::MaxSecondaryEnergy(), MCGIDI_particle_getInternalID(), MCGIDI_POPs_findParticleIndex(), Acts::ProtoLayer::measure(), MicromegasInit(), G4INCL::Random::Adapter::min(), G4hCoulombScatteringModel::MinPrimaryEnergy(), G4eCoulombScatteringModel::MinPrimaryEnergy(), MvtxInit(), G4LevelManager::NearestLevelIndex(), G4LightMedia::NeutronExchange(), nthick(), G4RPGReaction::NuclearReaction(), G4ICRU49NuclearStoppingModel::NuclearStoppingPower(), G4LightMedia::OmegaMinusExchange(), Acts::CKFSourceLinkSelector::operator()(), DicomVFileImage::operator+(), DicomPhantomZSliceHeader::operator+(), G4PenelopeComptonModel::OscillatorTotalCrossSection(), Acts::VolumeConfig::overlapsInR(), Acts::VolumeConfig::overlapsInZ(), G4RDBremsstrahlungParameters::Parameter(), G4RDeIonisationParameters::Parameter(), G4BremsstrahlungParameters::Parameter(), G4eIonisationParameters::Parameter(), G4LightMedia::PionPlusExchange(), PipeInit(), plu(), PlugDoorInit(), G4RPGInelastic::Pmltpc(), G4DipBustGenerator::PolarAngle(), G4LowEnergyGammaConversion::PostStepDoIt(), G4LowEnergyPhotoElectric::PostStepDoIt(), G4Scintillation::PostStepDoIt(), G4VMultipleScattering::PreparePhysicsTable(), G4INCL::INCL::prepareReaction(), G4RDeIonisationSpectrum::Probability(), G4eIonisationSpectrum::Probability(), G4RDeBremsstrahlungSpectrum::Probability(), G4eBremsstrahlungSpectrum::Probability(), G4GEMProbabilityVI::ProbabilityDistributionFunction(), CellularAutomaton_v1::process_single_track(), CellularAutomaton_v1::process_single_triplet(), G4LightMedia::ProtonExchange(), prt_normalize(), py3ent(), py4ent(), py4jts(), pyadsh(), pyalps(), pyboei(), pycell(), pyclus(), pydcyk(), pydecy(), pydisg(), pydocu(), pyeevt(), pyevnt(), pyevnw(), pyexec(), pyfill(), pyfscr(), pygaga(), pyggam(), pyglui(), pygram(), pyhepc(), pyhext(), pyhfth(), pyhiinit(), pyhiinre(), pyhiklim(), pyhikmap(), pyhimaxi(), pyhimult(), pyhiovly(), pyhirand(), pyhiremn(), pyhiscat(), pyhisigh(), pyhisspa(), pyhistfe(), pyhistfu(), pyhithia(), pyhixtot(), pyi3au(), pyindf(), pyinit(), pyinpr(), pyinre(), pyjmas(), pykfdi(), pykfin(), pyklim(), pykmap(), pylist(), pylogo(), pymael(), pymaxi(), pymign(), pymihg(), pymihk(), pymirm(), pymsin(), pymult(), pyofsh(), pyoper(), pyovly(), pyp(), pypdel(), pypdfu(), pypdga(), pypdpi(), pypdpo(), pypdpr(), pypile(), pyprep(), pyptfs(), pyptis(), pyptmi(), pyradk(), pyrand(), pyremn(), pyresd(), pyrget(), pyrnm3(), pyrnmq(), pyrobo(), pyrset(), pyscat(), pysgqc(), pysgwz(), pyshow(), pysigh(), pyslha(), pysphe(), pysspa(), pystfe(), pystfu(), pystrf(), pytabu(), pytecm(), pytest(), pythia(), pythru(), pyupda(), pywidt(), pyx3jt(), pyx4jt(), pyxjet(), pyxkfl(), pyxtee(), pyxtot(), pyzdis(), Acts::ProtoLayer::radialDistance(), G4NuclearRadii::RadiusCB(), G4RPGTwoCluster::ReactionStage(), G4RPGTwoBody::ReactionStage(), G4RPGFragmentation::ReactionStage(), G4PathFinder::RecheckDistanceToCurrentBoundary(), G4Navigator::RecheckDistanceToCurrentBoundary(), G4ITNavigator2::RecheckDistanceToCurrentBoundary(), Acts::TGeoLayerBuilder::registerSplit(), rkstepper(), rluget(), rluset(), FW::RootMaterialDecorator::RootMaterialDecorator(), RWellInit(), G4VoxelSafety::SafetyForVoxelHeader(), G4VoxelSafety::SafetyForVoxelNode(), G4ParticleHPContAngularPar::Sample(), G4VEmAdjointModel::SampleAdjSecEnergyFromCSMatrix(), G4PAIModelData::SampleAlongStepTransfer(), G4UrbanMscModel::SampleCosineTheta(), G4UrbanAdjointMscModel::SampleCosineTheta(), G4DipBustGenerator::SampleCosTheta(), G4PenelopeBremsstrahlungAngular::SampleDirection(), G4UrbanAdjointMscModel::SampleDisplacement(), G4eIonisationSpectrum::SampleEnergy(), G4RDeIonisationSpectrum::SampleEnergy(), G4RDeBremsstrahlungSpectrum::SampleEnergy(), G4eBremsstrahlungSpectrum::SampleEnergy(), G4SBBremTable::SampleEnergyTransfer(), G4SeltzerBergerModel::SampleEnergyTransfer(), TPCDaqDefs::FEEv1::SampleFit_PowerLawDoubleExp(), G4UniversalFluctuation::SampleFluctuations(), G4ElasticHadrNucleusHE::SampleInvariantT(), G4SampleResonance::SampleMass(), G4PAIModelData::SamplePostStepTransfer(), G4VScatteringCollision::SampleResonanceMass(), G4LEPTSDissociationModel::SampleSecondaries(), G4LEPTSExcitationModel::SampleSecondaries(), G4LivermoreGammaConversionModelRC::SampleSecondaries(), G4LivermoreNuclearGammaConversionModel::SampleSecondaries(), G4LivermorePolarizedGammaConversionModel::SampleSecondaries(), G4LivermoreGammaConversionModel::SampleSecondaries(), G4LivermoreBremsstrahlungModel::SampleSecondaries(), G4PolarizedMollerBhabhaModel::SampleSecondaries(), G4LivermoreIonisationModel::SampleSecondaries(), G4PenelopeRayleighModel::SampleSecondaries(), G4LDMBremModel::SampleSecondaries(), G4BetheHeitlerModel::SampleSecondaries(), G4SeltzerBergerModel::SampleSecondaries(), G4eplusTo3GammaOKVIModel::SampleSecondaries(), G4eBremsstrahlungRelModel::SampleSecondaries(), G4mplIonisationWithDeltaModel::SampleSecondaries(), G4eBremParametrizedModel::SampleSecondaries(), G4PairProductionRelModel::SampleSecondaries(), G4PenelopeComptonModel::SampleSecondaries(), G4MuPairProductionModel::SampleSecondaries(), G4eCoulombScatteringModel::SampleSecondaries(), G4MuBremsstrahlungModel::SampleSecondaries(), G4ICRU73QOModel::SampleSecondaries(), G4MuBetheBlochModel::SampleSecondaries(), G4BraggIonModel::SampleSecondaries(), G4BraggModel::SampleSecondaries(), G4AtimaEnergyLossModel::SampleSecondaries(), G4LindhardSorensenIonModel::SampleSecondaries(), G4BetheBlochModel::SampleSecondaries(), G4IonParametrisedLossModel::SampleSecondaries(), G4GammaTransition::SampleTransition(), G4EmElementSelector::SelectRandomAtom(), PHG4InputFilter::set_eta_range(), PHG4ParticleGenerator_flat_pT::set_eta_range(), PHG4ParticleGenerator::set_eta_range(), PHG4ParticleGeneratorD0::set_eta_range(), PHG4ParticleGeneratorVectorMeson::set_eta_range(), PHG4SimpleEventGenerator::set_eta_range(), PHG4InputFilter::set_etamin(), PHG4ParticleGenerator::set_mom_range(), PHG4ParticleGeneratorD0::set_mom_range(), PHG4ParticleGeneratorVectorMeson::set_mom_range(), PHG4SimpleEventGenerator::set_p_range(), PHG4ParticleGenerator::set_phi_range(), PHG4ParticleGenerator_flat_pT::set_phi_range(), PHG4SimpleEventGenerator::set_phi_range(), PHG4ParticleGenerator_flat_pT::set_pT_range(), PHG4ParticleGeneratorD0::set_pt_range(), PHG4ParticleGeneratorVectorMeson::set_pt_range(), PHG4SimpleEventGenerator::set_pt_range(), PHG4InputFilter::set_ptmin(), PHG4ParticleGeneratorD0::set_rapidity_range(), PHG4ParticleGeneratorVectorMeson::set_rapidity_range(), PHG4SimpleEventGenerator::set_theta_range(), PHG4ParticleGenerator::set_z_range(), PHG4ParticleGenerator_flat_pT::set_z_range(), G4RadioactiveDecayBase::SetDecayHalfAngle(), G4RadioactiveDecay::SetDecayHalfAngle(), eIDMLInterface::setEtaRange(), G4EmConfigurator::SetExtraEmModel(), G4VLongitudinalStringDecay::SetMinimalStringMass(), G4VLongitudinalStringDecay::SetMinMasses(), CexmcProductionModelMessenger::SetNewValue(), CexmcEnergyDepositDigitizerMessenger::SetNewValue(), G4mplIonisationModel::SetParticle(), G4mplIonisationWithDeltaModel::SetParticle(), PHG4TpcDirectLaser::SetPhiStepping(), G3Division::SetRangeAndAxis(), G4VEnergyLossProcess::SetStepFunction(), ECCEmRICHFastPIDMap::setThetaAcceptanceMinMax(), PHG4TpcDirectLaser::SetThetaStepping(), G4ScreeningMottCrossSection::SetupKinematic(), G4WentzelOKandVIxSection::SetupTarget(), G4EmParameters::SetVerbose(), PHG4ScoringManager::setVertexAcceptanceRange(), PHG4ScoringManager::setVertexHistRange(), G4AtimaEnergyLossModel::sezi_dedx_e(), G4EmCorrections::ShellCorrection(), G4LightMedia::SigmaMinusExchange(), G4LightMedia::SigmaPlusExchange(), G4RPGNeutronInelastic::SlowNeutron(), Acts::solenoidFieldMapper(), G4GeomTools::SphereExtent(), Acts::EigenStepper< bfield_t, extensionlist_t, auctioneer_t >::step(), G4VMultipleScattering::StorePhysicsTable(), G4Scheduler::SynchronizeTracks(), Acts::RectangleBounds::toStream(), G4EvaporationProbability::TotalProbability(), TPCInit(), TrackingServiceInit(), TRDInit(), CaloTriggerSim::truncate_8bit(), G4BulirschStoer::try_step(), nlohmann::detail::binary_writer< BasicJsonType, CharType >::ubjson_prefix(), ulalps(), G4EmConfigurator::UpdateModelEnergyRange(), CCalSteppingAction::UserSteppingAction(), G4Clebsch::Weight(), WorldSize(), Acts::AxisAlignedBoundingBox< entity_t, value_t, DIM >::wrap(), Acts::detail::Axis< AxisType::Equidistant, bdt >::wrapBin(), Acts::detail::Axis< AxisType::Variable, bdt >::wrapBin(), FW::RootMaterialWriter::write(), nlohmann::detail::binary_writer< BasicJsonType, CharType >::write_bson_integer(), nlohmann::detail::binary_writer< BasicJsonType, CharType >::write_msgpack(), nlohmann::detail::binary_writer< BasicJsonType, CharType >::write_number_with_ubjson_prefix(), G4LightMedia::XiMinusExchange(), and G4LightMedia::XiZeroExchange().

const __m128 one_o_100 = {0.01,0.01,0.01,0.01}
static

Definition at line 13 of file HelixHough_allButKappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 13 of file HelixHough_allButKappaRange_sse.cpp

const __m128 one_o_3 = {0.3333333333333333333, 0.3333333333333333333, 0.3333333333333333333, 0.3333333333333333333}
static

Definition at line 16 of file HelixHough_allButKappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 16 of file HelixHough_allButKappaRange_sse.cpp

const __m128 one_o_4 = {0.25,0.25,0.25,0.25}
static

Definition at line 11 of file HelixHough_allButKappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 11 of file HelixHough_allButKappaRange_sse.cpp

__m128 one_o_v = _vec_rec_ps(v)

Definition at line 100 of file HelixHough_allButKappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 100 of file HelixHough_allButKappaRange_sse.cpp

Referenced by HelixHough::dzdlRange_sse().

__m128 __m128 __m128 __m128 __m128 __m128& phi

Definition at line 155 of file HelixHough_allButKappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 155 of file HelixHough_allButKappaRange_sse.cpp

Referenced by __example_5.f__(), __example_6.f__(), __example_7.f__(), __example_8.f__(), accessStepWise(), G4HadPhaseSpaceGenbod::AccumulateFinalState(), G4RPGReaction::AddBlackTrackParticles(), AddFlowToParent(), CylindricalHough::addHits(), G4VarNtp::addParticle(), G4ParticleHPFinalState::adjust_final_state(), PHG4TpcDirectLaser::AimToPatternStep(), airy1(), airy1d(), airy2(), airy2d(), AnnularFieldSim::analyticFieldIntegral(), G4PreCompoundEmission::AngularDistribution(), AnnularFieldSim::AnnularFieldSim(), G4LEnp::ApplyYourself(), G4ParticleHPFissionFS::ApplyYourself(), G4LEpp::ApplyYourself(), G4HadronElastic::ApplyYourself(), G4ParticleHPCaptureFS::ApplyYourself(), G4ChargeExchange::ApplyYourself(), G4LENDModel::ApplyYourself(), G4NeutrinoElectronNcModel::ApplyYourself(), G4LENDElastic::ApplyYourself(), G4NeutrinoElectronCcModel::ApplyYourself(), G4NeutronElectronElModel::ApplyYourself(), G4LEHadronProtonElastic::ApplyYourself(), G4ParticleHPElasticFS::ApplyYourself(), G4NuMuNucleusCcModel::ApplyYourself(), G4LFission::ApplyYourself(), G4NuMuNucleusNcModel::ApplyYourself(), G4LMsdGenerator::ApplyYourself(), G4EMDissociation::ApplyYourself(), G4CutTubs::ApproxSurfaceNormal(), G4Torus::ApproxSurfaceNormal(), G4Tubs::ApproxSurfaceNormal(), G4Cons::ApproxSurfaceNormal(), G4MuonRadiativeDecayChannelWithSpin::atan4(), G4DecayWithSpin::AtRestDoIt(), atrobo(), attrad(), Acts::CylinderSurface::binningPosition(), Acts::Test::BOOST_AUTO_TEST_CASE(), Acts::Test::BOOST_DATA_TEST_CASE(), Acts::IntegrationTest::BOOST_DATA_TEST_CASE(), BOOST_DATA_TEST_CASE(), Acts::Test::BOOST_FIXTURE_TEST_CASE(), PHG4mRICHDetector::build_mRICH_wall_hside(), buildBarrelRouting(), buildCoolingRings(), buildEndcapRouting(), PHGenFitTrkProp::BuildLayerZPhiHitMap(), G4Molecule::BuildTrack(), HelixKalman::calculate_dAdAp(), HelixKalmanFilter::calculate_dAdAp(), CylinderKalman::calculate_dxda(), HelixKalmanFilter::calculate_dxda(), HelixHoughFuncs_v1::calculate_phi_range(), ActsTransformations::calculateDCA(), ActsEvaluator::calculateDCA(), G4MuonVDNuclearModel::CalculateEMVertex(), G4ElectroVDNuclearModel::CalculateEMVertex(), G4PolyconeSide::CalculateExtent(), HelixDCAFunc::calcValGradHessian(), FW::Generic::ProtoLayerCreatorT< detector_element_t >::centralProtoLayers(), Acts::LayerCreator::checkBinning(), G4RadioactiveDecayBase::ChooseCollimationDirection(), G4RadioactiveDecay::ChooseCollimationDirection(), PHTruthTrackSeeding::circleFitSeed(), PHActsSiliconSeeding::circleFitSeed(), G4PolyhedraSide::ClosestPhiSegment(), CMDistortionAnalysis(), CMDistortionAnalysisCart(), CMDistortionAnalysisPhiR(), CMDistortionReco(), CMDistortionRecoCart(), CMDistortionRecoPhiR(), LaserDrivenBeamLine::Collimator(), G4ParticleHPInelasticCompFS::CompositeApply(), PHG4EtaPhiParameterization::ComputeDimensions(), G4GoudsmitSaundersonMscModel::ComputeTruePathLengthLimit(), Acts::IntegrationTest::constant_field_propagation(), ExN04DetectorConstruction::Construct(), RE05DetectorConstruction::Construct(), B3DetectorConstruction::Construct(), Acts::TGeoDetectorElement::construct(), IORTDetectorConstruction::ConstructDisc(), PHG4InnerHcalDetector::ConstructInnerHcal(), PHG4InttDetector::ConstructIntt(), PHG4PSTOFDetector::ConstructMe(), G4JLeicVTXDetector::ConstructMe(), G4JLeicDIRCDetector::ConstructMe(), PHG4CEmcTestBeamDetector::ConstructMe(), PHG4HcalDetector::ConstructMe(), PHG4OuterHcalDetector::ConstructOuterHcal(), PHG4CEmcTestBeamDetector::ConstructTowerVolume(), RawClusterBuilderFwd::CorrectPhi(), BEmcRecCEMC::CorrectShowerDepth(), create_element(), DNAParser::CreateCutSolid(), Acts::Visualization::createEllipse(), Acts::SurfaceArrayCreator::createEquidistantAxis(), G4GenericPolycone::CreatePolyhedron(), G4Polyhedra::CreatePolyhedron(), G4Para::CreatePolyhedron(), G4Trap::CreatePolyhedron(), FW::Generic::ProtoLayerCreatorT< detector_element_t >::createProtoLayers(), Acts::detail::VerticesHelper::createSegment(), det::createTkLayoutTrackerBarrel(), det::createTkLayoutTrackerEndcap(), Acts::SurfaceArrayCreator::createVariableAxis(), G4AlphaDecay::DecayIt(), G4TritonDecay::DecayIt(), G4ECDecay::DecayIt(), G4ProtonDecay::DecayIt(), G4NeutronDecay::DecayIt(), G4BetaPlusDecay::DecayIt(), G4BetaMinusDecay::DecayIt(), G4ITDecay::DecayIt(), G4KL3DecayChannel::DecayIt(), G4NeutronBetaDecayChannel::DecayIt(), G4DalitzDecayChannel::DecayIt(), G4TauLeptonicDecayChannel::DecayIt(), G4MuonDecayChannelWithSpin::DecayIt(), PHActsTrackProjection::deltaPhi(), G4PolyconeSide::DistanceAway(), Acts::EllipseBounds::distanceToBoundary(), G4TwistBoxSide::DistanceToSurface(), G4TwistTrapAlphaSide::DistanceToSurface(), G4TwistTrapParallelSide::DistanceToSurface(), G4NRESP71M03::DKINMA(), dofistatescat(), doinstatescat(), dokinematics(), G4MaterialScanner::DoScan(), G4ScoringCylinder::Draw(), G4ScoringCylinder::DrawColumn(), CexmcScenePrimitives::DrawRadialLine(), CCaloOrganization::energyInMatrix(), LaserDrivenBeamLine::Entrancehole(), LaserDrivenBeamLine::EntrancePipe(), Acts::AdaptiveMultiVertexFinder< vfitter_t, sfinder_t >::estimateDeltaZ(), Acts::ImpactPointEstimator< input_track_t, propagator_t, propagator_options_t >::estimateImpactParameters(), QAG4SimulationCalorimeterSum::eval_trk_proj(), FW::TrackSelector::execute(), FW::ParticleSmearing::execute(), FW::ParticleSelector::execute(), LaserDrivenBeamLine::Exithole(), LaserDrivenBeamLine::ExitPipe(), LaserDrivenBeamLine::ExitWindow(), Par01PionShowerModel::Explode(), Par01EMShowerModel::Explode(), PHInitZVertexing::export_output(), PHPatternReco::export_output(), PHHoughSeeding::export_output(), G4PolyconeSide::Extent(), TpcSpaceChargeReconstructionHelper::extrapolate_phi1(), TpcSpaceChargeReconstructionHelper::extrapolate_phi2(), LaserDrivenBeamLine::FaradayCup(), fgp1(), fgp2(), fgp3(), AnnularFieldSim::fieldIntegral(), FW::EffPlotTool::fill(), FW::FakeRatePlotTool::fill(), FW::ResPlotTool::fill(), G4INCL::SigmaZeroDecayChannel::fillFinalState(), JetEvaluator::fillOutputNtuples(), CaloEvaluator::fillOutputNtuples(), SvtxEvaluator::fillOutputNtuples(), AnnularFieldSim::FilterPhiIndex(), AnnularFieldSim::FilterPhiPos(), LaserDrivenBeamLine::FinalCollimator(), sPHENIXTrackerTpc::finalize(), G4VElasticCollision::FinalState(), G4VScatteringCollision::FinalState(), CylinderGeomIntt::find_indices_from_segment_center(), CylinderGeomIntt::find_indices_from_world_location(), PHG4CylinderGeomv4::find_segment_center(), CylinderGeomIntt::find_segment_center(), PHG4CylinderGeomv4::find_strip_center(), CylinderGeomIntt::find_strip_center(), CylinderGeomMicromegas::find_tile_cylindrical(), HelixHough::findSeededHelices(), Acts::FullBilloirVertexFitter< input_track_t, linearizer_t >::fit(), fit_all_update(), ZHough_Cylindrical::fitTrack(), VtxTrackFinder::fitTrack(), ThreeHitSeedGrower::fitTrack(), NHitSeedFinder::fitTrack(), FourHitSeedFinder::fitTrack(), sPHENIXTrackerTpc::fitTrack(), sPHENIXTracker::fitTrack(), sPHENIXSeedFinder::fitTrack(), FourHitSeedFinder::fitTrackLine(), flap(), flap1(), flap2(), fullMaterial(), Acts::Test::SurfaceArrayCreatorFixture::fullPhiTestSurfacesBRL(), Acts::Test::SurfaceArrayCreatorFixture::fullPhiTestSurfacesEC(), G4ArrowModel::G4ArrowModel(), G4PlaneVectorRand(), G4PolyhedraSide::G4PolyhedraSide(), G4PolyPhiFace::G4PolyPhiFace(), G4RandomDirection(), G4RandomPointOnEllipse(), G4fissionEvent::G4SmpIsoDir(), G4ElasticHNScattering::GaussianPt(), G4QuarkExchange::GaussianPt(), G4SingleDiffractiveExcitation::GaussianPt(), G4QGSDiffractiveExcitation::GaussianPt(), G4QGSMSplitableHadron::GaussianPt(), G4DiffractiveExcitation::GaussianPt(), G4QGSParticipants::GaussianPt(), G4FTFAnnihilation::GaussianPt(), G4FTFModel::GaussianPt(), G4AdjointPosOnPhysVolGenerator::GenerateAPositionOnABoxBoundary(), G4AdjointPosOnPhysVolGenerator::GenerateAPositionOnASphereBoundary(), G4SPSAngDistribution::GenerateBeamFlux(), G4PolarizationTransition::GenerateGammaPhi(), G4LivermorePolarizedRayleighModel::GeneratePhi(), G4SPSPosDistribution::GeneratePointsOnSurface(), FW::Geant4::MMPrimaryGeneratorAction::GeneratePrimaries(), ExUCNPrimaryGeneratorAction::GeneratePrimaries(), F06PrimaryGeneratorAction::GeneratePrimaries(), PrimaryGeneratorAction4::GeneratePrimaries(), XrayFluoMercuryPrimaryGeneratorAction::GeneratePrimaries(), XrayFluoPlanePrimaryGeneratorAction::GeneratePrimaries(), XrayFluoPrimaryGeneratorAction::GeneratePrimaries(), GammaRayTelPrimaryGeneratorAction::GeneratePrimaries(), CCalPrimaryGeneratorAction::GeneratePrimaries(), G4InuclSpecialFunctions::generateWithFixedTheta(), G4InuclSpecialFunctions::generateWithRandomAngles(), TpcDistortionCorrection::get_corrected_position(), PHG4Utils::get_etaphi(), TowerJetInput::get_input(), CylinderGeomIntt::get_local_from_world_coords(), PHG4CylinderCellGeom::get_phibin(), SvtxTrackState_v1::get_rphi_error(), CylinderGeom_Mvtx::get_sensor_indices_from_world_coords(), PHG4TpcDistortion::get_x_distortion_cartesian(), PHG4TpcDistortion::get_y_distortion_cartesian(), PHG4TpcDistortion::get_z_distortion_cartesian(), G4WilsonAbrasionModel::GetAbradedNucleons(), G4TwistBoxSide::GetAreaCode(), G4TwistTrapParallelSide::GetAreaCode(), G4TwistTrapAlphaSide::GetAreaCode(), PHTpcResiduals::getCell(), G4ParticleHPDeExGammas::GetDecayGammas(), Acts::ImpactPointEstimator< input_track_t, propagator_t, propagator_options_t >::getDistanceAndMomentum(), G4OpBoundaryProcess::GetFacetNormal(), G4TwistTubsFlatSide::GetFacets(), G4TwistBoxSide::GetFacets(), G4TwistTrapParallelSide::GetFacets(), G4TwistTrapAlphaSide::GetFacets(), G4Nucleus::GetFermiMomentum(), PHField3DCylindrical::GetFieldCyl(), PHField2D::GetFieldValue(), PHField3DCylindrical::GetFieldValue(), G4MesonAbsorption::GetFinalState(), PHG4HcalDetector::GetLength(), kdfinder::TrackCandidate< T >::getMomForHit(), G4TwistBoxSide::GetNormal(), G4TwistTrapAlphaSide::GetNormal(), G4TwistTrapParallelSide::GetNormal(), G4TwistBoxSide::GetPhiUAtX(), G4TwistTrapParallelSide::GetPhiUAtX(), G4RDPhotoElectricAngularGeneratorPolarized::GetPhotoElectronDirection(), G4ParticleHPPhotonDist::GetPhotons(), G4VTwistedFaceted::GetPointInSolid(), G4Polycone::GetPointOnCone(), G4PolyconeSide::GetPointOnFace(), G4Polycone::GetPointOnRing(), G4VTwistedFaceted::GetPointOnSurface(), G4Polycone::GetPointOnSurface(), G4Paraboloid::GetPointOnSurface(), G4Ellipsoid::GetPointOnSurface(), G4Hype::GetPointOnSurface(), G4CutTubs::GetPointOnSurface(), G4Tubs::GetPointOnSurface(), G4Torus::GetPointOnSurface(), G4EllipticalCone::GetPointOnSurface(), G4Cons::GetPointOnSurface(), G4Sphere::GetPointOnSurface(), G4TwistedTubs::GetPointOnSurface(), G4Polycone::GetPointOnTubs(), BEmcRec::GetProb(), getqvec(), G4Absorber::GetRandomDirection(), G4PolarizationHelper::GetRandomFrame(), getscatterer(), PHG4TpcCentralMembrane::getSearchResult(), PHG4TpcCentralMembrane::getStripeID(), G4GDecay3::GetThreeBodyMomenta(), PHTruthClustering::getTpcSector(), CCaloOrganization::getUnitWithMaxEnergy(), Acts::CylinderSurface::globalToLocal(), PassiveProtonBeamLine::HadrontherapyBeamCollimators(), PassiveCarbonBeamLine::HadrontherapyBeamFinalCollimator(), PassiveProtonBeamLine::HadrontherapyBeamFinalCollimator(), PassiveCarbonBeamLine::HadrontherapyBeamNozzle(), PassiveProtonBeamLine::HadrontherapyBeamNozzle(), PassiveProtonBeamLine::HadrontherapyBeamScatteringFoils(), HadrontherapyModulator::HadrontherapyModulator(), PassiveCarbonBeamLine::HadrontherapyPMMACollimator(), hijels(), hijing(), hijsft(), hirobo(), G4NucleiModel::initializeCascad(), RawTowerDeadMapLoader::InitRun(), Acts::EllipseBounds::inside(), G4VTwistedFaceted::Inside(), Acts::CylinderVolumeBounds::inside(), Acts::CylinderBounds::inside3D(), G4RPGReaction::Isotropic(), LJScreening(), AnnularFieldSim::load3dBfield(), AnnularFieldSim::load_and_resample_spacecharge(), G4LatticeLogical::Load_NMap(), AnnularFieldSim::loadBfield(), AnnularFieldSim::loadEfield(), G4LatticeLogical::LoadMap(), Acts::ConeSurface::localToGlobal(), Acts::CylinderSurface::localToGlobal(), CaloCalibEmc_Pi0::Loop(), lu1ent(), lucell(), ludecy(), lueevt(), luindf(), luonia(), luprep(), luptdi(), lurobo(), lushow(), lutabu(), lutest(), luthru(), luxdif(), main(), Acts::Test::SurfaceArrayCreatorFixture::makeBarrelStagger(), makebranch(), makeinsplit(), G4PhaseSpaceDecayChannel::ManyBodyDecayIt(), G4GeneralPhaseSpaceDecay::ManyBodyDecayIt(), G4LatticeLogical::MapKtoV(), G4LatticeLogical::MapKtoVDir(), PHG4TpcPadPlaneReadout::MapToPadPlane(), MCGIDI_outputChannel_sampleProductsAtE(), Acts::ProtoLayer::measure(), Micromegas_Cells(), FW::Generic::modulePositionsRing(), MoliereScreening(), PHSimpleKFProp::MoveToFirstTPCCluster(), Acts::ConeSurface::normal(), Acts::CylinderSurface::normal(), PHActsSiliconSeeding::normPhi2Pi(), G4INCL::Random::normVector(), Acts::ObjectSorterT< Vector3D >::operator()(), FW::ParametricProcessGenerator::operator()(), Acts::DistanceSorterT< T >::operator()(), Acts::Test::MaterialScattering::operator()(), PHHepMCGenHelper::pair2Hep3Vector(), G4GDMLWriteParamvol::Para_dimensionsWrite(), PHG4GDMLWriteParamvol::Para_dimensionsWrite(), G4GDMLReadSolids::ParaRead(), PHG4GDMLWriteSolids::ParaWrite(), G4GDMLWriteSolids::ParaWrite(), Acts::ConeSurface::pathCorrection(), Acts::ImpactPointEstimator< input_track_t, propagator_t, propagator_options_t >::performNewtonApproximation(), PHField3DCylindrical::PHField3DCylindrical(), G4PolyhedraSide::PhiSegment(), G4PhotoElectricAngularGeneratorPolarized::PhotoElectronGeneratePhiAndTheta(), G4RDPhotoElectricAngularGeneratorPolarized::PhotoElectronGeneratePhiAndTheta(), DetectorConstruction::PlaceWithAxialRotations(), DetectorConstruction::PlaceWithDirectMatrix(), DetectorConstruction::PlaceWithEulerAngles(), DetectorConstruction::PlaceWithInverseMatrix(), DetectorConstruction::PlaceWithReflections(), plot_matscan(), plot_matscan_tdr(), G4PolyconeSide::PointOnCone(), PHGenFitTrkFitter::pos_cov_uvn_to_rz(), PHGenFitTrkFitter::pos_cov_XYZ_to_RZ(), G4DecayWithSpin::PostStepDoIt(), G4MuNeutrinoNucleusProcess::PostStepDoIt(), G4NeutrinoElectronProcess::PostStepDoIt(), G4LowEnergyRayleigh::PostStepDoIt(), G4LowEnergyCompton::PostStepDoIt(), G4LowEnergyGammaConversion::PostStepDoIt(), G4LowEnergyPolarizedCompton::PostStepDoIt(), G4LowEnergyIonisation::PostStepDoIt(), G4LowEnergyBremsstrahlung::PostStepDoIt(), G4ForwardXrayTR::PostStepDoIt(), G4VXTRenergyLoss::PostStepDoIt(), G4OpWLS::PostStepDoIt(), G4AnnihiToMuPair::PostStepDoIt(), G4Cerenkov::PostStepDoIt(), G4Scintillation::PostStepDoIt(), G4hImpactIonisation::PostStepDoIt(), G4INCL::INCL::preCascade(), BEmcRec::PredictEnergyProb(), PrimaryGeneratorAction3::PrimaryGeneratorAction3(), CaloEvaluator::printOutputInfo(), PHG4ParticleGenerator::process_event(), PHG4ParticleGenerator_flat_pT::process_event(), PHG4ParticleGeneratorD0::process_event(), RawTowerZDCCalibration::process_event(), RawTowerCalibration::process_event(), RawTowerZDCDigitizer::process_event(), RawTowerDigitizer::process_event(), PHG4CylinderCellReco::process_event(), G4CellNtuple::process_event(), G4SnglTree::process_event(), PHG4ParticleGeneratorVectorMeson::process_event(), PHG4SimpleEventGenerator::process_event(), G4SnglNtuple::process_event(), G4TowerNtuple::process_event(), PHTpcTrackSeedCircleFit::process_event(), G4DIRCTree::process_event(), SubtractTowers::process_event(), SubtractTowersCS::process_event(), RetowerCEMC::process_event(), DetermineTowerBackground::process_event(), PHGenFitTrackProjection::process_event(), LiteCaloEval::process_event(), PHMicromegasTpcTrackMatching::process_event(), RawTowerCombiner::process_event(), CaloAna::process_towers(), profile(), G4TwistBoxSide::ProjectPoint(), G4TwistTrapParallelSide::ProjectPoint(), G4TwistTrapAlphaSide::ProjectPoint(), sPHENIXTracker::projectToLayer(), sPHENIXSeedFinder::projectToLayer(), pwithpF(), py1ent(), py4jet(), pybesq(), pycell(), pydecy(), pydiff(), pydisg(), pyeevt(), pygaga(), pyhii3au(), pyhimult(), pyhiremn(), pyhiresd(), pyhiscat(), pyi3au(), pyindf(), pymign(), pymirm(), pymult(), pyonia(), pyprep(), pyptdi(), pyptfs(), pyptis(), pyptmi(), pyreco(), pyremn(), pyresd(), pyrobo(), pyscat(), pyshow(), pytabu(), pytest(), pythru(), pyxdif(), LaserDrivenBeamLine::Quadrupole(), quench(), G4AdjointComptonModel::RapidSampleSecondaries(), G4AdjointBremsstrahlungModel::RapidSampleSecondaries(), G4AdjointhIonisationModel::RapidSampleSecondaries(), G4RPGTwoCluster::ReactionStage(), G4RPGTwoBody::ReactionStage(), G4RPGFragmentation::ReactionStage(), GammaKnifeController::ReadFile(), FW::Options::readParticleGunOptions(), G4QuasiElRatios::RelDecayIn2(), G4RPGReaction::Rotate(), FW::RootBFieldWriter< bfield_t >::run(), G4ParticleHPIsotropic::Sample(), G4ParticleHPNBodyPhaseSpace::Sample(), G4ParticleHPLabAngularEnergy::Sample(), G4ParticleHPDiscreteTwoBody::Sample(), G4ParticleHPContAngularPar::Sample(), G4QGSMFragmentation::Sample4Momentum(), G4ParticleHPAngular::SampleAndUpdate(), G4PhotoElectricAngularGeneratorPolarized::SampleDirection(), G4DipBustGenerator::SampleDirection(), G4DeltaAngleFreeScat::SampleDirection(), G4SauterGavrilaAngularDistribution::SampleDirection(), G4DeltaAngle::SampleDirection(), G4RayleighAngularGenerator::SampleDirection(), G4GammaTransition::SampleDirection(), G4PenelopeBremsstrahlungAngular::SampleDirection(), G4ModifiedTsai::SampleDirection(), G4Generator2BN::SampleDirection(), G4Generator2BS::SampleDirection(), G4DNABornAngle::SampleDirectionForShell(), G4DNARuddAngle::SampleDirectionForShell(), G4PenelopeIonisationModel::SampleFinalStateElectron(), G4PenelopeIonisationModel::SampleFinalStatePositron(), G4AntiNuclElastic::SampleInvariantT(), G4NuMuNucleusCcModel::SampleLVkr(), G4NuMuNucleusNcModel::SampleLVkr(), G4DipBustGenerator::SamplePairDirections(), G4ModifiedTsai::SamplePairDirections(), G4VLongitudinalStringDecay::SampleQuarkPt(), G4WentzelVIModel::SampleScattering(), G4UrbanMscModel::SampleScattering(), G4UrbanAdjointMscModel::SampleScattering(), G4DNAUeharaScreenedRutherfordElasticModel::SampleSecondaries(), G4DNAScreenedRutherfordElasticModel::SampleSecondaries(), G4DNAChampionElasticModel::SampleSecondaries(), G4AdjointComptonModel::SampleSecondaries(), G4DNAELSEPAElasticModel::SampleSecondaries(), G4AdjointeIonisationModel::SampleSecondaries(), G4XrayRayleighModel::SampleSecondaries(), G4BoldyshevTripletModel::SampleSecondaries(), G4LivermorePolarizedPhotoElectricGDModel::SampleSecondaries(), G4LivermoreGammaConversionModelRC::SampleSecondaries(), G4DNAIonElasticModel::SampleSecondaries(), G4LivermoreComptonModifiedModel::SampleSecondaries(), G4LivermoreNuclearGammaConversionModel::SampleSecondaries(), G4AdjointBremsstrahlungModel::SampleSecondaries(), G4LivermorePolarizedGammaConversionModel::SampleSecondaries(), G4eeToTwoPiModel::SampleSecondaries(), G4ee2KChargedModel::SampleSecondaries(), G4LivermoreGammaConversionModel::SampleSecondaries(), G4ee2KNeutralModel::SampleSecondaries(), G4LivermoreComptonModel::SampleSecondaries(), G4MicroElecElasticModel::SampleSecondaries(), G4MuElecElasticModel::SampleSecondaries(), G4eeToPGammaModel::SampleSecondaries(), G4DNACPA100ElasticModel::SampleSecondaries(), G4PolarizedMollerBhabhaModel::SampleSecondaries(), G4DNACPA100ExcitationModel::SampleSecondaries(), G4PenelopeAnnihilationModel::SampleSecondaries(), G4LivermorePolarizedComptonModel::SampleSecondaries(), G4PenelopeRayleighModel::SampleSecondaries(), G4JAEAElasticScatteringModel::SampleSecondaries(), G4DNACPA100IonisationModel::SampleSecondaries(), G4AdjointhIonisationModel::SampleSecondaries(), G4AdjointIonIonisationModel::SampleSecondaries(), G4LDMBremModel::SampleSecondaries(), G4PenelopePhotoElectricModel::SampleSecondaries(), G4KleinNishinaModel::SampleSecondaries(), G4MuElecInelasticModel::SampleSecondaries(), G4PolarizedAnnihilationModel::SampleSecondaries(), G4eplusTo3GammaOKVIModel::SampleSecondaries(), G4eplusTo2GammaOKVIModel::SampleSecondaries(), G4mplIonisationWithDeltaModel::SampleSecondaries(), G4eeToTwoGammaModel::SampleSecondaries(), G4eSingleCoulombScatteringModel::SampleSecondaries(), G4IonCoulombScatteringModel::SampleSecondaries(), G4PenelopeComptonModel::SampleSecondaries(), G4PAIPhotModel::SampleSecondaries(), G4MollerBhabhaModel::SampleSecondaries(), G4MuPairProductionModel::SampleSecondaries(), G4MuBremsstrahlungModel::SampleSecondaries(), G4LowEPComptonModel::SampleSecondaries(), G4ICRU73QOModel::SampleSecondaries(), G4BraggModel::SampleSecondaries(), G4MuBetheBlochModel::SampleSecondaries(), G4BraggIonModel::SampleSecondaries(), G4DNAPTBElasticModel::SampleSecondaries(), G4AtimaEnergyLossModel::SampleSecondaries(), G4LindhardSorensenIonModel::SampleSecondaries(), G4DNAPTBIonisationModel::SampleSecondaries(), G4BetheBlochModel::SampleSecondaries(), G4LowEPPolarizedComptonModel::SampleSecondaries(), G4WentzelOKandVIxSection::SampleSingleScattering(), G4AntiNuclElastic::SampleThetaLab(), G4NuclNuclDiffuseElastic::SampleThetaLab(), G4DiffuseElastic::SampleThetaLab(), G4UCNMultiScattering::Scatter(), G4WilsonAblationModel::SelectSecondariesByDefault(), CaloTriggerInfov1::set_best2_EMCal_4x4_phi(), CaloTriggerInfov1::set_best_EMCal_2x2_phi(), CaloTriggerInfov1::set_best_EMCal_4x4_phi(), CaloTriggerInfov1::set_best_FullCalo_0p2x0p2_phi(), CaloTriggerInfov1::set_best_FullCalo_0p4x0p4_phi(), CaloTriggerInfov1::set_best_FullCalo_0p6x0p6_phi(), CaloTriggerInfov1::set_best_FullCalo_0p8x0p8_phi(), CaloTriggerInfov1::set_best_FullCalo_1p0x1p0_phi(), RawClusterv1::set_phi(), PHG4CylinderGeomv3::set_phi_slat_zero(), PHG4CylinderGeomv3::set_tiltangle(), ExN04CalorimeterHit::SetCellID(), RE05CalorimeterHit::SetCellID(), G4GHEKinematicsVector::SetEnergyAndUpdate(), HepGeom::BasicVector3D< T >::setEta(), G4GHEKinematicsVector::SetKineticEnergyAndUpdate(), G4GHEKinematicsVector::SetMassAndUpdate(), G4VisCommandsViewerSet::SetNewValue(), G4MatScanMessenger::SetNewValue(), G4LivermorePolarizedComptonModel::SetPhi(), G4LivermorePolarizedPhotoElectricGDModel::SetPhi(), G4LowEnergyPolarizedCompton::SetPhi(), G4LowEPPolarizedComptonModel::SetPhi(), G4RPGNeutronInelastic::SlowNeutron(), G4LundStringFragmentation::SplitEandP(), G4Para::StreamInfo(), G4Trap::StreamInfo(), AnnularFieldSim::sum_local_field_at(), Acts::SurfaceArrayCreator::surfaceArrayOnCylinder(), Acts::SurfaceArrayCreator::surfaceArrayOnDisc(), G4DiffuseElasticV2::ThetaCMStoThetaLab(), G4NuclNuclDiffuseElastic::ThetaCMStoThetaLab(), G4DiffuseElastic::ThetaCMStoThetaLab(), G4DiffuseElasticV2::ThetaLabToThetaCMS(), G4NuclNuclDiffuseElastic::ThetaLabToThetaCMS(), G4DiffuseElastic::ThetaLabToThetaCMS(), G4PhaseSpaceDecayChannel::ThreeBodyDecayIt(), G4GeneralPhaseSpaceDecay::ThreeBodyDecayIt(), G4GDMLWriteParamvol::Trap_dimensionsWrite(), PHG4GDMLWriteParamvol::Trap_dimensionsWrite(), G4GDMLReadSolids::TrapRead(), PHG4GDMLWriteSolids::TrapWrite(), G4GDMLWriteSolids::TrapWrite(), G4GDMLReadSolids::TwistedtubsRead(), G4ParticleHPInelasticCompFS::two_body_reaction(), G4PhaseSpaceDecayChannel::TwoBodyDecayIt(), G4GeneralPhaseSpaceDecay::TwoBodyDecayIt(), CylinderKalman::updateIntersection(), HelixKalmanFilter::updateIntersection(), PHActsVertexPropagator::updateTrackDCA(), PHActsVertexFinder::updateTrackDCA(), Acts::BinningData::value(), ActsEvaluator::visitTrackStates(), FW::RootTrajectoryWriter::writeT(), FW::RootMaterialTrackWriter::writeT(), FW::Obj::writeTube(), G4PolarizedComptonCrossSection::XSection(), and ZBLScreening().

phi_1 = _vec_atan2_ps(tmp5, tmp6)

Definition at line 23 of file HelixHough_allButKappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 23 of file HelixHough_allButKappaRange_sse.cpp

Referenced by HelixHough::phiRange_sse().

phi_2 = _vec_atan2_ps(tmp5, tmp6)

Definition at line 23 of file HelixHough_allButKappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 23 of file HelixHough_allButKappaRange_sse.cpp

Referenced by HelixHough::phiRange_sse().

s = zero

Definition at line 102 of file HelixHough_allButKappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 102 of file HelixHough_allButKappaRange_sse.cpp

__m128 s1 = _mm_xor_ps(tmp3, tmp2)

Definition at line 136 of file HelixHough_allButKappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 136 of file HelixHough_allButKappaRange_sse.cpp

Referenced by airy1(), airy1d(), airy2(), airy2d(), aiz(), biz(), BOOST_AUTO_TEST_CASE(), G4hhElastic::CalculateBQ(), sPHENIXTrackerTpc::calculateKappaTangents(), sPHENIXTracker::calculateKappaTangents(), sPHENIXSeedFinder::calculateKappaTangents(), G4QMDCollision::CalFinalStateOfTheBinaryCollisionJQMD(), G4eeToHadronsModel::ComputeCMCrossSectionPerElectron(), Acts::AtlasStepper< ConstantBField >::covarianceTransport(), G4ReduciblePolygon::CrossesItself(), G4OpBoundaryProcess::DielectricDielectric(), HelixHough::dzdlRange_sse(), CLHEP::HepRotation::eulerAngles(), example(), expai(), expaid(), G4IonFluctuations::Factor(), G4PolyconeSide::FindLineIntersect(), G4VisCommandSceneAddLogo::G4Logo::G4Logo(), G4PhysListFactory::G4PhysListFactory(), G4QuadrangularFacet::G4QuadrangularFacet(), G4eeToHadronsModel::GenerateCMPhoton(), G4CascadeFinalStateAlgorithm::GenerateCosTheta(), G4WorkerRunManager::GenerateEvent(), G4RPGReaction::GenerateNBodyEvent(), G4RPGReaction::GenerateNBodyEventT(), G4QuadrangularFacet::GetPointOnFace(), G4Trd::GetPointOnSurface(), G4Trap::GetPointOnSurface(), G4TrajectoryDrawerUtils::GetPointsAndTimes(), G4eeToHadronsModel::Initialise(), G4NucleiModel::initializeCascad(), PHG4CentralityReco::InitRun(), Acts::InternalSeed< SpacePoint >::InternalSeed(), Acts::Legacy::InternalSeed< SpacePoint >::InternalSeed(), G4TriangularFacet::Intersect(), G4PolyconeSide::Intersect(), G4TessellatedGeometryAlgorithms::IntersectLineAndLineSegment2D(), G4PolyhedraSide::LineHitsSegments(), G4DopplerProfile::LoadBiggsP(), G4RDDopplerProfile::LoadBiggsP(), G4RDShellData::LoadData(), G4RDDopplerProfile::LoadProfile(), G4DopplerProfile::LoadProfile(), MCGIDI_misc_PQUStringToDoubleInUnitOf(), MCGIDI_sampling_sampleX_from_pdfOfX(), G4PenelopeComptonModel::OscillatorTotalCrossSection(), kdfinder::Helix< T >::pathLengths(), plot_map(), ptwXY_div_ptwXY(), pyeig4(), pymaxi(), pytecm(), CLHEP::HepLorentzRotation::rotateX(), CLHEP::HepRotation::rotateX(), CLHEP::HepLorentzRotation::rotateY(), CLHEP::HepRotation::rotateY(), CLHEP::HepLorentzRotation::rotateZ(), CLHEP::HepRotation::rotateZ(), G4HadronElastic::SampleInvariantT(), scan_mom(), Acts::Legacy::InternalSeed< SpacePoint >::set(), G4EmLowEParametersMessenger::SetNewValue(), G4EmExtraParametersMessenger::SetNewValue(), storeAtts(), strnstr(), Acts::PrimitivesVisualization::test(), CLHEP::transformSmall(), and CLHEP::RandGaussQ::transformSmall().

const __m128 SIGNMASK = _mm_castsi128_ps(_mm_set1_epi32(0x80000000))
static

Definition at line 19 of file HelixHough_allButKappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 19 of file HelixHough_allButKappaRange_sse.cpp

__m128 temp1 = _mm_mul_ps(v, v)

Definition at line 103 of file HelixHough_allButKappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 103 of file HelixHough_allButKappaRange_sse.cpp

Referenced by CylindricalHough::addHits(), BinEntryPair5D::bin5D(), calc_v2(), HelixKalman::calculate_dAdAp(), HelixKalmanFilter::calculate_dAdAp(), CylinderKalman::calculate_dxda(), HelixKalmanFilter::calculate_dxda(), FitNewton::GaussianGradHessian::calcValGradHessian(), FitNewton::GaussianIntegralGradHessian::calcValGradHessian(), FitNewton::ChiSquareGradHessian::calcValGradHessianThread1(), FitNewton::GaussianRegGradHessian::calcValGradHessianThread1(), FitNewton::ChiSquareGradHessian::calcValGradThread1(), G4Nucleus::Cinema(), HelixHough::dzdlRange_sse(), fit_all_update(), SimpleTrack3D::fit_track(), ZHough_Cylindrical::fitTrack(), VtxTrackFinder::fitTrack(), ThreeHitSeedGrower::fitTrack(), NHitSeedFinder::fitTrack(), FourHitSeedFinder::fitTrack(), sPHENIXTrackerTpc::fitTrack(), sPHENIXTracker::fitTrack(), sPHENIXSeedFinder::fitTrack(), FourHitSeedFinder::fitTrackLine(), G4GaussHermiteQ::G4GaussHermiteQ(), G4GaussLaguerreQ::G4GaussLaguerreQ(), G4GaussLegendreQ::G4GaussLegendreQ(), G4fissionEvent::G4SmpTerrell(), G4ErrorSymMatrix::invertBunchKaufman(), G4GenericTrap::IsSegCrossingZ(), FitNewton::NewtonMinimizerGradHessian::lineSearch(), main(), sPHENIXTracker::projectToLayer(), sPHENIXSeedFinder::projectToLayer(), G4GoudsmitSaundersonMscModel::SampleMSC(), HelixHoughBin_v1::set_bins(), CylinderKalman::updateIntersection(), HelixKalmanFilter::updateIntersection(), and FitNewton::NewtonMinimizerGradHessian::zoom().

const __m128 three_pi_over_two = {3.*0x1.921fb54442d1846ap0f, 3.*0x1.921fb54442d1846ap0f, 3.*0x1.921fb54442d1846ap0f, 3.*0x1.921fb54442d1846ap0f}
static

Definition at line 20 of file HelixHough_allButKappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 20 of file HelixHough_allButKappaRange_sse.cpp

Referenced by HelixHough::allButKappaRange_sse().

__m128 tmp3 = _mm_mul_ps(k, x3)
__m128 tmp4 = _mm_mul_ps(uscale, ux)

Definition at line 36 of file HelixHough_allButKappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 36 of file HelixHough_allButKappaRange_sse.cpp

Referenced by HelixHough::allButKappaRange_sse(), fillBins4_sse(), and HelixHough::phiRange_sse().

tmp5 = _mm_add_ps(tmp1, tmp2)

Definition at line 38 of file HelixHough_allButKappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 38 of file HelixHough_allButKappaRange_sse.cpp

Referenced by HelixHough::allButKappaRange_sse(), and HelixHough::phiRange_sse().

tmp6 = _mm_add_ps(tmp3, tmp4)

Definition at line 39 of file HelixHough_allButKappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 39 of file HelixHough_allButKappaRange_sse.cpp

__m128 uscale = _vec_sqrt_ps(uscale2)

Definition at line 31 of file HelixHough_allButKappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 31 of file HelixHough_allButKappaRange_sse.cpp

Referenced by G4INCL::Ranecu::flat().

uscale2 = _mm_mul_ps(Delta2, k2)

Definition at line 28 of file HelixHough_allButKappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 28 of file HelixHough_allButKappaRange_sse.cpp

__m128 v = _mm_mul_ps(v, Delta)

Definition at line 94 of file HelixHough_allButKappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 94 of file HelixHough_allButKappaRange_sse.cpp

Referenced by G4EmModelActivator::ActivatePAI(), G4ASTARStopping::AddData(), G4PSTARStopping::AddData(), CylindricalHough::addHits(), G4AssemblyVolume::AddPlacedAssembly(), G4AssemblyVolume::AddPlacedVolume(), RunAction::AddToPhiVector(), RunAction::AddToThetaVector(), RunAction::AddToXVector(), RunAction::AddToYVector(), PHG4TruthTrackingAction::AddVertex(), G4PolyhedronArbitrary::AddVertex(), aiz(), G4BOptnLeadingParticle::ApplyFinalStateBiasing(), G4ParaFissionModel::ApplyYourself(), G4NeutronRadCapture::ApplyYourself(), G4LENDModel::ApplyYourself(), G4LENDElastic::ApplyYourself(), G4EMDissociation::ApplyYourself(), ar3jet(), arorie(), atrobo(), attrad(), Acts::SurfaceStub::binningPosition(), biz(), Acts::Test::BOOST_AUTO_TEST_CASE(), G4UnstableFragmentBreakUp::BreakUpChain(), G4EmCorrections::BuildCorrectionVector(), G4LossTableBuilder::BuildInverseRangeTable(), G4RDVeLowEnergyLoss::BuildInverseRangeTable(), G4hRDEnergyLoss::BuildInverseRangeTable(), G4LossTableBuilder::BuildRangeTable(), G4QMDMeanField::Cal2BodyQuantities(), HelixKalman::calculate_dAdAp(), HelixKalmanFilter::calculate_dAdAp(), CylinderKalman::calculate_dxda(), HelixKalmanFilter::calculate_dxda(), sPHENIXTrackerTpc::calculateKappaTangents(), sPHENIXTracker::calculateKappaTangents(), sPHENIXSeedFinder::calculateKappaTangents(), CML2ExpVoxels::calculateNormalizedEd(), G4QMDMeanField::CalGraduate(), G4ViewParameters::CatmullRomCubicSplineInterpolation(), CellParameterisation::CellParameterisation(), Acts::DiamondBounds::checkConsistency(), cleanup(), TPCFEETestRecov1::PadPlaneData::Clustering(), G4JpegCoder::CodeHuffman(), CCalVisualisable::colorBlue(), CCalVisualisable::colorGreen(), CCalVisualisable::colorRed(), compressevent(), nlohmann::detail::dtoa_impl::compute_boundaries(), G4KokoulinMuonNuclearXS::ComputeDDMicroscopicCrossSection(), G4hBremsstrahlungModel::ComputeDMicroscopicCrossSection(), G4LDMBremModel::ComputeDMicroscopicCrossSection(), G4MuBremsstrahlungModel::ComputeDMicroscopicCrossSection(), G4INCL::Nucleus::computeOneNucleonRecoilKinematics(), G4INCL::NuclearPotential::NuclearPotentialEnergyIsospin::computePotentialEnergy(), G4INCL::NuclearPotential::NuclearPotentialEnergyIsospinSmooth::computePotentialEnergy(), G4PSDoseDepositForCylinder3D::ComputeVolume(), G4PSPassageCellFluxForCylinder3D::ComputeVolume(), G4PSCellFluxForCylinder3D::ComputeVolume(), Acts::TGeoDetectorElement::construct(), PHG4InnerHcalDetector::ConstructHcalSingleScintillators(), PHG4OuterHcalDetector::ConstructHcalSingleScintillators(), G4RDGenerator2BN::ConstructMajorantSurface(), G4Generator2BN::ConstructMajorantSurface(), Fun4AllOscarInputManager::ConvertFromOscar(), Fun4AllHepMCInputManager::ConvertFromOscar(), G4UIcommand::ConvertToBool(), converttohepmc(), G4Material::CopyPointersOfBaseMaterial(), MuCrossSections::CRB_Mephi(), G4TessellatedSolid::CreatePolyhedron(), MuCrossSections::CRK_Mephi(), MuCrossSections::CRN_Mephi(), G4ChipsKaonMinusInelasticXS::CrossSectionFormula(), G4ChipsKaonPlusInelasticXS::CrossSectionFormula(), csz__huft_build(), csz__huft_free(), oncsSub_idfnalmwpc::decode(), oncsSub_idfnalmwpcv2::decode(), G4ICRU73QOModel::DEDXPerElement(), G4OpBoundaryProcess::DielectricLUTDAVIS(), G4AdjointComptonModel::DiffCrossSectionPerAtomPrimToScatPrim(), G4DNARuddIonisationModel::DifferentialCrossSection(), G4QuadrangularFacet::Distance(), G4TriangularFacet::Distance(), G4EllipticalTube::DistanceToIn(), G4IntersectionSolid::DistanceToIn(), G4Ellipsoid::DistanceToIn(), G4GenericTrap::DistanceToIn(), G4EllipticalCone::DistanceToIn(), G4TessellatedSolid::DistanceToIn(), G4EllipticalTube::DistanceToOut(), G4Orb::DistanceToOut(), G4Ellipsoid::DistanceToOut(), G4Paraboloid::DistanceToOut(), G4GenericTrap::DistanceToOut(), G4EllipticalCone::DistanceToOut(), G4TessellatedSolid::DistanceToOut(), G4TwistTrapFlatSide::DistanceToSurface(), G4TwistBoxSide::DistanceToSurface(), G4TwistTrapAlphaSide::DistanceToSurface(), G4TwistTrapParallelSide::DistanceToSurface(), G4TwistTubsFlatSide::DistanceToSurface(), G4TwistTubsSide::DistanceToSurface(), G4TwistTubsHypeSide::DistanceToSurface(), dofistatescat(), doinstatescat(), dokinematics(), G4ScoreLogColorMap::DrawColorChartText(), G4VScoreColorMap::DrawColorChartText(), CLHEP::DoubConv::dto2longs(), G4EmModelManager::DumpModelList(), G4OpRayleigh::DumpPhysicsTable(), G4OpWLS::DumpPhysicsTable(), G4Cerenkov::DumpPhysicsTable(), G4Scintillation::DumpPhysicsTable(), G4tgbGeometryDumper::DumpRotationMatrix(), Acts::Test::dumpVertices(), HelixHough::dzdlRange_sse(), G4QAOLowEnergyLoss::EnergyLoss(), G4VSolid::EstimateSurfaceArea(), G4CellScoreComposer::EstimatorCalculation(), Acts::VectorHelpers::eta(), Acts::IVisualization::face(), fg(), fgp(), HadrontherapyLet::FillEnergySpectrum(), SvtxEvaluator::fillOutputNtuples(), G4EmCalculator::FindDiscreteProcess(), G4EmCalculator::FindEnLossProcess(), G4EmCalculator::FindMscProcess(), HepPolyhedron::FindNeighbour(), CLHEP::RandStudentT::fire(), CLHEP::RandExponential::fireArray(), CLHEP::RandChiSquare::fireArray(), CLHEP::RandBinomial::fireArray(), CLHEP::RandGamma::fireArray(), CLHEP::RandPoisson::fireArray(), CLHEP::RandGaussQ::fireArray(), CLHEP::RandGauss::fireArray(), CLHEP::RandLandau::fireArray(), CLHEP::RandStudentT::fireArray(), CLHEP::RandPoissonQ::fireArray(), CLHEP::RandBreitWigner::fireArray(), fit_all_update(), SimpleTrack3D::fit_track(), ZHough_Cylindrical::fitTrack(), VtxTrackFinder::fitTrack(), ThreeHitSeedGrower::fitTrack(), NHitSeedFinder::fitTrack(), FourHitSeedFinder::fitTrack(), sPHENIXTrackerTpc::fitTrack(), sPHENIXTracker::fitTrack(), sPHENIXSeedFinder::fitTrack(), CLHEP::NonRandomEngine::flat(), G4JpegCoder::ForwardDCT(), G4EmElementSelector::G4EmElementSelector(), G4Para::G4Para(), G4RandomDirection(), MyGamma::GamCf(), MyGamma::Gamma(), MyGamma::GamSer(), G4INCL::Random::gaussWithMemory(), CLHEP::RandChiSquare::genChiSquare(), CexmcReimplementedGenbod::Generate(), PHG4PrimaryGeneratorAction::GeneratePrimaries(), G01PrimaryGeneratorAction::GeneratePrimaries(), G04PrimaryGeneratorAction::GeneratePrimaries(), ExP02PrimaryGeneratorAction::GeneratePrimaries(), genevent(), CLHEP::RandGamma::genGamma(), PHGenFitTrkFitter::get_rotation_matrix(), nlohmann::basic_json::get_to(), G4Fragment::GetAngularMomentum(), G4ElementData::GetComponentDataByID(), G4GIDI::getDataDirectories(), getdeltat(), G4PAIPhotData::GetEnergyPhotonTransfer(), G4PAIPhotData::GetEnergyPlasmonTransfer(), G4PAIModelData::GetEnergyTransfer(), G4PAIPhotData::GetEnergyTransfer(), G4Molecule::GetKineticEnergy(), getmass(), getnewmass(), HepPolyhedron::GetNextEdgeIndices(), HepPolyhedron::GetNextVertex(), HepPolyhedron::GetNextVertexIndex(), HepPolyhedron::GetNormal(), getpnorad1(), G4TriangularFacet::GetPointOnFace(), G4Polyhedra::GetPointOnPlane(), G4GenericTrap::GetPointOnSurface(), G4Trd::GetPointOnSurface(), G4Para::GetPointOnSurface(), G4Trap::GetPointOnSurface(), G4Polyhedra::GetPointOnTriangle(), G4QuasiElRatios::GetQF2IN_Ratio(), getqvec(), CLHEP::NonRandomEngine::getState(), CLHEP::HepJamesRandom::getState(), CLHEP::Ranlux64Engine::getState(), CLHEP::RanshiEngine::getState(), CLHEP::DualRand::getState(), CLHEP::RanecuEngine::getState(), CLHEP::RanluxEngine::getState(), HepPolyhedron::GetSurfaceArea(), HepPolyhedron::GetUnitNormal(), HepPolyhedron::GetVolume(), kdfinder::CircleFit< T >::GradientHessian(), nlohmann::detail::json_sax_dom_parser< BasicJsonType >::handle_value(), nlohmann::detail::json_sax_dom_callback_parser< BasicJsonType >::handle_value(), hiboost(), hijfrg(), hijhrd(), hijing(), hirobo(), CLHEP::Hep3Vector::howNear(), init(), G4NeutronInelasticXS::Initialise(), G4NeutronCaptureXS::Initialise(), G4ParticleInelasticXS::Initialise(), G4HadronXSDataTable::Initialise(), G4ElementData::InitialiseForElement(), HadrontherapyLet::Initialize(), initpythia(), G4TessellatedSolid::InsideNoVoxels(), G4TessellatedSolid::InsideVoxels(), G4PolyPhiFace::Intersect(), G4PolyconeSide::Intersect(), G4PolyhedraSide::Intersect(), G4PolyhedraSide::IntersectSidePlane(), HepPolyhedron::InvertFacets(), G4EmCorrections::IonHighOrderCorrections(), PHHepMCGenEvent::is_simulated(), isprimhadron(), isprimstring(), issecstring(), CCalVisualisable::isVisible(), CCalVisualisable::isWireFrame(), jewel(), klu(), G4VEnergyLossProcess::LambdaPhysicsVector(), G4VEmProcess::LambdaPhysicsVector(), HadrontherapyLet::LetOutput(), MyGamma::LnGamma(), G4INCL::Store::loadParticles(), lu1ent(), lu2ent(), lu3ent(), lu4ent(), luboei(), lucell(), luclus(), ludecy(), luedit(), lueevt(), luerrm(), luexec(), lufowo(), lugive(), luhepc(), luindf(), lujmas(), lujoin(), lulist(), luonia(), luprep(), lurobo(), lushow(), lusphe(), lustrf(), lutabu(), lutest(), luthru(), luxdif(), CCalMagneticField::MagneticField(), main(), Acts::Test::make_nocopy(), makebranch(), makecascade(), makeinsplit(), makesplitting(), makestrings_minl(), makestrings_vac(), PHGenFitTrkFitter::MakeSvtxTrack(), Acts::Polyhedron::move(), CLHEP::EngineFactory::newEngine(), G4GenericTrap::NormalToPlane(), G4RPGReaction::NuclearReaction(), G4RDAtomicTransitionManager::NumberOfReachableShells(), G4RDAtomicTransitionManager::NumberOfShells(), kdfinder::TVector< T >::operator!=(), FW::Pythia8Generator::operator()(), kdfinder::operator*(), HepGeom::BasicVector3D< T >::operator+(), kdfinder::operator/(), operator<<(), dfe::Variable::operator=(), G4INCL::ParticleEntryChannel::particleEnters(), nlohmann::basic_json::patch(), Acts::VectorHelpers::perp(), pevrec(), PHG4TrackFastSim::PHG4HitToMeasurementCylinder(), B0TrackFastSim::PHG4HitToMeasurementCylinder(), PHG4TrackFastSim::PHG4HitToMeasurementVerticalPlane(), B0TrackFastSim::PHG4HitToMeasurementVerticalPlane(), PHGeom_DSTInspection(), PHHepMCGenHelper::PHHepMCGenHelper_Verbosity(), Acts::VectorHelpers::phi(), DetectorConstruction::PlaceWithDirectMatrix(), DetectorConstruction::PlaceWithInverseMatrix(), PHGenFit::PlanarMeasurement::PlanarMeasurement(), plu(), G4PolyconeSide::PointOnCone(), poissonian(), pqdownheap(), G4VMultipleScattering::PreparePhysicsTable(), G4VEnergyLossProcess::PreparePhysicsTable(), G4TablesForExtrapolator::PrepareTable(), G4Physics2DVector::PrepareVectors(), G3VolTable::PrintAll(), PHGenFitTrkProp::Process(), PHHybridSeeding::Process(), HepMCCompress::process_event(), QAG4SimulationUpsilon::process_event(), HepMCNodeReader::process_event(), ReadEICFiles::process_event(), PHHepMCParticleSelectorDecayProductChain::process_event(), QAG4SimulationTracking::process_event(), PHG4DSTReader::process_event(), MyJetAnalysis::process_event(), sPHENIXTracker::projectToLayer(), sPHENIXSeedFinder::projectToLayer(), G4DNARuddIonisationExtendedModel::ProposedSampledEnergy(), ptwXY_div_s_ptwXY(), ptwXY_pow_callback(), CLHEP::NonRandomEngine::put(), CLHEP::MTwistEngine::put(), CLHEP::HepJamesRandom::put(), CLHEP::Ranlux64Engine::put(), CLHEP::RanshiEngine::put(), CLHEP::DualRand::put(), CLHEP::RanecuEngine::put(), CLHEP::RanluxEngine::put(), CLHEP::MixMaxRng::put(), CLHEP::HepRandomEngine::put(), py1ent(), py2ent(), py2frm(), py3ent(), py4ent(), py4frm(), py4jet(), py4jts(), py4jtw(), py6frm(), pyadsh(), pybesq(), pyboei(), pycell(), pyckbd(), pyclus(), pycttr(), pydecy(), pydiff(), pydisg(), pydocu(), pyedit(), pyeevt(), pyerrm(), pyevnt(), pyevnw(), pyevol(), pyexec(), pyfowo(), pyfscr(), pygaga(), pygfxx(), pygive(), pyhepc(), pyhidiff(), pyhiinki(), pyhimult(), pyhiremn(), pyhiresd(), pyhiscat(), pyhisspa(), pyhitest(), pyhithia(), pyinbm(), pyindf(), pyinki(), pyjmas(), pyjoin(), pyk(), pyklim(), pylist(), pymemx(), pymewt(), pymign(), pymihg(), pymihk(), pymirm(), pymult(), pyonia(), pyp(), pypdfu(), pypole(), pyprep(), pyptfs(), pyptis(), pyptmi(), pyreco(), pyremn(), pyresd(), pyrghm(), pyrobo(), pyscat(), pyshow(), pysigh(), pysphe(), pysspa(), pystbh(), pystrf(), pysubh(), pysugi(), pytabu(), pytaud(), pytbdy(), pytbhb(), pytbhg(), pytbhq(), pytest(), pythia(), pythru(), pyupev(), pyupin(), pyveto(), pyxdif(), ActsFatras::LandauDistribution::quantile(), G4RDAtomicTransitionManager::ReachableShell(), G4AtomicTransitionManager::ReachableShell(), G4LivermorePolarizedPhotoElectricGDModel::ReadData(), G4LivermoreBremsstrahlungModel::ReadData(), G4LivermorePolarizedPhotoElectricModel::ReadData(), G4LivermorePhotoElectricModel::ReadData(), G4SeltzerBergerModel::ReadData(), PHG4TTLDetector::RegisterLogicalVolume(), PHG4Sector::PHG4SectorConstructor::RegisterLogicalVolume(), ePHENIXRICH::ePHENIXRICHConstruction::RegisterLogicalVolume(), PHG4TTLDetector::RegisterPhysicalVolume(), PHG4Sector::PHG4SectorConstructor::RegisterPhysicalVolume(), ePHENIXRICH::ePHENIXRICHConstruction::RegisterPhysicalVolume(), G4DNARuddIonisationExtendedModel::RejectionFunction(), KFParticle_Tools::removeDuplicates(), CLHEP::HepJamesRandom::restoreStatus(), CLHEP::Ranlux64Engine::restoreStatus(), CLHEP::RanshiEngine::restoreStatus(), CLHEP::RanecuEngine::restoreStatus(), CLHEP::DualRand::restoreStatus(), CLHEP::RanluxEngine::restoreStatus(), G4NeutronInelasticXS::RetrieveVector(), G4NeutronCaptureXS::RetrieveVector(), G4ParticleInelasticXS::RetrieveVector(), kdfinder::rnd_gauss(), FW::RootMaterialDecorator::RootMaterialDecorator(), G4FermiBreakUpVI::SampleDecay(), G4UrbanMscModel::SampleDisplacementNew(), G4UrbanAdjointMscModel::SampleDisplacementNew(), G4SeltzerBergerModel::SampleEnergyTransfer(), G4ElectronIonPair::SampleIonsAlongStep(), G4LivermoreBremsstrahlungModel::SampleSecondaries(), G4KleinNishinaModel::SampleSecondaries(), G4eeToHadronsModel::SampleSecondaries(), G4AntiNuclElastic::SampleThetaLab(), CLHEP::HepJamesRandom::saveStatus(), CLHEP::Ranlux64Engine::saveStatus(), CLHEP::RanshiEngine::saveStatus(), CLHEP::RanecuEngine::saveStatus(), CLHEP::DualRand::saveStatus(), CLHEP::RanluxEngine::saveStatus(), G4VEnergyLossProcess::ScaledKinEnergyForLoss(), PHHepMCGenEventv1::set_boost_beta_vector(), PHHepMCGenEvent::set_collision_vertex(), boost::python::vector_indexing_suite< Container, NoProxy, final_vector_derived_policies< Container, NoProxy > >::set_item(), boost::python::map_indexing_suite< Container, NoProxy, final_map_derived_policies< Container, NoProxy > >::set_item(), EICG4dRICHHit::set_momentum(), EICG4dRICHHit::set_momentum_dir(), EICG4dRICHHit::set_position(), PHHepMCGenEventv1::set_rotation_vector(), boost::python::vector_indexing_suite< Container, NoProxy, final_vector_derived_policies< Container, NoProxy > >::set_slice(), CellularAutomaton_v1::set_verbose(), EICG4dRICHHit::set_vertex_momentum_dir(), EICG4dRICHHit::set_vertex_position(), RE01RegionInformation::SetCalorimeter(), PHG4RegionInformation::SetCalorimeter(), GPUTPCTrackParam::SetChi2(), G4PolynomialPDF::SetCoefficients(), CCalVisualisable::setColor(), CCalVisualisable::setColorBlue(), CCalVisualisable::setColorGreen(), CCalVisualisable::setColorRed(), GPUTPCTrackLinearisation::SetCosPhi(), GPUTPCTrackParam::SetCov(), G4VTwistSurface::CurrentStatus::SetCurrentStatus(), G4EmExtraParameters::SetDirectionalSplitting(), G4EmBiasingManager::SetDirectionalSplitting(), G4EmExtraParameters::SetDirectionalSplittingTarget(), G4EmBiasingManager::SetDirectionalSplittingTarget(), GPUTPCTrackLinearisation::SetDzDs(), GPUTPCBaseTrackParam::SetDzDs(), LXeEventAction::SetEventVerbose(), GPUTPCTrackParam::SetNDF(), G4MatScanMessenger::SetNewValue(), GPUTPCBaseTrackParam::SetPar(), GPUTPCTrackParam::SetParam(), G4INCL::Particle::setPotentialEnergy(), GPUTPCTrackLinearisation::SetQPt(), GPUTPCBaseTrackParam::SetQPt(), G4EmExtraParameters::SetQuantumEntanglement(), HepPolyhedron::SetReferences(), G4EmParameters::SetRetrieveMuDataFromFile(), GPUTPCTrackLinearisation::SetSinPhi(), GPUTPCBaseTrackParam::SetSinPhi(), RE01RegionInformation::SetTracker(), PHG4RegionInformation::SetTracker(), G4ParticlesWorkspace::SetVerbose(), G4PhysicsListWorkspace::SetVerbose(), G4SolidsWorkspace::SetVerbose(), G4GeometryWorkspace::SetVerbose(), DetectorConstruction::SetVerbose(), G4PAIySection::SetVerbose(), G4PAIxSection::SetVerbose(), G4VTransactionManager::SetVerboseLevel(), G4VPEventIO::SetVerboseLevel(), G4VHCIOentry::SetVerboseLevel(), G4VDCIOentry::SetVerboseLevel(), G4VMCTruthIO::SetVerboseLevel(), G4DCIOcatalog::SetVerboseLevel(), G4HCIOcatalog::SetVerboseLevel(), G4VPDigitIO::SetVerboseLevel(), G4VPHitIO::SetVerboseLevel(), G4VPDigitsCollectionIO::SetVerboseLevel(), G4VPHitsCollectionIO::SetVerboseLevel(), G4SynchrotronRadiationInMat::SetVerboseLevel(), G4PersistencyCenter::SetVerboseLevel(), G4PersistencyManager::SetVerboseLevel(), fileEventiterator::setVerbosity(), G4ScreenedCoulombCrossSection::SetVerbosity(), sPHENIXTrackerTpc::setVerbosity(), sPHENIXTracker::setVerbosity(), sPHENIXSeedFinder::setVerbosity(), G4MCTSimParticle::SetVertex(), G4TriangularFacet::SetVertices(), CCalVisualisable::setVisible(), CCalVisualisable::setWireFrame(), RE01RegionInformation::SetWorld(), PHG4RegionInformation::SetWorld(), GPUTPCBaseTrackParam::SetX(), GPUTPCBaseTrackParam::SetY(), GPUTPCBaseTrackParam::SetZ(), GPUTPCBaseTrackParam::SetZOffset(), G4AtimaEnergyLossModel::sezi_dedx_e(), G4RDAtomicTransitionManager::Shell(), G4AtomicTransitionManager::Shell(), CLHEP::RandStudentT::shoot(), CLHEP::RandExponential::shootArray(), CLHEP::RandChiSquare::shootArray(), CLHEP::RandGamma::shootArray(), CLHEP::RandBinomial::shootArray(), CLHEP::RandGaussQ::shootArray(), CLHEP::RandBreitWigner::shootArray(), CLHEP::RandPoisson::shootArray(), CLHEP::RandGauss::shootArray(), CLHEP::RandStudentT::shootArray(), CLHEP::RandLandau::shootArray(), CLHEP::RandPoissonQ::shootArray(), G4Torus::SolveNumericJT(), G4Abla::spdef(), Acts::AnnulusBounds::squaredNorm(), stirf(), G4UImessenger::StoB(), HadrontherapyLet::StoreLetAscii(), G4VEmProcess::StreamInfo(), G4PolyPhiFace::SurfaceTriangle(), G4PolyhedraSide::SurfaceTriangle(), Acts::template_switch(), Acts::VectorHelpers::theta(), tools::aida::to_vector(), G4RDAtomicTransitionManager::TotalNonRadiativeTransitionProbability(), G4RDAtomicTransitionManager::TotalRadiativeTransitionProbability(), G4AtomicTransitionManager::TotalRadiativeTransitionProbability(), PHGenFit::Track::Track(), PHGenFit2::Track::Track(), CLHEP::transformSmall(), CLHEP::RandGaussQ::transformSmall(), G4VHadPhaseSpaceAlgorithm::UniformVector(), HistoManager::Update(), CylinderKalman::updateIntersection(), HelixKalmanFilter::updateIntersection(), dfe::Variable::Variable(), PHSartreGenTrigger::Verbosity(), PHPy8GenTrigger::Verbosity(), PHPy6GenTrigger::Verbosity(), Rossegger::Verbosity(), PHG4Detector::Verbosity(), PHG4Sector::PHG4SectorConstructor::Verbosity(), FW::RootMaterialWriter::write(), nlohmann::detail::output_vector_adapter< CharType >::write_character(), nlohmann::detail::output_vector_adapter< CharType >::write_characters(), nlohmann::detail::binary_writer< BasicJsonType, CharType >::write_ubjson(), FW::Obj::writePlanarFace(), cheprep::BHepRepWriter::writeTag(), and BEmcRec::ZeroVector().

void __m128 val2

Definition at line 218 of file HelixHough_allButKappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 218 of file HelixHough_allButKappaRange_sse.cpp

Referenced by G4ParticleHPContAngularPar::BuildByInterpolation(), and maker().

void __m128 __m128 __m128 __m128 __m128 __m128& x3

Definition at line 23 of file HelixHough_allButKappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 23 of file HelixHough_allButKappaRange_sse.cpp

Referenced by G4ESTARStopping::AddData(), EICG4LumiDetector::AddTriangularTrapezoid(), HelixHough::allButKappaRange_sse(), ar3jet(), arorie(), attrad(), G4hhElastic::CalculateBQ(), sPHENIXTrackerTpc::calculateKappaTangents(), sPHENIXTracker::calculateKappaTangents(), sPHENIXSeedFinder::calculateKappaTangents(), G4ecpssrBaseLixsModel::CalculateL3CrossSection(), cg1(), cg3(), G4LivermorePolarizedPhotoElectricGDModel::ComputeCrossSectionPerAtom(), G4LivermorePolarizedPhotoElectricModel::ComputeCrossSectionPerAtom(), G4LivermorePhotoElectricModel::ComputeCrossSectionPerAtom(), G4BetheHeitlerModel::ComputeCrossSectionPerAtom(), G4PairProductionRelModel::ComputeParametrizedXSectionPerAtom(), PHG4HcalDetector::ConstructMe(), G4FTFAnnihilation::Create3QuarkAntiQuarkStrings(), G4DiffractiveExcitation::CreateStrings(), oncsSub_idrcpetdata::decode(), Packet_hbd_fpga::decode(), G4FissionParameters::DefineParameters(), G4InitXscPAI::DifPAIxSection(), G4PAIxSection::DifPAIxSection(), G4PAIySection::DifPAIySection(), G4BraggModel::ElectronicStoppingPower(), G4BraggIonModel::ElectronicStoppingPower(), G4STRead::FacetRead(), G4CrystalUnitCell::G4CrystalUnitCell(), genevent(), G4HarmonicPolMagField::GetFieldValue(), getneff(), G4CrystalUnitCell::GetUnitBasisTrigonal(), TrentoPassiveProtonBeamLine::HadrontherapyRidgeFilter(), GFlashHomoShowerParameterisation::IntegrateEneLongitudinal(), GFlashSamplingShowerParameterisation::IntegrateEneLongitudinal(), GFlashHomoShowerParameterisation::IntegrateNspLongitudinal(), GFlashSamplingShowerParameterisation::IntegrateNspLongitudinal(), lu3ent(), lueevt(), luonia(), lushow(), lux3jt(), nf_amc_clebsh_gordan(), nf_amc_reduced_matrix_element(), G4PAIySection::PAIdNdxCerenkov(), G4PAIxSection::PAIdNdxCerenkov(), G4InitXscPAI::PAIdNdxCherenkov(), G4PAIxSection::PAIdNdxMM(), CellularAutomaton_v1::process_single_track(), CellularAutomaton_v1::process_single_triplet(), py3ent(), pyeevt(), pyonia(), pyptfs(), pyqqbh(), pyresd(), pyrnm3(), pyrnmq(), pyshow(), pytbdy(), pyx3jt(), pyxdif(), G4BohrFluctuations::SampleFluctuations(), G4IonFluctuations::SampleFluctuations(), G4LivermorePolarizedPhotoElectricGDModel::SampleSecondaries(), G4LivermorePolarizedPhotoElectricModel::SampleSecondaries(), G4LivermorePhotoElectricModel::SampleSecondaries(), G4eplusTo3GammaOKVIModel::SampleSecondaries(), G4BraggModel::StoppingPower(), G4BraggIonModel::StoppingPower(), G4GDMLReadSolids::TrapRead(), G4GDMLReadSolids::TwistedtrapRead(), Acts::DiamondBounds::vertices(), and w6j1().

__m128 __m128& y

Definition at line 155 of file HelixHough_allButKappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 155 of file HelixHough_allButKappaRange_sse.cpp

Referenced by __example_2.f__(), __example_6.f__(), __example_7.f__(), __example_8.f__(), _testMe(), G4Pow::A13Low(), G4HadPhaseSpaceGenbod::AccumulateFinalState(), G4MagInt_Driver::AccurateAdvance(), TrackEvaluation::add_truth_information(), HistoManager::AddLeakingParticle(), Run::AddTransvDev(), ALICEKF::ALICEKalmanFilter(), G4DNABrownianTransportation::AlongStepDoIt(), G4ITSteppingVerbose::AlongStepDoItAllDone(), G4SteppingVerbose::AlongStepDoItAllDone(), G4ITSteppingVerbose::AlongStepDoItOneByOne(), G4SteppingVerbose::AlongStepDoItOneByOne(), G4AntiNeutronAnnihilationAtRest::AntiNeutronAnnihilation(), G4LowEIonFragmentation::ApplyYourself(), G4EllipticalTube::ApproxSurfaceNormal(), G4Ellipsoid::ApproxSurfaceNormal(), ar3jet(), G4ITSteppingVerbose::AtRestDoItInvoked(), G4SteppingVerbose::AtRestDoItInvoked(), G4eBremsstrahlungSpectrum::AverageEnergy(), G4RDeBremsstrahlungSpectrum::AverageEnergy(), G4EnergyLossForExtrapolator::AverageScatteringAngle(), avscatcen(), CLHEP::HepRotation::axis(), G4Abla::barfit(), Barycenter::Barycenter(), biz(), G4hImpactIonisation::BlochTerm(), CLHEP::HepLorentzVector::boost(), Acts::Test::BOOST_AUTO_TEST_CASE(), Acts::Test::BOOST_DATA_TEST_CASE(), BOOST_DATA_TEST_CASE(), G4Polyhedra::BoundingLimits(), G4ExtrudedSolid::BoundingLimits(), G4Trap::BoundingLimits(), G4GDMLReadSolids::BoxRead(), PHG4mRICHDetector::build_mRICH_sector(), PHG4mRICHDetector::build_mRICH_sector2(), PHG4mRICHDetector::build_mRICH_wall_eside(), PHG4mRICHDetector::build_mRICH_wall_eside_proj(), PHG4mRICHDetector::build_mRICH_wall_hside(), PHG4mRICHDetector::build_sensor(), PHGenFitTrkProp::BuildLayerZPhiHitMap(), DicomFileCT::BuildStructureIDs(), G4Voxelizer::BuildVoxelLimits(), calcta(), HelixHoughFuncs_v1::calculate_dzdl_range(), HelixHoughFuncs_v1::calculate_phi_range(), G4MuonVDNuclearModel::CalculateEMVertex(), G4Orb::CalculateExtent(), G4Tet::CalculateExtent(), G4Polyhedra::CalculateExtent(), CylinderKalman::calculateProjections(), HelixKalmanFilter::calculateProjections(), calcxsection(), G4ViewParameters::CatmullRomCubicSplineInterpolation(), CellParameterisation::CellParameterisation(), G4SynchrotronRadiation::Chebyshev(), G4PVPlacement::CheckOverlaps(), G4V3DNucleus::ChooseImpactXandY(), ChromosomeParameterisation::ChromosomeParameterisation(), kdfinder::CircleFit< T >::CircleFitByHyper(), kdfinder::CircleFit< T >::CircleFitByPratt(), ALICEKF::CircleFitByTaubin(), PHTpcClusterMover::CircleFitByTaubin(), PHTruthTrackSeeding::circleFitByTaubin(), PHActsSiliconSeeding::circleFitByTaubin(), kdfinder::CircleFit< T >::CircleFitByTaubin(), PHBBox::ClipLine(), CMDistortionAnalysis(), CMDistortionAnalysisCart(), CMDistortionAnalysisPhiR(), CMDistortionReco(), CMDistortionRecoCart(), G4GeomTools::comp_ellint_2(), G4ScreeningMottCrossSection::ComputeAngle(), G4GenericTrap::ComputeBBox(), G4KleinNishinaModel::ComputeCrossSectionPerAtom(), G4KleinNishinaCompton::ComputeCrossSectionPerAtom(), G4MollerBhabhaModel::ComputeCrossSectionPerElectron(), MyMollerBhabhaModel::ComputeDEDXPerVolume(), G4MollerBhabhaModel::ComputeDEDXPerVolume(), G4LindhardSorensenData::ComputeDeltaL(), G4LivermoreBremsstrahlungModel::ComputeDXSectionPerAtom(), G4SeltzerBergerModel::ComputeDXSectionPerAtom(), G4eBremsstrahlungRelModel::ComputeDXSectionPerAtom(), G4eBremParametrizedModel::ComputeDXSectionPerAtom(), PHG4FPbScDetector::computeIndex(), G4GenericTrap::ComputeIsTwisted(), G4ExtrudedSolid::ComputeLateralPlanes(), PDBlib::ComputeMatchEdepDNA(), G4GammaConversionToMuons::ComputeMeanFreePath(), G4eBremsstrahlungRelModel::ComputeRelDXSectionPerAtom(), G4DNABrownianTransportation::ComputeStep(), G4UrbanMscModel::ComputeTheta0(), G4UrbanAdjointMscModel::ComputeTheta0(), CellParameterisation::ComputeTransformation(), NeuronLoadDataFile::ComputeTransformation(), G4WentzelOKandVIxSection::ComputeTransportCrossSectionPerAtom(), Acts::IntegrationTest::constant_field_propagation(), ExN04DetectorConstruction::Construct(), G4MIRDPelvis::Construct(), RE05DetectorConstruction::Construct(), FFDetectorConstruction::Construct(), PHG4EPDDetector::construct_block(), XrayFluoMercuryDetectorConstruction::ConstructApparate(), XrayFluoPlaneDetectorConstruction::ConstructApparate(), XrayFluoDetectorConstruction::ConstructApparate(), WLSDetectorConstruction::ConstructDetector(), CCalG4Ecal::constructIn(), PHG4PSTOFDetector::ConstructMe(), G4JLeicDIRCDetector::ConstructMe(), G4JLeicVTXDetector::ConstructMe(), EICG4RPDetector::ConstructMe(), GammaRayTelDetectorConstruction::ConstructPayload(), UltraDetectorConstruction::ConstructReflector(), G4VVisCommand::ConvertToDoublePair(), BEmcRecEEMC::CorrectPosition(), BEmcRecFEMC::CorrectPosition(), BEmcRecCEMC::CorrectPosition(), BEmcRec::CorrectPosition(), BEmcRec::CorrectShowerDepth(), G4INCL::Random::correlatedGaussian(), Acts::IntegrationTest::covariance_bound(), Acts::IntegrationTest::covariance_curvilinear(), Acts::AtlasStepper< ConstantBField >::covarianceTransport(), create_element(), Acts::Visualization::createEllipse(), RawTowerBuilder::CreateNodes(), G4GenericTrap::CreatePolyhedron(), PHActsSiliconSeeding::createSvtxTrack(), G4GenericTrap::CreateTessellatedSolid(), G4LowEXsection::CrossSection(), G4XpimNTotal::CrossSection(), G4XpipNTotal::CrossSection(), G4ChipsKaonPlusInelasticXS::CrossSectionFormula(), csz__huft_build(), G4RadioactiveDecayBase::DecayAnalog(), G4PionRadiativeDecayChannel::DecayIt(), G4MuonRadiativeDecayChannelWithSpin::DecayIt(), G4UnknownDecay::DecayIt(), G4Decay::DecayIt(), G4MuonicAtomDecay::DecayIt(), G4RadioactiveDecay::DecayIt(), oncsSub_iduppetdata::decode(), oncsSub_iduppetdata_v104::decode(), G4ElasticHadrNucleusHE::DefineHadronValues(), G4DensityEffectCalculator::DEll(), G4VFieldModel::DescribeYourselfTo(), G4ElectroNuclearCrossSection::DFun(), G4AdjointeIonisationModel::DiffCrossSectionMoller(), G4LivermoreGammaConversionModelRC::Dilog(), G4Abla::direct(), kdfinder::TrackCandidate< T >::distanceToCircle(), G4EllipticalTube::DistanceToIn(), G4Ellipsoid::DistanceToIn(), G4EllipticalTube::DistanceToOut(), G4Ellipsoid::DistanceToOut(), G4UIcmdWith3VectorAndUnit::DoIt(), G4ScreenedCoulombClassicalKinematics::DoScreeningComputation(), G4ScoringBox::Draw(), G4ScoreLogColorMap::DrawColorChartBar(), G4VScoreColorMap::DrawColorChartBar(), G4ScoringBox::DrawColumn(), G4VScoreWriter::DumpAllQuantitiesToFile(), G4VScoreWriter::DumpQuantityToFile(), RE03UserScoreWriter::DumpQuantityToFile(), BrachyUserScoreWriter::DumpQuantityToFile(), G4VDecayChannel::DynamicalMass(), HelixHough::dzdlRange_sse(), G4ionEffectiveCharge::EffectiveCharge(), ei(), G4GeomTools::EllipsePerimeter(), G4GeomTools::EllipticConeLateralArea(), CCalEventAction::EndOfEventAction(), GammaRayTelEventAction::EndOfEventAction(), HistoManager::EndOfRun(), G4GMocrenFileSceneHandler::EndSavingGdd(), QAG4SimulationCalorimeterSum::eval_trk_proj(), G4QuarkExchange::ExciteParticipants(), Par01EMShowerModel::Explode(), export_G4ThreeVector(), export_G4TwoVector(), PerspectiveVisAction::ExtendedDraw(), G4IonFluctuations::Factor(), SvtxClusterEval::fast_approx_atan2(), fg(), fgp(), FW::BField::txt::fieldMapperXYZ(), FW::BField::root::fieldMapperXYZ(), CLHEP::DoubConv::fill_byte_order(), fillEvent(), G4INCL::ElasticChannel::fillFinalState(), CaloEvaluator::fillOutputNtuples(), SvtxEvaluator::fillOutputNtuples(), CML2PrimaryGenerationAction::fillParticlesContainer(), G4NucleiModel::fillZoneRadii(), PHTpcLookup::find(), NHitSeedFinder::find4Tracks(), NHitSeedFinder::find5Tracks(), NHitSeedFinder::find6Tracks(), PHG4CylinderGeomv4::find_strip_center(), G4PhysicsVector::FindLinearEnergy(), G4Physics2DVector::FindLinearX(), PHTpcSeedFinder::findSeeds(), CLHEP::RandPoisson::fire(), SimpleTrack3D::fit_track(), ZHough_Cylindrical::fitTrack(), VtxTrackFinder::fitTrack(), ThreeHitSeedGrower::fitTrack(), NHitSeedFinder::fitTrack(), FourHitSeedFinder::fitTrack(), sPHENIXTrackerTpc::fitTrack(), sPHENIXTracker::fitTrack(), sPHENIXSeedFinder::fitTrack(), FourHitSeedFinder::fitTrackLine(), CLHEP::MTwistEngine::flat(), G4Abla::fmaxhaz_old(), for(), G4JpegCoder::ForwardDCT(), Acts::IntegrationTest::foward_backward(), G4MuonRadiativeDecayChannelWithSpin::fron(), G4BoundingEnvelope::G4BoundingEnvelope(), G4ecpssrBaseKxsModel::G4ecpssrBaseKxsModel(), G4gspos(), G4gsrotm(), G4HadElementSelector::G4HadElementSelector(), G4Para::G4Para(), G4QuickRand(), G4RandomPointInEllipse(), G4RandomPointOnEllipse(), G4fissionEvent::G4SmpWatt(), G4Trap::G4Trap(), G4Abla::gammln(), simpleRandom::gauss(), gauss1(), gauss2(), gauss3(), gauss4(), G4INCL::Math::gaussianCDF(), CexmcReimplementedGenbod::Generate(), G4RDGenerator2BN::Generate2BN(), G4PhotonEvaporation::GenerateGamma(), GFlashHomoShowerParameterisation::GenerateLongitudinalProfile(), GFlashSamplingShowerParameterisation::GenerateLongitudinalProfile(), G4SPSPosDistribution::GeneratePointsInBeam(), G4SPSPosDistribution::GeneratePointsInPlane(), DMXParticleSource::GeneratePointsInVolume(), G4SPSPosDistribution::GeneratePointsInVolume(), G4SPSPosDistribution::GeneratePointsOnSurface(), ExUCNPrimaryGeneratorAction::GeneratePrimaries(), F06PrimaryGeneratorAction::GeneratePrimaries(), RE04PrimaryGeneratorAction::GeneratePrimaries(), XrayFluoPlanePrimaryGeneratorAction::GeneratePrimaries(), IORTPrimaryGeneratorAction::GeneratePrimaries(), XrayFluoPrimaryGeneratorAction::GeneratePrimaries(), GammaRayTelPrimaryGeneratorAction::GeneratePrimaries(), PHG4GDMLWriteSolids::GenTrapWrite(), G4GDMLWriteSolids::GenTrapWrite(), genfit::Field::get(), SvtxTruthEval::get_innermost_truth_hit(), G4ParticleHPThermalScattering::get_linear_interpolated(), G4LogConsts::get_log_poly(), SvtxTruthEval::get_outermost_truth_hit(), CLHEP::HepRotation::getAngleAxis(), G4GDMLWriteDefine::GetAngles(), PHG4GDMLWriteDefine::GetAngles(), ClusterSBPoints::GetBarycenter(), ALICEKF::GetCircleClusterResiduals(), G4VXTRenergyLoss::GetComptonPerAtom(), EmcCluster::GetCorrPos(), G4GenericTrap::GetCubicVolume(), G4LindhardSorensenData::GetDeltaL(), G4IonisParamMat::GetDensityCorrection(), XrayFluoDetectorConstruction::GetDetectorPosition(), EmcCluster::GetECoreCorrected(), G4ElectroNuclearCrossSection::GetEquivalentPhotonQ2(), G4NuclNuclDiffuseElastic::GetErfComp(), G4NuclNuclDiffuseElastic::GetErfInt(), G4TwistTrapFlatSide::GetFacets(), G4ProtonField::GetField(), PHFieldCleo::GetFieldValue(), PHFieldBeast::GetFieldValue(), PHField3DCartesian::GetFieldValue(), PHField2D::GetFieldValue(), PHField3DCylindrical::GetFieldValue(), PHG4OuterHcalField::GetFieldValue(), TabulatedField3D::GetFieldValue(), G4LineCurrentMagField::GetFieldValue(), EMField::GetFieldValue(), G4DELPHIMagField::GetFieldValue(), G4HarmonicPolMagField::GetFieldValue(), G4SextupoleMagField::GetFieldValue(), HadrontherapyMagneticField3D::GetFieldValue(), PurgMagTabulatedField3D::GetFieldValue(), getinspliti(), getinsudared(), G4ElasticHadrNucleusHE::GetLightFq2(), G4Accumulables::GetMergeFunction(), G4PenelopeBremsstrahlungFS::GetMomentumIntegral(), G4INCL::InterpolationTable::getNodeValues(), getpdfxint(), G4ParticleHPPhotonDist::GetPhotons(), getpnorad1(), G4PolyconeSide::GetPointOnFace(), G4VTwistedFaceted::GetPointOnSurface(), G4Ellipsoid::GetPointOnSurface(), G4GenericTrap::GetPointOnSurface(), G4EllipticalCone::GetPointOnSurface(), G4BoundingEnvelope::GetPrismAABB(), getscatterer(), getspliti(), getsscat(), G4GenericTrap::GetSurfaceArea(), A_Event::getTime(), G4INCL::SurfaceAvatar::getTransmissionProbability(), G4Trap::GetVertices(), G4ParticleHPVector::GetXsec(), getxsecint(), G4ParticleHPField::GetY(), G4ParticleHPPartial::GetY(), kdfinder::CircleFit< T >::GradientHessian(), G4HadronNucleonXsc::HadronNucleonXscNS(), G4ParticleHPElementData::Harmonise(), G4ParticleHPVector::Hash(), G4Abla::haz(), G4VhElectronicStoppingPower::HeEffChargeSquare(), G4BraggIonModel::HeEffChargeSquare(), hFarBwdDefineMagnets(), hFarFwdDefineMagnets(), hiboost(), hijsrt(), G4Bessel::I0(), G4Bessel::I1(), G4ParticleHPDiscreteTwoBody::Init(), G4ParticleHPList::Init(), G4ParticleHPVector::Init(), sPHENIXTracker::initDummyHits(), sPHENIXSeedFinder::initDummyHits(), Acts::LineSurface::initJacobianToGlobal(), Acts::Surface::initJacobianToGlobal(), Acts::Surface::initJacobianToLocal(), HcalRawTowerBuilder::InitRun(), G4EllipticalTube::Inside(), G4Ellipsoid::Inside(), G4GenericTrap::InsidePolygone(), G4PreCompoundFragment::IntegrateEmissionProbability(), G4VEmissionProbability::IntegrateProbability(), G4DataSet::IntegrationFunction(), G4RDEMDataSet::IntegrationFunction(), G4EMDataSet::IntegrationFunction(), G4Physics2DVector::InterpolateLinearX(), G4SynchrotronRadiation::InvSynFracInt(), G4hIonEffChargeSquare::IonEffChargeSquare(), G4Abla::IPOWERLIMHAZ(), G4GenericTrap::IsSegCrossing(), G4GenericTrap::IsSegCrossingZ(), G4Bessel::K0(), G4Bessel::K1(), G4INCL::NKbElasticChannel::KaonMomentum(), G4INCL::NKbToNKbChannel::KaonMomentum(), G4INCL::NKbToSpiChannel::KaonMomentum(), G4INCL::NpiToLKChannel::KaonMomentum(), G4INCL::NKbToLpiChannel::KaonMomentum(), G4INCL::NpiToSKChannel::KaonMomentum(), G4QMDGroundStateNucleus::killCMMotionAndAngularM(), G4EmCorrections::KShell(), kspos(), ksposp(), Acts::LayerArrayCreator::layerArray(), G4ParticleHPInterpolator::Lin(), G4ParticleHPInterpolator::LinearLinear(), LJScreening(), MyGamma::LnGamma(), PDBlib::Load(), PHG4CylinderGeom_Spacalv3::load_demo_sector_tower_map4(), G4LatticeLogical::Load_NMap(), G4INCL::Store::loadParticles(), G4ReactionProduct::Lorentz(), G4EmCorrections::LShell(), LXeMainVolume::LXeMainVolume(), main(), G4MuonVDNuclearModel::MakeSamplingTable(), PHG4ScoringManager::makeScoringHistograms(), PHActsSiliconSeeding::makeSpacePoint(), PHActsSiliconSeeding::makeSvtxTracks(), G4JpegCoder::makeYCC(), MCGIDI_angularEnergy_parsePointwiseFromTOM(), MCGIDI_energy_sampleWatt(), MCGIDI_energyAngular_linear_parseFromTOM(), MCGIDI_product_sampleMultiplicity(), G4hhIonisation::MinPrimaryEnergy(), molecule(), BEmcRec::Momenta(), momentumDistributions(), PHHepMCGenEvent::moveVertex(), nlohmann::detail::dtoa_impl::diyfp::mul(), G4INCL::CrossSectionsINCL46::NDeltaToNN(), G4INCL::CrossSectionsMultiPions::NDeltaToNN(), Acts::Legacy::AtlasSeedfinder< SpacePoint >::newSpacePoint(), nf_incompleteGammaFunctionComplementary(), G4GenericTrap::NormalToPlane(), G4ScreeningMottCrossSection::NuclearCrossSection(), odeint(), CLHEP::MTwistEngine::operator float(), CLHEP::MTwistEngine::operator unsigned int(), boost::operator!=(), FW::GaussianVertexGenerator::operator()(), operator+(), operator-(), G4GMocrenFileSceneHandler::Index3D::operator<(), boost::operator<(), boost::operator<=(), G4GMocrenFileSceneHandler::Index3D::operator==(), boost::operator>=(), CLHEP::operator>>(), HepGeom::operator>>(), G4GDMLReadSolids::ParaRead(), DNAParser::ParseFile(), G4DNADingfelderChargeIncreaseModel::PartialCrossSection(), G4DNADingfelderChargeDecreaseModel::PartialCrossSection(), G4PhotoElectricAngularGeneratorPolarized::PerpendicularVector(), PG4gspos(), PG4gsposp(), phase(), G4eeCrossSections::PhaseSpace3p(), HelixHough::phiRange_sse(), G4PhotoElectricAngularGeneratorPolarized::PhotoElectronRotationMatrix(), G4RDPhotoElectricAngularGeneratorPolarized::PhotoElectronRotationMatrix(), G4Bessel::pI0(), G4Bessel::pI1(), pickvtx(), G4INCL::CrossSectionsINCL46::piNToDelta(), G4INCL::CrossSectionsMultiPions::piNToDelta(), G4Bessel::pK0(), plot(), G4GeomTools::PointInPolygon(), G4DataInterpolation::PolynomInterpolation(), G4GDMLWriteDefine::Position_vectorWrite(), PHG4GDMLWriteDefine::Position_vectorWrite(), G4SteppingVerbose::PostStepDoItAllDone(), G4ITSteppingVerbose::PostStepDoItAllDone(), G4SteppingVerbose::PostStepDoItOneByOne(), G4ITSteppingVerbose::PostStepDoItOneByOne(), G4Pow::powN(), PHG4Hitv1::print(), printBField(), printHits(), CaloEvaluator::printOutputInfo(), SvtxEvaluator::printOutputInfo(), G4INCL::Store::printParticleConfiguration(), G4eBremsstrahlungSpectrum::Probability(), G4RDeBremsstrahlungSpectrum::Probability(), PHTruthTrackSeeding::Process(), PHG4ParticleGeneratorD0::process_event(), PHG4FullProjSpacalCellReco::process_event(), PHG4ParticleGeneratorVectorMeson::process_event(), PHG4SimpleEventGenerator::process_event(), PHGenFitTrackProjection::process_event(), PHG4MicromegasHitReco::process_event(), PHTpcCentralMembraneClusterizer::process_event(), Acts::Legacy::AtlasSeedfinder< SpacePoint >::production3Sp(), prt_fitslices(), prt_smooth(), ptwXY_appendXY(), ptwXY_applyFunction2(), ptwXY_applyFunctionZeroCrossing(), ptwXY_binary_ptwXY(), ptwXY_convolution(), ptwXY_createFromFunctionBisect(), ptwXY_createFromFunctionZeroCrossing(), ptwXY_createGaussianCenteredSigma1_2(), ptwXY_div_ptwXY(), ptwXY_div_ptwXY_forFlats(), ptwXY_div_s_ptwXY(), ptwXY_dullEdges(), ptwXY_exp_s(), ptwXY_getYMin(), ptwXY_integrate(), ptwXY_integrateWithWeight_sqrt_x(), ptwXY_integrateWithWeight_x(), ptwXY_intersectionWith_ptwX(), ptwXY_LinLogToLinLin(), ptwXY_LogLinToLinLin(), ptwXY_LogLogToLinLin(), ptwXY_mergeClosePoints(), ptwXY_mul2_s_ptwXY(), ptwXY_otherToLinLin(), ptwXY_setValueAtX_overrideIfClose(), ptwXY_setXYDataFromXsAndYs(), ptwXY_setXYPairAtIndex(), ptwXY_thicken(), ptwXY_thin2(), ptwXY_union(), ptwXY_xSlice(), pyangl(), pyct5l(), pyct5m(), pyfcmp(), pygaga(), pygfxx(), pygram(), pyhistfu(), pylamf(), pypdfu(), pypdpi(), pypdpo(), pyptis(), pyreco(), pyrvg4(), pyrvs(), pysimp(), pystfu(), pywidt(), pyxxz6(), G4DNAWaterDissociationDisplacer::radialDistributionOfProducts(), G4NuclearRadii::Radius(), G4NuclearRadii::RadiusECS(), G4DataInterpolation::RationalPolInterpolation(), ReadASCII(), G4LivermorePolarizedPhotoElectricGDModel::ReadData(), G4LivermorePolarizedPhotoElectricModel::ReadData(), G4LivermorePhotoElectricModel::ReadData(), Acts::IntegrationTest::readFieldXYZ(), readFile(), CexmcReconstructor::ReconstructEntryPoints(), PHGenFitTrkProp::ReFitTrack(), PHGenFitTrkFitter::ReFitTrack(), G4ParticleHPFastLegendre::regularEvaluate(), G4ParticleHPFastLegendre::regularIntegrate(), G4Generator2BS::RejectionFunction(), PHCASeeding::RemoveBadClusters(), Acts::TGeoLayerBuilder::resolveSensitive(), rk4step(), rkstepper(), HepGeom::BasicVector3D< T >::rotate(), GPUTPCTrackParam::Rotate(), HepGeom::BasicVector3D< T >::rotateX(), HepGeom::BasicVector3D< T >::rotateZ(), G4GDMLWriteDefine::Rotation_vectorWrite(), PHG4GDMLWriteDefine::Rotation_vectorWrite(), FW::RootBFieldWriter< bfield_t >::run(), Acts::Test::runTest(), Packet_cdevwcm::rValue(), PHG4Utils::sA(), G4GenericTrap::SafetyToFace(), G4ParticleHPLabAngularEnergy::Sample(), G4ParticleHPLegendreStore::Sample(), G4ParticleHPDiscreteTwoBody::Sample(), G4ParticleHPContAngularPar::Sample(), G4INCL::NDeltaToDeltaLKChannel::sampleDeltaMass(), G4INCL::NDeltaToDeltaSKChannel::sampleDeltaMass(), G4INCL::NDeltaOmegaProductionChannel::sampleDeltaMass(), G4INCL::NDeltaEtaProductionChannel::sampleDeltaMass(), G4INCL::DeltaProductionChannel::sampleDeltaMass(), G4DeltaAngle::SampleDirection(), G4RayleighAngularGenerator::SampleDirection(), G4Generator2BN::SampleDirection(), G4Generator2BS::SampleDirection(), G4SeltzerBergerModel::SampleEnergyTransfer(), G4INCL::ParticleSampler::sampleOneParticleWithFuzzyRPCorrelation(), G4LivermoreBremsstrahlungModel::SampleSecondaries(), G4PolarizedMollerBhabhaModel::SampleSecondaries(), G4LivermorePolarizedRayleighModel::SampleSecondaries(), G4MollerBhabhaModel::SampleSecondaries(), G4ChargeExchange::SampleT(), G4QGSMSplitableHadron::SampleX(), G4GDMLWriteDefine::Scale_vectorWrite(), PHG4GDMLWriteDefine::Scale_vectorWrite(), G4ElementSelector::SelectZandA(), serai(), seraid(), RawTowerGeomv2::set_center_y(), RawTowerGeomv1::set_center_y(), RawTowerGeomv4::set_center_y(), RawTowerZDCGeomv1::set_center_y(), RawTowerGeomv3::set_center_y(), PHG4ParticleGeneratorVectorMeson::set_existing_vertex_offset_vector(), PHG4SimpleEventGenerator::set_existing_vertex_offset_vector(), PHG4FPbScSubsystem::set_Place(), PHG4ParticleGeneratorVectorMeson::set_vertex_distribution_function(), PHHepMCGenHelper::set_vertex_distribution_function(), PHG4SimpleEventGenerator::set_vertex_distribution_function(), PHG4ParticleGeneratorVectorMeson::set_vertex_distribution_mean(), PHHepMCGenHelper::set_vertex_distribution_mean(), PHG4SimpleEventGenerator::set_vertex_distribution_mean(), PHG4ParticleGeneratorVectorMeson::set_vertex_distribution_width(), PHHepMCGenHelper::set_vertex_distribution_width(), PHG4SimpleEventGenerator::set_vertex_distribution_width(), PHG4ParticleGeneratorBase::set_vtx(), SimpleHit3D::set_y(), SvtxTrackState_v1::set_y(), SvtxVertex_v1::set_y(), PHG4Showerv1::set_y(), GlobalVertexv1::set_y(), G4TwistBoxSide::SetCorners(), G4TwistTrapParallelSide::SetCorners(), G4TwistTrapAlphaSide::SetCorners(), G4TwistTrapFlatSide::SetCorners(), G4TwistTubsFlatSide::SetCorners(), G4TwistTubsSide::SetCorners(), G4TwistTubsHypeSide::SetCorners(), G4ParticleHPVector::SetData(), CML2Acc1::SetJawAperture(), CML2Acc2::SetJawAperture(), CML2AccSaturn::SetJawAperture(), G4VisCommandViewerAddCutawayPlane::SetNewValue(), G4VisCommandsViewerSet::SetNewValue(), G4VisCommandViewerChangeCutawayPlane::SetNewValue(), G4VisCommandSceneAddDate::SetNewValue(), G4VisCommandSceneAddEventID::SetNewValue(), G4AdjointSimMessenger::SetNewValue(), G4VisCommandSceneAddLogo2D::SetNewValue(), G4VisCommandSceneAddText::SetNewValue(), G4VisCommandSceneAddText2D::SetNewValue(), G4RDPhotoElectricAngularGeneratorPolarized::SetPerpendicularVector(), G4LivermorePolarizedGammaConversionModel::SetPerpendicularVector(), G4LivermorePolarizedComptonModel::SetPerpendicularVector(), G4LivermorePolarizedPhotoElectricGDModel::SetPerpendicularVector(), G4LowEnergyPolarizedCompton::SetPerpendicularVector(), G4LowEPPolarizedComptonModel::SetPerpendicularVector(), LXePMTSD::SetPmtPositions(), G4ParticleHPVector::SetPoint(), PHG4HcalSubsystem::SetPosition(), ActsFatras::Particle::setPosition4(), G4ParticleHPList::SetValue(), G4ViewParameters::SetXGeometryString(), CMFlashClusterv1::setY(), TrkrClusterv1::setY(), TrkrClusterv2::setY(), F02PrimaryGeneratorAction::SetYVertex(), F01PrimaryGeneratorAction::SetYVertex(), F03PrimaryGeneratorAction::SetYVertex(), F04PrimaryGeneratorAction::SetYvertex(), CLHEP::RandPoisson::shoot(), kdfinder::CircleFit< T >::SigmaWithLargeCircleOption(), NeuronLoadDataFile::SingleNeuronSWCfile(), G4ConvergenceTester::slope_fitting_function(), G4INCL::RootFinder::solve(), G4PAIySection::SplainPAI(), G4PAIxSection::SplainPAI(), G4INCL::CrossSectionsMultiPions::spnPiMinusPHE(), G4INCL::CrossSectionsMultiPions::spnPiPlusPHE(), F04SteppingVerbose::StepInfo(), ExN04SteppingVerbose::StepInfo(), FCALSteppingVerbose::StepInfo(), eRositaSteppingVerbose::StepInfo(), XrayFluoSteppingVerbose::StepInfo(), PurgMagSteppingVerbose::StepInfo(), RE05SteppingVerbose::StepInfo(), ExP01SteppingVerbose::StepInfo(), F05SteppingVerbose::StepInfo(), G4SteppingVerbose::StepInfo(), G4ITSteppingVerbose::StepInfo(), F03SteppingVerbose::StepInfo(), F01SteppingVerbose::StepInfo(), G4ITSteppingVerbose::StepInfoForLeadingTrack(), stirf(), nlohmann::detail::dtoa_impl::diyfp::sub(), G4EllipticalTube::SurfaceNormal(), G4Ellipsoid::SurfaceNormal(), G4GenericTrap::SurfaceNormal(), Acts::Frustum< value_t, DIM, SIDES >::svg(), G4ParticleHPVector::ThinOut(), Acts::IntegrationTest::to_cylinder(), Acts::IntegrationTest::to_surface(), tog4(), HepPolyhedron::Transform(), Acts::Seedfinder< external_spacepoint_t >::transformCoordinates(), G4PolyPhiFace::Triangulate(), G4GDMLReadSolids::TwistedboxRead(), ulangl(), FCALSteppingAction::UserSteppingAction(), WLSSteppingAction::UserSteppingAction(), G4Physics2DVector::Value(), G4PhysicsVector::Value(), c2_scaled_function_p< float_type >::value_with_derivatives(), c2_recip_p< float_type >::value_with_derivatives(), w6j1(), while(), DMXEventAction::writePmtHitsToFile(), PHG4InnerHcalDetector::x_at_y(), and CLHEP::RandGaussZiggurat::ziggurat_nfix().

__m128 __m128 __m128& z

Definition at line 155 of file HelixHough_allButKappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 155 of file HelixHough_allButKappaRange_sse.cpp

Referenced by G4GMocrenIO::addDoseDist(), HistoManager::AddLeakingParticle(), RE06DetectorConstruction::AddMaterial(), Run::AddPhantomStep(), HistoManager::AddTargetStep(), ALICEKF::ALICEKalmanFilter(), G4DNABrownianTransportation::AlongStepDoIt(), G4ITSteppingVerbose::AlongStepDoItAllDone(), G4SteppingVerbose::AlongStepDoItAllDone(), G4ITSteppingVerbose::AlongStepDoItOneByOne(), G4SteppingVerbose::AlongStepDoItOneByOne(), G4Analyser::analyse(), AnnularFieldSim::AnnularFieldSim(), G4AntiNeutronAnnihilationAtRest::AntiNeutronAnnihilation(), G4Ellipsoid::ApproxSurfaceNormal(), G4ITSteppingVerbose::AtRestDoItInvoked(), G4SteppingVerbose::AtRestDoItInvoked(), avscatcen(), CLHEP::HepRotation::axis(), Acts::SolenoidBField::B_r(), Acts::SolenoidBField::B_z(), G4Abla::barfit(), Barycenter::Barycenter(), G4AtimaEnergyLossModel::Bethek_dedx_e(), G4PolynomialPDF::Bisect(), CLHEP::HepLorentzVector::boost(), Acts::Test::BOOST_AUTO_TEST_CASE(), Acts::Test::BOOST_DATA_TEST_CASE(), BOOST_DATA_TEST_CASE(), Acts::IntegrationTest::BOOST_DATA_TEST_CASE(), Acts::Test::BOOST_FIXTURE_TEST_CASE(), G4GDMLReadSolids::BoxRead(), PHG4mRICHDetector::build_mRICH_sector(), PHG4mRICHDetector::build_mRICH_sector2(), PHG4mRICHDetector::build_mRICH_wall_eside(), PHG4mRICHDetector::build_mRICH_wall_eside_proj(), PHG4mRICHDetector::build_mRICH_wall_hside(), G4DiffuseElasticV2::BuildAngleTable(), G4DiffuseElastic::BuildAngleTable(), PHG4TTLDetector::BuildBarrelTTL(), PHG4TTLDetector::BuildForwardTTL(), Acts::Legacy::AtlasSeedfinder< SpacePoint >::buildFrameWork(), PHGenFitTrkProp::BuildLayerZPhiHitMap(), G4tgbVolume::BuildSolidForDivision(), G4Voxelizer::BuildVoxelLimits(), HelixHoughFuncs_v1::calculate_dzdl_range(), G4NuclNuclDiffuseElastic::CalculateCoulombPhase(), G4NuclNuclDiffuseElastic::CalculateCoulombPhaseZero(), G4Orb::CalculateExtent(), G4Tet::CalculateExtent(), G4ExtrudedSolid::CalculateExtent(), CylinderKalman::calculateProjections(), HelixKalmanFilter::calculateProjections(), G4ViewParameters::CatmullRomCubicSplineInterpolation(), CellParameterisation::CellParameterisation(), G4PVPlacement::CheckOverlaps(), G4StatMFMacroCanonical::ChooseZ(), ChromosomeParameterisation::ChromosomeParameterisation(), CMDistortionAnalysis(), CMDistortionAnalysisCart(), CMDistortionAnalysisPhiR(), CMDistortionReco(), CMDistortionRecoCart(), CMDistortionRecoPhiR(), PHG4FPbScDetector::computeIndex(), G4IonisParamMat::ComputeIonParameters(), PDBlib::ComputeMatchEdepDNA(), G4SandiaTable::ComputeMatSandiaMatrix(), G4SandiaTable::ComputeMatSandiaMatrixPAI(), RunAction::ComputeMscHighland(), Run::ComputeMscHighland(), G4DNABrownianTransportation::ComputeStep(), CellParameterisation::ComputeTransformation(), NeuronLoadDataFile::ComputeTransformation(), G4GDMLReadSolids::ConeRead(), Acts::IntegrationTest::constant_field_propagation(), H02DetectorConstruction::Construct(), ExN04DetectorConstruction::Construct(), G4MIRDPelvis::Construct(), G4MIRDThyroid::Construct(), B03DetectorConstruction::Construct(), ExP02DetectorConstruction::Construct(), RE05DetectorConstruction::Construct(), B01DetectorConstruction::Construct(), B02DetectorConstruction::Construct(), GeometryConstruction::Construct(), OpNoviceDetectorConstruction::Construct(), ExN01DetectorConstruction::Construct(), eRositaDetectorConstruction::Construct(), B5DetectorConstruction::Construct(), ExN02DetectorConstruction::Construct(), ExP01DetectorConstruction::Construct(), PHG4SpacalDetector::Construct_AzimuthalSeg(), XrayFluoMercuryDetectorConstruction::ConstructApparate(), XrayFluoPlaneDetectorConstruction::ConstructApparate(), XrayFluoDetectorConstruction::ConstructApparate(), F04DetectorConstruction::ConstructDetector(), PHG4OuterHcalDetector::ConstructHcalSingleScintillators(), PHG4InnerHcalDetector::ConstructHcalSingleScintillators(), CCalG4Ecal::constructIn(), DetectorConstruction::ConstructMaterials(), PHG4PSTOFDetector::ConstructMe(), G4EicDircDetector::ConstructMe(), GammaRayTelDetectorConstruction::ConstructPayload(), UltraDetectorConstruction::ConstructReflector(), UltraDetectorConstruction::ConstructTableMaterials(), BEmcRec::CorrectShowerDepth(), G4NuclNuclDiffuseElastic::CoulombAmplitude(), Acts::IntegrationTest::covariance_bound(), Acts::IntegrationTest::covariance_curvilinear(), Acts::AtlasStepper< ConstantBField >::covarianceTransport(), MuCrossSections::CR_PerAtom(), create_element(), RawTowerBuilder::CreateNodes(), PHActsSiliconSeeding::createSvtxTrack(), G4DNAUeharaScreenedRutherfordElasticModel::CrossSectionPerVolume(), G4DNAScreenedRutherfordElasticModel::CrossSectionPerVolume(), csz__huft_build(), G4GDMLReadSolids::CutTubeRead(), G4RadioactiveDecayBase::DecayAnalog(), G4UnknownDecay::DecayIt(), G4Decay::DecayIt(), G4MuonicAtomDecay::DecayIt(), G4RadioactiveDecay::DecayIt(), G4BraggModel::DEDX(), G4BraggIonModel::DEDX(), ExN04DetectorConstruction::DefineMaterials(), RE05DetectorConstruction::DefineMaterials(), GB03DetectorConstruction::DefineMaterials(), B4cDetectorConstruction::DefineMaterials(), B4dDetectorConstruction::DefineMaterials(), RE06DetectorConstruction::DefineMaterials(), B4DetectorConstruction::DefineMaterials(), DetectorConstruction::DefineMaterials(), RMC01DetectorConstruction::DefineMaterials(), LXeDetectorConstruction::DefineMaterials(), G4EicDircDetector::DefineMaterials(), F02DetectorConstruction::DefineMaterials(), F01DetectorConstruction::DefineMaterials(), PHG4Reco::DefineMaterials(), ExN03DetectorConstruction::DefineMaterials(), F03DetectorConstruction::DefineMaterials(), GammaRayTelDetectorConstruction::DefineMaterials(), deriv(), G4VFieldModel::DescribeYourselfTo(), G4QGSParticipants::DeterminePartonMomenta(), G4AtimaFluctuations::Dispersion(), G4Ellipsoid::DistanceToIn(), G4Ellipsoid::DistanceToOut(), G4TwistTubsSide::DistanceToSurface(), dofistatescat(), G4UIcmdWith3VectorAndUnit::DoIt(), dokinematics(), G4ScoringCylinder::Draw(), G4ScoringBox::Draw(), G4ScoringCylinder::DrawColumn(), G4ScoringBox::DrawColumn(), G4VScoreWriter::DumpAllQuantitiesToFile(), G4VScoreWriter::DumpQuantityToFile(), BrachyUserScoreWriter::DumpQuantityToFile(), RE03UserScoreWriter::DumpQuantityToFile(), HelixHough::dzdlRange_sse(), G4ionEffectiveCharge::EffectiveCharge(), G4Abla::eflmac(), G4Abla::eflmac_profi(), Acts::DD4hepLayerBuilder::endcapLayers(), CCalEventAction::EndOfEventAction(), GammaRayTelEventAction::EndOfEventAction(), G4GMocrenFileSceneHandler::EndSavingGdd(), CCaloOrganization::energyInMatrix(), CLHEP::HepStat::erfQ(), QAG4SimulationCalorimeterSum::eval_trk_proj(), Par01PionShowerModel::Explode(), Par01EMShowerModel::Explode(), G4EquilibriumEvaporator::explosion(), export_G4ThreeVector(), PerspectiveVisAction::ExtendedDraw(), TpcSpaceChargeReconstructionHelper::extrapolate_phi1(), TpcSpaceChargeReconstructionHelper::extrapolate_z(), SvtxClusterEval::fast_approx_atan2(), FCALMaterialConsultant::FCALMaterialConsultant(), FW::BField::txt::fieldMapperRZ(), FW::BField::root::fieldMapperRZ(), FW::BField::txt::fieldMapperXYZ(), FW::BField::root::fieldMapperXYZ(), CLHEP::DoubConv::fill_byte_order(), fillEvent(), G4INCL::ElasticChannel::fillFinalState(), Acts::Legacy::AtlasSeedfinder< SpacePoint >::fillLists(), CaloEvaluator::fillOutputNtuples(), SvtxEvaluator::fillOutputNtuples(), CML2PrimaryGenerationAction::fillParticlesContainer(), Acts::TrackDensityVertexFinder< vfitter_t, track_density_t >::find(), CylinderGeomMicromegas::find_tile_cylindrical(), G4Physics2DVector::FindBinLocation(), G4BinaryCascade::FindFragments(), HelixHough::findHelices(), HelixHough::findSeededHelices_run(), for(), Acts::IntegrationTest::foward_backward(), G4Abla::frldm(), Acts::Test::SurfaceArrayFixture::fullPhiTestSurfacesBRL(), Acts::Test::SurfaceArrayCreatorFixture::fullPhiTestSurfacesBRL(), Acts::Test::LayerCreatorFixture::fullPhiTestSurfacesBRL(), Acts::Test::SurfaceArrayFixture::fullPhiTestSurfacesEC(), Acts::Test::SurfaceArrayCreatorFixture::fullPhiTestSurfacesEC(), Acts::Test::LayerCreatorFixture::fullPhiTestSurfacesEC(), g(), G4BoundingEnvelope::G4BoundingEnvelope(), G4EmCaptureCascade::G4EmCaptureCascade(), G4Expf(), G4gsmate(), G4gspos(), G4gsrotm(), G4Para::G4Para(), G4RandomDirection(), G4fissionEvent::G4SmpWatt(), G4Trap::G4Trap(), G4NuclNuclDiffuseElastic::GammaLogarithm(), G4NuclNuclDiffuseElastic::GammaLogB2n(), simpleRandom::gauss(), G4INCL::Math::gaussianCDF(), CLHEP::RandChiSquare::genChiSquare(), CexmcReimplementedGenbod::Generate(), G4NucleiModel::generateModel(), G4SPSPosDistribution::GeneratePointsInBeam(), G4SPSPosDistribution::GeneratePointsInPlane(), DMXParticleSource::GeneratePointsInVolume(), G4SPSPosDistribution::GeneratePointsInVolume(), G4SPSPosDistribution::GeneratePointsOnSurface(), PrimaryGeneratorAction1::GeneratePrimaries(), ExUCNPrimaryGeneratorAction::GeneratePrimaries(), F06PrimaryGeneratorAction::GeneratePrimaries(), XrayFluoPlanePrimaryGeneratorAction::GeneratePrimaries(), IORTPrimaryGeneratorAction::GeneratePrimaries(), XrayFluoPrimaryGeneratorAction::GeneratePrimaries(), FFPrimaryGeneratorAction::GeneratePrimaries(), GammaRayTelPrimaryGeneratorAction::GeneratePrimaries(), PrimaryGenerator::GeneratePrimaryVertex(), genfit::Field::get(), TpcDirectLaserReconstruction::get_cell_index(), TpcSpaceChargeReconstruction::get_cell_index(), TpcDistortionCorrection::get_corrected_position(), TowerJetInput::get_input(), CLHEP::HepRotation::getAngleAxis(), G4GDMLWriteDefine::GetAngles(), PHG4GDMLWriteDefine::GetAngles(), G4hhElastic::GetAqQ(), ClusterSBPoints::GetBarycenter(), AnnularFieldSim::GetBFieldAt(), PHTpcResiduals::getCell(), AnnularFieldSim::GetChargeAt(), G4hhElastic::GetCofS1(), G4hhElastic::GetCofS2(), G4hhElastic::GetCofS3(), G4NuclNuclDiffuseElastic::GetCoulombElasticXsc(), G4DiffuseElastic::GetCoulombElasticXsc(), G4NuclNuclDiffuseElastic::GetCoulombIntegralXsc(), G4DiffuseElastic::GetCoulombIntegralXsc(), G4NuclNuclDiffuseElastic::GetCoulombTotalXsc(), G4DiffuseElastic::GetCoulombTotalXsc(), XrayFluoDetectorConstruction::GetDetectorPosition(), G4NuclNuclDiffuseElastic::GetDiffuseElasticSumXsc(), G4DiffuseElastic::GetDiffuseElasticSumXsc(), GVFlashShowerParameterisation::GetEffZ(), G4NuclNuclDiffuseElastic::GetErf(), G4NuclNuclDiffuseElastic::GetErfSer(), G4TwistTubsSide::GetFacets(), G4TwistBoxSide::GetFacets(), G4TwistTrapParallelSide::GetFacets(), G4TwistTubsHypeSide::GetFacets(), G4TwistTrapAlphaSide::GetFacets(), AnnularFieldSim::GetFieldAt(), PHField2D::GetFieldCyl(), PHField3DCylindrical::GetFieldCyl(), PHFieldCleo::GetFieldValue(), PHField3DCartesian::GetFieldValue(), PHFieldBeast::GetFieldValue(), PHField2D::GetFieldValue(), PHField3DCylindrical::GetFieldValue(), TabulatedField3D::GetFieldValue(), EMField::GetFieldValue(), G4DELPHIMagField::GetFieldValue(), G4HarmonicPolMagField::GetFieldValue(), HadrontherapyMagneticField3D::GetFieldValue(), PurgMagTabulatedField3D::GetFieldValue(), G4VScoreWriter::GetIndex(), G4LundStringFragmentation::GetLightConeZ(), G4QGSMFragmentation::GetLightConeZ(), ALICEKF::GetLineClusterResiduals(), getmass(), G4CutTubs::GetMaxMinZ(), getnewmass(), G4QAOLowEnergyLoss::GetOccupationNumber(), G4ComponentGGHadronNucleusXsc::GetParticleBarCorIn(), G4ComponentGGHadronNucleusXsc::GetParticleBarCorTot(), getpdf(), getpdfxintexact(), getpnorad1(), G4Paraboloid::GetPointOnSurface(), G4Ellipsoid::GetPointOnSurface(), G4TwistedTubs::GetPointOnSurface(), G4BoundingEnvelope::GetPrismAABB(), G4DiffractiveExcitation::GetQuarkFractionOfKink(), getscatterer(), getsscat(), A_Event::getTime(), CCaloOrganization::getUnitWithMaxEnergy(), G4Trap::GetVertices(), gmin(), gmre(), G4EquilibriumEvaporator::goodRemnant(), gphoton(), kdfinder::CircleFit< T >::GradientHessian(), G4Abla::guet(), G4VhElectronicStoppingPower::HeEffChargeSquare(), G4BraggIonModel::HeEffChargeSquare(), hFarBwdDefineMagnets(), hFarFwdDefineMagnets(), G4GDMLReadSolids::HypeRead(), G4RKFieldIntegrator::Init(), sPHENIXTracker::initDummyHits(), sPHENIXSeedFinder::initDummyHits(), G4NuclNuclDiffuseElastic::InitDynParameters(), G4Abla::initEvapora(), DicomDetectorConstruction::InitialisationOfMaterials(), Materials::Initialise(), G4INCL::HFB::initialize(), G4NucleiModel::initializeCascad(), Acts::LineSurface::initJacobianToGlobal(), Acts::Surface::initJacobianToGlobal(), Acts::Surface::initJacobianToLocal(), G4NuclNuclDiffuseElastic::InitParameters(), G4NuclNuclDiffuseElastic::InitParametersGla(), HcalRawTowerBuilder::InitRun(), PHG4FullProjSpacalCellReco::InitRun(), sPHENIXTrackerTpc::initSplitting(), sPHENIXTracker::initSplitting(), sPHENIXSeedFinder::initSplitting(), G4Ellipsoid::Inside(), Acts::Legacy::InternalSeed< SpacePoint >::InternalSeed(), intpgghigh(), intpgglow(), intpqghigh(), intpqglow(), intpqq(), G4hIonEffChargeSquare::IonEffChargeSquare(), Acts::SolenoidBField::k2(), G4INCL::NKbToSpiChannel::KaonMomentum(), G4INCL::NKbToNKbChannel::KaonMomentum(), G4INCL::NKbToLpiChannel::KaonMomentum(), G4INCL::NpiToLKChannel::KaonMomentum(), G4INCL::NpiToSKChannel::KaonMomentum(), G4INCL::NKbElasticChannel::KaonMomentum(), ksmate(), ksmixt(), kspos(), ksposp(), G4Ellipsoid::LateralSurfaceArea(), Acts::LayerArrayCreator::layerArray(), lgam(), PHTpcClusterMover::line_fit(), ALICEKF::line_fit(), PHTruthTrackSeeding::lineFit(), PHActsSiliconSeeding::lineFit(), G03DetectorConstruction::ListOfMaterials(), G02DetectorConstruction::ListOfMaterials(), MyGamma::LnGamma(), PDBlib::Load(), AnnularFieldSim::load3dBfield(), AnnularFieldSim::load_and_resample_spacecharge(), G4LatticeLogical::Load_NMap(), AnnularFieldSim::loadBfield(), G4RDCompositeEMDataSet::LoadData(), G4RDBremsstrahlungParameters::LoadData(), G4RDeIonisationParameters::LoadData(), G4BremsstrahlungParameters::LoadData(), G4eIonisationParameters::LoadData(), G4CompositeDataSet::LoadData(), G4CompositeEMDataSet::LoadData(), AnnularFieldSim::loadEfield(), G4CompositeEMDataSet::LoadNonLogData(), G4INCL::Store::loadParticles(), G4ReactionProduct::Lorentz(), luindf(), lushow(), lustrf(), luzdis(), LXeMainVolume::LXeMainVolume(), main(), Acts::Test::SurfaceArrayFixture::makeBarrel(), Acts::Test::SurfaceArrayCreatorFixture::makeBarrel(), Acts::Test::LayerCreatorFixture::makeBarrel(), Acts::Test::SurfaceArrayCreatorFixture::makeBarrelStagger(), Acts::Test::LayerCreatorFixture::makeBarrelStagger(), G4InuclNuclei::makeNuclearFragment(), PHG4ScoringManager::makeScoringHistograms(), PHActsSiliconSeeding::makeSpacePoint(), makesplitting(), makestrings_minl(), PHActsSiliconSeeding::makeSvtxTracks(), MCGIDI_energy_sampleWatt(), Acts::ProtoLayer::measure(), molecule(), momentumDistributions(), G4INCL::KinematicsUtils::momentumInCM(), PHHepMCGenEvent::moveVertex(), Acts::Legacy::AtlasSeedfinder< SpacePoint >::newSpacePoint(), nf_amc_z_coefficient(), nf_gammaFunction(), nf_incompleteGammaFunctionComplementary(), G4ShellData::NumberOfShells(), G4RDShellData::NumberOfShells(), ActsFatras::BetheHeitler::operator()(), FW::GaussianVertexGenerator::operator()(), ActsFatras::LandauDistribution::operator()(), GMocrenDataPrimitive< T >::operator+(), operator+(), GMocrenDataPrimitive< T >::operator+=(), operator-(), G4GMocrenFileSceneHandler::Index3D::operator<(), GMocrenDataPrimitive< T >::operator=(), G4GMocrenFileSceneHandler::Index3D::operator==(), CLHEP::operator>>(), HepGeom::operator>>(), G4GDMLReadSolids::ParaRead(), G3EleTable::parse(), DNAParser::ParseFile(), G4DNAMillerGreenExcitationModel::PartialCrossSection(), pdfint(), G4PhotoElectricAngularGeneratorPolarized::PerpendicularVector(), PG4gsmate(), PG4gsmixt(), PG4gspos(), PG4gsposp(), pgg(), pgq(), G4NuclNuclDiffuseElastic::PhaseFar(), G4NuclNuclDiffuseElastic::PhaseNear(), PHField2D::PHField2D(), PHField3DCylindrical::PHField3DCylindrical(), pickvtx(), plot(), Acts::ConeSurface::polyhedronRepresentation(), G4GDMLWriteDefine::Position_vectorWrite(), PHG4GDMLWriteDefine::Position_vectorWrite(), G4SteppingVerbose::PostStepDoItAllDone(), G4ITSteppingVerbose::PostStepDoItAllDone(), G4SteppingVerbose::PostStepDoItOneByOne(), G4ITSteppingVerbose::PostStepDoItOneByOne(), pqg(), pqq(), PHG4Hitv1::print(), printBField(), G4RDVCrossSectionHandler::PrintData(), G4VCrossSectionHandler::PrintData(), G4PixeCrossSectionHandler::PrintData(), printHits(), CaloEvaluator::printOutputInfo(), SvtxEvaluator::printOutputInfo(), G4INCL::Store::printParticleConfiguration(), PHTruthTrackSeeding::Process(), PHG4CylinderCellReco::process_event(), PHG4FullProjSpacalCellReco::process_event(), PHG4SimpleEventGenerator::process_event(), PHGenFitTrackProjection::process_event(), PHTpcCentralMembraneClusterizer::process_event(), Acts::Legacy::AtlasSeedfinder< SpacePoint >::production3Sp(), HepGeom::BasicVector3D< T >::pseudoRapidity(), ptwXY_exp_s(), ptwXY_f_integrate(), pydcyk(), pyeig4(), pygfxx(), pyhiscat(), pyhisspa(), pyindf(), pylamf(), pymewt(), pyptfs(), pyptis(), pyreco(), pyscat(), pyshow(), pysspa(), pystrf(), pyzdis(), G4Abla::qrot(), ActsFatras::LandauDistribution::quantile(), G4DNAWaterDissociationDisplacer::radialDistributionOfProducts(), G4NuclearRadii::RadiusCB(), ReadASCII(), Acts::IntegrationTest::readFieldXYZ(), readFile(), PHGenFitTrkFitter::ReFitTrack(), Acts::TGeoLayerBuilder::resolveSensitive(), G4GMocrenIO::retrieveData2(), G4GMocrenIO::retrieveData3(), G4GMocrenIO::retrieveData4(), RICHSetup(), HepGeom::BasicVector3D< T >::rotate(), HepGeom::BasicVector3D< T >::rotateX(), HepGeom::BasicVector3D< T >::rotateY(), G4GDMLWriteDefine::Rotation_vectorWrite(), PHG4GDMLWriteDefine::Rotation_vectorWrite(), FW::RootBFieldWriter< bfield_t >::run(), Acts::Test::runTest(), G4WentzelVIModel::SampleScattering(), G4DNAUeharaScreenedRutherfordElasticModel::SampleSecondaries(), G4DNAScreenedRutherfordElasticModel::SampleSecondaries(), G4LivermorePolarizedRayleighModel::SampleSecondaries(), G4PolarizedMollerBhabhaModel::SampleSecondaries(), G4MollerBhabhaModel::SampleSecondaries(), G4RDCompositeEMDataSet::SaveData(), G4CompositeDataSet::SaveData(), G4CompositeEMDataSet::SaveData(), G4GDMLWriteDefine::Scale_vectorWrite(), PHG4GDMLWriteDefine::Scale_vectorWrite(), SensitiveDetectorHit::SensitiveDetectorHit(), Acts::Legacy::InternalSeed< SpacePoint >::set(), RawTowerGeomv2::set_center_z(), RawTowerGeomv1::set_center_z(), RawTowerGeomv4::set_center_z(), RawTowerZDCGeomv1::set_center_z(), RawTowerGeomv3::set_center_z(), PHG4CylinderCellGeom::set_etamin(), PHG4BlockCellGeom::set_etamin(), PHG4CylinderCellGeom::set_etastep(), PHG4BlockCellGeom::set_etastep(), PHG4ParticleGeneratorVectorMeson::set_existing_vertex_offset_vector(), PHG4SimpleEventGenerator::set_existing_vertex_offset_vector(), PHG4FPbScSubsystem::set_Place(), PHG4ParticleGeneratorVectorMeson::set_vertex_distribution_function(), PHHepMCGenHelper::set_vertex_distribution_function(), PHG4SimpleEventGenerator::set_vertex_distribution_function(), PHG4ParticleGeneratorVectorMeson::set_vertex_distribution_mean(), PHHepMCGenHelper::set_vertex_distribution_mean(), PHG4SimpleEventGenerator::set_vertex_distribution_mean(), PHG4ParticleGeneratorVectorMeson::set_vertex_distribution_width(), PHHepMCGenHelper::set_vertex_distribution_width(), PHG4SimpleEventGenerator::set_vertex_distribution_width(), PHG4ParticleGeneratorBase::set_vtx(), PHG4ParticleGeneratorBase::set_vtx_z(), PHG4Particlev3::set_Z(), SimpleHit3D::set_z(), SvtxTrackState_v1::set_z(), BbcVertexv1::set_z(), SvtxVertex_v1::set_z(), GlobalVertexv1::set_z(), PHG4Showerv1::set_z(), RawClusterv1::set_z(), PHG4HcalSteppingAction::set_zmax(), PHG4CylinderGeomv1::set_zmax(), PHG4HcalSteppingAction::set_zmin(), PHG4CylinderGeomv1::set_zmin(), PHG4CylinderCellGeom::set_zmin(), PHG4BlockCellGeom::set_zmin(), PHG4BlockCellGeom::set_zstep(), PHG4CylinderCellGeom::set_zstep(), B5DetectorConstruction::SetArmAngle(), ExN04CalorimeterHit::SetCellID(), B5EmCalorimeterHit::SetCellID(), RE05CalorimeterHit::SetCellID(), B5HadCalorimeterHit::SetColumnID(), G4TwistTrapParallelSide::SetCorners(), G4TwistBoxSide::SetCorners(), G4TwistTrapAlphaSide::SetCorners(), G4TwistTrapFlatSide::SetCorners(), G4TwistTubsFlatSide::SetCorners(), G4TwistTubsSide::SetCorners(), G4TwistTubsHypeSide::SetCorners(), F04SimpleSolenoid::SetFringeZ(), CML2Acc1::SetJawAperture(), CML2Acc2::SetJawAperture(), CML2AccSaturn::SetJawAperture(), SensitiveDetectorHit::SetLayerID(), B5DriftChamberHit::SetLayerID(), G4VisCommandViewerAddCutawayPlane::SetNewValue(), G4VisCommandsViewerSet::SetNewValue(), G4VisCommandViewerChangeCutawayPlane::SetNewValue(), G4AdjointSimMessenger::SetNewValue(), G4VisCommandSceneAddText::SetNewValue(), G4ElementaryParticleCollider::setNucleusState(), G4Polycone::SetOriginalParameters(), G4Polyhedra::SetOriginalParameters(), G4Abla::SetParametersG4(), G4RDPhotoElectricAngularGeneratorPolarized::SetPerpendicularVector(), G4LivermorePolarizedComptonModel::SetPerpendicularVector(), G4LivermorePolarizedGammaConversionModel::SetPerpendicularVector(), G4LivermorePolarizedPhotoElectricGDModel::SetPerpendicularVector(), G4LowEnergyPolarizedCompton::SetPerpendicularVector(), G4LowEPPolarizedComptonModel::SetPerpendicularVector(), LXePMTSD::SetPmtPositions(), PHG4HcalSubsystem::SetPosition(), ActsFatras::Particle::setPosition4(), B5HadCalorimeterHit::SetRowID(), G4DeexPrecoParameters::SetUploadZ(), PHG4IonGun::SetZ(), CMFlashClusterv1::setZ(), TrkrClusterv1::setZ(), TrkrClusterv2::setZ(), G4FissionLevelDensityParameterINCLXX::setZHigh(), G4FissionLevelDensityParameterINCLXX::setZLow(), Acts::Legacy::Seed< SpacePoint >::setZVertex(), F03PrimaryGeneratorAction::SetZVertex(), F01PrimaryGeneratorAction::SetZVertex(), F02PrimaryGeneratorAction::SetZVertex(), F04PrimaryGeneratorAction::SetZvertex(), sgmin(), kdfinder::CircleFit< T >::SigmaWithLargeCircleOption(), G3toG4DetectorConstruction::SimpleConstruct(), NeuronLoadDataFile::SingleNeuronSWCfile(), G4LundStringFragmentation::SplitEandP(), G4QGSMFragmentation::SplitEandP(), F04SteppingVerbose::StepInfo(), ExN04SteppingVerbose::StepInfo(), eRositaSteppingVerbose::StepInfo(), FCALSteppingVerbose::StepInfo(), XrayFluoSteppingVerbose::StepInfo(), PurgMagSteppingVerbose::StepInfo(), RE05SteppingVerbose::StepInfo(), ExP01SteppingVerbose::StepInfo(), F05SteppingVerbose::StepInfo(), G4SteppingVerbose::StepInfo(), G4ITSteppingVerbose::StepInfo(), F01SteppingVerbose::StepInfo(), F03SteppingVerbose::StepInfo(), G4ITSteppingVerbose::StepInfoForLeadingTrack(), G4hSRIM2000p::StoppingPower(), G4hICRU49He::StoppingPower(), G4hICRU49p::StoppingPower(), G4hZiegler1985p::StoppingPower(), G4hParametrisedLossModel::StoppingPower(), G4BraggModel::StoppingPower(), G4BraggIonModel::StoppingPower(), G4GMocrenIO::storeData2(), G4GMocrenIO::storeData3(), G4GMocrenIO::storeData4(), AnnularFieldSim::sum_local_field_at(), surface(), G4Ellipsoid::SurfaceNormal(), G4NuclNuclDiffuseElastic::TestAngleTable(), G4DiffuseElastic::TestAngleTable(), Acts::IntegrationTest::to_cylinder(), Acts::IntegrationTest::to_surface(), tog4(), HepPolyhedron::Transform(), G4GDMLReadSolids::TrapRead(), G4GDMLReadSolids::TrdRead(), G4PolyPhiFace::Triangulate(), G4GDMLReadSolids::TubeRead(), G4GDMLReadSolids::TwistedboxRead(), G4GDMLReadSolids::TwistedtrapRead(), G4GDMLReadSolids::TwistedtrdRead(), G4Abla::umass(), FCALSteppingAction::UserSteppingAction(), and DMXEventAction::writePmtHitsToFile().

__m128 __m128& z1

Definition at line 91 of file HelixHough_allButKappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 91 of file HelixHough_allButKappaRange_sse.cpp

Referenced by Run::AddPhantomStep(), HelixHough::allButKappaRange_sse(), G4Hype::ApproxDistOutside(), ClusteringAlgo::AreOnTheSameCluster(), AreOnTheSameCluster(), G4RDeBremsstrahlungSpectrum::AverageValue(), G4eBremsstrahlungSpectrum::AverageValue(), G4ParticleHPInelasticBaseFS::BaseApply(), HepGeom::BasicVector3D< G4double >::BasicVector3D(), G4CutTubs::BoundingLimits(), CellularAutomaton_v1::calculate_kappa_tangents(), G4PolyconeSide::CalculateExtent(), G4Torus::CalculateExtent(), sPHENIXTrackerTpc::calculateKappaTangents(), sPHENIXTracker::calculateKappaTangents(), sPHENIXSeedFinder::calculateKappaTangents(), CEmc(), cg3(), G4VoxelLimits::ClipToLimits(), G4ICRU49NuclearStoppingModel::ComputeDEDXPerVolume(), G4ExtrudedSolid::ComputeProjectionParameters(), GFlashHomoShowerParameterisation::ComputeRadialParameters(), GFlashSamplingShowerParameterisation::ComputeRadialParameters(), B5DetectorConstruction::Construct(), G3Division::CreateEnvelope(), G4ScreeningMottCrossSection::DifferentialXSection(), G4ExtrudedSolid::DistanceToIn(), G4ExtrudedSolid::DistanceToOut(), G4FermiFragmentsPoolVI::Dump(), Rossegger::Ephi(), Rossegger::Ephi_(), Rossegger::Er(), Rossegger::Er_(), Rossegger::Ez(), Rossegger::Ez_(), G4STRead::FacetRead(), fgp1(), fgp2(), fgp3(), GPUTPCTrackParam::Filter(), G4Abla::fissionDistri(), flap(), flap1(), flap2(), G4EmCaptureCascade::G4EmCaptureCascade(), G4NuclNuclDiffuseElastic::GammaLogB2n(), genevent(), G4hhElastic::GetF2(), G4hhElastic::GetF3(), TabulatedField3D::GetFieldValue(), EMField::GetFieldValue(), HadrontherapyElectricTabulatedField3D::GetFieldValue(), AnnularFieldSim::GetGroupCellCenter(), G4CutTubs::GetMaxMinZ(), getmd(), G4ScreenedNuclearRecoil::GetMeanFreePath(), ClusterSBPoints::HasInBarycenter(), G4LEPTSDiffXS::InterpolateCDXS(), G4RDeBremsstrahlungSpectrum::IntSpectrum(), G4eBremsstrahlungSpectrum::IntSpectrum(), G4Ellipsoid::LateralSurfaceArea(), G4NativeScreenedCoulombCrossSection::LoadData(), G4CompetitiveFission::MassDistribution(), G4Abla::mglms(), NeuronLoadDataFile::NeuralNetworkDATAfile(), G4LindhardRobinsonPartition::PartitionNIEL(), G4ScreenedNuclearRecoil::PostStepDoIt(), PHG4GenHit::process_event(), PHG4MvtxHitReco::process_event(), PHG4InttHitReco::process_event(), PHG4ParticleGeneratorVectorMeson::process_event(), CellularAutomaton_v1::process_single_track(), CellularAutomaton_v1::process_single_triplet(), PhantomSD::ProcessHits(), profile(), ptwXY_exp(), ptwXY_exp_s(), py4jtw(), pyhiscat(), pyscat(), CLHEP::HepLorentzVector::rapidity(), CLHEP::Hep3Vector::rapidity(), CLHEP::HepRotation::rotateX(), CLHEP::HepRotation::rotateY(), CLHEP::HepRotation::rotateZ(), G4IonCoulombCrossSection::SampleCosineTheta(), G4RDeIonisationSpectrum::SampleEnergy(), G4eIonisationSpectrum::SampleEnergy(), G4WentzelVIModel::SampleScattering(), G4eSingleCoulombScatteringModel::SampleSecondaries(), G4IonCoulombScatteringModel::SampleSecondaries(), G4WentzelOKandVIxSection::SampleSingleScattering(), HepGeom::BasicVector3D< G4double >::set(), PHG4ConeSubsystem::Set_eta_range(), CLHEP::Hep3Vector::setCylindrical(), G4VisCommandSceneAddArrow::SetNewValue(), G4VisCommandSceneAddLine::SetNewValue(), G4ScreenedCoulombCrossSection::standardmass(), G4hNuclearStoppingModel::TheValue(), and HepGeom::Transform3D::Transform3D().

__m128 __m128 __m128& z2

Definition at line 91 of file HelixHough_allButKappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 91 of file HelixHough_allButKappaRange_sse.cpp

Referenced by Run::AddPhantomStep(), HelixHough::allButKappaRange_sse(), G4Hype::ApproxDistOutside(), ClusteringAlgo::AreOnTheSameCluster(), AreOnTheSameCluster(), G4RDeBremsstrahlungSpectrum::AverageValue(), G4eBremsstrahlungSpectrum::AverageValue(), G4CutTubs::BoundingLimits(), CellularAutomaton_v1::calculate_kappa_tangents(), G4Torus::CalculateExtent(), sPHENIXTrackerTpc::calculateKappaTangents(), sPHENIXTracker::calculateKappaTangents(), sPHENIXSeedFinder::calculateKappaTangents(), CEmc(), cg3(), G4VoxelLimits::ClipToLimits(), G4ICRU49NuclearStoppingModel::ComputeDEDXPerVolume(), G4hPairProductionModel::ComputeDMicroscopicCrossSection(), G4MuPairProductionModel::ComputeDMicroscopicCrossSection(), G4ExtrudedSolid::ComputeProjectionParameters(), GFlashHomoShowerParameterisation::ComputeRadialParameters(), GFlashSamplingShowerParameterisation::ComputeRadialParameters(), B5DetectorConstruction::Construct(), PHG4OuterHcalDetector::ConstructHcalSingleScintillators(), MuCrossSections::CRP_Mephi(), G4TwistTubsHypeSide::DistanceToSurface(), G4FermiFragmentsPoolVI::Dump(), G4STRead::FacetRead(), G4EmCaptureCascade::G4EmCaptureCascade(), G4NuclNuclDiffuseElastic::GammaLogB2n(), genevent(), G4hhElastic::GetF2(), G4hhElastic::GetF3(), TabulatedField3D::GetFieldValue(), EMField::GetFieldValue(), G4DELPHIMagField::GetFieldValue(), G4HarmonicPolMagField::GetFieldValue(), getms(), G4ParameterisationPolyconeZ::GetR(), G4ParameterisationPolyhedraZ::GetR(), ClusterSBPoints::HasInBarycenter(), G4LEPTSDiffXS::InterpolateCDXS(), G4RDeBremsstrahlungSpectrum::IntSpectrum(), G4eBremsstrahlungSpectrum::IntSpectrum(), G4hIonEffChargeSquare::IonEffChargeSquare(), G4Ellipsoid::LateralSurfaceArea(), G4CompetitiveFission::MassDistribution(), NeuronLoadDataFile::NeuralNetworkDATAfile(), G4ICRU49NuclearStoppingModel::NuclearStoppingPower(), G4LindhardRobinsonPartition::PartitionNIEL(), PHG4MvtxHitReco::process_event(), PHG4InttHitReco::process_event(), CellularAutomaton_v1::process_single_track(), CellularAutomaton_v1::process_single_triplet(), PhantomSD::ProcessHits(), ptwXY_exp(), py4jtw(), pyhiscat(), pyscat(), G4RDeIonisationSpectrum::SampleEnergy(), G4eIonisationSpectrum::SampleEnergy(), G4WentzelVIModel::SampleScattering(), PHG4ConeSubsystem::Set_eta_range(), G4VisCommandSceneAddArrow::SetNewValue(), G4VisCommandSceneAddLine::SetNewValue(), G4hNuclearStoppingModel::StoppingPower(), and HepGeom::Transform3D::Transform3D().