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

Go to the source code of this file.

Functions

static const unsigned int
allones[4] 
__attribute__ ((aligned(16)))
 
static void __attribute__ ((always_inline)) _vec_select_ux_uy(__m128 v_phi
 
 _vec_sin_cos_ps (v_phi, sinval, cosval)
 
 _vec_select_ux_uy (v_phi, ux, uy, tanphi, phisel)
 

Variables

static const __m128 one_o_2 = {0.5,0.5,0.5,0.5}
 
static void __m128 & ux = _mm_and_ps(phisel, tmp3)
 
static void __m128 __m128 & uy = _mm_and_ps(phisel, tmp4)
 
static void __m128 __m128 __m128 & tanphi = _mm_div_ps(num, denom)
 
static void __m128 __m128
__m128 __m128 & 
phisel
 
__m128 phi_sign = _mm_and_ps((__m128)vec_sgn, v_phi)
 
__m128 pos_phi = _mm_xor_ps(phi_sign, v_phi)
 
__m128 v_phi_m_pi = _mm_sub_ps(v_phi, pi)
 
__m128 pos_phi_m_pi = _mm_xor_ps(phi_sign, v_phi_m_pi)
 
__m128 v_twopi_m_phi = _mm_sub_ps(twopi, v_phi)
 
__m128 pos_twopi_m_phi = _mm_xor_ps(phi_sign, v_twopi_m_phi)
 
__m128 tmp2 = _mm_cmplt_ps(pos_phi_m_pi, pi_over_four)
 
__m128 sinval = {0.,0.,0.,0.}
 
__m128 cosval = {0.,0.,0.,0.}
 
__m128 num = _mm_and_ps(phisel, sinval)
 
__m128 denom = _mm_and_ps(phisel, cosval)
 
__m128 v_phi_p_pi02 = _mm_add_ps(v_phi, pi_over_two)
 
__m128 phi_compare = _mm_and_ps(phisel, v_phi_p_pi02)
 
__m128 tmp3 = _mm_mul_ps(tanphi, tanphi)
 
__m128 tmp4 = _mm_cmplt_ps(phi_compare, twopi)
 
static void __m128 y
 
static void __m128 __m128 v_phi
 
static void __m128 __m128 __m128 v_mind
 
static void __m128 __m128
__m128 __m128 
v_maxd
 
static void __m128 __m128
__m128 __m128 __m128 & 
v_mink = _mm_and_ps(tmp1, invr2)
 
static void __m128 __m128
__m128 __m128 __m128 __m128 & 
v_maxk = _mm_and_ps(tmp1, invr1)
 
static void __m128 __m128
__m128 __m128 __m128 __m128
__m128 & 
reflection_min = _mm_or_ps(reflection_min, tmp1)
 
static void __m128 __m128
__m128 __m128 __m128 __m128
__m128 __m128 & 
reflection_max = _mm_or_ps(reflection_max, tmp1)
 
static void __m128 __m128
__m128 __m128 __m128 __m128
__m128 __m128 __m128 & 
incorrect_quadrant = _mm_or_ps(incorrect_quadrant, tmp3)
 
static void __m128 __m128
__m128 __m128 __m128 __m128
__m128 __m128 __m128 __m128 & 
correct_quadrant
 
__m128 dy = {0.,0.,0.,0.}
 
__m128 t = {0.,0.,0.,0.}
 
__m128 tP = {0.,0.,0.,0.}
 
__m128 mx = {0.,0.,0.,0.}
 
__m128 my = {0.,0.,0.,0.}
 
__m128 Ix = {0.,0.,0.,0.}
 
__m128 Iy = {0.,0.,0.,0.}
 
__m128 r1 = {0.,0.,0.,0.}
 
__m128 r2 = {0.,0.,0.,0.}
 
__m128i vec_ones = _mm_load_si128((__m128i*)allones)
 
__m128i vec_sgn = _mm_load_si128((__m128i*)sign_int)
 
__m128 tmp1 = _mm_mul_ps(uy, y)
 
 dx = _mm_mul_ps(ux, v_mind)
 
__m128 Ix_sign = _mm_and_ps((__m128)vec_sgn, Ix)
 
__m128 ux_sign = _mm_and_ps((__m128)vec_sgn, ux)
 
__m128 Iy_sign = _mm_and_ps((__m128)vec_sgn, Iy)
 
__m128 uy_sign = _mm_and_ps((__m128)vec_sgn, uy)
 
__m128 invr1 = _mm_div_ps(one, r1)
 
__m128 invr2 = _mm_div_ps(one, r2)
 

Function Documentation

static const unsigned int allones [4] __attribute__ ( (aligned(16))  )
static
static void __attribute__ ( (always_inline)  )
inlinestatic
_vec_select_ux_uy ( v_phi  ,
ux  ,
uy  ,
tanphi  ,
phisel   
)
_vec_sin_cos_ps ( v_phi  ,
sinval  ,
cosval   
)

Variable Documentation

correct_quadrant
Initial value:
{
__m128 dx = {0.,0.,0.,0.}

Definition at line 72 of file HelixHough_kappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 72 of file HelixHough_kappaRange_sse.cpp

__m128 cosval = {0.,0.,0.,0.}

Definition at line 38 of file HelixHough_kappaRange_sse.cpp.

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

dx = _mm_mul_ps(ux, v_mind)

Definition at line 96 of file HelixHough_kappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 96 of file HelixHough_kappaRange_sse.cpp

dy = {0.,0.,0.,0.}

Definition at line 74 of file HelixHough_kappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 74 of file HelixHough_kappaRange_sse.cpp

incorrect_quadrant = _mm_or_ps(incorrect_quadrant, tmp3)

Definition at line 71 of file HelixHough_kappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 71 of file HelixHough_kappaRange_sse.cpp

__m128 invr1 = _mm_div_ps(one, r1)

Definition at line 215 of file HelixHough_kappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 215 of file HelixHough_kappaRange_sse.cpp

__m128 invr2 = _mm_div_ps(one, r2)

Definition at line 216 of file HelixHough_kappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 216 of file HelixHough_kappaRange_sse.cpp

Ix = {0.,0.,0.,0.}

Definition at line 83 of file HelixHough_kappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 83 of file HelixHough_kappaRange_sse.cpp

Ix_sign = _mm_and_ps((__m128)vec_sgn, Ix)

Definition at line 134 of file HelixHough_kappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 134 of file HelixHough_kappaRange_sse.cpp

Iy = {0.,0.,0.,0.}

Definition at line 84 of file HelixHough_kappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 84 of file HelixHough_kappaRange_sse.cpp

Iy_sign = _mm_and_ps((__m128)vec_sgn, Iy)

Definition at line 140 of file HelixHough_kappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 140 of file HelixHough_kappaRange_sse.cpp

num = _mm_and_ps(phisel, sinval)

Definition at line 41 of file HelixHough_kappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 41 of file HelixHough_kappaRange_sse.cpp

Referenced by G4eplusAnnihilation::AtRestDoIt(), PHG4mRICHDetector::build_aerogel(), G4VEmProcess::BuildPhysicsTable(), G4VMultipleScattering::BuildPhysicsTable(), G4VEnergyLossProcess::BuildPhysicsTable(), CellularAutomaton_v1::calculate_kappa_tangents(), G4ILawTruncatedExp::ComputeNonInteractionProbabilityAt(), G4MultiNavigator::ComputeSafety(), G4PathFinder::ComputeSafety(), G4ITMultiNavigator::ComputeSafety(), G4ITPathFinder::ComputeSafety(), G4MultiNavigator::ComputeStep(), G4ITMultiNavigator::ComputeStep(), OpNoviceDetectorConstruction::Construct(), LXeDetectorConstruction::Construct(), CCalG4Ecal::constructIn(), G4EicDircDetector::ConstructMe(), G4EicDircDetector::DefineMaterials(), G4TwistBoxSide::DistanceToSurface(), G4TwistTrapAlphaSide::DistanceToSurface(), G4TwistTrapParallelSide::DistanceToSurface(), G4QMDMeanField::DoClusterJudgment(), G4PathFinder::DoNextLinearStep(), G4ITPathFinder::DoNextLinearStep(), ExGflashEventAction::EndOfEventAction(), G4AtimaFluctuations::EnergyTable_interpolate(), G4AtimaEnergyLossModel::EnergyTable_interpolate(), G4CreateCloneVTE(), G4gspos(), G4ITMultiNavigator::G4ITMultiNavigator(), G4ITPathFinder::G4ITPathFinder(), G4MultiNavigator::G4MultiNavigator(), G4PathFinder::G4PathFinder(), G4TrackState< G4ITMultiNavigator >::G4TrackState(), G4TrackState< G4ITPathFinder >::G4TrackState(), G4MultiNavigator::GetGlobalExitNormal(), G4ITMultiNavigator::GetGlobalExitNormal(), G4eBremsstrahlungRelModel::InitLPMFunctions(), G4PairProductionRelModel::InitLPMFunctions(), kspos(), ksposp(), nlohmann::detail::binary_reader< BasicJsonType, SAX >::little_endianess(), G4PathFinder::Locate(), G4ITPathFinder::Locate(), G4MultiNavigator::LocateGlobalPointAndSetup(), G4ITMultiNavigator::LocateGlobalPointAndSetup(), G4MultiNavigator::LocateGlobalPointWithinVolume(), G4ITMultiNavigator::LocateGlobalPointWithinVolume(), G4GMocrenIO::mergeDoseDist(), num_elem(), GMocrenDataPrimitive< T >::operator+(), GMocrenDataPrimitive< T >::operator+=(), GMocrenDataPrimitive< T >::operator=(), pevrec(), PG4gspos(), PG4gsposp(), G4VEmProcess::PostStepDoIt(), G4VEnergyLossProcess::PostStepDoIt(), G4MultiNavigator::PrepareNavigators(), G4ITMultiNavigator::PrepareNavigators(), G4PathFinder::PrepareNewTrack(), G4ITPathFinder::PrepareNewTrack(), G4MultiNavigator::PrintLimited(), G4PathFinder::PrintLimited(), G4ITMultiNavigator::PrintLimited(), G4ITPathFinder::PrintLimited(), fastvec::push_back(), G4PathFinder::ReLocate(), G4ITPathFinder::ReLocate(), G4MultiNavigator::ResetHierarchyAndLocate(), G4ITMultiNavigator::ResetHierarchyAndLocate(), G4ITMultiNavigator::ResetState(), simpleRandom::rnd(), G4ePolarizedBremsstrahlungModel::SampleSecondaries(), G4PolarizedGammaConversionModel::SampleSecondaries(), G4PolarizedPEEffectModel::SampleSecondaries(), ExGflashHit::SetCrystalNum(), WLSDetectorConstruction::SetNumberOfCladding(), PHG4HcalDetector::SetNumScint(), PHG4HcalSubsystem::SetNumScint(), G4EicDircDetector::SetQuantumEfficiency(), LXeMainVolume::SurfaceProperties(), Acts::Frustum< value_t, DIM, SIDES >::svg(), G4Torus::TorusRootsJT(), G4MultiNavigator::WhichLimited(), G4PathFinder::WhichLimited(), G4ITMultiNavigator::WhichLimited(), and G4ITPathFinder::WhichLimited().

phi_compare = _mm_and_ps(phisel, v_phi_p_pi02)

Definition at line 49 of file HelixHough_kappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 49 of file HelixHough_kappaRange_sse.cpp

phi_sign = _mm_and_ps((__m128)vec_sgn, v_phi)

Definition at line 18 of file HelixHough_kappaRange_sse.cpp.

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

__m128 phisel
Initial value:
{
__m128i vec_sgn = _mm_load_si128((__m128i*)sign_int)

Definition at line 15 of file HelixHough_kappaRange_sse.cpp.

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

__m128 pos_phi = _mm_xor_ps(phi_sign, v_phi)

Definition at line 19 of file HelixHough_kappaRange_sse.cpp.

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

__m128 pos_phi_m_pi = _mm_xor_ps(phi_sign, v_phi_m_pi)

Definition at line 24 of file HelixHough_kappaRange_sse.cpp.

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

__m128 pos_twopi_m_phi = _mm_xor_ps(phi_sign, v_twopi_m_phi)

Definition at line 29 of file HelixHough_kappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 29 of file HelixHough_kappaRange_sse.cpp

r1 = {0.,0.,0.,0.}

Definition at line 85 of file HelixHough_kappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 85 of file HelixHough_kappaRange_sse.cpp

Referenced by TrackEvaluation::add_truth_information(), Run::AddPhantomStep(), G4VSceneHandler::AddPrimitive(), G4Hype::ApproxDistOutside(), CLHEP::HepLorentzRotation::boostX(), G4hhElastic::CalculateBQ(), G4GenericPolycone::CalculateExtent(), G4Polycone::CalculateExtent(), G4PolyconeSide::CalculateExtent(), G4Torus::CalculateExtent(), G4PSDoseDepositForCylinder3D::ComputeVolume(), G4PSPassageCellFluxForCylinder3D::ComputeVolume(), G4PSCellFluxForCylinder3D::ComputeVolume(), G4EicDircDetector::ConstructMe(), PHG4HcalDetector::ConstructMe(), G4VRangeToEnergyConverter::ConvertCutToKineticEnergy(), G4FTFAnnihilation::Create3QuarkAntiQuarkStrings(), G4AdjointCrossSurfChecker::CrossingASphere(), CLHEP::HepBoostX::distance2(), CLHEP::HepBoostZ::distance2(), CLHEP::HepBoostY::distance2(), CLHEP::HepBoost::distance2(), CLHEP::HepLorentzRotation::distance2(), G4TwistTubsHypeSide::DistanceToSurface(), G4EnergyLossForExtrapolator::EnergyAfterStep(), G4EnergyLossForExtrapolator::EnergyBeforeStep(), CLHEP::Hep3Vector::eta(), example(), fgp3(), G4NuclearAbrasionGeometry::G4NuclearAbrasionGeometry(), generatez(), G4ContinuousGainOfEnergy::GetContinuousStepLimit(), AnnularFieldSim::GetGroupCellCenter(), G4QGSMFragmentation::GetLightConeZ(), G4MuonicAtomHelper::GetMuonCaptureRate(), G4MuonMinusBoundDecay::GetMuonCaptureRate(), G4Tet::GetPointOnSurface(), gett(), HepPolyhedronHype::HepPolyhedronHype(), HepPolyhedronParaboloid::HepPolyhedronParaboloid(), hijsft(), QAG4Util::interpolate(), G4PiNuclearCrossSection::Interpolate(), G4ComponentBarNucleonNucleusXsc::Interpolate(), CLHEP::HepBoostZ::isNear(), CLHEP::HepBoostX::isNear(), CLHEP::HepBoostY::isNear(), CLHEP::HepBoost::isNear(), CLHEP::HepLorentzRotation::isNear(), G4GenericTrap::NormalToPlane(), kdfinder::Helix< T >::pathLengths(), G4STRead::PhysvolRead(), BEmcRec::PredictEnergyParam(), PhantomSD::ProcessHits(), pymael(), pymirm(), pytecm(), G4InuclSpecialFunctions::randomGauss(), G4DNACPA100IonisationModel::RandomizeEjectedElectronEnergyFromCompositionSampling(), G4RPGReaction::Rotate(), CLHEP::Hep3Vector::rotate(), CLHEP::HepLorentzRotation::rotateY(), CLHEP::HepLorentzRotation::rotateZ(), Run::Run(), G4LivermoreGammaConversionModelRC::SampleSecondaries(), G4QGSParticipants::SampleX(), scan_mom(), CLHEP::Hep3Vector::setEta(), G4LivermorePolarizedGammaConversionModel::SetPhi(), G4LivermorePolarizedGammaConversionModel::SetPsi(), PHHybridSeeding::setSearchRadius(), G4GenericTrap::SurfaceNormal(), HelixHough::vote_pairs(), G4NucleiModel::zoneIntegralGaussian(), and G4NucleiModel::zoneIntegralWoodsSaxon().

r2 = {0.,0.,0.,0.}

Definition at line 86 of file HelixHough_kappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 86 of file HelixHough_kappaRange_sse.cpp

Referenced by G4VSceneHandler::AddPrimitive(), G4VMultipleScattering::AlongStepDoIt(), G4Hype::ApproxDistOutside(), CLHEP::HepLorentzVector::boost(), CLHEP::HepLorentzRotation::boostY(), G4hhElastic::CalculateBQ(), G4PolyconeSide::CalculateExtent(), G4Torus::CalculateExtent(), G4DNAMoleculeEncounterStepper::CalculateStep(), G4DNAMoleculeEncounterStepper::CheckAndRecordResults(), G4EicDircDetector::ConstructMe(), PHG4HcalDetector::ConstructMe(), G4FTFAnnihilation::Create3QuarkAntiQuarkStrings(), G4AdjointCrossSurfChecker::CrossingASphere(), CLHEP::HepLorentzRotation::distance2(), G4Hype::DistanceToIn(), G4Hype::DistanceToOut(), G4TwistTubsHypeSide::DistanceToSurface(), example(), fgp3(), G4INCL::OmegaNToPiNChannel::fillFinalState(), G4INCL::EtaNToPiNChannel::fillFinalState(), G4LineCurrentMagField::GetFieldValue(), G4DELPHIMagField::GetFieldValue(), G4QGSMFragmentation::GetLightConeZ(), getmass(), G4MuonicAtomHelper::GetMuonCaptureRate(), G4MuonMinusBoundDecay::GetMuonCaptureRate(), G4Hype::GetPointOnSurface(), G4Tet::GetPointOnSurface(), gett(), HepPolyhedronHype::HepPolyhedronHype(), HepPolyhedronParaboloid::HepPolyhedronParaboloid(), hijcsc(), hijing(), hijsft(), G4NucleiModel::initializeCascad(), G4CutTubs::Inside(), G4Tubs::Inside(), G4Cons::Inside(), G4PiNuclearCrossSection::Interpolate(), G4ComponentBarNucleonNucleusXsc::Interpolate(), intersect_circles(), CylindricalHough::intersect_circles(), CLHEP::HepLorentzRotation::isNear(), G4INCL::PiNToMultiPionsChannel::isospinRepartition(), luclus(), MCGIDI_KalbachMann_sampleEp(), G4GenericTrap::NormalToPlane(), G4INCL::ParticleEntryChannel::particleEnters(), G4INCL::TransmissionChannel::particleLeaves(), kdfinder::Helix< T >::pathLengths(), G4STRead::PhysvolRead(), BEmcRec::PredictEnergyParam(), eIDMLInterface::process_event(), PhantomSD::ProcessHits(), Acts::Legacy::AtlasSeedfinder< SpacePoint >::production3Sp(), pyclus(), pymael(), pymirm(), pytecm(), G4InuclSpecialFunctions::randomGauss(), G4DNACPA100IonisationModel::RandomizeEjectedElectronEnergyFromCompositionSampling(), G4RPGReaction::Rotate(), CLHEP::HepLorentzRotation::rotateX(), CLHEP::HepLorentzRotation::rotateZ(), Run::Run(), G4LivermoreGammaConversionModelRC::SampleSecondaries(), G4QGSParticipants::SampleX(), G4QMDGroundStateNucleus::samplingPosition(), scan_mom(), G4LivermorePolarizedGammaConversionModel::SetPhi(), G4LivermorePolarizedGammaConversionModel::SetPsi(), PHHybridSeeding::setSearchRadius(), G4GenericTrap::SurfaceNormal(), and G4Torus::TorusRootsJT().

reflection_max = _mm_or_ps(reflection_max, tmp1)

Definition at line 71 of file HelixHough_kappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 71 of file HelixHough_kappaRange_sse.cpp

reflection_min = _mm_or_ps(reflection_min, tmp1)

Definition at line 71 of file HelixHough_kappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 71 of file HelixHough_kappaRange_sse.cpp

__m128 sinval = {0.,0.,0.,0.}

Definition at line 37 of file HelixHough_kappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 37 of file HelixHough_kappaRange_sse.cpp

t = {0.,0.,0.,0.}

Definition at line 79 of file HelixHough_kappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 79 of file HelixHough_kappaRange_sse.cpp

Referenced by __attribute__(), G4MesonAbsorption::AbsorptionCrossSection(), Acts::AccumulatedMaterialProperties::accumulate(), TrackEvaluation::add_truth_information(), G4coutDestination::AddCerrTransformer(), G4coutDestination::AddCoutTransformer(), Run::AddSP(), Run::AddTrackLength(), G4VAtomDeexcitation::AlongStepDeexcitation(), G4eLowEnergyLoss::AlongStepDoIt(), alphas(), G4EmBiasingManager::ApplySecondaryBiasing(), G4LEpp::ApplyYourself(), G4HadronElastic::ApplyYourself(), G4ChargeExchange::ApplyYourself(), G4LMsdGenerator::ApplyYourself(), G4eplusAnnihilation::AtRestDoIt(), G4MuonMinusAtomicCapture::AtRestDoIt(), G4HadronStoppingProcess::AtRestDoIt(), G4EnergyLossForExtrapolator::AverageScatteringAngle(), avscatcen(), CLHEP::HepLorentzVector::boost(), Acts::Test::BOOST_AUTO_TEST_CASE(), G4NistMaterialBuilder::BuildMaterial(), G4VRangeToEnergyConverter::BuildRangeVector(), G4GEMProbability::CalcProbability(), FW::Obj::calculateBezierPoint(), G4MuonVDNuclearModel::CalculateEMVertex(), G4VViewer::G4Spline::CatmullRom_Eq(), G4ViewParameters::CatmullRomCubicSplineInterpolation(), G4ConvergenceTester::check_stat_history(), G4GeomTools::ClosestPointOnSegment(), G4UIGAG::CodeGenTclTree(), G4INCL::SigmaZeroDecayChannel::computeDecayTime(), Acts::computeEnergyLossLandau(), G4VViewer::ComputeFlyThrough(), G4WentzelOKandVIxSection::ComputeMaxElectronScattering(), RunAction::ComputeMscHighland(), Run::ComputeMscHighland(), G4INCL::NuclearPotential::NuclearPotentialEnergyIsospin::computePotentialEnergy(), G4INCL::NuclearPotential::NuclearPotentialEnergyIsospinSmooth::computePotentialEnergy(), G4INCL::Nucleus::computeSeparationEnergyBalance(), PHG4Sector::PHG4SectorConstructor::Construct_Sectors(), BEmcRecCEMC::CorrectPosition(), BEmcRecFEMC::CorrectPosition(), BEmcRecEEMC::CorrectPosition(), Acts::Seedfinder< external_spacepoint_t >::createSeedsForGroup(), G4ChipsHyperonInelasticXS::CrossSectionFormula(), G4ChipsKaonPlusInelasticXS::CrossSectionFormula(), G4DNADingfelderChargeIncreaseModel::CrossSectionPerVolume(), csz__huft_free(), csz__Inflate_block(), csz__Inflate_codes(), G4AnalyticalPolSolver::CubicRoots(), G4DalitzDecayChannel::DecayIt(), oncsSub_iduppetdata::decode(), oncsSub_iduppetdata_v104::decode(), Packet_idcdevdescr::decode(), deriv(), Acts::deriveEnergyLossLandauQOverP(), nlohmann::basic_json::json_value::destroy(), G4ErrorMatrix::dfact_matrix(), G4TriangularFacet::Distance(), G4VTwistSurface::DistanceToBoundary(), G4TwistTubsHypeSide::DistanceToSurface(), G4GenericTrap::DistToTriangle(), doCompression(), dokinematics(), Packet_idcdevdescr::dump(), CCalSteppingAction::endOfEvent(), CLHEP::HepStat::erfQ(), Par01EMShowerModel::Explode(), RawClusterBuilderTopo::export_clusters(), RawClusterBuilderTopo::export_single_cluster(), G4QuasiElRatios::FetchElTot(), G4VEnergyLossProcess::FillSecondariesAlongStep(), kdfinder::find_tracks(), HelixHough::findHelices(), G4JTPolynomialSolver::FindRoots(), CLHEP::RandPoisson::fire(), CLHEP::DualRand::flat(), fullMaterial(), g(), G4NucleusLimits::G4NucleusLimits(), G4Poisson(), G4QuadrangularFacet::G4QuadrangularFacet(), G4ParticleHPMadlandNixSpectrum::Gamma05(), G4INCL::Math::gaussianCDF(), G4RDGenerator2BN::Generate2BN(), G4SPSEneDistribution::GenerateBbodyEnergies(), G4INCL::StandardPropagationModel::generateBinaryCollisionAvatar(), G4SPSEneDistribution::GenerateCPowEnergies(), CLHEP::RandGamma::genGamma(), CLHEP::RandPoissonQ::get(), CLHEP::RandStudentT::get(), CLHEP::RandPoisson::get(), CLHEP::RandExponential::get(), CLHEP::RandChiSquare::get(), CLHEP::RandBinomial::get(), CLHEP::RandGamma::get(), CLHEP::RandExpZiggurat::get(), CLHEP::RandGauss::get(), CLHEP::RandGeneral::get(), CLHEP::RandBreitWigner::get(), CLHEP::RandFlat::get(), PHTimer::get_clock_counts(), G4UImanager::GetCurrentDoubleValue(), G4UImanager::GetCurrentIntValue(), G4NuclNuclDiffuseElastic::GetErf(), getinsudakov(), G4INCL::KinematicsUtils::getLocalEnergy(), getnatmdmin(), G4UIGainServer::GetNewTreeStructure(), G4UIGAG::GetNewTreeStructure(), G4UIGainServer::GetNewTreeValues(), G4UIGAG::GetNewTreeValues(), G4INCL::AllocationPool< T >::getObject(), getpnorad1(), G4Polyhedra::GetPointOnPlane(), G4Hype::GetPointOnSurface(), G4TrajectoryDrawerUtils::GetPointsAndTimes(), G4PenelopeBremsstrahlungModel::GetPositronXSCorrection(), getproba(), getqvec(), G4INCL::ParticleSampler::getRPCorrelationCoefficient(), G4INCL::ParticleTable::getRPCorrelationCoefficient(), Fun4AllUtils::GetRunSegment(), getscatterer(), getsscat(), CLHEP::NonRandomEngine::getState(), CLHEP::HepJamesRandom::getState(), CLHEP::Ranlux64Engine::getState(), getsudakov(), gett(), A_Event::getTime(), G4INCL::NuclearDensity::getTransmissionRadius(), gphoton(), kdfinder::CircleFit< T >::GradientHessian(), G4ParticleHPElementData::Harmonise(), G4ParticleHPChannel::Harmonise(), PHG4CylinderGeom_Spacalv3::ImportParameters(), G4BoldyshevTripletModel::Initialise(), G4DNASancheExcitationModel::Initialise(), G4PAIPhotData::Initialise(), G4PAIModelData::Initialise(), dfe::FlatSet< T, Compare, Container >::insert_or_assign(), G4TriangularFacet::Intersect(), Acts::AxisAlignedBoundingBox< entity_t, value_t, DIM >::intersect(), G4TessellatedGeometryAlgorithms::IntersectLineAndLineSegment2D(), G4INCL::PauliGlobal::isBlocked(), layerMaterial(), PHTruthClustering::line_circle_intersection(), SvtxTruthEval::line_circle_intersection(), G4INCL::Store::loadParticles(), main(), make_forward_station_basic(), make_GEM_station(), make_LANL_FST_station(), kdfinder::make_triplets(), Fun4AllHistoManager::makeHisto(), Mat_map(), md5_process(), G4ParticleHPVector::Merge(), G4hCoulombScatteringModel::MinPrimaryEnergy(), G4eCoulombScatteringModel::MinPrimaryEnergy(), PHHepMCGenEvent::moveVertex(), nf_incompleteGammaFunctionComplementary(), Acts::Logging::TimedOutputDecorator::now(), oamlBuffer::oamlBuffer(), FW::GaussianVertexGenerator::operator()(), operator*(), operator/(), CLHEP::operator>>(), kdfinder::Helix< T >::pathLength(), G4Bessel::pK0(), plot(), plot_map(), CLHEP::RandPoissonQ::poissonDeviateQuick(), CLHEP::possibleKeywordInput(), G4INCL::BinaryCollisionAvatar::postInteraction(), G4HadronElasticProcess::PostStepDoIt(), G4NeutrinoElectronProcess::PostStepDoIt(), G4MuNeutrinoNucleusProcess::PostStepDoIt(), G4GammaConversionToMuons::PostStepDoIt(), G4VEmProcess::PostStepDoIt(), G4VEnergyLossProcess::PostStepDoIt(), PHG4Hitv1::print(), G4GEMProbabilityVI::ProbabilityDistributionFunction(), RawClusterBuilderTopo::process_event(), ParticleFlowReco::process_event(), DetermineTowerBackground::process_event(), PHG4MicromegasHitReco::process_event(), PHGenFitTrkFitter::process_event(), TpcDirectLaserReconstruction::process_track(), Acts::Legacy::AtlasSeedfinder< SpacePoint >::production3Sp(), G4ParticleChangeForDecay::ProposeLocalTime(), CLHEP::RandPoissonQ::put(), CLHEP::RandStudentT::put(), CLHEP::RandPoisson::put(), CLHEP::NonRandomEngine::put(), CLHEP::RandExponential::put(), CLHEP::RandChiSquare::put(), CLHEP::RandBinomial::put(), CLHEP::RandGamma::put(), CLHEP::HepJamesRandom::put(), CLHEP::Ranlux64Engine::put(), CLHEP::RandExpZiggurat::put(), CLHEP::RandGauss::put(), CLHEP::RandGeneral::put(), CLHEP::RandBreitWigner::put(), CLHEP::RandFlat::put(), pygfxx(), pyhistfu(), pypdga(), pypdpo(), pypole(), pyprep(), pyr(), pyreco(), pystfu(), pysubh(), pythag(), G4JTPolynomialSolver::QuadraticPolynomialIteration(), G4DNAMillerGreenExcitationModel::R(), G4DNARuddIonisationModel::R(), G4DNARuddIonisationExtendedModel::R(), G4DNACPA100IonisationModel::RandomizeEjectedElectronEnergyFromCompositionSampling(), G4AdjointhIonisationModel::RapidSampleSecondaries(), G4JTPolynomialSolver::RealPolynomialIteration(), G4coutDestination::ReceiveG4cerr_(), kdfinder::LinearFit< T >::RegularFit(), G4INCL::UnorderedVector< IAvatar * >::remove(), nlohmann::json_pointer< BasicJsonType >::replace_substring(), CLHEP::RandGauss::restoreDistState(), CLHEP::RandGauss::restoreEngineStatus(), rlu(), FW::RootMaterialDecorator::RootMaterialDecorator(), G4Scintillation::sample_time(), G4hhElastic::SampleBisectionalT(), G4NuclNuclDiffuseElastic::SampleCoulombMuCMS(), G4Generator2BN::SampleDirection(), G4LEpp::SampleInvariantT(), G4LEnp::SampleInvariantT(), G4ChipsElasticModel::SampleInvariantT(), G4LEHadronProtonElastic::SampleInvariantT(), G4NuclNuclDiffuseElastic::SampleInvariantT(), G4DiffuseElasticV2::SampleInvariantT(), G4hhElastic::SampleInvariantT(), G4DiffuseElastic::SampleInvariantT(), G4INCL::ParticleSampler::sampleOneParticleWithoutRPCorrelation(), G4eeToHadronsModel::SampleSecondaries(), G4VEnergyLossProcess::SampleSubCutSecondaries(), G4ChargeExchange::SampleT(), G4LMsdGenerator::SampleT(), G4NuclNuclDiffuseElastic::SampleT(), G4DiffuseElastic::SampleT(), G4NuclNuclDiffuseElastic::SampleTableT(), G4DiffuseElasticV2::SampleTableT(), G4DiffuseElastic::SampleTableT(), G4hhElastic::SampleTest(), G4NuclNuclDiffuseElastic::SampleThetaLab(), G4DiffuseElastic::SampleThetaLab(), CLHEP::RandGauss::saveDistState(), CLHEP::RandGauss::saveEngineStatus(), scatprimfunc(), BbcVertexv1::set_t(), GlobalVertexv1::set_t(), PHG4ParticleGeneratorBase::set_t0(), PHG4CylinderGeomv1::set_thickness(), PHG4CylinderCellGeom::set_thickness(), RawTowerGeomContainer_Cylinderv1::set_thickness(), RawTowerZDCv1::set_time(), RawTowerv1::set_time(), PHHepMCGenHelper::set_vertex_distribution_function(), PHHepMCGenHelper::set_vertex_distribution_mean(), PHHepMCGenHelper::set_vertex_distribution_width(), doiPETRun::SetAnnihilationTime(), WLSPhotonDetHit::SetArrivalTime(), PHTimeStamp::setBinTics(), G4INCL::Book::setCurrentTime(), G4INCL::Config::setDecayTimeThreshold(), G4QMDReaction::SetDT(), G4HeatedKleinNishinaCompton::SetElectronTemperature(), G4INCL::Particle::setEmissionTime(), G4INCL::Book::setFirstCollisionTime(), G4HadProjectile::SetGlobalTime(), InteractionInformation::SetGlobalTime(), G4INCL::Config::setHadronizationTime(), G4GMocrenIO::setID(), G4INCL::Config::setLocalEnergyBBType(), G4INCL::Config::setLocalEnergyPiType(), HistoMessenger::SetNewValue(), DMXStackingActionMessenger::SetNewValue(), DMXEventActionMessenger::SetNewValue(), G4EmExtraParametersMessenger::SetNewValue(), G4WorkerThread::SetPinAffinity(), LXeEventAction::SetPMTThreshold(), G4PrimaryParticle::SetProperTime(), G4INCL::ParticleSampler::setRPCorrelationCoefficient(), CLHEP::HepJamesRandom::setSeed(), G4TessellatedSolid::SetSolidClosed(), G4NuclideTable::SetThresholdOfHalfLife(), B5DriftChamberHit::SetTime(), G4MCTSimVertex::SetTime(), DMXPmtHit::SetTime(), G4ReactionProduct::SetTOF(), G4GHEKinematicsVector::SetTOF(), CLHEP::Hep4RotationInterface::setTolerance(), Run::SetTrackLength(), G4INCL::IAvatar::setType(), G4INCL::Particle::setType(), CLHEP::RandPoissonQ::setupForDefaultMu(), CLHEP::RandPoisson::shoot(), CLHEP::RandPoissonQ::shoot(), kdfinder::CircleFit< T >::SigmaWithLargeCircleOption(), G4TrajectoryDrawerUtils::SliceLine(), G4Torus::SolveNumericJT(), G4UImessenger::StoD(), G4UImessenger::StoI(), G4UImessenger::StoL(), subcrs1(), subcrs2(), subcrs3(), subcrs4(), subcrs5(), subcrs6(), subcrs7(), G4MTRunManager::TerminateWorkers(), nlohmann::detail::to_json_tuple_impl(), nlohmann::detail::lexer< BasicJsonType >::token_type_name(), G4ErrorMatrix::trace(), G4ErrorSymMatrix::trace(), c2_tan_p< float_type >::value_with_derivatives(), FW::RootMaterialWriter::write(), FW::Obj::writeTube(), simpleRandom::xMD5Update(), G4UIparameter::Yylex(), and G4UIcommand::Yylex().

__m128 tanphi = _mm_div_ps(num, denom)

Definition at line 14 of file HelixHough_kappaRange_sse.cpp.

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

Referenced by main().

tmp1 = _mm_mul_ps(uy, y)

Definition at line 94 of file HelixHough_kappaRange_sse.cpp.

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

tmp2 = _mm_cmplt_ps(pos_phi_m_pi, pi_over_four)

Definition at line 32 of file HelixHough_kappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 32 of file HelixHough_kappaRange_sse.cpp

tmp3 = _mm_mul_ps(tanphi, tanphi)

Definition at line 52 of file HelixHough_kappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 52 of file HelixHough_kappaRange_sse.cpp

tmp4 = _mm_cmplt_ps(phi_compare, twopi)

Definition at line 57 of file HelixHough_kappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 57 of file HelixHough_kappaRange_sse.cpp

tP = {0.,0.,0.,0.}

Definition at line 80 of file HelixHough_kappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 80 of file HelixHough_kappaRange_sse.cpp

Referenced by G4LENDModel::ApplyYourself(), and G4LENDElastic::ApplyYourself().

__m128 ux = _mm_and_ps(phisel, tmp3)

Definition at line 14 of file HelixHough_kappaRange_sse.cpp.

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

ux_sign = _mm_and_ps((__m128)vec_sgn, ux)

Definition at line 136 of file HelixHough_kappaRange_sse.cpp.

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

__m128 uy = _mm_and_ps(phisel, tmp4)

Definition at line 14 of file HelixHough_kappaRange_sse.cpp.

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

uy_sign = _mm_and_ps((__m128)vec_sgn, uy)

Definition at line 141 of file HelixHough_kappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 141 of file HelixHough_kappaRange_sse.cpp

void __m128 __m128 __m128 __m128 v_maxd

Definition at line 71 of file HelixHough_kappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 71 of file HelixHough_kappaRange_sse.cpp

v_maxk = _mm_and_ps(tmp1, invr1)

Definition at line 71 of file HelixHough_kappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 71 of file HelixHough_kappaRange_sse.cpp

void __m128 __m128 __m128 v_mind

Definition at line 71 of file HelixHough_kappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 71 of file HelixHough_kappaRange_sse.cpp

v_mink = _mm_and_ps(tmp1, invr2)

Definition at line 71 of file HelixHough_kappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 71 of file HelixHough_kappaRange_sse.cpp

void __m128 __m128 v_phi

Definition at line 71 of file HelixHough_kappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 71 of file HelixHough_kappaRange_sse.cpp

Referenced by Fill().

__m128 v_phi_m_pi = _mm_sub_ps(v_phi, pi)

Definition at line 22 of file HelixHough_kappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 22 of file HelixHough_kappaRange_sse.cpp

__m128 v_phi_p_pi02 = _mm_add_ps(v_phi, pi_over_two)

Definition at line 48 of file HelixHough_kappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 48 of file HelixHough_kappaRange_sse.cpp

__m128 v_twopi_m_phi = _mm_sub_ps(twopi, v_phi)

Definition at line 27 of file HelixHough_kappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 27 of file HelixHough_kappaRange_sse.cpp

__m128i vec_ones = _mm_load_si128((__m128i*)allones)

Definition at line 88 of file HelixHough_kappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 88 of file HelixHough_kappaRange_sse.cpp

__m128i vec_sgn = _mm_load_si128((__m128i*)sign_int)

Definition at line 89 of file HelixHough_kappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 89 of file HelixHough_kappaRange_sse.cpp

void __m128 y

Definition at line 71 of file HelixHough_kappaRange_sse.cpp.

View newest version in sPHENIX GitHub at line 71 of file HelixHough_kappaRange_sse.cpp