EIC Software
Reference for
EIC
simulation and reconstruction software on GitHub
|
#include "HelixHough.h"
#include "vector_math_inline.h"
#include <emmintrin.h>
#include <xmmintrin.h>
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 |
|
inlinestatic |
_vec_sin_cos_ps | ( | phi | , |
sn | , | ||
cs | |||
) |
Referenced by dfe::Dispatcher::add(), AnalyzeSimpleTree::AnalyzeSimpleTree(), RawTowerv1::identify(), PHG4CylinderGeom::ImportParameters(), MySimpleTree::MySimpleTree(), pprocess(), prun(), MyTClonesArray::Reset(), MySimpleTree::Reset(), and MyTClonesArray::~MyTClonesArray().
|
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
|
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
|
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__(), EICG4dRICHDetector::ActivateVolumeTree(), Nystrom::adaptiveStep(), MultiArray< TVector3 >::Add(), AddLayers_MiniTPCDrift(), aiz(), ALICEKF::ALICEKalmanFilter(), AnalyticFieldModel::AnalyticFieldModel(), ar3jet(), biz(), bsfint(), EtmDetector::Build(), KFParticle_eventReconstruction::buildChain(), CbmRichRingFitterCOPLight::CalcChi2(), CbmRichRingFitterBase::CalcChi2(), calcta(), HelixKalman::calculate_dAdAp(), HelixKalmanFilter::calculate_dAdAp(), CylinderKalman::calculate_dxda(), HelixKalmanFilter::calculate_dxda(), HelixHoughFuncs_v1::calculate_dzdl_range(), HelixHoughFuncs_v1::calculate_phi_range(), HelixDCAFunc::calcValGradHessian(), VertexFitFunc::calcValGradHessian(), calcxsection(), tetgenmesh::checkseg4split(), Acts::GenericCuboidVolumeBounds::construct(), PHInitZVertexing::convertHelixCovarianceToEuclideanCovariance(), PHPatternReco::convertHelixCovarianceToEuclideanCovariance(), PHHoughSeeding::convertHelixCovarianceToEuclideanCovariance(), converttohepmc(), Acts::AtlasStepper< bfield_t >::covarianceTransport(), Acts::GaussianGridTrackDensity< mainGridSize, trkGridSize >::createTrackGrid(), PHSimpleVertexFinder::dcaTwoLines(), oncsSub_iddrs4v1::decode(), oncsSub_idsrs_v01::decode(), oncsSub_idfnalmwpc::decode(), oncsSub_idfnalmwpcv2::decode(), oncsSub_iddreamv0::decode(), CbmRichRingFinderHoughImpl::DefineLocalAreaAndHits(), deltas(), RawTowerBuilder::Detector(), RawClusterBuilderGraph::Detector(), RawClusterBuilderTemplate::Detector(), RawClusterBuilderFwd::Detector(), HcalRawTowerBuilder::Detector(), PHG4MvtxHitReco::Detector(), RawTowerDeadTowerInterp::detector(), RawTowerDigitizer::Detector(), RawTowerZDCDigitizer::Detector(), PHG4InttHitReco::Detector(), RawTowerZDCCalibration::Detector(), PHG4ForwardCalCellReco::Detector(), RawTowerCalibration::Detector(), PHG4HcalCellReco::Detector(), RawTowerBuilderByHitIndex::Detector(), PHG4BlockCellReco::Detector(), PHG4InttDigitizer::Detector(), B0RawTowerBuilderByHitIndex::Detector(), BwdRawTowerBuilderByHitIndex::Detector(), RawTowerBuilderByHitIndexBECAL::Detector(), RawTowerBuilderByHitIndexLHCal::Detector(), RawTowerBuilderDRCALO::Detector(), EICG4ZDCRawTowerBuilderByHitIndex::Detector(), PHG4CylinderCellReco::Detector(), RawClusterBuilderHelper::Detector(), PHG4FullProjSpacalCellReco::Detector(), PHG4TpcDirectLaser::Detector(), PHG4TpcCentralMembrane::Detector(), PHG4TpcElectronDrift::Detector(), RawDigitBuilderTTL::Detector(), RawTowerCombiner::Detector(), dfint(), dfintnew(), FairGeoRotation::diff2(), Acts::BoundaryCheck::distance(), CbmRichRingFitterRobustCOP::DoFit(), CbmRichRingFitterTAU::DoFit(), doinstatescat(), dokinematics(), dqn32(), Acts::GenericCuboidVolumeBounds::draw(), Acts::AxisAlignedBoundingBox< entity_t, value_t, DIM >::draw(), nlohmann::detail::serializer< BasicJsonType >::dump_float(), HelixHough::dzdlRange_sse(), eix(), eixint(), LiteCaloEval::End(), expai(), expaid(), PHInitZVertexing::export_output(), PHPatternReco::export_output(), PHHoughSeeding::export_output(), fdilut(), ffhe3(), ffhe4(), sPHENIXTrackerTpc::finalize(), HelixHough::findSeededHelices(), fit_all_update(), ZHough_Cylindrical::fitTrack(), VtxTrackFinder::fitTrack(), ThreeHitSeedGrower::fitTrack(), NHitSeedFinder::fitTrack(), FourHitSeedFinder::fitTrack(), sPHENIXTrackerTpc::fitTrack(), sPHENIXTracker::fitTrack(), sPHENIXSeedFinder::fitTrack(), FourHitSeedFinder::fitTrackLine(), fspen(), fspens(), fv(), fw(), fws(), RawTowerBuilderDRCALO::GeometryTableFile(), RawTowerBuilderByHitIndex::GeometryTableFile(), B0RawTowerBuilderByHitIndex::GeometryTableFile(), BwdRawTowerBuilderByHitIndex::GeometryTableFile(), RawTowerBuilderByHitIndexBECAL::GeometryTableFile(), RawTowerBuilderByHitIndexLHCal::GeometryTableFile(), EICG4ZDCRawTowerBuilderByHitIndex::GeometryTableFile(), MultiArray< TVector3 >::Get(), Packet_A::getCheckSumStatus(), getdeltat(), getinsudafast(), getinsudakov(), getinsudared(), getltimemax(), getmdmin(), getnatmdmin(), getneff(), getneffmax(), getpdf(), getpdfxintexact(), getpnorad1(), MultiArray< TVector3 >::GetPtr(), getqvec(), getscatterer(), getsscat(), getsudakov(), gettemp(), gettempmax(), nlohmann::detail::dtoa_impl::grisu2_digit_gen(), grv98pa(), hijwds(), tetgenmesh::hilbert_init(), tetgenmesh::hilbert_split(), i1mcry(), tetgenmesh::incircle3d(), insudaint(), intersect_circles(), CylindricalHough::intersect_circles(), Acts::detail::IntersectionHelper2D::intersectEllipse(), Acts::detail::IntersectionHelper2D::intersectSegment(), FairUtilString::IsFloat(), FairUtilString::IsInt(), nanoflann::KDTreeEigenMatrixAdaptor< MatrixType, DIM, Distance >::kdtree_distance(), GFDetPlane::LabToPlane(), layerMaterial(), lmeps(), lustrf(), lxsect(), lysspa(), lzp(), main(), makebranch(), HelixHough::makeClusters(), makestrings_minl(), md5_process(), medderiv(), medinit(), mednextevt(), mkf2(), MovePointArc(), MovePointLinear(), MovePointPower(), MovePointPowerSeries(), MovePointPowerSeries2(), MovePointSinus(), mrs99(), mrs991(), mrs9910(), mrs9911(), mrs9912(), mrs992(), mrs993(), mrs994(), mrs995(), mrs996(), mrs997(), mrs998(), mrs999(), mrseb(), MultiArray< TVector3 >::MultiArray(), npart(), nthick(), Acts::MaterialInteractor::operator()(), nanoflann::L1_Adaptor< T, DataSource, _DistanceType >::operator()(), nanoflann::L2_Adaptor< T, DataSource, _DistanceType >::operator()(), FairGeoMatrix::operator/=(), Acts::GenericCuboidVolumeBounds::orientedSurfaces(), PHG4CylinderCellReco::OutputDetector(), parpol(), parpolnew(), Smear::ParseInputFunction(), kdfinder::Helix< T >::pathLength(), kdfinder::Helix< T >::pathLengths(), pdfint(), pepsimainerhic(), perinola(), PHRTreeSeeding::phidiff(), PHIODataNode< T >::PHIODataNode(), HelixHough::phiRange_sse(), polint(), polint5(), polint6(), pollzp(), sPHENIXTracker::projectToLayer(), sPHENIXSeedFinder::projectToLayer(), py3ent(), py4ent(), pyalem(), pyangl(), pyapps(), pyboei(), pycell(), pycjdc(), pyclus(), pycteq(), pydecy(), pydisg(), pydocu(), pyedit(), pyeig4(), pyevnt(), pyevnw(), pyevol(), pyfint(), pygaga(), pygau2(), pygaus(), pygbeh(), pygdir(), 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(), qqt(), FairDbConfDialog::Query(), r1990(), FairGenericParAsciiFileIo::readData(), FairGeoAsciiIo::readDetectorSetup(), FairDbConf::RegistryToString(), kdfinder::LinearFit< T >::rofunc(), GPUTPCTrackParam::Rotate(), TPCFEETestRecov1::roughZeroSuppression(), rv2(), serai(), seraid(), FairDbConfigurable::Set(), MultiArray< TVector3 >::Set(), HcalRawTowerBuilder::set_cell_decal_factor(), EvalRootTTree::set_cesum(), EventEvaluator::set_depth_MCstack(), EventEvaluatorEIC::set_depth_MCstack(), PHG4GenHit::set_eloss(), EvalRootTTree::set_geta(), EvalRootTTree::set_gphi(), EvalRootTTree::set_gtheta(), EvalRootTTree::set_hesum(), PHG4GenHit::set_phi(), RawTowerZDCDigitizer::set_sipm_effective_pixel(), RawTowerDigitizer::set_sipm_effective_pixel(), EvalRootTTree::set_tesum(), PHG4GenHit::set_theta(), HcalRawTowerBuilder::set_tower_decal_factor(), HcalRawTowerBuilder::set_tower_decal_factor_real(), CbmRichRingLight::SetABCDEF(), PndTrack::SetChi2(), PndTrack::SetChiSquareCCDF(), PHDataNode< PHDWORD >::setData(), FairGeoMedium::setDensity(), GFTrackCand::setDip(), CbmRichRing::SetDistance(), Smear::Device::SetDistribution(), CbmRichRing::SetDPar(), FairVolume::setGeoNode(), GFKalman::setInitialDirection(), GFPseudoSpacepointWireHitPolicy::setMaxDistance(), GFWirepointHitPolicy::setMaxDistance(), GFWireHitPolicy::setMaxDistance(), genfit::WireMeasurement::setMaxDistance(), genfit::WireMeasurementNew::setMaxDistance(), surface_t::setNormal(), Smear::ParticleMCS::SetNumSigma(), Smear::ParticleID::SetPIDUseMC(), GeaneTrackRep::setPropDir(), splitfncint(), strc10(), strc11(), strc20(), strc21(), FairDbConf::StringToRegistry(), EICG4ZDCRawTowerBuilderByHitIndex::SubDetector(), GFDetPlane::toLab(), genfit::DetPlane::toLab(), FairGeanePro::Track2ToPoint(), trackProximity(), GPUTPCTrackParam::TransportToX(), trkDist(), CylinderKalman::updateIntersection(), HelixKalmanFilter::updateIntersection(), vacpol(), vegas(), wdsax(), 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 |
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().
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 genfit::RKTrackRep::extrapolateToCone().
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(), and genfit::RKTrackRep::extrapolateToCone().
__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 b0tracker(), HelixKalman::calculate_dAdAp(), HelixKalmanFilter::calculate_dAdAp(), HelixHoughFuncs_v1::calculate_dzdl_range(), EicToyModel::CalculateDefaultEtaBoundaries(), EicToyModel::CalculateEtaEndPoint(), HelixDCAFunc::calcValGradHessian(), FairGeoTrap::calcVoluParam(), kdfinder::CircleFit< T >::ChiSqr(), kdfinder::CircleFit< T >::CircleFitByChernovHoussam(), Collimator::Collimator(), FstGeoParData::ConstructGeometry(), G4EicDircDetector::ConstructMe(), EicPndFieldMap::Contains(), BEmcRecCEMC::CorrectPosition(), CreateBoundaryLayer(), CreateBoundaryLayerDivide(), CreateKnots(), CylindricalCoordinateTransformation(), dfufi_pol(), CbmRichRingFitterRobustCOP::DoFit(), dr1998(), HelixHough::dzdlRange_sse(), fbst(), fdilut(), FindPeriodicNodes(), 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(), fv(), fws(), PHG4TpcDistortion::get_x_distortion_cartesian(), PndFieldMap::GetBx(), PndTransMap::GetBxyz(), PndDipoleMap::GetBxyz(), PndSolenoidMap::GetBxyz(), PndFieldMap::GetBy(), PndFieldMap::GetBz(), GPUTPCTrackParam::GetDCAPoint(), GPUTPCTrackParam::GetDist2(), GPUTPCTrackParam::GetDistXZ2(), EmcCluster::GetSubClusters(), kdfinder::CircleFit< T >::GradientHessian(), grv94di(), grv94ho(), grv94lo(), hcal(), hijcsc(), CbmRichRingFinderHoughSimd::HoughTransformGroup(), EicBeamLineElementMap::Initialize(), PHG4Utils::line_and_rectangle_intersect(), lmprin(), lzp(), main(), make_single_tower(), MergeElements(), mkasym(), mkf2(), mkr(), PHSimpleKFProp::MoveToFirstTPCCluster(), Acts::Test::MeasurementCreator::operator()(), kdfinder::CircleFit< T >::OptimalRadius(), parton(), kdfinder::Helix< T >::pathLength(), kdfinder::Helix< T >::pathLengths(), pepsimainerhic(), phidst_pol(), pollzp(), BEmcRec::PredictEnergy(), BEmcRec::PredictEnergyParam(), BEmcRec::PredictEnergyProb(), PHG4BlockCellReco::process_event(), PHG4CylinderCellReco::process_event(), PHTpcTrackSeedCircleFit::process_event(), Acts::Legacy::AtlasSeedfinder< SpacePoint >::production3Sp(), Nystrom::propagate(), pyboei(), pygamm(), pygrvd(), pygrvl(), pygrvm(), pygrvs(), pygrvv(), pyhigamm(), pymsin(), pyqqbh(), quench(), r1998(), radquad_pol(), ReorderAutomatic(), ReorderElements(), Acts::TGeoParser::select(), SeparateCartesianBoundaries(), SeparateMainaxisBoundaries(), PHG4ParticleGeneratorVectorMeson::set_decay_vertex_offset(), RawTowerGeomv2::set_size_x(), RawTowerZDCGeomv1::set_size_x(), RawTowerGeomv3::set_size_x(), ActsFatras::Particle::setDirection(), FairHit::SetDx(), FairTrackPar::SetDX(), CbmPixelHit::SetDx(), FairHit::SetDxyz(), SetElementDivision(), PHG4EICForwardEcalDetector::SetTowerDimensions(), PHG4ForwardEcalDetector::SetTowerDimensions(), PHG4ForwardDualReadoutDetector::SetTowerDimensions(), PHInitZVertexing::shift_coordinate_system(), PHPatternReco::shift_coordinate_system(), PHHoughSeeding::shift_coordinate_system(), kdfinder::CircleFit< T >::Sigma(), kdfinder::CircleFit< T >::SigmaWithLargeCircleOption(), Acts::EventDataView3DTest::testMultiTrajectory(), FairGeanePro::Track3ToLine(), GPUTPCTrackParam::TransportToX(), vegas(), photonNucleusLuminosity::vmsigmapt(), and zdc().
Definition at line 162 of file HelixHough_allButKappaRange_sse.cpp.
View newest version in sPHENIX GitHub at line 162 of file HelixHough_allButKappaRange_sse.cpp
__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 HelixKalman::calculate_dAdAp(), HelixKalmanFilter::calculate_dAdAp(), HelixHoughFuncs_v1::calculate_dzdl_range(), HelixDCAFunc::calcValGradHessian(), kdfinder::CircleFit< T >::ChiSqr(), kdfinder::CircleFit< T >::CircleFitByChernovHoussam(), Collimator::Collimator(), G4EicDircDetector::ConstructMe(), EicPndFieldMap::Contains(), CreateBoundaryLayer(), CreateBoundaryLayerDivide(), CreateKnots(), CylindricalCoordinateTransformation(), CbmRichRingFitterRobustCOP::DoFit(), EicToyModel::DrawMarkers(), HelixHough::dzdlRange_sse(), FindPeriodicNodes(), 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(), PHG4TpcDistortion::get_y_distortion_cartesian(), PndFieldMap::GetBx(), PndTransMap::GetBxyz(), PndDipoleMap::GetBxyz(), PndSolenoidMap::GetBxyz(), PndFieldMap::GetBy(), PndFieldMap::GetBz(), GPUTPCTrackParam::GetDCAPoint(), GPUTPCTrackParam::GetDist2(), EmcCluster::GetSubClusters(), kdfinder::CircleFit< T >::GradientHessian(), hijcsc(), CbmRichRingFinderHoughSimd::HoughTransformGroup(), EicBeamLineElementMap::Initialize(), PHG4Utils::line_and_rectangle_intersect(), main(), MergeElements(), PHSimpleKFProp::MoveToFirstTPCCluster(), Acts::Test::MeasurementCreator::operator()(), kdfinder::CircleFit< T >::OptimalRadius(), kdfinder::Helix< T >::pathLength(), kdfinder::Helix< T >::pathLengths(), phidst_pol(), polint(), polint5(), polint6(), BEmcRec::PredictEnergy(), BEmcRec::PredictEnergyParam(), BEmcRec::PredictEnergyProb(), PHG4BlockCellReco::process_event(), PHG4CylinderCellReco::process_event(), PHTpcTrackSeedCircleFit::process_event(), Acts::Legacy::AtlasSeedfinder< SpacePoint >::production3Sp(), Nystrom::propagate(), pymsin(), pyplot(), quench(), radquad_pol(), ReorderAutomatic(), ReorderElements(), Acts::TGeoParser::select(), SeparateCartesianBoundaries(), SeparateMainaxisBoundaries(), PHG4ParticleGeneratorVectorMeson::set_decay_vertex_offset(), RawTowerGeomv2::set_size_y(), RawTowerZDCGeomv1::set_size_y(), RawTowerGeomv3::set_size_y(), ActsFatras::Particle::setDirection(), FairHit::SetDxyz(), FairHit::SetDy(), FairTrackPar::SetDY(), CbmPixelHit::SetDy(), SetElementDivision(), PHG4EICForwardEcalDetector::SetTowerDimensions(), PHG4ForwardEcalDetector::SetTowerDimensions(), PHG4ForwardDualReadoutDetector::SetTowerDimensions(), PHInitZVertexing::shift_coordinate_system(), PHPatternReco::shift_coordinate_system(), PHHoughSeeding::shift_coordinate_system(), kdfinder::CircleFit< T >::Sigma(), kdfinder::CircleFit< T >::SigmaWithLargeCircleOption(), Acts::EventDataView3DTest::testMultiTrajectory(), GPUTPCTrackParam::TransportToX(), and PHG4ZDCSteppingAction::UserSteppingAction().
Definition at line 163 of file HelixHough_allButKappaRange_sse.cpp.
View newest version in sPHENIX GitHub at line 163 of file HelixHough_allButKappaRange_sse.cpp
Referenced by kdfinder::CircleFit< T >::CircleFitByHyper(), kdfinder::CircleFit< T >::CircleFitByPratt(), ALICEKF::CircleFitByTaubin(), PHTpcClusterMover::CircleFitByTaubin(), PHTruthTrackSeeding::circleFitByTaubin(), PHActsSiliconSeeding::circleFitByTaubin(), kdfinder::CircleFit< T >::CircleFitByTaubin(), CbmRichRingFitterCOPLight::DoFit(), CbmRichRingFitterRobustCOP::DoFit(), CbmRichRingFitterTAU::DoFit(), and CbmRichRingFitterCOP::FitRing().
Definition at line 138 of file HelixHough_allButKappaRange_sse.cpp.
View newest version in sPHENIX GitHub at line 138 of file HelixHough_allButKappaRange_sse.cpp
Referenced by HelixKalman::calculate_dAdAp(), HelixKalmanFilter::calculate_dAdAp(), CylinderKalman::calculate_dxda(), HelixKalmanFilter::calculate_dxda(), CellularAutomaton_v1::calculate_kappa_tangents(), sPHENIXTrackerTpc::calculateKappaTangents(), sPHENIXTracker::calculateKappaTangents(), sPHENIXSeedFinder::calculateKappaTangents(), HelixHough::dzdlRange_sse(), FindBoundaryBoundary(), FindBulkBoundary(), CellularAutomaton_v1::process_single_track(), and CellularAutomaton_v1::process_single_triplet().
Definition at line 142 of file HelixHough_allButKappaRange_sse.cpp.
View newest version in sPHENIX GitHub at line 142 of file HelixHough_allButKappaRange_sse.cpp
Referenced by CylindricalHough::addHits(), HelixKalman::calculate_dAdAp(), HelixKalmanFilter::calculate_dAdAp(), HelixKalman::calculate_dApdp(), HelixKalmanFilter::calculate_dApdp(), CylinderKalman::calculate_dxda(), HelixKalmanFilter::calculate_dxda(), HelixHoughFuncs_v1::calculate_dzdl_range(), HelixDCAFunc::calcValGradHessian(), PHInitZVertexing::convertHelixCovarianceToEuclideanCovariance(), PHPatternReco::convertHelixCovarianceToEuclideanCovariance(), PHHoughSeeding::convertHelixCovarianceToEuclideanCovariance(), PHInitZVertexing::export_output(), PHPatternReco::export_output(), PHHoughSeeding::export_output(), HelixHough::findSeededHelices(), FourHitSeedFinder::findTracks_3_4(), ZHough_Cylindrical::fitTrack(), VtxTrackFinder::fitTrack(), ThreeHitSeedGrower::fitTrack(), NHitSeedFinder::fitTrack(), FourHitSeedFinder::fitTrack(), sPHENIXTrackerTpc::fitTrack(), sPHENIXTracker::fitTrack(), sPHENIXSeedFinder::fitTrack(), FourHitSeedFinder::fitTrackLine(), main(), sPHENIXTracker::projectToLayer(), sPHENIXSeedFinder::projectToLayer(), CylinderKalman::updateIntersection(), and HelixKalmanFilter::updateIntersection().
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
|
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(), lscale(), ludecy(), luprep(), lustrf(), pydecy(), pyfscr(), pymihk(), pymirm(), pyprep(), pyreco(), and pystrf().
__m128 __m128 __m128 __m128& 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
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
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(), GPUTPCTrackParam::CalculateFitParameters(), EventSelectionModule::execute(), genfit::RKTrackRep::extrapolateToCone(), genfit::RKTrackRep::extrapolateToCylinder(), genfit::RKTrackRep::extrapolateToSphere(), ActsExamples::RandomNumbers::generateSeed(), LoadTriangleInput(), lqev(), lqgev(), lremh(), pyqqbh(), pysugi(), rk4step(), RungeKuttaRequest::serveRequest(), and Nystrom::step().
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
Referenced by lysspa().
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 |
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__(), Acts::VolumeConfig::adaptR(), Acts::VolumeConfig::adaptZ(), gbl::BorderedBandMatrix::addBlockMatrix(), EicGeoParData::AddLogicalVolumeGroup(), FwdHoughTree::AddNodeGroup(), Acts::adjustBinUtility(), AerogelInit(), Acts::CylinderVolumeBuilder::analyzeContent(), approx(), arorie(), attrad(), gbl::BorderedBandMatrix::bandOfAVAT(), Barrel(), Barrel_HcalInit(), Bbc_Reco(), BbcInit(), BeamLine(), BeamLineDefineBeamPipe(), BeamLineDefineMagnets(), BeamLineInit(), BECAL_Eval(), BECAL_Towers(), BECALInit(), Acts::CuboidVolumeBuilder::binningRange(), Acts::Test::BOOST_AUTO_TEST_CASE(), Acts::ConeVolumeBounds::buildSurfaceBounds(), ActsExamples::TGeo::buildTGeoDetector(), nlohmann::detail::binary_writer< BasicJsonType, CharType >::calc_bson_integer_size(), nlohmann::detail::binary_writer< BasicJsonType, CharType >::calc_bson_unsigned_size(), erhic::LeptonKinematicsComputer::Calculate(), CaloTrigger_Sim(), Acts::AdaptiveMultiVertexFinder< vfitter_t, sfinder_t >::canRecoverFromNoCompatibleTracks(), CEmc(), CEmc_1DProjectiveSpacal(), CEmc_2DProjectiveSpacal(), CEMC_Cells(), CEMC_Clusters(), CEMC_Eval(), CEMC_QA(), CEMC_Towers(), CEmcAlbedoInit(), Centrality(), Acts::Extent::check(), kdfinder::CircleFit< T >::CircleFitByChernovHoussam(), Acts::AnnulusBounds::closestOnSegment(), TPCFEETestRecov1::Clustering(), compareMatrices(), Acts::SurfaceArray::SurfaceGridLookup< Axes >::completeBinning(), erhic::JacquetBlondelComputer::ComputeQSquared(), erhic::DoubleAngleComputer::ComputeQSquared(), conkin(), gbl::GblTrajectory::construct(), genfit::WirePointMeasurement::constructMeasurementsOnPlane(), genfit::WireMeasurement::constructMeasurementsOnPlane(), genfit::WireMeasurementNew::constructMeasurementsOnPlane(), convert_cell_list_to_mgrid(), PHActsInitialVertexFinder::createCentroidMap(), Acts::SurfaceArrayCreator::createEquidistantAxis(), Acts::CylinderVolumeHelper::createGapTrackingVolume(), Acts::createProtoMaterial(), CTDInit(), Acts::TGeoSurfaceConverter::cylinderComponents(), twoPhotonLuminosity::D2LDMDY(), dcross(), genfit::Track::deletePoint(), demo(), ActsExamples::determineEventFilesRange(), ActsExamples::Sequencer::determineEventsRange(), DIRCInit(), Acts::TGeoSurfaceConverter::discComponents(), nanoflann::KDTreeSingleIndexAdaptor< nanoflann::L2_Simple_Adaptor< double, kdfinder::KDPointCloud< double > >, kdfinder::KDPointCloud< double >, 3 >::divideTree(), dlower(), dokinematics(), Draw_ratio(), genfit::EventDisplay::drawEvent(), DRCALO_Towers(), DRCALOInit(), DRichInit(), dupper(), EEMC_Clusters(), EEMC_Eval(), EEMC_Towers(), EEMCH_Clusters(), EEMCH_Eval(), EEMCH_Towers(), EEMCHInit(), EEMCHSetup(), EEMCInit(), EEMCSetup(), EGEM_Init(), EHCAL_Clusters(), EHCAL_Eval(), EHCAL_Towers(), EHCALInit(), ei(), EndCap_ElectronInit(), EndCap_HadronInit(), EPDInit(), errorOf1DHistograms(), Acts::CylinderVolumeHelper::estimateAndCheckDimension(), nBodyPhaseSpaceGen::estimateMaxWeight(), nBodyPhaseSpaceGen::eventAccepted(), ActsExamples::TrackSelector::execute(), ActsExamples::TruthSeedSelector::execute(), ActsExamples::ParticleSelector::execute(), Acts::Extent::extend(), Acts::Polyhedron::extent(), FEMC_Clusters(), FEMC_Eval(), FEMC_Towers(), FEMCInit(), FGEM_FastSim_Eval(), FGEM_FastSim_Reco(), FGEM_Init(), FHCAL_Clusters(), FHCAL_Eval(), FHCAL_Towers(), FHCALInit(), genfit::TGeoMaterialInterface::findNextBoundary(), Acts::FullBilloirVertexFitter< input_track_t, linearizer_t >::fit(), fjetrig(), PHTpcTrackFollower::followTrack(), FST_Init(), G4DSTreader(), G4DSTreader_EICDetector(), G4DSTreader_fsPHENIX(), G4DSTreader_LBLDetector(), Gem(), GemInit(), generatez(), genevent(), PHG4CylinderGeom_Spacalv3::get_max_lightguide_height(), PHG4Sector::Sector_Geometry::get_max_R(), getdeltat(), genfit::KalmanFitStatus::getForwardPVal(), getinsudared(), PHG4SteppingAction::GetLightCorrection(), getmd(), getmdmax(), getmdmin(), Acts::FsmwMode1dFinder::getMode(), getnewmass(), getpdf(), getpdfxint(), genfit::AbsKalmanFitter::getPVal(), genfit::FitStatus::getPVal(), getqvec(), getspliti(), getsscat(), getxsecint(), gridBoxFactory(), nlohmann::detail::dtoa_impl::grisu2_digit_gen(), Acts::DiscTrapezoidBounds::halfPhiSector(), HCalInner(), HCALInner_Cells(), HCALInner_Clusters(), HCALInner_Eval(), HCALInner_QA(), HCALInner_Towers(), HCalInnerInit(), HCalOuter(), HCALOuter_Cells(), HCALOuter_Clusters(), HCALOuter_Eval(), HCALOuter_QA(), HCALOuter_Towers(), HCalOuterInit(), hFarFwdBeamLineInit(), hFarFwdDefineBeamPipe(), hFarFwdDefineDetectorsIP6(), hFarFwdDefineDetectorsIP8(), hFarFwdDefineMagnets(), hijcsc(), HIJetReco(), hijing(), hijset(), hijsft(), hiptdi(), PHActsSiliconSeeding::identifyBestSeed(), nanoflann::KNNResultSet< DistanceType, IndexType, CountType >::init(), EicBeamLineElementMap::Initialize(), HtcKalmanFilter::InitializeMgridSlice(), initpythia(), InputRegister(), genfit::Track::insertPoint(), genfit::Track::insertPoints(), Acts::AnnulusBounds::inside(), Acts::LineSurface::intersect(), Intt(), Intt_Cells(), Intt_Clustering(), Intt_QA(), InttInit(), erhic::Pid::InvalidCode(), gbl::VSymMatrix::invert(), gbl::BorderedBandMatrix::invertBand(), KFParticle_Tools::isInRange(), Jet_Eval(), Jet_FwdEval(), Jet_FwdReco(), Jet_QA(), Jet_Reco(), jetini(), JLDIRCInit(), Acts::JsonGeometryConverter::jsonToBinUtility(), Acts::JsonGeometryConverter::jsonToVolumeMaterial(), KFParticle_D0_Reco(), KFParticle_Lambdac_Reco(), KFParticle_QA(), KFParticle_Upsilon_Reco(), klu(), largeintersection(), Acts::LayerArrayCreator::layerArray(), leptox(), LFHCAL_Eval(), LFHCAL_Towers(), LFHCALInit(), linit(), lmeps(), lprwts(), lqcdpr(), lscale(), lsigmx(), lsmall(), 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(), luxdif(), luxjet(), luxkfl(), luxtot(), luzdis(), lweits(), lxsect(), lyremn(), lysspa(), lystfu(), lzp(), Magnet(), MagnetInit(), main(), makebranch(), makeinsplit(), Acts::mapMaterialPoints(), Acts::materialMapperRZ(), Acts::materialMapperXYZ(), Maximi(), Maximum(), MicromegasInit(), PHG4mRICHDetector::mRichParameter::mRichParameter(), Mvtx(), Mvtx_Cells(), Mvtx_Clustering(), Mvtx_QA(), MvtxInit(), genfit::MaterialEffects::noiseBrems(), nthick(), Acts::CKFSourceLinkSelector::operator()(), ZCylinderSurfaceBuilder::operator()(), Acts::Test::MaterialScattering::operator()(), Acts::Test::MinimalOutlierFinder::operator()(), Acts::VolumeConfig::overlapsInR(), Acts::VolumeConfig::overlapsInZ(), ParticleFlow(), kdfinder::Helix< T >::pathLengths(), pepsimainerhic(), kdfinder::Helix< T >::period(), Pipe(), PipeInit(), Piston(), PistonInit(), plu(), PlugDoorInit(), polleptox(), pollinit(), pollzp(), PHSimpleVertexFinder::process_event(), genfit::KalmanFitterRefTrack::processTrackWithRep(), genfit::KalmanFitter::processTrackWithRep(), py1ent(), py2ent(), py2frm(), py3ent(), py4ent(), py4frm(), py4jet(), py4jts(), py4jtw(), py6frm(), pyadsh(), pyalps(), pybesq(), pyboei(), pycell(), pyclus(), pycteq(), pyctq2(), 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(), 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(), pystel(), pystfu(), pystga(), pystpi(), pystpr(), pystrf(), pysugi(), pytabu(), pytbdy(), pytest(), pythrg(), pyupda(), pyupin(), pyveto(), pywidt(), pywidx(), pyx3jt(), pyx4jt(), pyxdif(), pyxjet(), pyxkfl(), pyxtee(), pyxtot(), pyzdis(), qqt(), quench(), twoPhotonLuminosity::radmul(), ActsExamples::Options::readTGeoLayerBuilderConfigs(), Acts::detail::recoverSpacePoint(), Acts::TGeoLayerBuilder::registerSplit(), nlohmann::detail::serializer< BasicJsonType >::remove_sign(), Acts::AdaptiveMultiVertexFinder< vfitter_t, sfinder_t >::removeTrackIfIncompatible(), RICHInit(), rkstepper(), rluset(), ActsExamples::RootMaterialDecorator::RootMaterialDecorator(), TPCFEETestRecov1::roughZeroSuppression(), TPCDaqDefs::FEEv1::SampleFit_PowerLawDoubleExp(), scan_viewer(), 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::set_z_range(), PHG4ParticleGenerator_flat_pT::set_z_range(), HoughTree::SetBorrowedHitCounterLimit(), FwdTrackFinder::SetBorrowedHitCounterLimit(), HoughTree::SetBorrowedPlusMissingHitCounterLimit(), FwdTrackFinder::SetBorrowedPlusMissingHitCounterLimit(), PHTrackSelector::SetChi2NDFHits(), FairPrimaryGenerator::SetEventTimeInterval(), FairRootManager::SetEventTimeInterval(), FairEventManager::SetEvtMaxEnergy(), sPHENIXTrackerTpc::setFastChi2Cut(), sPHENIXTracker::setFastChi2Cut(), sPHENIXSeedFinder::setFastChi2Cut(), FairEventManager::SetMaxEnergy(), genfit::AbsKalmanFitter::setMinIterations(), FwdTrackFinder::SetMissingHitCounterLimit(), EicBoxGenerator::SetMomentumRange(), HoughTree::SetOkHitCounterLimits(), EicBoxGenerator::SetPhiRange(), PHG4TpcDirectLaser::SetPhiStepping(), EicAsciiBoxGenerator::SetPtRange(), EicBoxGenerator::SetThetaRange(), PHG4TpcDirectLaser::SetThetaStepping(), PHG4ScoringManager::setVertexAcceptanceRange(), PHG4ScoringManager::setVertexHistRange(), EPhenixMomentum::Smear(), genfit::Track::sort(), splitfncint(), Acts::EigenStepper< bfield_t, extensionlist_t, auctioneer_t >::step(), TopoClusterReco(), Acts::RectangleBounds::toStream(), Acts::ConstrainedStep::toString(), TPC(), TPC_Cells(), TPC_Clustering(), TPC_QA(), TPCInit(), Tracking_Eval(), Tracking_QA(), Tracking_Reco(), TrackingInit(), TrackingServiceCone(), TrackingServiceCylinder(), TrackingServiceInit(), GPUTPCTrackParam::TransportToX(), TreeToHepMC(), TTL_Init(), nlohmann::detail::binary_writer< BasicJsonType, CharType >::ubjson_prefix(), ulalps(), ulmass(), Acts::detail::PointwiseMaterialInteraction::updateVariance(), VTXInit(), WorldSize(), Acts::AxisAlignedBoundingBox< entity_t, value_t, DIM >::wrap(), Acts::detail::Axis< AxisType::Equidistant, bdt >::wrapBin(), Acts::detail::Axis< AxisType::Variable, bdt >::wrapBin(), ActsExamples::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(), xsecint(), ZDC_Eval(), ZDC_Towers(), and ZDCInit().
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__(), Acts::VolumeConfig::adaptR(), Acts::VolumeConfig::adaptZ(), FwdHoughTree::AddNodeGroup(), Acts::adjustBinUtility(), Acts::CylinderVolumeBuilder::analyzeContent(), approx(), ar3jet(), arorie(), attrad(), Barrel(), Barrel_HcalInit(), BbcInit(), BeamLine(), BeamLineInit(), BECALInit(), genfit::MeasuredStateOnPlane::blowUpCov(), BOOST_AUTO_TEST_CASE(), Acts::Test::BOOST_AUTO_TEST_CASE(), nlohmann::detail::binary_writer< BasicJsonType, CharType >::calc_bson_integer_size(), CEmc(), CEmc_1DProjectiveSpacal(), CEmc_2DProjectiveSpacal(), CEmcAlbedoInit(), CharmJetMVAOptimization(), Acts::Extent::check(), eicpy.cpplint::CheckForCopyright(), Acts::AnnulusBounds::closestOnSegment(), TPCFEETestRecov1::Clustering(), conkin(), PHG4FullProjSpacalDetector::Construct_Fibers_SameLengthFiberPerTower(), PHG4FullProjTiltedSpacalDetector::Construct_Fibers_SameLengthFiberPerTower(), convert_cell_list_to_mgrid(), Acts::CylinderVolumeHelper::createGapTrackingVolume(), Acts::createProtoMaterial(), Acts::Sycl::createSeedsForGroupSycl(), CTDInit(), Acts::ATLASCuts< SpacePoint >::cutPerMiddleSP(), TestHostCuts::cutPerMiddleSP(), Acts::TGeoSurfaceConverter::cylinderComponents(), dcross(), gbl::BorderedBandMatrix::decomposeBand(), genfit::Track::deletePoint(), ActsExamples::determineEventFilesRange(), ActsExamples::Sequencer::determineEventsRange(), DIRCInit(), Acts::TGeoSurfaceConverter::discComponents(), nanoflann::KDTreeSingleIndexAdaptor< nanoflann::L2_Simple_Adaptor< double, kdfinder::KDPointCloud< double > >, kdfinder::KDPointCloud< double >, 3 >::divideTree(), dofistatescat(), doinstatescat(), dokinematics(), Draw_ratio(), genfit::EventDisplay::drawEvent(), DRCALOInit(), dupper(), EEMCHInit(), EEMCInit(), EGEM_Init(), EHCALInit(), ei(), EndCap_ElectronInit(), EPDInit(), errorOf1DHistograms(), Acts::CylinderVolumeHelper::estimateAndCheckDimension(), ActsExamples::TrackSelector::execute(), ActsExamples::TruthSeedSelector::execute(), ActsExamples::ParticleSelector::execute(), eicpy.qaplots::execute(), Acts::Extent::extend(), Acts::Polyhedron::extent(), FEMCInit(), FHCALInit(), Acts::fieldMapperRZ(), sPHENIXTrackerTpc::findTracksBySegments(), sPHENIXTracker::findTracksBySegments(), sPHENIXSeedFinder::findTracksBySegments(), flipol(), Gem(), kdfinder::get_track_color(), getinsudared(), PHG4SteppingAction::GetLightCorrection(), getnewmass(), getpdfxint(), PHG4TruthInfoContainer::GetPrimaryVertexIndex(), getspliti(), getxsecint(), gridBoxFactory(), EicTpcDigiHitProducer::HandleHit(), HCalInnerInit(), HCalOuterInit(), hFarFwdBeamLineInit(), hijels(), hijing(), hijsft(), hiptdi(), init(), EicBeamLineElementMap::Initialize(), HtcKalmanFilter::InitializeMgridSlice(), genfit::Track::insertPoint(), genfit::Track::insertPoints(), intbtk2(), InttInit(), gbl::BorderedBandMatrix::invertBand(), jetini(), JLDIRCInit(), Acts::JsonGeometryConverter::jsonToBinUtility(), Acts::JsonGeometryConverter::jsonToVolumeMaterial(), HoughTree::LaunchPatternFinder(), Acts::LayerArrayCreator::layerArray(), leptox(), LFHCALInit(), linit(), lqcdpr(), lshowr(), lsigmx(), lu3ent(), lu4ent(), luboei(), lucell(), luclus(), ludcyk(), ludecy(), lueevt(), luexec(), luhepc(), luindf(), lujmas(), lukfdi(), lulist(), luprep(), luradk(), lurobo(), lushow(), lusphe(), lustrf(), lutabu(), luthru(), luupda(), lux3jt(), lux4jt(), luxjet(), luxkfl(), luxtot(), luzdis(), lweits(), lyremn(), lysspa(), MagnetInit(), main(), makebranch(), genfit::EventDisplay::makeLines(), makesplitting(), FairDb::MakeTimeStamp(), Acts::mapMaterialPoints(), MicromegasInit(), Minimi(), Minimum(), MvtxInit(), nthick(), Acts::CKFSourceLinkSelector::operator()(), Acts::VolumeConfig::overlapsInR(), Acts::VolumeConfig::overlapsInZ(), pepsimainerhic(), PipeInit(), plu(), PlugDoorInit(), polleptox(), pollinit(), gbl::VVector::print(), gbl::VMatrix::print(), gbl::VSymMatrix::print(), beamBeamSystem::probabilityOfPhotonBreakup(), CellularAutomaton_v1::process_single_track(), CellularAutomaton_v1::process_single_triplet(), 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(), 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(), pystel(), pystga(), pystpi(), pystpr(), pystrf(), pytabu(), pytecm(), pytest(), pythru(), pyupda(), pywidt(), pyx3jt(), pyx4jt(), pyxjet(), pyxkfl(), pyxtee(), pyzdis(), Acts::TGeoLayerBuilder::registerSplit(), rkstepper(), rluget(), rluset(), ActsExamples::RootMaterialDecorator::RootMaterialDecorator(), rv2(), TPCDaqDefs::FEEv1::SampleFit_PowerLawDoubleExp(), ValTimeStamp::Set(), 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_flat_pT::set_phi_range(), PHG4ParticleGenerator::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_flat_pT::set_z_range(), PHG4ParticleGenerator::set_z_range(), FairPrimaryGenerator::SetEventTimeInterval(), FairRootManager::SetEventTimeInterval(), FairEventManager::SetEvtMinEnergy(), FairEventManager::SetMinEnergy(), CbmStack::SetMinPoints(), PndStack::SetMinPoints(), EicBoxGenerator::SetMomentumRange(), HoughTree::SetOkHitCounterLimits(), EicBoxGenerator::SetPhiRange(), PHG4TpcDirectLaser::SetPhiStepping(), EicAsciiBoxGenerator::SetPtRange(), EicBoxGenerator::SetThetaRange(), PHG4TpcDirectLaser::SetThetaStepping(), PHG4ScoringManager::setVertexAcceptanceRange(), PHG4ScoringManager::setVertexHistRange(), Acts::solenoidFieldMapper(), gbl::BorderedBandMatrix::solveBand(), genfit::Track::sort(), Acts::EigenStepper< bfield_t, extensionlist_t, auctioneer_t >::step(), ValValidate::TestTimeStamp(), Acts::RectangleBounds::toStream(), TPCInit(), TrackingServiceInit(), CaloTriggerSim::truncate_8bit(), nlohmann::detail::binary_writer< BasicJsonType, CharType >::ubjson_prefix(), ulalps(), VTXInit(), WorldSize(), Acts::AxisAlignedBoundingBox< entity_t, value_t, DIM >::wrap(), Acts::detail::Axis< AxisType::Equidistant, bdt >::wrapBin(), Acts::detail::Axis< AxisType::Variable, bdt >::wrapBin(), ActsExamples::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(), and ZDCInit().
|
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
|
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
|
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(), AddFlowToParent(), CylindricalHough::addHits(), PHG4TpcDirectLaser::AimToPatternStep(), airy1(), airy1d(), airy2(), airy2d(), analysis_resolution(), AnnularFieldSim::analyticFieldIntegral(), AnnularFieldSim::AnnularFieldSim(), atrobo(), attrad(), BeamLine(), 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(), BuildePHENIX_0_0(), BuildeSTAR_0_0(), PHGenFitTrkProp::BuildLayerZPhiHitMap(), BuildPerfectDetector(), BuildSTAR_0_0(), BuildWithTof(), BuildZEUS_0_0(), HelixKalman::calculate_dAdAp(), HelixKalmanFilter::calculate_dAdAp(), CylinderKalman::calculate_dxda(), HelixKalmanFilter::calculate_dxda(), HelixHoughFuncs_v1::calculate_phi_range(), ActsTransformations::calculateDCA(), ActsEvaluator::calculateDCA(), HelixDCAFunc::calcValGradHessian(), GFDaf::calcWeights(), genfit::DAF::calcWeights(), EicKfNodeTemplateOrth2D::CartesianToCylindrical(), ActsExamples::Generic::ProtoLayerCreatorT< detector_element_t >::centralProtoLayers(), Acts::LayerCreator::checkBinning(), PHTruthTrackSeeding::circleFitSeed(), PHActsSiliconSeeding::circleFitSeed(), CMDistortionAnalysis(), CMDistortionAnalysisCart(), CMDistortionAnalysisPhiR(), CMDistortionReco(), CMDistortionRecoCart(), CMDistortionRecoPhiR(), PHG4EtaPhiParameterization::ComputeDimensions(), computeHermesPhiH(), PHG4InnerHcalDetector::ConstructInnerHcal(), PHG4InttDetector::ConstructIntt(), PHG4PSTOFDetector::ConstructMe(), G4JLeicVTXDetector::ConstructMe(), G4JLeicDIRCDetector::ConstructMe(), PHG4CEmcTestBeamDetector::ConstructMe(), PHG4HcalDetector::ConstructMe(), PHG4OuterHcalDetector::ConstructOuterHcal(), PHG4CEmcTestBeamDetector::ConstructTowerVolume(), Smear::Acceptance::Zone::Contains(), RawClusterBuilderFwd::CorrectPhi(), BEmcRecCEMC::CorrectShowerDepth(), create_element(), Acts::EventDataView3D::createEllipse(), Acts::SurfaceArrayCreator::createEquidistantAxis(), ActsExamples::Generic::ProtoLayerCreatorT< detector_element_t >::createProtoLayers(), Acts::detail::VerticesHelper::createSegment(), det::createTkLayoutTrackerBarrel(), det::createTkLayoutTrackerEndcap(), Acts::SurfaceArrayCreator::createVariableAxis(), PHActsTrackProjection::deltaPhi(), Acts::TGeoSurfaceConverter::discComponents(), dofistatescat(), doinstatescat(), EtmAzimuthalScan::DoIt(), dokinematics(), Acts::GeometryView3D::drawSurfaceArray(), Acts::ImpactPointEstimator< input_track_t, propagator_t, propagator_options_t >::estimateImpactParameters(), QAG4SimulationCalorimeterSum::eval_trk_proj(), QAG4SimulationEicCalorimeterSum::eval_trk_proj(), ActsExamples::ParticleSmearing::execute(), ActsExamples::TruthSeedSelector::execute(), ActsExamples::ParticleSelector::execute(), PHInitZVertexing::export_output(), PHPatternReco::export_output(), PHHoughSeeding::export_output(), TpcSpaceChargeReconstructionHelper::extrapolate_phi1(), TpcSpaceChargeReconstructionHelper::extrapolate_phi2(), fgp1(), fgp2(), fgp3(), AnnularFieldSim::fieldIntegral(), ActsExamples::EffPlotTool::fill(), ActsExamples::DuplicationPlotTool::fill(), ActsExamples::FakeRatePlotTool::fill(), ActsExamples::ResPlotTool::fill(), eicpy.qaplots.TrackHists::fill(), JetEvaluator::fillOutputNtuples(), CaloEvaluator::fillOutputNtuples(), SvtxEvaluator::fillOutputNtuples(), AnnularFieldSim::FilterPhiIndex(), AnnularFieldSim::FilterPhiPos(), sPHENIXTrackerTpc::finalize(), 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(), CbmRichRingFitterQa::GenerateEllipse(), ActsExamples::PrimaryGeneratorAction::GeneratePrimaries(), 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(), PHTpcResiduals::getCell(), Acts::ImpactPointEstimator< input_track_t, propagator_t, propagator_options_t >::getDistanceAndMomentum(), PHField3DCylindrical::GetFieldCyl(), PHField2D::GetFieldValue(), PHField3DCylindrical::GetFieldValue(), PHG4HcalDetector::GetLength(), kdfinder::TrackCandidate< T >::getMomForHit(), BEmcRec::GetProb(), getqvec(), getscatterer(), PHG4TpcCentralMembrane::getSearchResult(), PHG4TpcCentralMembrane::getStripeID(), PHTruthClustering::getTpcSector(), Acts::CylinderSurface::globalToLocal(), EicTpcDigiHitProducer::HandleHit(), hijels(), hijing(), hijsft(), hirobo(), EicSmearTask::Init(), RawTowerDeadMapLoader::InitRun(), Acts::EllipseBounds::inside(), Acts::ConeVolumeBounds::inside(), Acts::CylinderVolumeBounds::inside(), Acts::CylinderBounds::inside3D(), lazimu(), lepto(), AnnularFieldSim::load3dBfield(), AnnularFieldSim::load_and_resample_spacecharge(), AnnularFieldSim::loadBfield(), LoadData(), AnnularFieldSim::loadEfield(), Acts::ConeSurface::localCartesianToBoundLocalDerivative(), Acts::CylinderSurface::localCartesianToBoundLocalDerivative(), Acts::LineSurface::localCartesianToBoundLocalDerivative(), Acts::ConeSurface::localToGlobal(), Acts::CylinderSurface::localToGlobal(), CaloCalibEmc_Pi0::Loop(), lprikt(), lqev(), lqgev(), lqqbev(), lsmall(), lu1ent(), lucell(), ludecy(), lueevt(), luindf(), luonia(), luprep(), luptdi(), lurobo(), lushow(), lutabu(), lutest(), luthru(), luxdif(), main(), Acts::Test::SurfaceArrayCreatorFixture::makeBarrelStagger(), makebranch(), makeinsplit(), FwdHoughTree::MappingCall(), PHG4TpcPadPlaneReadout::MapToPadPlane(), Micromegas_Cells(), ActsExamples::Generic::modulePositionsRing(), PHSimpleKFProp::MoveToFirstTPCCluster(), Acts::ConeSurface::normal(), Acts::CylinderSurface::normal(), PHActsSiliconSeeding::normPhi2Pi(), Acts::ObjectSorterT< Vector3D >::operator()(), ActsExamples::ParametricParticleGenerator::operator()(), Acts::DistanceSorterT< T >::operator()(), Acts::Test::MaterialScattering::operator()(), PHHepMCGenHelper::pair2Hep3Vector(), PHG4GDMLWriteParamvol::Para_dimensionsWrite(), PHG4GDMLWriteSolids::ParaWrite(), Acts::ConeSurface::pathCorrection(), Acts::ImpactPointEstimator< input_track_t, propagator_t, propagator_options_t >::performNewtonApproximation(), PHField3DCylindrical::PHField3DCylindrical(), Gammaavectormeson::pi0Decay(), plot_matscan(), plot_matscan_tdr(), pollazimu(), PHGenFitTrkFitter::pos_cov_uvn_to_rz(), PHGenFitTrkFitter::pos_cov_XYZ_to_RZ(), BEmcRec::PredictEnergyProb(), CaloEvaluator::printOutputInfo(), PHG4ParticleGenerator::process_event(), PHG4ParticleGenerator_flat_pT::process_event(), PHG4ParticleGeneratorD0::process_event(), RawTowerZDCCalibration::process_event(), RawTowerCalibration::process_event(), PHG4CylinderCellReco::process_event(), RawTowerDigitizer::process_event(), RawTowerZDCDigitizer::process_event(), G4SnglTree::process_event(), PHG4SimpleEventGenerator::process_event(), G4CellNtuple::process_event(), G4SnglNtuple::process_event(), G4TowerNtuple::process_event(), PHG4ParticleGeneratorVectorMeson::process_event(), PHTpcTrackSeedCircleFit::process_event(), G4DIRCTree::process_event(), SubtractTowers::process_event(), SubtractTowersCS::process_event(), RetowerCEMC::process_event(), DetermineTowerBackground::process_event(), SamplingFractionReco::process_event(), PHGenFitTrackProjection::process_event(), LiteCaloEval::process_event(), PHMicromegasTpcTrackMatching::process_event(), RawTowerCombiner::process_event(), CaloAna::process_towers(), profile(), 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(), quench(), radgen_event(), EicBoxGenerator::ReadEvent(), ActsExamples::Options::readParticleGunOptions(), ActsExamples::RootBFieldWriter< bfield_t >::run(), 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(), CbmMCEventHeader::SetPhi(), CbmRichRing::SetPhi(), CbmMCEvent::SetPhi(), EicBoxGenerator::SetPhi(), CbmStripHit::SetPhi(), CbmRichRingLight::SetPhi(), FairTrackParH::SetTrackPar(), CbmRichRing::SetXYABPhi(), AnnularFieldSim::sum_local_field_at(), Acts::SurfaceArrayCreator::surfaceArrayOnCylinder(), Acts::SurfaceArrayCreator::surfaceArrayOnDisc(), Acts::Test::CylindricalTrackingGeometry::surfacesRing(), EicKfNodeTemplateRadial1D::TemplateToThreeDee(), EicKfNodeTemplateAsimuthal1D::TemplateToThreeDee(), EicKfNodeTemplateCylindrical2D::TemplateToThreeDee(), Acts::detail::transformFreeToBoundParameters(), Acts::detail::transformFreeToCurvilinearParameters(), PHG4GDMLWriteParamvol::Trap_dimensionsWrite(), PHG4GDMLWriteSolids::TrapWrite(), Gammaavectormeson::twoBodyDecay(), Gammagammasingle::twoBodyDecay(), CylinderKalman::updateIntersection(), HelixKalmanFilter::updateIntersection(), PHActsVertexPropagator::updateTrackDCA(), PHActsVertexFinder::updateTrackDCA(), Acts::BinningData::value(), ActsEvaluator::visitTrackStates(), VstRadLength(), ActsExamples::RootTrajectoryWriter::writeT(), and ActsExamples::RootMaterialTrackWriter::writeT().
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().
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().
__m128 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
Referenced by aiz(), ar3jet(), arorie(), attrad(), biz(), bornin(), bsrlu(), conkin(), dcross(), deltas(), dlower(), dupper(), f2allm(), fw(), fws(), gadap(), gadap2(), gadapf(), grv94di(), grv94ho(), grv94lo(), intbtk2(), leptox(), linit(), lprikt(), lsigmx(), parton(), pepsimainerhic(), polleptox(), pollinit(), pybesq(), pycba2(), pycbal(), pycdiv(), pycsrt(), pygano(), pygdir(), pygrvd(), pygrvl(), pygrvm(), pygrvs(), pygrvw(), pygvmd(), pyhiinki(), pyinbm(), pyinki(), pyinom(), pyr(), pysimp(), pytbhg(), pytbhq(), pythag(), pyxtot(), pyxxz6(), rlu(), and tails().
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 FluxMonitorGrid::AddEntry(), BOOST_AUTO_TEST_CASE(), sPHENIXTrackerTpc::calculateKappaTangents(), sPHENIXTracker::calculateKappaTangents(), sPHENIXSeedFinder::calculateKappaTangents(), genfit::GblFitter::constructGblInfo(), Acts::AtlasStepper< bfield_t >::covarianceTransport(), HelixHough::dzdlRange_sse(), PHG4CentralityReco::InitRun(), Acts::InternalSeed< SpacePoint >::InternalSeed(), Acts::Legacy::InternalSeed< SpacePoint >::InternalSeed(), orient2dadapt(), kdfinder::Helix< T >::pathLengths(), beamBeamSystem::probabilityOfPhotonBreakup(), genfit::GFGbl::processTrackWithRep(), FairDbConfDialog::Query(), FairGeoSet::read(), Acts::PrimitivesView3DTest::run(), mesh_t::save(), Acts::Legacy::InternalSeed< SpacePoint >::set(), FairGeoRotation::setEulerAngles(), strnstr(), FairGeanePro::Track2ToLine(), trackProximity(), tetgenmesh::tri_edge_2d(), and tetgenmesh::tri_edge_tail().
|
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
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(), 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(), FitNewton::NewtonMinimizerGradHessian::lineSearch(), main(), sPHENIXTracker::projectToLayer(), sPHENIXSeedFinder::projectToLayer(), HelixHoughBin_v1::set_bins(), CylinderKalman::updateIntersection(), HelixKalmanFilter::updateIntersection(), and FitNewton::NewtonMinimizerGradHessian::zoom().
Definition at line 104 of file HelixHough_allButKappaRange_sse.cpp.
View newest version in sPHENIX GitHub at line 104 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::GaussianRegGradHessian::calcValGradHessianThread1(), 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(), FitNewton::NewtonMinimizerGradHessian::lineSearch(), main(), sPHENIXTracker::projectToLayer(), sPHENIXSeedFinder::projectToLayer(), HelixHoughBin_v1::set_bins(), CylinderKalman::updateIntersection(), HelixKalmanFilter::updateIntersection(), and FitNewton::NewtonMinimizerGradHessian::zoom().
|
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().
Definition at line 33 of file HelixHough_allButKappaRange_sse.cpp.
View newest version in sPHENIX GitHub at line 33 of file HelixHough_allButKappaRange_sse.cpp
Referenced by HelixKalman::calculate_dAdAp(), HelixKalmanFilter::calculate_dAdAp(), CylinderKalman::calculate_dxda(), HelixKalmanFilter::calculate_dxda(), sPHENIXTrackerTpc::calculateKappaTangents(), sPHENIXTracker::calculateKappaTangents(), sPHENIXSeedFinder::calculateKappaTangents(), MapsGeoParData::ConstructMimosaCell(), MapsGeoParData::ConstructStave(), HelixHough::dzdlRange_sse(), fillBins4_sse(), partonx6(), HelixHough::phiRange_sse(), PHHepMCParticleSelectorDecayProductChain::process_event(), sPHENIXTracker::projectToLayer(), sPHENIXSeedFinder::projectToLayer(), CylinderKalman::updateIntersection(), and HelixKalmanFilter::updateIntersection().
Definition at line 34 of file HelixHough_allButKappaRange_sse.cpp.
View newest version in sPHENIX GitHub at line 34 of file HelixHough_allButKappaRange_sse.cpp
Referenced by HelixKalman::calculate_dAdAp(), HelixKalmanFilter::calculate_dAdAp(), sPHENIXTrackerTpc::calculateKappaTangents(), sPHENIXTracker::calculateKappaTangents(), sPHENIXSeedFinder::calculateKappaTangents(), MapsGeoParData::ConstructMimosaCell(), MapsGeoParData::ConstructStave(), HelixHough::dzdlRange_sse(), fillBins4_sse(), partonx6(), HelixHough::phiRange_sse(), and PHHepMCParticleSelectorDecayProductChain::process_event().
Definition at line 35 of file HelixHough_allButKappaRange_sse.cpp.
View newest version in sPHENIX GitHub at line 35 of file HelixHough_allButKappaRange_sse.cpp
Referenced by HelixKalman::calculate_dAdAp(), HelixKalmanFilter::calculate_dAdAp(), HelixHough::dzdlRange_sse(), fillBins4_sse(), and HelixHough::phiRange_sse().
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().
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().
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
|
static |
Definition at line 12 of file HelixHough_allButKappaRange_sse.cpp.
View newest version in sPHENIX GitHub at line 12 of file HelixHough_allButKappaRange_sse.cpp
Referenced by Acts::Test::BOOST_AUTO_TEST_CASE(), sPHENIXTrackerTpc::calculateKappaTangents(), sPHENIXTracker::calculateKappaTangents(), sPHENIXSeedFinder::calculateKappaTangents(), and Acts::ConeSurface::polyhedronRepresentation().
__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
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 ux = {0.,0.,0.,0.} |
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(), CylinderKalman::calculate_dxda(), HelixKalmanFilter::calculate_dxda(), HelixDCAFunc::calcValGradHessian(), intersect_circles(), CylindricalHough::intersect_circles(), main(), sPHENIXTracker::projectToLayer(), sPHENIXSeedFinder::projectToLayer(), CylinderKalman::updateIntersection(), and HelixKalmanFilter::updateIntersection().
__m128 uy = {0.,0.,0.,0.} |
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(), CylinderKalman::calculate_dxda(), HelixKalmanFilter::calculate_dxda(), HelixDCAFunc::calcValGradHessian(), intersect_circles(), CylindricalHough::intersect_circles(), main(), sPHENIXTracker::projectToLayer(), sPHENIXSeedFinder::projectToLayer(), CylinderKalman::updateIntersection(), and HelixKalmanFilter::updateIntersection().
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
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 KfMatrix::SetToProduct().
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 EICG4LumiDetector::AddTriangularTrapezoid(), HelixHough::allButKappaRange_sse(), ar3jet(), arorie(), attrad(), sPHENIXTrackerTpc::calculateKappaTangents(), sPHENIXTracker::calculateKappaTangents(), sPHENIXSeedFinder::calculateKappaTangents(), PHG4HcalDetector::ConstructMe(), oncsSub_idrcpetdata::decode(), Packet_hbd_fpga::decode(), genevent(), getneff(), photonNucleusCrossSection::integrated_Q2_dep(), photonNucleusCrossSection::integrated_x_section(), lqmcut(), lu3ent(), lueevt(), luonia(), lushow(), lux3jt(), luxdif(), polfit(), CellularAutomaton_v1::process_single_track(), CellularAutomaton_v1::process_single_triplet(), py3ent(), pyeevt(), pyonia(), pyptfs(), pyqqbh(), pyresd(), pyrnm3(), pyrnmq(), pyshow(), pytbdy(), pyx3jt(), pyxdif(), and Acts::DiamondBounds::vertices().
__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__(), TrackEvaluation::add_truth_information(), ALICEKF::ALICEKalmanFilter(), alphas(), ar3jet(), avscatcen(), BeamLine(), BeamLineDefineMagnets(), bessel::besI0(), bessel::besI1(), biz(), Acts::Test::BOOST_AUTO_TEST_CASE(), Acts::Test::BOOST_DATA_TEST_CASE(), BOOST_DATA_TEST_CASE(), bornin(), 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(), erhic::Pythia6EventBuilder::BuildEvent(), PHGenFitTrkProp::BuildLayerZPhiHitMap(), CbmRichRingFitterEllipseBase::CalcChi2(), FairGeoMedium::calcRadiationLength(), calcta(), erhic::LeptonKinematicsComputer::Calculate(), HelixHoughFuncs_v1::calculate_dzdl_range(), HelixHoughFuncs_v1::calculate_phi_range(), tetgenmesh::calculateabovepoint(), CylinderKalman::calculateProjections(), HelixKalmanFilter::calculateProjections(), FairGeoOldAsciiIo::calculateShapePoints(), calcxsection(), EicKfNodeTemplateOrth2D::CartesianToCylindrical(), kdfinder::CircleFit< T >::CircleFitByHyper(), kdfinder::CircleFit< T >::CircleFitByPratt(), ALICEKF::CircleFitByTaubin(), PHTpcClusterMover::CircleFitByTaubin(), PHTruthTrackSeeding::circleFitByTaubin(), PHActsSiliconSeeding::circleFitByTaubin(), kdfinder::CircleFit< T >::CircleFitByTaubin(), ClassImp(), PHBBox::ClipLine(), CMDistortionAnalysis(), CMDistortionAnalysisCart(), CMDistortionAnalysisPhiR(), CMDistortionReco(), CMDistortionRecoCart(), PHG4FPbScDetector::computeIndex(), erhic::JacquetBlondelComputer::ComputeQSquared(), erhic::JacquetBlondelComputer::ComputeX(), erhic::DoubleAngleComputer::ComputeX(), erhic::JacquetBlondelComputer::ComputeY(), erhic::DoubleAngleComputer::ComputeY(), conkin(), FairGeoInterface::connectOutput(), PHG4EPDDetector::construct_block(), PHG4PSTOFDetector::ConstructMe(), G4JLeicVTXDetector::ConstructMe(), G4JLeicDIRCDetector::ConstructMe(), EICG4RPDetector::ConstructMe(), Smear::Acceptance::CustomCut::Contains(), BEmcRecCEMC::CorrectPosition(), BEmcRecEEMC::CorrectPosition(), BEmcRecFEMC::CorrectPosition(), BEmcRec::CorrectPosition(), BEmcRec::CorrectShowerDepth(), Acts::AtlasStepper< bfield_t >::covarianceTransport(), create_element(), Acts::EventDataView3D::createEllipse(), CreateKnots(), RawTowerBuilder::CreateNodes(), Acts::Sycl::createSeedsForGroupSycl(), PHActsSiliconSeeding::createSvtxTrack(), CylindricalCoordinateCurve(), CylindricalCoordinateImprove(), CylindricalCoordinateTransformation(), bessel::dbesk0(), bessel::dbesk1(), dcross(), oncsSub_iduppetdata::decode(), oncsSub_iduppetdata_v104::decode(), deltas(), demo(), kdfinder::TrackCandidate< T >::distanceToCircle(), DISVariables(), dlower(), CbmRichRingFitterTAU::DoFit(), dqcd(), dqcdi(), dqn32(), CbmRichGeoTest::DrawH3(), dsigma(), dupper(), HelixHough::dzdlRange_sse(), ei(), QAG4SimulationCalorimeterSum::eval_trk_proj(), QAG4SimulationEicCalorimeterSum::eval_trk_proj(), SvtxClusterEval::fast_approx_atan2(), ffu(), fg(), fgp(), ActsExamples::BField::txt::fieldMapperXYZ(), ActsExamples::BField::root::fieldMapperXYZ(), fillEvent(), CaloEvaluator::fillOutputNtuples(), SvtxEvaluator::fillOutputNtuples(), PHTpcLookup::find(), NHitSeedFinder::find4Tracks(), NHitSeedFinder::find5Tracks(), NHitSeedFinder::find6Tracks(), PHG4CylinderGeomv4::find_strip_center(), PHTpcSeedFinder::findSeeds(), SimpleTrack3D::fit_track(), FitProfile(), FitResolution(), ZHough_Cylindrical::fitTrack(), VtxTrackFinder::fitTrack(), ThreeHitSeedGrower::fitTrack(), NHitSeedFinder::fitTrack(), FourHitSeedFinder::fitTrack(), sPHENIXTrackerTpc::fitTrack(), sPHENIXTracker::fitTrack(), sPHENIXSeedFinder::fitTrack(), FourHitSeedFinder::fitTrackLine(), flgint(), flintg(), flipol(), flqint(), fltabl(), fltint(), gamma(), simpleRandom::gauss(), gauss1(), gauss2(), gauss3(), gauss4(), PHG4GDMLWriteSolids::GenTrapWrite(), genfit::Field::get(), SvtxTruthEval::get_innermost_truth_hit(), SvtxTruthEval::get_outermost_truth_hit(), PHG4GDMLWriteDefine::GetAngles(), GetBinominalRatio(), PndTransMap::GetBxyz(), PndDipoleMap::GetBxyz(), PndSolenoidMap::GetBxyz(), EicMagneticFieldFromGradients::GetBxyzCore(), EicMagneticField::GetBxyzCore(), ALICEKF::GetCircleClusterResiduals(), EmcCluster::GetCorrPos(), EicRunDigi::GetDetectorHits(), EmcCluster::GetECoreCorrected(), PHFieldCleo::GetFieldValue(), PHField3DCartesian::GetFieldValue(), PHFieldBeast::GetFieldValue(), PHField2D::GetFieldValue(), PHField3DCylindrical::GetFieldValue(), PHG4OuterHcalField::GetFieldValue(), getinspliti(), getinsudared(), PndPidCandidate::GetNearestParameterization(), getpdfxint(), getpnorad1(), CbmMCTrack::GetRapidity(), Smear::ParticleMCS::GetRapidity(), getscatterer(), getspliti(), getsscat(), A_Event::getTime(), getxsecint(), kdfinder::CircleFit< T >::GradientHessian(), hFarFwdDefineMagnets(), hiboost(), hijsrt(), sPHENIXTracker::initDummyHits(), sPHENIXSeedFinder::initDummyHits(), Acts::LineSurface::initJacobianToGlobal(), Acts::Surface::initJacobianToGlobal(), Acts::Surface::initJacobianToLocal(), CbmRichRingFitterEllipseTau::InitMatrices(), HcalRawTowerBuilder::InitRun(), tetgenmesh::insertconstrainedpoints(), intbtk2(), itafun(), Acts::LayerArrayCreator::layerArray(), lazimu(), lepto(), leptox(), lflav(), lframe(), linit(), lkinem(), lmcmnd(), lmidat(), lminew(), lminto(), lmpint(), lmprin(), lmrazz(), lmsimp(), mesh_t::load(), PHG4CylinderGeom_Spacalv3::load_demo_sector_tower_map4(), tetgenio::load_node_call(), LoadAnsysInput(), LoadElmergrid(), LoadFieldviewInput(), LoadGidInput(), lprwts(), lqcdpr(), lqev(), lqgev(), lqmcut(), lqqbev(), lremh(), lscale(), lsci(), lsigmx(), LSLTrackRep::LSLTrackRep(), lsmall(), lweits(), lxp(), lxsect(), lyspli(), lzp(), main(), make_single_tower(), PHG4ScoringManager::makeScoringHistograms(), PHActsSiliconSeeding::makeSpacePoint(), PHActsSiliconSeeding::makeSvtxTracks(), BEmcRec::Momenta(), momentumDistributions(), MovePointAngle(), MovePointArc(), MovePointLinear(), MovePointPower(), MovePointPowerSeries(), MovePointPowerSeries2(), MovePointSinus(), PHHepMCGenEvent::moveVertex(), nlohmann::detail::dtoa_impl::diyfp::mul(), Acts::Legacy::AtlasSeedfinder< SpacePoint >::newSpacePoint(), CbmRichUrqmdTest::NofHits(), CbmRichUrqmdTest::NofProjections(), tetgenmesh::norm2(), odeint(), FairRKPropagator::OneStepRungeKutta(), boost::operator!=(), boost::operator<(), boost::operator<=(), boost::operator>=(), tetgenmesh::outmesh2vtk(), parton(), pepsimainerhic(), phase(), HelixHough::phiRange_sse(), pickvtx(), Gammaavectormeson::pickwEgamq2(), podinl(), poldqcd(), poldqcdi(), poldsigma(), polint(), polint5(), polint6(), pollazimu(), polleptox(), pollinit(), pollzp(), PHG4GDMLWriteDefine::Position_vectorWrite(), PHG4Hitv1::print(), printBField(), printHits(), CaloEvaluator::printOutputInfo(), SvtxEvaluator::printOutputInfo(), beamBeamSystem::probabilityOfPhotonBreakup(), 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(), pyangl(), pyct5l(), pyct5m(), pyfcmp(), pygaga(), pygfxx(), pygram(), pyhistfu(), pylamf(), pypdfu(), pypdpi(), pypdpo(), pyptis(), pyreco(), pyrvg4(), pyrvs(), pysimp(), pystpi(), pystpr(), pywidt(), pyxxz6(), genfit::tools::QR(), radgam_pol(), rdarry(), rdarrynlo(), Acts::IntegrationTest::readFieldXYZ(), readFile(), FairGeoTube::readPoints(), FairGeoTubs::readPoints(), FairGeoCons::readPoints(), FairGeoPgon::readPoints(), FairGeoCone::readPoints(), FairGeoEltu::readPoints(), FairGeoPcon::readPoints(), FairGeoSphe::readPoints(), FairGeoBasicShape::readPoints(), readSeedFile(), PHGenFitTrkProp::ReFitTrack(), PHGenFitTrkFitter::ReFitTrack(), PHCASeeding::RemoveBadClusters(), ReorderElements(), riwfun(), rk4step(), rkstepper(), randomGenerator::Rndom(), GPUTPCTrackParam::Rotate(), RotateTranslateScale(), PHG4GDMLWriteDefine::Rotation_vectorWrite(), ActsExamples::RootBFieldWriter< bfield_t >::run(), rv2(), Packet_cdevwcm::rValue(), PHG4Utils::sA(), SaveCanvas(), PHG4GDMLWriteDefine::Scale_vectorWrite(), Acts::TGeoParser::select(), SeparateCartesianBoundaries(), SeparateMainaxisBoundaries(), 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(), LqstCell::set_localY(), 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(), FairBoxSetDraw::SetBoxDimensions(), CbmRichRing::SetCenterY(), CbmRichRingLight::SetCenterY(), PHG4HcalSubsystem::SetPosition(), PndFieldMap::SetPosition(), ActsFatras::Particle::setPosition4(), FairTrackParH::SetTrackPar(), vector3::SetVector(), EicProtoGenerator::SetVertex(), FairMCEventHeader::SetVertex(), CbmMCEvent::SetVertex(), CbmVertex::SetVertex(), node_t::setX(), CbmRichRingLight::SetXYABP(), CbmRichRing::SetXYABPhi(), CbmRichRingLight::SetXYR(), FairHit::SetXYZ(), FairMCPoint::SetXYZ(), FairTrackPar::SetY(), CMFlashClusterv1::setY(), TrkrClusterv2::setY(), TrkrClusterv1::setY(), FairHit::SetY(), FairMCPoint::SetY(), FairTrackParam::SetY(), CbmPixelHit::SetY(), FairTrackParH::SetY_sc(), kdfinder::CircleFit< T >::SigmaWithLargeCircleOption(), Smear::Tracker::Smear(), strf(), nlohmann::detail::dtoa_impl::diyfp::sub(), Acts::Frustum< value_t, DIM, SIDES >::svg(), tails(), EicKfNodeTemplateRadial1D::ThreeDeeToTemplate(), EicKfNodeTemplateAsimuthal1D::ThreeDeeToTemplate(), tetgenmesh::transfernodes(), Acts::Seedfinder< external_spacepoint_t, platform_t >::transformCoordinates(), twoPhotonLuminosity::twoPhotonDifferentialLuminosity(), ulangl(), vacpol(), vector3::vector3(), VirtSpacePointRecoHit::VirtSpacePointRecoHit(), PHG4InnerHcalDetector::x_at_y(), and xytabl().
void __m128 __m128 __m128 __m128 __m128 __m128 __m128& y3 |
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 EICG4LumiDetector::AddTriangularTrapezoid(), HelixHough::allButKappaRange_sse(), sPHENIXTrackerTpc::calculateKappaTangents(), sPHENIXTracker::calculateKappaTangents(), sPHENIXSeedFinder::calculateKappaTangents(), PHG4HcalDetector::ConstructMe(), getneff(), hijing(), CellularAutomaton_v1::process_single_track(), CellularAutomaton_v1::process_single_triplet(), pyhiklim(), pyklim(), pykmap(), and Acts::DiamondBounds::vertices().
__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 ALICEKF::ALICEKalmanFilter(), AnnularFieldSim::AnnularFieldSim(), FairModule::AssignMediumAtImport(), avscatcen(), Acts::SolenoidBField::B_r(), Acts::SolenoidBField::B_z(), BeamLine(), BeamLineDefineMagnets(), BeastMagneticField::BeastMagneticField(), Acts::Test::BOOST_AUTO_TEST_CASE(), BOOST_DATA_TEST_CASE(), Acts::IntegrationTest::BOOST_DATA_TEST_CASE(), Acts::Test::BOOST_DATA_TEST_CASE(), Acts::Test::BOOST_FIXTURE_TEST_CASE(), PHG4mRICHDetector::build_mRICH_sector(), PHG4mRICHDetector::build_mRICH_sector2(), PHG4mRICHDetector::build_mRICH_wall_eside(), PHG4mRICHDetector::build_mRICH_wall_eside_proj(), PHG4mRICHDetector::build_mRICH_wall_hside(), PHG4TTLDetector::BuildBarrelTTL(), PHG4TTLDetector::BuildForwardTTL(), Acts::Legacy::AtlasSeedfinder< SpacePoint >::buildFrameWork(), PHGenFitTrkProp::BuildLayerZPhiHitMap(), FairGeoMedium::calcRadiationLength(), HelixHoughFuncs_v1::calculate_dzdl_range(), tetgenmesh::calculateabovepoint(), CylinderKalman::calculateProjections(), HelixKalmanFilter::calculateProjections(), FairGeoOldAsciiIo::calculateShapePoints(), ClassImp(), CMDistortionAnalysis(), CMDistortionAnalysisCart(), CMDistortionAnalysisPhiR(), CMDistortionReco(), CMDistortionRecoCart(), CMDistortionRecoPhiR(), Acts::detail::combineSlabs(), PHG4FPbScDetector::computeIndex(), Smear::RadialTracker::ComputeIntersectionWithRadius(), Smear::PlanarTracker::ComputeIntersectionWithRadius(), PHG4SpacalDetector::Construct_AzimuthalSeg(), PHG4InnerHcalDetector::ConstructHcalSingleScintillators(), PHG4OuterHcalDetector::ConstructHcalSingleScintillators(), PHG4PSTOFDetector::ConstructMe(), G4EicDircDetector::ConstructMe(), Smear::Acceptance::CustomCut::Contains(), BEmcRec::CorrectShowerDepth(), Acts::AtlasStepper< bfield_t >::covarianceTransport(), genfit::MeasurementCreator::create(), create_element(), CreateKnotsExtruded(), RawTowerBuilder::CreateNodes(), PHActsSiliconSeeding::createSvtxTrack(), Acts::GaussianGridTrackDensity< mainGridSize, trkGridSize >::createTrackGrid(), CylindricalCoordinateCurve(), CylindricalCoordinateTransformation(), G4EicDircDetector::DefineMaterials(), PHG4Reco::DefineMaterials(), deriv(), dofistatescat(), dokinematics(), Acts::GeometryView3D::drawSurfaceArray(), HelixHough::dzdlRange_sse(), Acts::DD4hepLayerBuilder::endcapLayers(), QAG4SimulationCalorimeterSum::eval_trk_proj(), QAG4SimulationEicCalorimeterSum::eval_trk_proj(), TpcSpaceChargeReconstructionHelper::extrapolate_phi1(), TpcSpaceChargeReconstructionHelper::extrapolate_z(), f2allm(), SvtxClusterEval::fast_approx_atan2(), fieldconverter(), ActsExamples::BField::txt::fieldMapperRZ(), ActsExamples::BField::root::fieldMapperRZ(), ActsExamples::BField::txt::fieldMapperXYZ(), ActsExamples::BField::root::fieldMapperXYZ(), eicpy.qaplots.TrackHists::fill(), fillEvent(), Acts::Legacy::AtlasSeedfinder< SpacePoint >::fillLists(), CaloEvaluator::fillOutputNtuples(), SvtxEvaluator::fillOutputNtuples(), Acts::TrackDensityVertexFinder< vfitter_t, track_density_t >::find(), Acts::GridDensityVertexFinder< mainGridSize, trkGridSize, vfitter_t >::find(), CylinderGeomMicromegas::find_tile_cylindrical(), HelixHough::findHelices(), HelixHough::findSeededHelices_run(), flgint(), flqint(), fltint(), Acts::Material::fromMassDensity(), Acts::Material::fromMolarDensity(), 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(), simpleRandom::gauss(), genfit::Field::get(), TpcDirectLaserReconstruction::get_cell_index(), TpcSpaceChargeReconstruction::get_cell_index(), TpcDistortionCorrection::get_corrected_position(), TowerJetInput::get_input(), PHG4GDMLWriteDefine::GetAngles(), AnnularFieldSim::GetBFieldAt(), GetBinominalRatio(), PndTransMap::GetBxyz(), PndDipoleMap::GetBxyz(), PndSolenoidMap::GetBxyz(), PHTpcResiduals::getCell(), AnnularFieldSim::GetChargeAt(), AnnularFieldSim::GetFieldAt(), PHField2D::GetFieldCyl(), PHField3DCylindrical::GetFieldCyl(), PHFieldCleo::GetFieldValue(), PHField3DCartesian::GetFieldValue(), PHFieldBeast::GetFieldValue(), PHField2D::GetFieldValue(), PHField3DCylindrical::GetFieldValue(), ALICEKF::GetLineClusterResiduals(), getmass(), LSLTrackRep::getMom(), getnewmass(), getpdf(), getpdfxintexact(), getpnorad1(), LSLTrackRep::getPos(), LSLTrackRep::getPosMom(), getscatterer(), getsscat(), A_Event::getTime(), Smear::GetVariable(), gmin(), gmre(), gphoton(), kdfinder::CircleFit< T >::GradientHessian(), hFarFwdDefineMagnets(), sPHENIXTracker::initDummyHits(), sPHENIXSeedFinder::initDummyHits(), Acts::LineSurface::initJacobianToGlobal(), Acts::Surface::initJacobianToGlobal(), Acts::Surface::initJacobianToLocal(), HcalRawTowerBuilder::InitRun(), PHG4FullProjSpacalCellReco::InitRun(), sPHENIXTrackerTpc::initSplitting(), sPHENIXTracker::initSplitting(), sPHENIXSeedFinder::initSplitting(), tetgenmesh::insertconstrainedpoints(), Acts::ConeVolumeBounds::inside(), Acts::Legacy::InternalSeed< SpacePoint >::InternalSeed(), intpgghigh(), intpgglow(), intpqghigh(), intpqglow(), intpqq(), CbmRichRingFitterEllipseTau::Jacobi(), Acts::SolenoidBField::k2(), Acts::LayerArrayCreator::layerArray(), PHTpcClusterMover::line_fit(), ALICEKF::line_fit(), PHTruthTrackSeeding::lineFit(), PHActsSiliconSeeding::lineFit(), mesh_t::load(), AnnularFieldSim::load3dBfield(), AnnularFieldSim::load_and_resample_spacecharge(), tetgenio::load_node_call(), LoadAnsysInput(), AnnularFieldSim::loadBfield(), AnnularFieldSim::loadEfield(), LoadElmergrid(), LoadFieldviewInput(), LoadGidInput(), lremh(), LSLTrackRep::LSLTrackRep(), ludcyk(), luindf(), lushow(), lustrf(), luzdis(), lysspa(), main(), Acts::Test::SurfaceArrayFixture::makeBarrel(), Acts::Test::SurfaceArrayCreatorFixture::makeBarrel(), Acts::Test::LayerCreatorFixture::makeBarrel(), Acts::Test::SurfaceArrayCreatorFixture::makeBarrelStagger(), Acts::Test::LayerCreatorFixture::makeBarrelStagger(), PHG4ScoringManager::makeScoringHistograms(), PHActsSiliconSeeding::makeSpacePoint(), makesplitting(), makestrings_minl(), PHActsSiliconSeeding::makeSvtxTracks(), mfield2eve(), mkasym(), mkf2(), momentumDistributions(), PHHepMCGenEvent::moveVertex(), Acts::Legacy::AtlasSeedfinder< SpacePoint >::newSpacePoint(), tetgenmesh::norm2(), Acts::GaussianGridTrackDensity< mainGridSize, trkGridSize >::normal2D(), FairRKPropagator::OneStepRungeKutta(), ActsFatras::BetheHeitler::operator()(), ActsFatras::LandauDistribution::operator()(), tetgenmesh::outmesh2vtk(), parton(), pdfint(), pgg(), pgq(), PHField2D::PHField2D(), PHField3DCylindrical::PHField3DCylindrical(), pickvtx(), EtmDetector::PlaceG4Volume(), Acts::ConeSurface::polyhedronRepresentation(), PHG4GDMLWriteDefine::Position_vectorWrite(), pqg(), pqq(), PHG4Hitv1::print(), printBField(), printHits(), CaloEvaluator::printOutputInfo(), SvtxEvaluator::printOutputInfo(), PHTruthTrackSeeding::Process(), PHG4CylinderCellReco::process_event(), PHG4FullProjSpacalCellReco::process_event(), PHG4SimpleEventGenerator::process_event(), PHGenFitTrackProjection::process_event(), PHTpcCentralMembraneClusterizer::process_event(), Acts::Legacy::AtlasSeedfinder< SpacePoint >::production3Sp(), Nystrom::propagate(), pydcyk(), pyeig4(), pygfxx(), pyhiscat(), pyhisspa(), pyindf(), pylamf(), pymewt(), pyptfs(), pyptis(), pyreco(), pyscat(), pyshow(), pysspa(), pystrf(), pyzdis(), ActsFatras::LandauDistribution::quantile(), twoPhotonLuminosity::radmul(), Acts::IntegrationTest::readFieldXYZ(), readFile(), FairGeoTube::readPoints(), FairGeoTubs::readPoints(), FairGeoCons::readPoints(), FairGeoPgon::readPoints(), FairGeoEltu::readPoints(), FairGeoPcon::readPoints(), FairGeoCone::readPoints(), FairGeoBasicShape::readPoints(), readSeedFile(), PHGenFitTrkFitter::ReFitTrack(), ReorderElements(), RICHSetup(), RotateTranslateScale(), PHG4GDMLWriteDefine::Rotation_vectorWrite(), ActsExamples::RootBFieldWriter< bfield_t >::run(), PHG4GDMLWriteDefine::Scale_vectorWrite(), Acts::TGeoParser::select(), SeparateCartesianBoundaries(), SeparateMainaxisBoundaries(), 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(), LqstCell::set_localZ(), 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(), PHG4BlockCellGeom::set_zmin(), PHG4CylinderCellGeom::set_zmin(), PHG4BlockCellGeom::set_zstep(), PHG4CylinderCellGeom::set_zstep(), FairBoxSetDraw::SetBoxDimensions(), EicGeoMedium::setComponent(), FairGeoMedium::setComponent(), FairIon::SetParams(), PHG4HcalSubsystem::SetPosition(), PndFieldMap::SetPosition(), ActsFatras::Particle::setPosition4(), FairPrimaryGenerator::SetTarget(), FairTrackParH::SetTrackPar(), vector3::SetVector(), EicProtoGenerator::SetVertex(), FairMCEventHeader::SetVertex(), CbmMCEvent::SetVertex(), CbmVertex::SetVertex(), FairHit::SetXYZ(), FairMCPoint::SetXYZ(), PHG4IonGun::SetZ(), FairTrackPar::SetZ(), CbmBaseHit::SetZ(), CMFlashClusterv1::setZ(), FairHit::SetZ(), TrkrClusterv2::setZ(), TrkrClusterv1::setZ(), FairMCPoint::SetZ(), FairTrackParam::SetZ(), KalmanNode::SetZ(), FairTrackParH::SetZ_sc(), CbmRichReconstruction::SetZTrackExtrapolation(), Acts::Legacy::Seed< SpacePoint >::setZVertex(), sgmin(), kdfinder::CircleFit< T >::SigmaWithLargeCircleOption(), MediaBank::StartNextLayer(), AnnularFieldSim::sum_local_field_at(), surface(), tetgenmesh::transfernodes(), vector3::vector3(), and VirtSpacePointRecoHit::VirtSpacePointRecoHit().
__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 HelixHough::allButKappaRange_sse(), CellularAutomaton_v1::calculate_kappa_tangents(), sPHENIXTrackerTpc::calculateKappaTangents(), sPHENIXTracker::calculateKappaTangents(), sPHENIXSeedFinder::calculateKappaTangents(), CEmc(), vc2020_03_20::CreateGeometry(), CylindricalCoordinateCurve(), Rossegger::Ephi(), Rossegger::Ephi_(), Rossegger::Er(), Rossegger::Er_(), Rossegger::Ez(), Rossegger::Ez_(), fgp1(), fgp2(), fgp3(), GPUTPCTrackParam::Filter(), flap(), flap1(), flap2(), genevent(), AnnularFieldSim::GetGroupCellCenter(), getmd(), tetgenmesh::hilbert_sort3(), EicBeamLineElementMap::Initialize(), insphereslow(), lzp(), MediaSliceArray::MediaSliceArray(), MovePointAngle(), pollzp(), PHG4GenHit::process_event(), PHG4MvtxHitReco::process_event(), PHG4InttHitReco::process_event(), PHG4ParticleGeneratorVectorMeson::process_event(), CellularAutomaton_v1::process_single_track(), CellularAutomaton_v1::process_single_triplet(), profile(), py4jtw(), pyhiscat(), pyscat(), PHG4ConeSubsystem::Set_eta_range(), tails(), tetgenmesh::tri_edge_2d(), and tetgenmesh::tri_edge_tail().
__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 HelixHough::allButKappaRange_sse(), CellularAutomaton_v1::calculate_kappa_tangents(), sPHENIXTrackerTpc::calculateKappaTangents(), sPHENIXTracker::calculateKappaTangents(), sPHENIXSeedFinder::calculateKappaTangents(), CEmc(), PHG4OuterHcalDetector::ConstructHcalSingleScintillators(), vc2020_03_20::CreateGeometry(), CylindricalCoordinateCurve(), CylindricalCoordinateTransformation(), genevent(), getms(), tetgenmesh::hilbert_sort3(), insphereslow(), MediaSliceArray::MediaSliceArray(), PHG4MvtxHitReco::process_event(), PHG4InttHitReco::process_event(), CellularAutomaton_v1::process_single_track(), CellularAutomaton_v1::process_single_triplet(), py4jtw(), pyhiscat(), pyscat(), PHG4ConeSubsystem::Set_eta_range(), and tails().