FairRoot/PandaRoot
Classes | Macros | Typedefs | Functions | Variables
P4_F32vec4.h File Reference
#include <iostream>
#include <cmath>
#include "xmmintrin.h"
#include "vec_arithmetic.h"
#include "std_alloc.h"

Go to the source code of this file.

Classes

class  F32vec4
 

Macros

#define _f32vec4_abs_mask   (static_cast<F32vec4>(__f32vec4_abs_mask_cheat.m))
 
#define _f32vec4_sgn_mask   (static_cast<F32vec4>(__f32vec4_sgn_mask_cheat.m))
 
#define _f32vec4_zero   (static_cast<F32vec4>(__f32vec4_zero_cheat.m))
 
#define _f32vec4_one   (static_cast<F32vec4>(__f32vec4_one_cheat.m))
 
#define _f32vec4_true   (static_cast<F32vec4>(__f32vec4_true_cheat.m))
 
#define _f32vec4_false   (static_cast<F32vec4>(__f32vec4_false_cheat.m))
 
#define if3(a, b, c)   ((a)&(b)) | ((!(a))&(c))
 
#define NotEmpty(a)   bool((a)[0])|bool((a)[1])|bool((a)[2])|bool((a)[3])
 
#define Empty(a)   !(bool((a)[0])|bool((a)[1])|bool((a)[2])|bool((a)[3]))
 
#define _f1(A, F)   F32vec4( F(A[0]), F(A[1]), F(A[2]), F(A[3]) )
 
#define _fvecalignment   __attribute__ ((aligned(16)))
 

Typedefs

typedef F32vec4 fvec
 
typedef float fscal
 

Functions

class F32vec4 __attribute__ ((aligned(16)))
 
float & operator[] (int i)
 
 F32vec4 ()
 
 F32vec4 (const __m128 &a)
 
 F32vec4 (const float &a)
 
 F32vec4 (const float &f0, const float &f1, const float &f2, const float &f3)
 
 operator __m128 () const
 
F32vec4 operator+ (const F32vec4 &a, const F32vec4 &b)
 
F32vec4 operator- (const F32vec4 &a, const F32vec4 &b)
 
F32vec4 operator* (const F32vec4 &a, const F32vec4 &b)
 
F32vec4 operator/ (const F32vec4 &a, const F32vec4 &b)
 
F32vec4 min (const F32vec4 &a, const F32vec4 &b)
 
F32vec4 max (const F32vec4 &a, const F32vec4 &b)
 
F32vec4 sqrt (const F32vec4 &a)
 
F32vec4 rsqrt (const F32vec4 &a)
 
F32vec4 rcp (const F32vec4 &a)
 
F32vec4 fabs (const F32vec4 &a)
 
F32vec4 sgn (const F32vec4 &a)
 
F32vec4 asgnb (const F32vec4 &a, const F32vec4 &b)
 
F32vec4 operator& (const F32vec4 &a, const F32vec4 &b)
 
F32vec4 operator| (const F32vec4 &a, const F32vec4 &b)
 
F32vec4 operator^ (const F32vec4 &a, const F32vec4 &b)
 
F32vec4 operator! (const F32vec4 &a)
 
F32vec4 operator< (const F32vec4 &a, const F32vec4 &b)
 
F32vec4 operator<= (const F32vec4 &a, const F32vec4 &b)
 
F32vec4 operator> (const F32vec4 &a, const F32vec4 &b)
 
F32vec4 operator>= (const F32vec4 &a, const F32vec4 &b)
 
F32vec4 operator== (const F32vec4 &a, const F32vec4 &b)
 
F32vec4 bool2int (const F32vec4 &a)
 
 vec_arithmetic (F32vec4, float)
 
F32vec4 exp (const F32vec4 &a)
 
F32vec4 log (const F32vec4 &a)
 
F32vec4 sin (const F32vec4 &a)
 
F32vec4 cos (const F32vec4 &a)
 
F32vec4 acos (const F32vec4 &a)
 
F32vec4 atan2 (const F32vec4 &y, const F32vec4 &x)
 
std::ostreamoperator<< (std::ostream &strm, const F32vec4 &a)
 
std::istreamoperator>> (std::istream &strm, F32vec4 &a)
 

Variables

union {
   float   f
 
   unsigned int   i
 
__f_one = {1.f}
 
union {
   unsigned int   i [4]
 
   __m128   m
 
__f32vec4_abs_mask_cheat = {{0x7fffffff, 0x7fffffff, 0x7fffffff, 0x7fffffff}}
 
union {
   unsigned int   i [4]
 
   __m128   m
 
__f32vec4_sgn_mask_cheat = {{0x80000000, 0x80000000, 0x80000000, 0x80000000}}
 
union {
   unsigned int   i [4]
 
   __m128   m
 
__f32vec4_zero_cheat = {{ 0, 0, 0, 0}}
 
union {
   unsigned int   i [4]
 
   __m128   m
 
__f32vec4_one_cheat = {{__f_one.i , __f_one.i , __f_one.i , __f_one.i }}
 
union {
   unsigned int   i [4]
 
   __m128   m
 
__f32vec4_true_cheat = {{0xFFFFFFFF, 0xFFFFFFFF, 0xFFFFFFFF, 0xFFFFFFFF}}
 
union {
   unsigned int   i [4]
 
   __m128   m
 
__f32vec4_false_cheat = {{0x00000000, 0x00000000, 0x00000000, 0x00000000}}
 
__m128 v
 
const int fvecLen = 4
 

Macro Definition Documentation

#define _f1 (   A,
  F 
)    F32vec4( F(A[0]), F(A[1]), F(A[2]), F(A[3]) )

Definition at line 107 of file P4_F32vec4.h.

#define _f32vec4_abs_mask   (static_cast<F32vec4>(__f32vec4_abs_mask_cheat.m))

Definition at line 37 of file P4_F32vec4.h.

#define _f32vec4_false   (static_cast<F32vec4>(__f32vec4_false_cheat.m))

Definition at line 42 of file P4_F32vec4.h.

#define _f32vec4_one   (static_cast<F32vec4>(__f32vec4_one_cheat.m))

Definition at line 40 of file P4_F32vec4.h.

#define _f32vec4_sgn_mask   (static_cast<F32vec4>(__f32vec4_sgn_mask_cheat.m))

Definition at line 38 of file P4_F32vec4.h.

#define _f32vec4_true   (static_cast<F32vec4>(__f32vec4_true_cheat.m))

Definition at line 41 of file P4_F32vec4.h.

#define _f32vec4_zero   (static_cast<F32vec4>(__f32vec4_zero_cheat.m))

Definition at line 39 of file P4_F32vec4.h.

#define _fvecalignment   __attribute__ ((aligned(16)))

Definition at line 223 of file P4_F32vec4.h.

#define Empty (   a)    !(bool((a)[0])|bool((a)[1])|bool((a)[2])|bool((a)[3]))

Definition at line 94 of file P4_F32vec4.h.

#define if3 (   a,
  b,
  c 
)    ((a)&(b)) | ((!(a))&(c))
#define NotEmpty (   a)    bool((a)[0])|bool((a)[1])|bool((a)[2])|bool((a)[3])

Definition at line 93 of file P4_F32vec4.h.

Typedef Documentation

typedef float fscal

Definition at line 219 of file P4_F32vec4.h.

typedef F32vec4 fvec

Definition at line 218 of file P4_F32vec4.h.

Function Documentation

class F32vec4 __attribute__ ( (aligned(16))  )
friend F32vec4 __attribute__::acos ( const F32vec4 a)

Definition at line 113 of file P4_F32vec4.h.

Referenced by analysis_digi_cluster_7gammaAnalysis_FullEmc(), analysis_digi_cluster_allGammasAnalysis_FullEmc(), analysis_digi_cluster_allGammasAnalysis_fwendcap(), analysis_digi_cluster_fwendcap(), angle(), PndFsmRich::compThetaC(), PndFsmDrcDisc::compThetaC(), PndFsmDrcBarrel::compThetaC(), createRootGeometry_RICH(), PndDrcReco::DetermineCherenkov(), PndDiscTaskReconstruction::Exec(), PndDskFLGHitProducerIdeal::Exec(), PndTrkCTGeometryCalculations::FindingParallelTrackAngularRange(), PndTrkCTGeometryCalculations::FindingParallelTrackAngularRange2(), PndTrkCTGeometryCalculations::FindIntersectionsOuterCircle(), PndSttTrackFinderReal::FindIntersectionsOuterCircle(), PndDrcReco::FindPdg(), PndDrcLutReco::FindPdg(), KFParticle::GetAngle(), KFParticleSIMD::GetAngle(), KFParticle::GetAngleRZ(), KFParticleSIMD::GetAngleRZ(), KFParticle::GetAngleXY(), KFParticleSIMD::GetAngleXY(), PndSciTAnaIdeal::GetDPhi(), PndRichGeo::init(), PndRiemannTrack::init(), PndTrkCTGeometryCalculations::IntersectionsWithGapSemicircle(), PndSttTrackFinderReal::IntersectionsWithGapSemicircle(), mz_pp_to_leplep_vandewi_event(), mz_pp_to_leplep_vandewi_sigma(), mz_pp_to_pipi_vandewi_event(), mzangle(), mzazimuthal(), mzpolar(), PndSttTrackFinderReal::PndSttFindingParallelTrackAngularRange(), PndDrc::ProcessHits(), PndDsk::ProcessHitsParticle(), PndDrcRecoLookupMapS::ProcessPhotonHit(), PndDrcRecoLookupMap::ProcessPhotonHit(), PndHypBupGenerator::ReadEvent(), PndGasGenerator::ReadEvent(), PndBoxGenerator::ReadEvent(), PndVolGenerator::ReadEvent(), PndFixStepParticleGun::ReadEvent(), PndFsmDrcBarrel::respond(), RhoRhoPHOTOSUserTreeAnalysis(), PndRichPhoton::TrackCalc(), trapmap_barrel(), and trapmap_disc().

119 { // mask returned
friend F32vec4 __attribute__::asgnb ( const F32vec4 a,
const F32vec4 b 
)

Definition at line 51 of file P4_F32vec4.h.

References i.

51  { return (reinterpret_cast<const float*>(&v))[i]; }
52 
53  F32vec4( ):v(_mm_set_ps1(0)){}
F32vec4()
Definition: P4_F32vec4.h:9
__m128 v
Definition: P4_F32vec4.h:4
unsigned int i
Definition: P4_F32vec4.h:22
friend F32vec4 __attribute__::atan2 ( const F32vec4 y,
const F32vec4 x 
)

Definition at line 117 of file P4_F32vec4.h.

Referenced by PndTrkCTFindTrackInXY2::AddMvdHitsToSttTracks(), PndTrkCTFindTrackInXY::AssociateSciTilHit(), PndTrkCTFindTrackInXY2::AssociateSciTilHit(), PndSttTrackFinderReal::AssociateSciTilHit(), PndSttTrackFinderReal::AssociateSkewHitsToXYTrack(), CAMath::ATan2< float >(), PndTrkCleanup::BadTrack_ParStt(), PndTrkSttConformalFilling::BoxConformalFilling(), PndTrkCTGeometryCalculations::CalculateArcLength(), PndSttTrackFinderReal::CalculateArcLength(), PndTrkCTGeometryCalculations::CalculateSandZ2(), PndSttTrackFinderReal::ChooseEntranceExit(), PndTrkCTGeometryCalculations::ChooseEntranceExit3(), PndTrkCTGeometryCalculations::ChooseEntranceExitbis(), PndSttTrackFinderReal::ChooseEntranceExitbis(), PndTrkTracking2::CollectParSttHitsagain(), PndTrkComparisonMCtruth::ComparisonwithMC(), createRootGeometry_RICH(), PndTrkCTFindTrackInXY2::DecideWhichAngularRangeAndCharge(), PndFsmTof::detected(), PndFsmStt::detected(), PndFsmDrcBarrel::detected(), PndSttTrackFinderReal::DoFind(), PndTrkPlotMacros::DrawHexagonCircleInMacro(), PndTrkPlotMacros2::DrawHexagonCircleInMacro(), PndSttTrackFitterQATask::Exec(), PndTrkCTGeometryCalculations::FindingParallelTrackAngularRange(), PndTrkCTGeometryCalculations::FindingParallelTrackAngularRange2(), PndTrkCTGeometryCalculations::FindIntersectionsOuterCircle(), PndSttTrackFinderReal::FindIntersectionsOuterCircle(), PndSttTrackFinderReal::FindTrackEntranceExitbiHexagon(), PndTrkCTGeometryCalculations::FindTrackEntranceExitbiHexagonLeft(), PndSttTrackFinderReal::FindTrackEntranceExitbiHexagonLeft(), PndTrkCTGeometryCalculations::FindTrackEntranceExitbiHexagonLeft2(), PndTrkCTGeometryCalculations::FindTrackEntranceExitbiHexagonRight(), PndSttTrackFinderReal::FindTrackEntranceExitbiHexagonRight(), PndTrkCTGeometryCalculations::FindTrackEntranceExitbiHexagonRight2(), PndSttTrackFinderReal::FindTrackEntranceExitHexagonCircle(), PndTrkCTGeometryCalculations::FindTrackEntranceExitHexagonCircleLeft(), PndSttTrackFinderReal::FindTrackEntranceExitHexagonCircleLeft(), PndTrkCTGeometryCalculations::FindTrackEntranceExitHexagonCircleLeft2(), PndTrkCTGeometryCalculations::FindTrackEntranceExitHexagonCircleRight(), PndSttTrackFinderReal::FindTrackEntranceExitHexagonCircleRight(), PndTrkCTGeometryCalculations::FindTrackEntranceExitHexagonCircleRight2(), PndTrkCTFindTrackInXY::FindTrackInXYProjection(), PndTrkCTFindTrackInXY2::FindTrackInXYProjection(), PndSttTrackFinderReal::FindTrackInXYProjection(), KFParticleBase::GetDStoParticleBy(), KFParticleBaseSIMD::GetDStoParticleBy(), KFParticleBase::GetDStoParticleBz(), KFParticleBaseSIMD::GetDStoParticleBz(), KFParticleBase::GetDStoPointBy(), KFParticleBaseSIMD::GetDStoPointBy(), KFParticleBase::GetDStoPointBz(), KFParticleBaseSIMD::GetDStoPointBz(), KFParticle::GetExternalTrackParam(), KFParticleSIMD::GetExternalTrackParam(), KFParticleBase::GetPhi(), KFParticleBaseSIMD::GetPhi(), KFParticle::GetTheta(), PndFtsHoughTrackCand::getThetaZxRad(), PndTrkCleanup::GoodTrack(), PndTrkTracking2::InfoXYZParal(), PndTrkCTGeometryCalculations::IntersectionsWithGapSemicircle(), PndSttTrackFinderReal::IntersectionsWithGapSemicircle(), PndTrkCTGeometryCalculations::IsInsideArc(), PndSttTrackFinderReal::IsInsideArc(), PndTrkCTGeometryCalculations::ListAxialSectorsCrossedbyTrack_and_Hits(), PndTrkTracking2::MatchMvdHitsToSttTracks(), PndTrkTracking2::MatchMvdHitsToSttTracks2(), PndTrkTracking2::MatchMvdHitsToSttTracksagain(), mzazimuthal(), PndTrkCTFindTrackInXY::OrderingParallel(), PndTrkTracking2::OrderingSttSkewandSttParallel(), PndTrkCTFindTrackInXY2::OrderingUsingConformal(), PndTrkTracking2::OrderingUsingConformal(), PndSttTrackFinderReal::OrderingUsingConformal(), PndTrkCTFindTrackInXY2::OrderingUsingFi(), PndSttTrackFinderReal::PndSttBoxConformalFilling(), PndSttTrackFinderReal::PndSttFindingParallelTrackAngularRange(), PndSttTrackFinderReal::PndSttInfoXYZParal(), PndSttTrackFinderReal::PndSttOrdering(), PndSttTrackFinderReal::PndSttOrderingParallel(), PndSttTrackFinderReal::PndSttOrderingSkewandParallel(), PndSttTrackFinderReal::PndSttTrkAssociatedParallelHitsToHelix5(), PndSttTrackFinderReal::PndSttTrkAssociatedParallelHitsToHelixQuater(), PndTrkTracking2::StoreSZ_MvdScitil(), PndTrkPlotMacros::SttInfoXYZParal(), PndTrkPlotMacros2::SttInfoXYZParal(), PndTrkCleanup::SttParalCleanup(), PndTrkCleanup::SttSkewCleanup(), PndTrkCleanup::Track_Crosses_MvdBarrelPartialAzimuthalCoverage(), PndRichPhoton::TrackCalc(), RhoKinVtxFitter::TransportToVertex(), RhoKinHyperonVtxFitter::TransportToVertex(), PndTrkCTFindTrackInXY2::TrkAssociatedParallelHitsToHelix5(), PndTrkCTFindTrackInXY::TrkAssociatedParallelHitsToHelix5(), PndTrkCTFindTrackInXY2::TrkAssociatedParallelHitsToHelix6(), PndTrkCTFindTrackInXY::TrkAssociatedParallelHitsToHelixQuater(), PndTrkPlotMacros::WriteAllMacros(), PndTrkPlotMacros2::WriteAllMacros(), PndTrkPlotMacros::WriteMacroParallelHitsGeneral(), PndTrkPlotMacros2::WriteMacroParallelHitsGeneral(), PndSttTrackFinderReal::WriteMacroParallelHitswithRfromMC(), PndSttTrackFinderReal::WriteMacroSkewAssociatedHits(), PndTrkPlotMacros::WriteMacroSkewAssociatedHitswithMC(), PndTrkPlotMacros2::WriteMacroSkewAssociatedHitswithMC(), PndSttTrackFinderReal::WriteMacroSkewAssociatedHitswithMC(), PndTrkPlotMacros2::WriteMacroSkewAssociatedHitswithMC_Degree(), PndSttTrackFinderReal::WriteMacroSkewAssociatedHitswithRfromMC(), and PndTrkCleanup::XYCleanup().

119  { // mask returned
120  return _mm_cmplt_ps(a, b);
121  }
122  friend F32vec4 operator<=( const F32vec4 &a, const F32vec4 &b ){ // mask returned
123  return _mm_cmple_ps(a, b);
124  }
125  friend F32vec4 operator>( const F32vec4 &a, const F32vec4 &b ){ // mask returned
126  return _mm_cmpgt_ps(a, b);
127  }
128  friend F32vec4 operator>=( const F32vec4 &a, const F32vec4 &b ){ // mask returned
129  return _mm_cmpge_ps(a, b);
130  }
131  friend F32vec4 operator==( const F32vec4 &a, const F32vec4 &b ){ // mask returned
132  return _mm_cmpeq_ps(a, b);
133  }
134 
135  #define if3(a, b, c) ((a)&(b)) | ((!(a))&(c)) // analog (a) ? b : c
136 
137  #define NotEmpty(a) bool((a)[0])|bool((a)[1])|bool((a)[2])|bool((a)[3])
138  #define Empty(a) !(bool((a)[0])|bool((a)[1])|bool((a)[2])|bool((a)[3]))
139  // bool NotEmpty(const F32vec4 &a) { return a[0]||a[1]||a[2]||a[3]; }
140  // bool Empty(const F32vec4 &a) { return !(a[0]||a[1]||a[2]||a[3]); } // optimize
141  friend F32vec4 bool2int( const F32vec4 &a){ // mask returned
142  return if3(a,1,0);
143  }
144 
145  /* Define all operators for consistensy */
146 
147  vec_arithmetic(F32vec4,float);
148 
149  /* Non intrinsic functions */
150 
151 #define _f1(A,F) F32vec4( F(A[0]), F(A[1]), F(A[2]), F(A[3]) )
152 
153  friend F32vec4 exp( const F32vec4 &a ){ return _f1( a, exp ); }
154  friend F32vec4 log( const F32vec4 &a ){ return _f1( a, log ); }
155  friend F32vec4 sin( const F32vec4 &a ){ return _f1( a, sin ); }
156  friend F32vec4 cos( const F32vec4 &a ){ return _f1( a, cos ); }
157  friend F32vec4 acos( const F32vec4 &a ){ return _f1( a, acos ); }
friend F32vec4 acos(const F32vec4 &a)
Definition: P4_F32vec4.h:113
friend F32vec4 cos(const F32vec4 &a)
Definition: P4_F32vec4.h:112
friend F32vec4 exp(const F32vec4 &a)
Definition: P4_F32vec4.h:109
TTree * b
friend F32vec4 sin(const F32vec4 &a)
Definition: P4_F32vec4.h:111
friend F32vec4 operator>=(const F32vec4 &a, const F32vec4 &b)
Definition: P4_F32vec4.h:84
friend F32vec4 log(const F32vec4 &a)
Definition: P4_F32vec4.h:110
#define _f1(A, F)
Definition: P4_F32vec4.h:107
friend F32vec4 operator>(const F32vec4 &a, const F32vec4 &b)
Definition: P4_F32vec4.h:81
Int_t a
Definition: anaLmdDigi.C:126
friend F32vec4 operator<=(const F32vec4 &a, const F32vec4 &b)
Definition: P4_F32vec4.h:78
vec_arithmetic(F32vec4, float)
#define if3(a, b, c)
Definition: P4_F32vec4.h:91
friend F32vec4 operator==(const F32vec4 &a, const F32vec4 &b)
Definition: P4_F32vec4.h:87
friend F32vec4 bool2int(const F32vec4 &a)
Definition: P4_F32vec4.h:97
friend F32vec4 __attribute__::bool2int ( const F32vec4 a)

Definition at line 97 of file P4_F32vec4.h.

101  { // mask returned
friend F32vec4 __attribute__::cos ( const F32vec4 a)

Definition at line 112 of file P4_F32vec4.h.

Referenced by ana_pid(), PndLmdStripClusterTask::Backmap(), PndSdsStripClusterTask::Backmap(), PndEmcXClMoments::Calc_AbsZernikeMoment(), chigen::PythiaChiGen::calculateHadronRemnants(), PndTrkTracking2::CalculateSinandCosin(), PndCAGBTracker::CATrackFinder(), PndTrkComparisonMCtruth::ComparisonwithMC(), compFoxWolfMoms(), constructGasManifold(), PndHypGe::ConstructHPGeGeometry(), constructMechanicalFrame(), CAMath::Cos(), create_half_geo(), create_HV_MAPS(), create_HypSTxy3Cmic_RootGeo5LayExt(), create_lumi(), create_lumi_geanetest(), create_scit_rootgeo_201505(), create_scit_rootgeo_201508(), create_scit_rootgeo_201601(), create_scit_rootgeo_201601_plot(), create_scit_rootgeo_pSuperModule(), createdirc(), createdirc_prism(), createdircPix(), createRootGeoFileFwEndCap_2011(), createRootGeometry_beampipe(), createRootGeometry_DIRC(), createRootGeometry_DIRC_fsEVdroplens_MCPs(), createRootGeometry_DIRC_sepEV_06_2013(), createRootGeometry_DIRC_sepEV_MCPs(), createRootGeometry_DIRC_updated_06_2013(), createRootGeometry_RICH(), createstt(), PndGiBuuJPsiEE::DecayTrack(), PndRiemannTrack::dip(), PndSttTrackFinderIdeal::DoFind(), PndSttHelixTrackFitter::DoFitPlain(), PndDrcRecoLookupMap::DrawDetectorLayout(), PndFTSCADisplay::DrawHelix(), DrawHits::DrawHisto(), PndFTSCADisplay::DrawParticleGlobal(), PndFsmEmcBwCap::dtheta(), PndFsmEmcFwCap::dtheta(), emc_correction_QA(), PndEmcClusterSimpleCalibrator::Energy(), PndFtsHoughSpace::equationParabola(), PndFtsHoughSpace::equationParabolaPz(), error_matrix_fit(), PndDiscTaskReconstruction::Exec(), PndSttHelixHitProducer::Exec(), PndSttTrackFitterQATask::Exec(), PndCATracking::Exec(), PndHypStripClusterTask::Exec(), PndSciTAnaIdeal::Exec(), PndEmcXClMoments::Fast_AbsZernikeMoment(), PndDrcLutReco::FillAmbiguities(), PndDrcHitProducerReal::FindDrcHitPositionTilt(), PndTrkCTGeometryCalculations::FindIntersectionsOuterCircle(), PndSttTrackFinderReal::FindIntersectionsOuterCircle(), PndPhoGunShortP::FindReflectionType(), PndPhoGunShort::FindReflectionType(), findSectorIn(), PndTrkCTFindTrackInXY::FindTrackInXYProjection(), PndSttTrackFinderReal::FindTrackInXYProjection(), PndSttHelixTrackFitter::FinishEventDisplay(), FitFunction1(), PndTrkGlpkFits::FitHelixCylinder(), PndTrkLegendreFits::FitHelixCylinder(), PndTrkChi2Fits::FitHelixCylinder(), PndSttTrackFinderReal::FitHelixCylinder(), PndTrkLegendreFits::FitHelixCylinder2(), PndSttTrackFinderReal::FitSZspace(), RhoKalmanVtxFitter::FitVertexFast(), for(), RhoEventShapes::FoxWolfMomH(), EventShape::FoxWolfMomH(), PndEventShape::FoxWolfMomH(), PndDrcTimeDigiTask::FuncD3(), function_beampipe(), PndLmdDim::Generate_rootgeom(), PndLmdGeometryFactory::generateCVDCoolingDisc(), PndLmdGeometryFactory::generateLmdGeometry(), PndLmdGeometryFactory::generatePCB(), Get_PolyLine_circle(), PndFTSTopoReconstructor::GetChiToPrimVertex(), KFParticleBaseSIMD::GetDistanceToVertexLine(), KFParticleBase::GetDStoParticleBy(), KFParticleBaseSIMD::GetDStoParticleBy(), KFParticleBase::GetDStoParticleBz(), KFParticleBaseSIMD::GetDStoParticleBz(), KFParticleBase::GetDStoPointBz(), PndEmcCluster::GetEnergyCorrected(), GetEntriesFast(), PndEmcErrorMatrix::GetErrorMatrix(), PndSttHelixTrackFitter::GetHitAngle(), PndPidCorrelator::GetMvdInfo(), PndFtsHoughTrackCand::getPZPXLabLine(), PndFtsHoughTrackCand::getPZPXLabParabola(), PndSttTrackFinderIdeal::GetTrack(), PndPidCorrelator::GetTrackInfo(), PndSoftTriggerTask::GetVarValue(), PndFTSCATrackParam::GetXYZPxPyPzQ(), PndFsmTrack::HelixRep(), HPGe_geo(), PndPhoGunShort::Init(), PndPhoGunShortP::Init(), PndRichGeo::init(), PndSttHelixTrackFitter::IntersectionFinder(), PndTrkCTGeometryCalculations::IntersectionsWithGapSemicircle(), PndSttTrackFinderReal::IntersectionsWithGapSemicircle(), PndTrkCTGeometryCalculations::IsInTargetPipe(), PndTrkCTGeometryCalculations::IsInternal(), PndSttTrackFinderReal::IsInternal(), PndTrkLegendreFits::LoadMatrix_FindMaximum(), PndTrkTracking2::LoadPndTrack_TrackCand(), PndDrcReco::LookUpTable(), PndEmcClusterMoments::Major1(), PndEmcClusterMoments::Major2(), PndEmcClusterMoments::Minor1(), PndEmcClusterMoments::Minor2(), PndSttHelixTrackFitter::MinuitFit(), PndTrkCleanup::MvdCleanup(), mz_pp_to_leplep_vandewi_event(), mz_pp_to_pipi_vandewi_event(), GFMaterialEffects::noiseCoulomb(), PndDrcHitProducerReal::NumberOfBounces(), PndDrc::NumberOfBounces(), operator>>(), PndTrkTracking2::OrderingConformal_Loading_ListTrackCandHit(), PndTrkTracking2::OrderingSttSkewandSttParallel(), RhoCalculationTools::P7toPRG(), placeSingleLayerSkewedLeft(), placeSingleLayerSkewedRight(), plotrotleft(), plotrotright(), plotTrackCands(), PndHypCalcStrip::PndHypCalcStrip(), PndLmdCalStrip::PndLmdCalStrip(), PndLmdDim::PndLmdDim(), PndSdsCalcStrip::PndSdsCalcStrip(), PndSdsCalcStripDif::PndSdsCalcStripDif(), PndSttTrackFinderReal::PndSttInfoXYZSkew(), PndSttTrackFinderReal::PndSttOrderingSkewandParallel(), PndSttTrackFinderReal::PndSttTrkAssociatedParallelHitsToHelixQuater(), PndDrc::ProcessHits(), PndDsk::ProcessHitsParticle(), DecayTreeFitter::InternalParticle::projectKineConstraint(), PndGeoDskFLG::Propagate(), propagate(), PndFsmTrack::Propagate(), PndAnalysis::Propagator(), PndRhoTupleQA::qa2Body(), PndHypBupGenerator::ReadEvent(), PndGasGenerator::ReadEvent(), PndBoxGenerator::ReadEvent(), PndVolGenerator::ReadEvent(), PndDrcRecoLookupMapS::RecoAmbigTime(), PndDrcRecoLookupMap::RecoAmbigTime(), PndLmdDim::reCreate_transformation_matrices(), PndFsmRich::respond(), PndFsmDrcDisc::respond(), Photospp::PhotosParticle::rotate(), KFPTrack::RotateXY(), KFParticleBase::RotateXY(), KFParticleBaseSIMD::RotateXY(), PndMdtParamDigi::SamplingPosition(), PndEmcXClMoments::SecondMomentTheta(), PndFastSim::SetFlatCovMatrix(), sim(), PndTrkCleanup::SttParalCleanup(), PndTrkCleanup::SttSkewCleanup(), PndTrkCleanup::Track_Crosses_MvdMiniDisk_withMargin(), PndTrkCleanup::TrackCleanup(), KFParticleBase::TransportBz(), KFParticleBaseSIMD::TransportBz(), RhoKinHyperonVtxFitter::TransportToPoca(), trapmap_barrel(), trapmap_disc(), PndTrkCTFindTrackInXY::TrkAssociatedParallelHitsToHelixQuater(), PndTrkPlotMacros::WriteMacroParallel_MvdHitsGeneralConformalwithMC(), PndTrkPlotMacros2::WriteMacroParallel_MvdHitsGeneralConformalwithMC(), PndTrkPlotMacros::WriteMacroParallelHitsGeneral(), PndTrkPlotMacros2::WriteMacroParallelHitsGeneral(), PndSttTrackFinderReal::WriteMacroParallelHitsGeneral(), PndTrkPlotMacros::WriteMacroParallelHitsGeneralConformalwithMC(), PndTrkPlotMacros2::WriteMacroParallelHitsGeneralConformalwithMC(), PndSttTrackFinderReal::WriteMacroParallelHitsGeneralConformalwithMC(), PndSttTrackFinderReal::WriteMacroParallelHitswithRfromMC(), PndSttTrackFinderReal::WriteMacroSkewAssociatedHits(), PndSttTrackFinderReal::WriteMacroSkewAssociatedHitswithMC(), PndSttTrackFinderReal::WriteMacroSkewAssociatedHitswithRfromMC(), PndTrkPlotMacros::WriteMacroSttParallelAssociatedHitsandMvdwithMC(), PndTrkPlotMacros2::WriteMacroSttParallelAssociatedHitsandMvdwithMC(), PndSttHelixTrackFitter::XYFit(), PndSttHelixTrackFitter::XYFitThroughOrigin(), PndSttHelixTrackFitter::ZFinder(), and PndSttHelixTrackFitter::ZFinderThroughOrigin().

119 { // mask returned
friend F32vec4 __attribute__::exp ( const F32vec4 a)

Definition at line 109 of file P4_F32vec4.h.

Referenced by PndSdsCalcStrip::CalcFk(), GFDaf::calcWeights(), PndEmcCR2RCPulseshape::degenerate_solution(), PndEmcCRRCPulseshape::degenerate_solution(), PndEmcAsicPulseshape::degenerate_solution(), PndPidFtofAssociatorTask::DoPidMatch(), PndPidDrcAssociatorTask::DoPidMatch(), PndEmcClusterSimpleCalibrator::Energy(), GFMaterialEffects::energyLossBetheBloch(), PndFastSim::Exec(), PndDrcTimeDigiTask::Exec(), PndEmcExpClusterSplitter::Exec(), FitFunction1(), PndDiscTaskReconstruction::gauss(), PndDiscTaskPID::gauss(), PndFsmRich::gauss(), PndFsmSttPid::gauss(), PndFsmDrcDisc::gauss(), PndFsmDrcBarrel::gauss(), PndFsmStt::gauss(), PndFsmMvd::gauss(), PndFsmEffTracker::gauss(), PndFsmTof::gauss_t(), PndEmcExpPulseshape::general_solution(), PndEmcCR2RCPulseshape::general_solution(), PndEmcCRRCPulseshape::general_solution(), PndEmcAsicPulseshape::general_solution(), PndEmcCluster::GetEnergyCorrected(), getFromWeightFile(), PndMdtParamDigi::GetMPVofPrimaryIonization(), ReadBDT::GetMvaValue__(), PndMdtParamDigi::GetRawSignalbyWeightingAvalanche(), PndMvdSimplePidAlgo::LandauIntegral(), PndMvdIdealPidAlgo::LandauIntegral(), PndEmcClusterProperties::LiloWhere(), MeanExcEnergy_get(), GFMaterialEffects::noiseBetheBloch(), PndEmcFittedPulseshape::operator()(), PndSttSingleStraw::Polya(), PndFtsSingleStraw::Polya(), PndDrcHitProducerReal::ProcessBarPoint(), PndDrcRecoLookupMap::ProcessPhotonHit(), PndDrcDigiTask::ProcessPhotonPoint(), PndCorrDistGenerator::ReadEvent(), chigen::models::ColorSingletPartonicModel::setKin(), chigen::models::ColorSingletPartonicModel::setTrialKin(), PndSttSingleStraw::Signal(), and PndFtsSingleStraw::Signal().

110 { // mask returned
__attribute__::F32vec4 ( )

Definition at line 9 of file P4_F32vec4.h.

20 {
__attribute__::F32vec4 ( const __m128 &  a)

Definition at line 10 of file P4_F32vec4.h.

20 {
__attribute__::F32vec4 ( const float &  a)

Definition at line 11 of file P4_F32vec4.h.

20 {
__attribute__::F32vec4 ( const float &  f0,
const float &  f1,
const float &  f2,
const float &  f3 
)

Definition at line 13 of file P4_F32vec4.h.

20 {
friend F32vec4 __attribute__::fabs ( const F32vec4 a)

Definition at line 47 of file P4_F32vec4.h.

Referenced by PndAnaPidSelector::Accept(), RhoGoodPhotonSelector::Accept(), RhoEnergyParticleSelector::Accept(), RhoMassParticleSelector::Accept(), RhoMomentumParticleSelector::Accept(), PndSoftTriggerTask::AcceptDstCut(), PndFastSim::acceptFilters(), PndTrkCTFindTrackInXY::AcceptHitsConformal(), PndDrcTimeDigiTask::ActivatePixel(), KFParticleBase::AddDaughterWithEnergyCalc(), KFParticleBaseSIMD::AddDaughterWithEnergyCalc(), KFParticleBase::AddDaughterWithEnergyFit(), PndTrkCTFindTrackInXY2::AddMvdHitsToSttTracks(), PndTrkTracking2::AssociateBetterAfterFitSkewHitsToXYTrack(), PndSttTrackFinderReal::AssociateBetterAfterFitSkewHitsToXYTrack(), PndTrkComparisonMCtruth::AssociateFoundTrackstoMCquater(), PndSttTrackFinderReal::AssociateSkewHitsToXYTrack(), PndLmdStripClusterTask::Backmap(), PndSdsStripClusterTask::Backmap(), bestEffEvt(), bestSuppressionEvt(), PndRichReco::BetaPeakFinding(), BOOST_AUTO_TEST_CASE(), PndAnalysis::BuildMcCands(), PndSdsStripCorrelator::CalcChargeDifferenceCut(), PndSdsStripCorrelator::CalcLikelihoodAlgo(), PndSdsCalcPixel::CalcPixel(), PndTrkSttAdjacencies::CalculateAdjacentStt(), PndTrkSttAdjacencies::CalculateAdjacentStt2(), PndTrkCTGeometryCalculations::CalculateCircleThru3Points(), PndFTSCAParam::CalculateFieldSlice(), PndTrkCategorizeStt::CategorizeStt(), PndLmdSigCleanTask::Check(), PndTrkCluster::CheckClusterAgainsV(), PndFTSCAParam::CheckFieldApproximation(), Photospp::PhotosHEPEVTParticle::checkMomentumConservation(), GFWirepointHitPolicy::checkPlane(), GFWireHitPolicy::checkPlane(), PndRiemannTrackFinder::CheckRiemannHit(), PndMvdSttGemRiemannTrackFinder::CheckRiemannHitGem(), PndMvdSttGemRiemannTrackFinder::CheckRiemannHitMvd(), PndMvdSttGemRiemannTrackFinder::CheckRiemannHitSkewedStt(), PndMvdSttGemRiemannTrackFinder::CheckRiemannHitStt(), GeaneTrackRep::checkState(), PndTrkClean::CleanSectors(), PndTrkLegendreSecTask::CleanUpSkewHitList(), PndTrkLegendreTask::CleanUpSkewHitList(), PndTrkLegendreSecTask2::CleanUpSkewHitList(), PndTrkTrackFinder::CleanUpSkewHitList(), PndTrkLegendreSecTask::CleanupZPhiFit(), PndTrkLegendreTask::CleanupZPhiFit(), PndTrkLegendreSecTask2::CleanupZPhiFit(), RhoFindOmittedParticle::ClosestFit(), DecayTreeFitter::closestPointParams(), PndTrkTracking2::CollectParSttHitsagain(), PndTrkComparisonMCtruth::ComparisonwithMC(), compThrust(), RhoKinVtxFitter::Compute(), RhoKinHyperonVtxFitter::Compute(), PndTrkCombiLegendreTask::ComputePerpendicularChi2(), PndTrkLegendreNew::ComputePlaneExtremities(), PndTrkCombiLegendreTask::ComputePlaneExtremities(), PndTrkTrackFinder::ComputePlaneExtremities(), PndTrkTools::ComputePocaToLineOnCircle(), PndTrkCombiLegendreTransform::ComputeThetaR(), convolutionAnalysis(), PndRiemannTrack::correctSttHit(), PndSimpleCombinerTask::CountChargedDaughters(), countDoubles(), PndTrkLegendreNew::CreateClusterAroundTrack(), PndTrkCombiLegendreTask::CreateClusterAroundTrack(), PndTrkTrackFinder::CreateClusterAroundTrack(), PndTrkCombiLegendreTask::CreateClusterAroundTrack3(), createdirc(), createdirc_prism(), createdircPix(), PndSoftTriggerTask::CreateKs0Cands(), DecayTreeFitter::ParticleBase::createParticle(), createRootGeoFileFwEndCap_2011(), createRootGeometry_DIRC(), createRootGeometry_DIRC_fsEVdroplens_MCPs(), createRootGeometry_DIRC_sepEV_06_2013(), createRootGeometry_DIRC_sepEV_MCPs(), createRootGeometry_DIRC_updated_06_2013(), PndEmcStructure::crystal_name_analysis(), PndFastSim::cutAndSmear(), PndRiemannTrack::dDip(), PndFsmMdcFS::detected(), PndFsmRich::detected(), PndFsmStt::detected(), PndFsmTof::detected(), PndFsmDrcBarrel::detected(), PndFsmEmcPid::detected(), GFWirepointHitPolicy::detPlane(), GFWireHitPolicy::detPlane(), diffQA(), PndLmdCalStrip::DigiStripFromPoint(), PndTrkCTGeometryCalculations::Dist_SZ(), PndTrkCTGeometryCalculations::Dist_SZ_bis(), PndTrkCombiLegendreTask::DoesBelong(), PndGemTrackFinderIdeal::DoFind(), PndSttTrackFinderReal::DoFind(), PndSttTrackFinderIdeal::DoFind(), PndFTSCADisplay::DrawGBHits(), PndFTSCADisplay::DrawParticleGlobal(), PndFTSCADisplay::DrawRecoTrack(), PndTrkTracking2::EliminateSpuriousSZ_bis(), PndTrkTracking2::EliminateSpuriousSZ_ter(), emc_correction_hist(), emc_correction_parametrization(), GFMaterialEffects::energyLossBetheBloch(), GFMaterialEffects::energyLossBrems(), eps(), PndSttMvdGemTracking::EvaluatePerformances(), PndTrkAddTCA::Exec(), PndMcListConverter::Exec(), PndLmdHitMergeTask::Exec(), PndLmdStripClusterTask::Exec(), PndFtsDataAccessor::Exec(), PndSttHelixHitProducer::Exec(), PndSttMvdGemTracking::Exec(), PndMixBackgroundEvents::Exec(), PndCATracking::Exec(), PndHypStripClusterTask::Exec(), PndTrkLegendreSecTask::Exec(), PndTrkLegendreSecTask2::Exec(), PndTrkLegendreTask::Exec(), PndLmdDigiQTask::Exec(), PndLmdTrkQTask::Exec(), PndFastSim::Exec(), PndTrkCombiLegendreTask::Exec(), PndDskFLGHitProducerIdeal::Exec(), PndTrkTracking2::Exec(), PndTrkTrackFinder::Exec(), PndSciTAnaIdeal::Exec(), PndEmcPhiBumpSplitter::Exec(), PndSdsStripClusterTask::Exec(), RKTrackRep::Extrap(), GeaneTrackRep::extrapolate(), RKTrackRep::extrapolate(), GeaneTrackRep::extrapolateToLine(), RKTrackRep::extrapolateToLine(), GeaneTrackRep::extrapolateToPoint(), RKTrackRep::extrapolateToPoint(), FCQaVar(), PndDrcLutReco::FillAmbiguities(), PndSoftTriggerTask::FillGlobalLists(), PndSttMvdGemTracking::FillTrueDistances(), DecayTreeFitter::Constraint::filter(), KFParticleFinder::Find2DaughterDecay(), PndCAGBTracker::FindBestCandidate(), PndFTSCAGBTracker::FindBestCandidate(), findcut(), findcuts(), PndTrkCTGeometryCalculations::FindDistance(), PndTrkComparisonMCtruth::FindDistance(), PndDrcReco::FindPdg(), PndDrcLutReco::FindPdg(), PndTrkCTFindTrackInXY2::FindTrackInXYProjection(), PndRiemannTrackFinder::FindTracksWithSimilarParameters(), KFParticleFinder::FindTrackV0Decay(), PndMvdRiemannVertexFinderTask::FindVertex(), PndDrcReco::Finish(), PndDrcRecoLookupMap::Finish(), PndRichRecoTask::FinishTask(), PndRecoDafFit::Fit(), PndRecoDafFit2::Fit(), PndRecoKalmanFit2::Fit(), PndRecoKalmanFit::Fit(), PndSttMvdGemTracking::Fit(), DecayTreeFitter::Fitter::fit(), PndTrkGlpkFits::FitHelixCylinder(), PndTrkLegendreFits::FitHelixCylinder(), PndTrkChi2Fits::FitHelixCylinder(), PndSttTrackFinderReal::FitHelixCylinder(), PndTrkLegendreFits::FitHelixCylinder2(), PndTrkGlpkFits::FitSZspace(), PndTrkChi2Fits::FitSZspace(), PndTrkLegendreFits::FitSZspace(), PndSttTrackFinderReal::FitSZspace(), PndTrkChi2Fits::FitSZspace_Chi2_AnnealingtheMvdOnly(), fittest(), PndTrkSttConformalFilling::FromXYtoConformal(), PndFilteredPrimaryGenerator::GenerateEvent(), Photospp::PH_HEPEVT_Interface::get(), KFParticle::GetAngle(), KFParticleSIMD::GetAngle(), KFParticle::GetAngleRZ(), KFParticleSIMD::GetAngleRZ(), KFParticle::GetAngleXY(), KFParticleSIMD::GetAngleXY(), KFParticleBaseSIMD::GetArmenterosPodolanski(), PndFTSTopoReconstructor::GetChiToPrimVertex(), PndSdsStripCorrelator::getCombinations(), KFParticleBase::GetDecayLength(), KFParticleBaseSIMD::GetDecayLength(), KFParticleBase::GetDecayLengthXY(), KFParticleBaseSIMD::GetDecayLengthXY(), KFParticleBase::GetDeviationFromVertex(), PndSttTube::GetDistance(), KFParticle::GetDistanceFromVertexXY(), KFParticleSIMD::GetDistanceFromVertexXY(), KFParticleBase::GetDStoParticleBy(), KFParticleBaseSIMD::GetDStoParticleBy(), KFParticleBase::GetDStoParticleBz(), KFParticleBaseSIMD::GetDStoParticleBz(), KFParticleBaseSIMD::GetDStoParticleCBM(), KFParticleBase::GetDStoParticleLine(), KFParticleBase::GetDStoPointBy(), KFParticleBaseSIMD::GetDStoPointBy(), KFParticleBase::GetDStoPointBz(), KFParticleBaseSIMD::GetDStoPointBz(), KFParticleBaseSIMD::GetDStoPointCBM(), KFParticle::GetErrE(), KFParticleSIMD::GetErrE(), PndEmcErrorMatrix::GetErrorMatrix(), KFParticle::GetErrPx(), KFParticleSIMD::GetErrPx(), KFParticle::GetErrPy(), KFParticleSIMD::GetErrPy(), KFParticle::GetErrPz(), KFParticleSIMD::GetErrPz(), KFParticle::GetErrS(), KFParticleSIMD::GetErrS(), KFParticle::GetErrX(), KFParticleSIMD::GetErrX(), KFParticle::GetErrY(), KFParticleSIMD::GetErrY(), KFParticle::GetErrZ(), KFParticleSIMD::GetErrZ(), KFParticleBaseSIMD::GetEta(), PndSttMvdGemTracking::GetInitialParams(), PndMvdSttGemRiemannTrackFinder::GetMaxPlaneDist(), PndMvdSttGemRiemannTrackFinder::GetMaxSZChi2(), PndAnalysis::GetMcCandList(), PndTrkComparisonMCtruth::getMCInfo(), GeaneTrackRep::getMom(), RKTrackRep::getMom(), KFParticleBaseSIMD::GetMomentum(), PndPidCorrelator::GetMvdInfo(), PndSdsCalcPixelDif::GetPixels(), RhoVtxPoca::GetPoca(), RhoVtxPoca::GetPocaChargedToNeutral(), GeaneTrackRep::getPocaOnLine(), GeaneTrackRep::getPosMom(), RKTrackRep::getPosMom(), GeaneTrackRep::getPosMomCov(), KFParticleBaseSIMD::GetPt(), PndSdsAdcChargeConversion::GetRelativeError(), PndHypCalcStrip::GetStrips(), PndLmdCalStrip::GetStrips(), PndSdsCalcStripDif::GetStrips(), PndSdsCalcStrip::GetStripsDif(), PndSdsCalcStrip::GetStripsNoDif(), PndSttTrackFinderIdeal::GetTrackletCircular(), PndSttPoint::GetTrueDistance(), PndFtsHoughTrackCand::getXLabForParabola(), PndTrkHit::GetXYDistanceFromTrack(), PndFTSCATrackParam::GetXYZPxPyPzQ(), PndTrkCleanup::GoodTrack(), PndFsmTrack::HelixRep(), PndRichReco::HitSelection(), PndRiemannTrackFinder::HitTooClose(), PndSttHelixTrackFitter::Hough(), PndSttHelixTrackFitter::HoughThroughOrigin(), PndTrkTracking2::InfoXYZParal(), PndFTSTopoReconstructor::Init(), PndSoftTriggerTask::Init(), PndLmdSigCleanTask::Init(), PndRichReco::Init(), PndFTSCAGBTracker::InitialTrackApproximation(), DecayTreeFitter::InternalParticle::initPar1(), PndSttHelixTrackFitter::IntersectionFinder(), PndSttMvdGemTracking::IntersectionFinder(), PndTrkLegendreNew::IntersectionFinder(), PndTrkTrackFinder::IntersectionFinder(), PndTrkCombiLegendreTask::IntersectionFinder(), PndCAGBTracker::InvertCholetsky(), PndFTSCAGBTracker::InvertCholetsky(), KFParticleBaseSIMD::InvertCholetsky3(), KFParticleBase::InvertSym3(), KFParticleBaseSIMD::InvertSym3(), PndSttGeomPoint::Is2D(), PndTrackingQualityBarrelAnalysisNewLinks::IsBarrelMVD(), IsBarrelMVD(), PndTrkCTGeometryCalculations::IsInMvdMiniDisk10_41to10_43(), PndTrkCTGeometryCalculations::IsInMvdMiniDisk10_41to10_43withMargin(), PndTrkCTGeometryCalculations::IsInMvdMiniDisk14_77to14_79(), PndTrkCTGeometryCalculations::IsInMvdMiniDisk14_77to14_79withMargin(), PndTrkCTGeometryCalculations::IsInMvdMiniDisk15_21to15_23(), PndTrkCTGeometryCalculations::IsInMvdMiniDisk15_21to15_23withMargin(), PndTrkCTGeometryCalculations::IsInMvdMiniDisk1_97to1_99(), PndTrkCTGeometryCalculations::IsInMvdMiniDisk1_97to1_99withMargin(), PndTrkCTGeometryCalculations::IsInMvdMiniDisk21_77to21_79(), PndTrkCTGeometryCalculations::IsInMvdMiniDisk21_77to21_79withMargin(), PndTrkCTGeometryCalculations::IsInMvdMiniDisk22_21to22_23(), PndTrkCTGeometryCalculations::IsInMvdMiniDisk22_21to22_23withMargin(), PndTrkCTGeometryCalculations::IsInMvdMiniDisk2_41to2_43(), PndTrkCTGeometryCalculations::IsInMvdMiniDisk2_41to2_43withMargin(), PndTrkCTGeometryCalculations::IsInMvdMiniDisk3_97to3_99(), PndTrkCTGeometryCalculations::IsInMvdMiniDisk3_97to3_99withMargin(), PndTrkCTGeometryCalculations::IsInMvdMiniDisk4_41to4_43(), PndTrkCTGeometryCalculations::IsInMvdMiniDisk4_41to4_43withMargin(), PndTrkCTGeometryCalculations::IsInMvdMiniDisk6_97to6_99(), PndTrkCTGeometryCalculations::IsInMvdMiniDisk6_97to6_99withMargin(), PndTrkCTGeometryCalculations::IsInMvdMiniDisk7_41to7_43(), PndTrkCTGeometryCalculations::IsInMvdMiniDisk7_41to7_43withMargin(), PndTrkCTGeometryCalculations::IsInMvdMiniDisk9_97to9_99(), PndTrkCTGeometryCalculations::IsInMvdMiniDisk9_97to9_99withMargin(), PndTrkCTGeometryCalculations::IsInTargetPipe(), PndCANPlet::IsRightNeighbour(), FTSCANPlet::IsRightNeighbour(), IsRightNeighbour(), PndTrkCleanup::IsThereMvdHitInBarrel(), RhoEventShapes::Legendre(), EventShape::Legendre(), PndEventShape::Legendre(), Legendre(), PndLmdLinFitTask::line3DfitMS(), PndFtsHoughTrackFinder::LineBehindDipoleMatchesToLinePlusParabola(), PndTrkLegendreFits::LoadMatrix_FindMaximum(), PndTrkLegendreFits::LoadMatrix_FindMaximum2(), PndTrkTracking2::LoadPndTrack_TrackCand(), PndRichGeo::LocalPositionDiscretization(), PndHypGeoHandling::LocalToMasterErrorsPath(), PndDrcReco::LookUpTable(), main(), PndEmcClusterMoments::Major1(), PndEmcWaveform::MakeWaveform(), PndHypGeoHandling::MasterToLocalErrorsPath(), PndTrkTracking2::MatchMvdHitsToSttTracks(), PndTrkTracking2::MatchMvdHitsToSttTracks2(), PndTrkTracking2::MatchMvdHitsToSttTracksagain(), PndFTSCAGBTracker::Merge(), PndEmcClusterMoments::Minor1(), PndTrkCleanup::MvdCleanup(), mz_pp_to_leplep_vandewi_event(), GFMaterialEffects::noiseBrems(), GFMaterialEffects::noiseCoulomb(), PndDrcHitProducerReal::NumberOfBounces(), PndDrcRecoLookupMapS::NumberOfBounces(), PndDrcRecoLookupMap::NumberOfBounces(), PndDrc::NumberOfBounces(), operator==(), PndTrkCTFindTrackInXY2::OrderingUsingR(), RhoCalculationTools::P6FromTrajectory(), RhoCalculationTools::P7toHelix(), RhoCalculationTools::P7toPRG(), placeSingleLayerSkewedLeft(), placeSingleLayerSkewedRight(), plotTrackCands(), PndSttTrackFinderReal::PndSttAcceptHitsConformal(), PndSttTrackFinderReal::PndSttFitSZspacebis(), PndSttTrackFinderReal::PndSttFromXYtoConformal(), PndSttTrackFinderReal::PndSttFromXYtoConformal2(), PndSttTrackFinderReal::PndSttInfoXYZParal(), PndSttTrackFinderReal::PndSttInfoXYZSkew(), PndSttTrackFinderReal::PndSttOrdering(), PndSttTrackFinderReal::PndSttTrkAssociatedParallelHitsToHelix(), PndSttTrackFinderReal::PndSttTrkAssociatedParallelHitsToHelix5(), PndSttTrackFinderReal::PndSttTrkAssociatedParallelHitsToHelixQuater(), PndRichGeo::PositionDiscretization(), SensorGrid::BasicGrid::PositionToPixel(), PndDrc::ProcessHits(), PndDsk::ProcessHitsParticle(), PndPhoGunShortP::ProcessPhotonHit(), PndPhoGunShort::ProcessPhotonHit(), PndDrcRecoLookupMapS::ProcessPhotonHit(), PndDrcRecoLookupMap::ProcessPhotonHit(), DecayTreeFitter::InternalParticle::projectKineConstraint(), PndFsmTrack::Propagate(), propagate_mclist(), PndSttMvdGemTracking::PropagateToGemPlaneAsHelix(), FairGeaneTrKalStt::Propagation(), PndRhoTupleQA::qaComp(), qadalitz(), qadalitz2(), QAmacro_emc_4(), QAmacro_mvd_ana(), PndRhoTupleQA::qaPid(), PndCAGBTracker::ReadHitsFromFile(), PndDrcRecoLookupMapS::RecoAmbigTime(), PndDrcRecoLookupMap::RecoAmbigTime(), PndTrkTracking2::RefitMvdStt(), PndSoftTriggerTask::RemoveDoubles(), PndFsmCmpDet::respond(), PndFsmCombiDet::respond(), PndFsmDetTemplate::respond(), PndFsmSimpleTracker::respond(), PndFsmEmcBwCap::respond(), PndFsmEmcBarrel::respond(), PndFsmMdcTS::respond(), PndFsmEmcFS::respond(), PndFsmEmcFwCap::respond(), PndFsmMdcFS::respond(), PndFsmMvd::respond(), PndFsmMvd2::respond(), PndFsmMvdPid::respond(), PndFsmTof::respond(), PndFsmSttPid::respond(), PndFsmSimpleVtx::respond(), PndFsmStt::respond(), PndFsmRich::respond(), PndFsmDrcBarrel::respond(), PndFsmDrcDisc::respond(), PndFsmEffTracker::respond(), RhoFindOmittedParticle::RhoFindOmittedParticle(), RKTrackRep::RKutta(), PndCATrackParam::Rotate(), PndFTSCATrackParam::Rotate(), run_ana_eta_c_stt(), run_ana_eta_c_tpc(), runLumiPixel4bNoiseTrkFilter(), selectMass(), PndSoftTriggerTask::SelectPid(), SenseAlign(), PndFastSim::SetFlatCovMatrix(), PndCAGBTracker::SetHits(), genfit::StepLimits::setLimit(), SimpleCand::SetMass(), KFParticleBase::SetMassConstraint(), KFParticleBaseSIMD::SetMassConstraint(), PndFTSCAMCTrack::SetMCTrack(), RhoKinHyperonVtxFitter::SetMinDChisq(), RhoKinVtxFitter::SetMinDChisq(), PndIdealTrackFinder::SetMomentumSmearing(), PndFtsTrackerIdeal::SetMomentumSmearing(), GFDetPlane::setNormal(), GFDaf::setProbCut(), KFParticleBase::SetProductionVertex(), KFParticleBaseSIMD::SetProductionVertex(), PndIdealTrackFinder::SetRelativeMomentumSmearing(), PndFtsTrackerIdeal::SetRelativeMomentumSmearing(), RhoCandidate::SetType(), PndIdealTrackFinder::SetVertexSmearing(), PndFtsTrackerIdeal::SetVertexSmearing(), PndFastSim::smearEnergy(), PndFastSim::smearTrack(), RhoKinHyperonFitter::Solve(), PndLmdTrackFinderCATask::SortHitsByZ(), PndLmdTrackFinderTask::SortHitsByZ(), PndStraightLineTrackFinderTask::SortHitsByZ(), PndTrkComparisonMCtruth::stampaMCTracks(), RhoCalculationTools::StateFromTrajectory(), RKTrackRep::stepalong(), GFDetPlane::straightLineToPlane(), PndTrkPlotMacros::SttInfoXYZParal(), PndTrkPlotMacros2::SttInfoXYZParal(), PndTrkCleanup::SttParalCleanup(), PndTrkCleanup::SttSkewCleanup(), PndTrkBoundaryParStraws2::SttTubeList(), KFParticleBaseSIMD::SubtractFromVertex(), PndFastSim::sumResponse(), PndSoftTriggerTask::TagMode(), RhoEventShapes::Thrust(), EventShape::Thrust(), PndEventShape::Thrust(), track_check(), track_check_2pi_stt(), track_check_2pi_tpc(), track_check_4pi_stt(), track_check_4pi_tpc(), PndRichPhoton::TrackCalc(), transform_jost_fieldmap(), KFParticleBase::TransportBz(), KFParticleBaseSIMD::TransportBz(), KFParticleBaseSIMD::TransportCBM(), RhoKinHyperonVtxFitter::TransportToPoca(), RhoKinVtxFitter::TransportToVertex(), RhoKinHyperonVtxFitter::TransportToVertex(), trapmap_barrel(), trapmap_disc(), trickySummaryAlign(), PndTrkCTFindTrackInXY2::TrkAssociatedParallelHitsToHelix5(), PndTrkCTFindTrackInXY::TrkAssociatedParallelHitsToHelix5(), PndTrkCTFindTrackInXY2::TrkAssociatedParallelHitsToHelix6(), PndTrkCTFindTrackInXY::TrkAssociatedParallelHitsToHelixQuater(), PndFastSim::UpdateGammaHit(), visualize_fieldmaps(), PndTrkPlotMacros::WriteMacroParallel_MvdHitsGeneralConformalwithMC(), PndTrkPlotMacros2::WriteMacroParallel_MvdHitsGeneralConformalwithMC(), PndSttTrackFinderReal::WriteMacroParallelAssociatedHitswithMC(), PndSttTrackFinderReal::WriteMacroParallelHitsConformalwithMCspecial(), PndTrkPlotMacros::WriteMacroParallelHitsGeneral(), PndTrkPlotMacros2::WriteMacroParallelHitsGeneral(), PndSttTrackFinderReal::WriteMacroParallelHitsGeneral(), PndTrkPlotMacros::WriteMacroParallelHitsGeneralConformalwithMC(), PndTrkPlotMacros2::WriteMacroParallelHitsGeneralConformalwithMC(), PndSttTrackFinderReal::WriteMacroParallelHitsGeneralConformalwithMC(), PndSttTrackFinderReal::WriteMacroParallelHitswithRfromMC(), PndSttTrackFinderReal::WriteMacroSkewAssociatedHits(), PndTrkPlotMacros::WriteMacroSkewAssociatedHitswithMC(), PndTrkPlotMacros2::WriteMacroSkewAssociatedHitswithMC(), PndSttTrackFinderReal::WriteMacroSkewAssociatedHitswithMC(), PndTrkPlotMacros2::WriteMacroSkewAssociatedHitswithMC_Degree(), PndSttTrackFinderReal::WriteMacroSkewAssociatedHitswithRfromMC(), PndTrkPlotMacros2::WriteMacroSttParallel(), PndTrkPlotMacros::WriteMacroSttParallelAssociatedHitsandMvdwithMC(), PndTrkPlotMacros2::WriteMacroSttParallelAssociatedHitsandMvdwithMC(), PndCATracking::WriteMVDHits(), writeTuple(), PndSttHelixTrackFitter::XYFit(), PndSttHelixTrackFitter::XYFitThroughOrigin(), PndSttMvdGemTracking::ZFind(), PndSttHelixTrackFitter::ZFinder(), and PndSttHelixTrackFitter::ZFinderThroughOrigin().

50 { return (reinterpret_cast<float*>(&v))[i]; }
__m128 v
Definition: P4_F32vec4.h:4
unsigned int i
Definition: P4_F32vec4.h:22
friend F32vec4 __attribute__::log ( const F32vec4 a)
friend F32vec4 __attribute__::max ( const F32vec4 a,
const F32vec4 b 
)

Definition at line 26 of file P4_F32vec4.h.

References i.

Referenced by PndFtsHoughSpace::AddHitsToTrackletByCalculating(), PndTrackCombiner::addLine(), anaDMesonsCharged(), FairEvtFilterOnSingleParticleCounts::AndMinMaxCharge(), FairEvtFilterOnSingleParticleCounts::AndMinMaxGeom(), FairEvtFilterOnSingleParticleCounts::AndMinMaxMom(), attachFiles(), bestEffEvt(), bestSeparation(), bestSepEvt(), bestSuppressionEvt(), pixelCluster::calculateCenter(), create_HypSTxy3Cmic_rootgeo3(), create_HypSTxy3Cmic_RootGeo5Lay(), create_HypSTxy3Cmic_RootGeo5LayExt(), PndFtsLineApproximator::createExpandedTrackCand(), DrawEveHisto(), PndFTSCADisplay::DrawGBPoints(), drawMvdHistos(), PndFTSCADisplay::DrawPVHisto(), PndFTSCAGBTracker::EstimatePV(), PndDrcAccuDigiPixelDraw::Exec(), PndSttHelixHitProducer::Exec(), PndEmcHitProducer::Exec(), FCDrawVariable(), fillUserHisto(), PndFtsHoughSpace::FindAllPeaksBinsWoMergingWithSearchWindow(), PndFtsHoughSpace::FindAllPeaksScanPathsMergeBins(), PndFtsHoughSpace::FindAllPeaksScanPathsMergeBinsCalculatingPaths(), findcuts(), FindMax(), PndTrkLegendreFits::FindMaximumInMatrix(), DecayTreeFitter::Fitter::fit(), fitsb(), PndTrkLegendreFits::FitSZspace(), PndSttTrackFinderReal::FixDiscontinuitiesFiangleinSZplane(), PndSttHitCorrector::GetAverageOfAngles(), genfit::KalmanFitStatus::getForwardPVal(), PndPlane::getIntersection(), PndLmdSensorAligner::getPairSpread(), genfit::FitStatus::getPVal(), PndPmtTask::Init(), inspectmode(), inspectvar(), lutmean(), MakeHoughParabolaFitwithBfield(), makeMaps(), CAMath::Max(), nsL1::SimdAlloc< T >::max_size(), PndEmcCluster::Maxima(), mz_pp_to_leplep_vandewi_event(), mz_pp_to_pipi_vandewi_event(), mz_pp_to_pipi_vandewi_maximum_sigma(), poormantracks(), PndSoftTriggerTask::PrintList(), DecayTreeFitter::MergedConstraint::push_back(), PndRhoTupleQA::qaMcList(), PndEvtGenGenerator::ReadAsciiEvent(), PndSttHelixTrackFitter::RunEventDisplay(), RhoGoodPhotonSelector::SetCrystals(), PndSoftTriggerTask::SetEtaQASelection(), PndGoodTrackSelector::SetFtsHits(), PndGoodTrackSelector::SetGemHits(), PndFastSim::SetInvMassFilter(), PndSoftTriggerTask::SetKs0QASelection(), genfit::AbsKalmanFitter::setMinIterations(), PndEvtFilterOnInvMassCounts::SetMinMaxCounts(), PndEvtFilterOnInvMassCounts::SetMinMaxInvMass(), PndFastSim::SetMultFilter(), PndGoodTrackSelector::SetMvdHits(), PndSoftTriggerTask::SetPi0QASelection(), PndPmtPoormantracks::SetPtRange(), PndSoftTriggerLine::SetQAMassWindow(), PndGoodTrackSelector::SetShowerEnergy(), RhoGoodPhotonSelector::SetShowerEnergy(), PndGoodTrackSelector::SetSttHits(), RhoGoodPhotonSelector::SetTheta(), PndSimpleAnalysis::SetupAnalysis(), PndEmcFadcFilter::SetupDoubleDifferentiator(), softtrigger_kin5(), softtrigger_toy12(), TMVATester(), toy_core(), tut_ana(), tut_ana_d0(), tut_ana_d0_qahelper(), tut_ana_task(), tut_ana_task_d0(), PndSttHelixTrackFitter::ZFinder(), and PndSttHelixTrackFitter::ZFinderThroughOrigin().

26 {
friend F32vec4 __attribute__::min ( const F32vec4 a,
const F32vec4 b 
)

Definition at line 25 of file P4_F32vec4.h.

Referenced by PndFtsHoughSpace::AddHitsToTrackletByCalculating(), anaDMesonsCharged(), FairEvtFilterOnSingleParticleCounts::AndMinMaxCharge(), FairEvtFilterOnSingleParticleCounts::AndMinMaxGeom(), FairEvtFilterOnSingleParticleCounts::AndMinMaxMom(), bestEffEvt(), bestSeparation(), bestSepEvt(), bestSuppressionEvt(), PndEventShape::ComputeSphericity(), PndSttHitCorrector::CorrectHits(), createdirc(), createdirc_prism(), PndFTSCADisplay::DrawGBPoints(), PndSttCellTrackletGenerator::EvaluateState(), TtCracowTask::Exec(), PndSttHelixHitProducer::Exec(), fillUserHisto(), PndFtsHoughSpace::FindAllPeaksScanPathsMergeBins(), PndFtsHoughSpace::FindAllPeaksScanPathsMergeBinsCalculatingPaths(), PndFtsCellTrackletGenerator::FindTracklets(), fitsb(), PndSttTrackFinderReal::FixDiscontinuitiesFiangleinSZplane(), PndLmdSensorAligner::getPairSpread(), PndPmtTask::Init(), inspectmode(), inspectvar(), makeMaps(), CAMath::Min(), PndEmcClusterMoments::Minor1(), PndEmcClusterMoments::Minor2(), poormantracks(), PndSttHelixTrackFitter::RunEventDisplay(), RhoGoodPhotonSelector::SetCrystals(), PndSoftTriggerTask::SetEtaQASelection(), PndGoodTrackSelector::SetFtsHits(), PndSoftTriggerTask::SetGammaMinE(), PndGoodTrackSelector::SetGemHits(), PndFastSim::SetInvMassFilter(), PndSoftTriggerTask::SetKs0QASelection(), PndEvtFilterOnInvMassCounts::SetMinMaxCounts(), PndEvtFilterOnInvMassCounts::SetMinMaxInvMass(), PndStack::SetMinPoints(), PndFastSim::SetMultFilter(), PndGoodTrackSelector::SetMvdHits(), PndSoftTriggerTask::SetPi0QASelection(), PndPmtPoormantracks::SetPtRange(), PndSoftTriggerLine::SetQAMassWindow(), PndGoodTrackSelector::SetShowerEnergy(), RhoGoodPhotonSelector::SetShowerEnergy(), PndGoodTrackSelector::SetSttHits(), RhoGoodPhotonSelector::SetTheta(), PndSoftTriggerTask::SetTrackMinP(), PndSimpleAnalysis::SetupAnalysis(), softtrigger_kin5(), softtrigger_toy12(), PndEventShape::Thrust(), toy_core(), trafo_matrix_fit(), tut_ana(), tut_ana_d0(), tut_ana_d0_qahelper(), tut_ana_task(), tut_ana_task_d0(), PndSttHelixTrackFitter::ZFinder(), and PndSttHelixTrackFitter::ZFinderThroughOrigin().

26 {
__attribute__::operator __m128 ( ) const

Definition at line 16 of file P4_F32vec4.h.

20 {
friend F32vec4 __attribute__::operator! ( const F32vec4 a)

Definition at line 66 of file P4_F32vec4.h.

66  { return _mm_div_ps(a,b); }
67 
68  /* Functions */
TTree * b
friend F32vec4 __attribute__::operator& ( const F32vec4 a,
const F32vec4 b 
)

Definition at line 57 of file P4_F32vec4.h.

57  :v(_mm_set_ps(f3,f2,f1,f0)) {}
58 
59  /* Conversion function */
TF1 * f1
Definition: reco_analys2.C:50
__m128 v
Definition: P4_F32vec4.h:4
TFile * f3
TFile * f2
friend F32vec4 __attribute__::operator* ( const F32vec4 a,
const F32vec4 b 
)

Definition at line 21 of file P4_F32vec4.h.

23 {1.f};
friend F32vec4 __attribute__::operator+ ( const F32vec4 a,
const F32vec4 b 
)

Definition at line 19 of file P4_F32vec4.h.

20 {
friend F32vec4 __attribute__::operator- ( const F32vec4 a,
const F32vec4 b 
)

Definition at line 20 of file P4_F32vec4.h.

20 {
friend F32vec4 __attribute__::operator/ ( const F32vec4 a,
const F32vec4 b 
)

Definition at line 22 of file P4_F32vec4.h.

23 {1.f};
friend F32vec4 __attribute__::operator< ( const F32vec4 a,
const F32vec4 b 
)

Definition at line 75 of file P4_F32vec4.h.

76  { return _mm_rsqrt_ps(a); }
77 
friend std::ostream& __attribute__::operator<< ( std::ostream strm,
const F32vec4 a 
)

Definition at line 159 of file P4_F32vec4.h.

161  {
162  const F32vec4 pi(3.1415926535897932);
#define pi
Definition: createSTT.C:60
friend F32vec4 __attribute__::operator<= ( const F32vec4 a,
const F32vec4 b 
)

Definition at line 78 of file P4_F32vec4.h.

84  {
friend F32vec4 __attribute__::operator== ( const F32vec4 a,
const F32vec4 b 
)

Definition at line 87 of file P4_F32vec4.h.

91  { return _mm_and_ps(a, _f32vec4_abs_mask); }
#define _f32vec4_abs_mask
Definition: P4_F32vec4.h:37
friend F32vec4 __attribute__::operator> ( const F32vec4 a,
const F32vec4 b 
)

Definition at line 81 of file P4_F32vec4.h.

84  {
friend F32vec4 __attribute__::operator>= ( const F32vec4 a,
const F32vec4 b 
)

Definition at line 84 of file P4_F32vec4.h.

84  {
85  F32vec4 Ra0 = _mm_rcp_ps(a);
86  return _mm_sub_ps(_mm_add_ps(Ra0, Ra0), _mm_mul_ps(_mm_mul_ps(Ra0, a), Ra0));
friend std::istream& __attribute__::operator>> ( std::istream strm,
F32vec4 a 
)

Definition at line 164 of file P4_F32vec4.h.

float operator[] ( int  i)

Definition at line 6 of file P4_F32vec4.h.

20 {
friend F32vec4 __attribute__::operator^ ( const F32vec4 a,
const F32vec4 b 
)

Definition at line 63 of file P4_F32vec4.h.

63  { return _mm_add_ps(a,b); }
64  friend F32vec4 operator -(const F32vec4 &a, const F32vec4 &b) { return _mm_sub_ps(a,b); }
65  friend F32vec4 operator *(const F32vec4 &a, const F32vec4 &b) { return _mm_mul_ps(a,b); }
friend F32vec4 operator-(const F32vec4 &a, const F32vec4 &b)
Definition: P4_F32vec4.h:20
friend F32vec4 operator*(const F32vec4 &a, const F32vec4 &b)
Definition: P4_F32vec4.h:21
friend F32vec4 __attribute__::operator| ( const F32vec4 a,
const F32vec4 b 
)

Definition at line 60 of file P4_F32vec4.h.

References F32vec4::v.

60  { return v; } /* Convert to __m128 */
61 
62  /* Arithmetic Operators */
__m128 v
Definition: P4_F32vec4.h:4
friend F32vec4 __attribute__::rcp ( const F32vec4 a)

Definition at line 40 of file P4_F32vec4.h.

45 {
friend F32vec4 __attribute__::rsqrt ( const F32vec4 a)
friend F32vec4 __attribute__::sgn ( const F32vec4 a)

Definition at line 50 of file P4_F32vec4.h.

References i.

50 { return (reinterpret_cast<float*>(&v))[i]; }
__m128 v
Definition: P4_F32vec4.h:4
unsigned int i
Definition: P4_F32vec4.h:22
friend F32vec4 __attribute__::sin ( const F32vec4 a)

Definition at line 111 of file P4_F32vec4.h.

Referenced by ana_pid(), PndTrkTracking2::AssociateBetterAfterFitSkewHitsToXYTrack(), PndSttTrackFinderReal::AssociateBetterAfterFitSkewHitsToXYTrack(), PndTrkTracking2::AssociateSkewHitsToXYTrack(), PndLmdStripClusterTask::Backmap(), PndSdsStripClusterTask::Backmap(), BOOST_AUTO_TEST_CASE(), PndEmcXClMoments::Calc_AbsZernikeMoment(), chigen::PythiaChiGen::calculateHadronRemnants(), PndTrkTracking2::CalculateSinandCosin(), PndCAGBTracker::CATrackFinder(), PndTrkComparisonMCtruth::ComparisonwithMC(), constructGasManifold(), constructMechanicalFrame(), create_half_geo(), create_HV_MAPS(), create_HypSTxy3Cmic_RootGeo5LayExt(), create_lumi(), create_lumi_geanetest(), create_scit_rootgeo_201505(), create_scit_rootgeo_201508(), create_scit_rootgeo_201601(), create_scit_rootgeo_201601_plot(), create_scit_rootgeo_pSuperModule(), createdirc(), createdirc_prism(), createdircPix(), createRootGeometry_beampipe(), createRootGeometry_DIRC(), createRootGeometry_DIRC_fsEVdroplens_MCPs(), createRootGeometry_DIRC_sepEV_06_2013(), createRootGeometry_DIRC_sepEV_MCPs(), createRootGeometry_DIRC_updated_06_2013(), createRootGeometry_RICH(), createstt(), PndFastSim::cutAndSmear(), PndRiemannTrack::dDip(), PndGiBuuJPsiEE::DecayTrack(), PndTrkCTFindTrackInXY2::DecideWhichAngularRangeAndCharge(), PndSttTrackFinderIdeal::DoFind(), PndSttHelixTrackFitter::DoFitPlain(), PndFsmMdcTS::dp(), PndFsmStt::dp(), PndDrcRecoLookupMap::DrawDetectorLayout(), PndFTSCADisplay::DrawHelix(), DrawHits::DrawHisto(), PndFTSCADisplay::DrawParticleGlobal(), PndFsmEmcBarrel::dtheta(), PndFtsHoughSpace::equationParabola(), PndFtsHoughSpace::equationParabolaPz(), error_matrix_fit(), PndDiscTaskReconstruction::Exec(), PndSttTrackFitterQATask::Exec(), PndSttHelixHitProducer::Exec(), PndDiscTaskDigitization::Exec(), PndCATracking::Exec(), PndHypStripClusterTask::Exec(), PndSciTAnaIdeal::Exec(), PndEmcXClMoments::Fast_AbsZernikeMoment(), PndTrkCTGeometryCalculations::FindIntersectionsOuterCircle(), PndSttTrackFinderReal::FindIntersectionsOuterCircle(), PndPhoGunShortP::FindReflectionType(), PndPhoGunShort::FindReflectionType(), PndTrkCTFindTrackInXY::FindTrackInXYProjection(), PndSttTrackFinderReal::FindTrackInXYProjection(), PndSttHelixTrackFitter::FinishEventDisplay(), PndTrkGlpkFits::FitHelixCylinder(), PndTrkLegendreFits::FitHelixCylinder(), PndTrkChi2Fits::FitHelixCylinder(), PndSttTrackFinderReal::FitHelixCylinder(), PndTrkLegendreFits::FitHelixCylinder2(), PndSttTrackFinderReal::FitSZspace(), RhoKalmanVtxFitter::FitVertexFast(), for(), function_beampipe(), PndLmdDim::Generate_rootgeom(), PndLmdGeometryFactory::generateCVDCoolingDisc(), PndLmdGeometryFactory::generateLmdGeometry(), PndLmdGeometryFactory::generatePCB(), Get_PolyLine_circle(), PndFTSTopoReconstructor::GetChiToPrimVertex(), KFParticleBase::GetDStoParticleBy(), KFParticleBaseSIMD::GetDStoParticleBy(), KFParticleBase::GetDStoParticleBz(), KFParticleBaseSIMD::GetDStoParticleBz(), KFParticleBase::GetDStoPointBz(), GetEntriesFast(), PndEmcErrorMatrix::GetErrorMatrix(), PndSttHelixTrackFitter::GetHitAngle(), PndFtsHoughTrackCand::getPZPXLabLine(), PndFtsHoughTrackCand::getPZPXLabParabola(), PndSttTrackFinderIdeal::GetTrack(), PndFtsHoughTrackCand::getXLabForParabola(), PndFTSCATrackParam::GetXYZPxPyPzQ(), PndFsmTrack::HelixRep(), PndRichGeo::init(), PndSttHelixTrackFitter::IntersectionFinder(), PndTrkCTGeometryCalculations::IntersectionsWithGapSemicircle(), PndSttTrackFinderReal::IntersectionsWithGapSemicircle(), PndTrkCTGeometryCalculations::IsInTargetPipe(), PndTrkCTGeometryCalculations::IsInternal(), PndSttTrackFinderReal::IsInternal(), PndTrkLegendreFits::LoadMatrix_FindMaximum(), PndTrkTracking2::LoadPndTrack_TrackCand(), PndEmcClusterMoments::Major1(), PndEmcClusterMoments::Major2(), MakeHoughParabolaFitwithBfield(), PndEmcClusterMoments::Minor1(), PndEmcClusterMoments::Minor2(), PndSttHelixTrackFitter::MinuitFit(), PndTrkCleanup::MvdCleanup(), mz_pp_to_leplep_vandewi_event(), mz_pp_to_pipi_vandewi_event(), GFMaterialEffects::noiseCoulomb(), PndDrcHitProducerReal::NumberOfBounces(), PndDrc::NumberOfBounces(), operator>>(), PndTrkTracking2::OrderingConformal_Loading_ListTrackCandHit(), PndTrkTracking2::OrderingSttSkewandSttParallel(), RhoCalculationTools::P6FromTrajectory(), RhoCalculationTools::P7toPRG(), placeSingleLayerSkewedLeft(), placeSingleLayerSkewedRight(), plotrotleft(), plotrotright(), PndHypCalcStrip::PndHypCalcStrip(), PndLmdCalStrip::PndLmdCalStrip(), PndLmdDim::PndLmdDim(), PndSdsCalcStrip::PndSdsCalcStrip(), PndSdsCalcStripDif::PndSdsCalcStripDif(), PndSttTrackFinderReal::PndSttInfoXYZSkew(), PndSttTrackFinderReal::PndSttOrderingSkewandParallel(), PndSttTrackFinderReal::PndSttTrkAssociatedParallelHitsToHelixQuater(), DecayTreeFitter::InternalParticle::projectKineConstraint(), PndGeoDskFLG::Propagate(), propagate(), PndFsmTrack::Propagate(), putStrawRotatedLeft(), putStrawRotatedRight(), putStrawRotatedShortLeft(), putStrawRotatedShortRight(), PndDrcRecoLookupMapS::RecoAmbigTime(), PndDrcRecoLookupMap::RecoAmbigTime(), PndLmdDim::reCreate_transformation_matrices(), PndFsmTof::respond(), PndFsmDrcBarrel::respond(), Photospp::PhotosParticle::rotate(), KFPTrack::RotateXY(), PndCATrackParamVector::RotateXY(), KFParticleBase::RotateXY(), KFParticleBaseSIMD::RotateXY(), PndFTSCATrackParamVector::RotateXY(), PndMdtParamDigi::SamplingPosition(), PndEmcXClMoments::SecondMomentPhi(), PndFastSim::SetFlatCovMatrix(), CAMath::Sin(), PndFtsSingleStraw::StrawSignal(), PndSttSingleStraw::StrawSignal(), PndTrkCleanup::SttParalCleanup(), PndTrkCleanup::SttSkewCleanup(), PndTrkCleanup::Track_Crosses_MvdMiniDisk_withMargin(), PndTrkCleanup::TrackCleanup(), KFParticleBase::TransportBz(), KFParticleBaseSIMD::TransportBz(), RhoKinHyperonVtxFitter::TransportToPoca(), RhoCalculationTools::TransportToZ(), trapmap_barrel(), trapmap_disc(), PndTrkCTFindTrackInXY::TrkAssociatedParallelHitsToHelixQuater(), PndTrkPlotMacros::WriteMacroParallel_MvdHitsGeneralConformalwithMC(), PndTrkPlotMacros2::WriteMacroParallel_MvdHitsGeneralConformalwithMC(), PndTrkPlotMacros::WriteMacroParallelHitsGeneral(), PndTrkPlotMacros2::WriteMacroParallelHitsGeneral(), PndSttTrackFinderReal::WriteMacroParallelHitsGeneral(), PndTrkPlotMacros::WriteMacroParallelHitsGeneralConformalwithMC(), PndTrkPlotMacros2::WriteMacroParallelHitsGeneralConformalwithMC(), PndSttTrackFinderReal::WriteMacroParallelHitsGeneralConformalwithMC(), PndSttTrackFinderReal::WriteMacroParallelHitswithRfromMC(), PndSttTrackFinderReal::WriteMacroSkewAssociatedHits(), PndSttTrackFinderReal::WriteMacroSkewAssociatedHitswithMC(), PndSttTrackFinderReal::WriteMacroSkewAssociatedHitswithRfromMC(), PndTrkPlotMacros::WriteMacroSttParallelAssociatedHitsandMvdwithMC(), PndTrkPlotMacros2::WriteMacroSttParallelAssociatedHitsandMvdwithMC(), PndSttHelixTrackFitter::XYFit(), PndSttHelixTrackFitter::XYFitThroughOrigin(), PndSttHelixTrackFitter::ZFinder(), and PndSttHelixTrackFitter::ZFinderThroughOrigin().

119 { // mask returned
friend F32vec4 __attribute__::sqrt ( const F32vec4 a)

Definition at line 29 of file P4_F32vec4.h.

Referenced by RhoSimpleVertexSelector::Accept(), KFParticleBase::AddDaughterWithEnergyCalc(), KFParticleBaseSIMD::AddDaughterWithEnergyCalc(), KFParticleBase::AddDaughterWithEnergyFitMC(), KFParticleBaseSIMD::AddDaughterWithEnergyFitMC(), PndEmcWaveform::AddElecNoiseAndDigitise(), PndTrkCTFindTrackInXY2::AddMvdHitsToSttTracks(), PndEmcWaveform::AddShapedElecNoiseAndDigitise(), ana_jpsi(), analyse_etac1(), analyse_etac1_slc(), analyse_J(), analyse_J_slc(), analyse_phi(), analyse_phi2(), analyse_phi_base(), AnalyseCombinedGammaFiles(), analysis_digi_cluster_7gammaAnalysis_FullEmc(), analysis_digi_cluster_allGammasAnalysis_FullEmc(), analysis_digi_cluster_allGammasAnalysis_fwendcap(), analysis_digi_cluster_fwendcap(), angle(), PndEmcClusterDistances::AngularSeparation(), PndSttTrackFinderReal::AssociateSkewHitsToXYTrack(), PndLmdStripClusterTask::Backmap(), PndTrkCleanup::BadTrack_ParStt(), bestCombiEvt(), bestSignificance(), PndSdsChargeWeightingAlgorithms::Binary(), RhoCandidate::Boost(), Photospp::PhotosParticle::boostAlongZ(), PndTrkSttConformalFilling::BoxConformalFilling(), PndEmcXClMoments::Calc_AbsZernikeMoment(), GFMaterialEffects::calcBeta(), PndMvdNoiseProducer::CalcChargeAboveThreshold(), PndSdsNoiseProducer::CalcChargeAboveThreshold(), PndSdsCalcStrip::CalcFk(), PndSdsStripCorrelator::CalcLikelihoodAlgo(), PndSdsStripClusterTask::CalcMeanCharge(), PndTrackCand::CalcTimeStamp(), pixelCluster::calculateCenter(), PndSdsTimeWalkCorrSimple::CalculateCharge(), PndTrkCTGeometryCalculations::CalculateCircleThru3Points(), PndHypGeGammaAna::CalculateCompton(), PndFTSCAParam::CalculateFieldSlice(), PndTrkCTGeometryCalculations::calculateintersections(), PndSttTrackFinderReal::calculateintersections(), chigen::PythiaChiGen::calculateKinematics(), PndHypGeGammaAna::CalculatePeakWidth(), PndTrkCTGeometryCalculations::CalculateSandZ2(), PndTrkBoundaryParStraws2::CalculateSpecialRegion(), PndLmdCalStrip::CalCurveStripFromPoint(), GFDaf::calcWeights(), PndCAGBTracker::CATrackFinder(), PndSdsChargeWeightingAlgorithms::CenterOfGravity(), PndLmdCalStrip::ChargeDiffusion(), PndSdsCalcStripDif::ChargeDiffusion(), PndFTSCAParam::CheckFieldApproximation(), Photospp::PhotosHEPEVTParticle::checkMomentumConservation(), Photospp::PhotosHepMCParticle::checkMomentumConservation(), chigen::ChiGen::ChiGen(), PndTrkLegendreSecTask::CleanupZPhiFit(), PndTrkLegendreTask::CleanupZPhiFit(), PndTrkLegendreSecTask2::CleanupZPhiFit(), RhoFindOmittedParticle::ClosestFit(), PndTrkTracking2::CollectParSttHitsagain(), KFParticleFinder::CombineTrackPart(), PndTrkComparisonMCtruth::ComparisonwithMC(), PndFsmSttPid::compdEdx(), PndFsmMvd::compdEdx(), PndFsmStt::compdEdx(), PndFsmEffTracker::compdEdx(), PndFsmRich::compThetaC(), PndFsmDrcDisc::compThetaC(), PndFsmDrcBarrel::compThetaC(), PndSttHit::ComputedEdx(), PndTrkTools::ComputePocaToPointOnCircle2(), PndTrkTools::ComputeSegmentCircleIntersection(), PndDiscSensorMCPoint::ComputeWavelenght(), KFParticleBaseSIMD::Construct(), KFParticleBase::ConstructGammaBz(), KFParticleBaseSIMD::ConstructGammaBz(), constructGasManifold(), create_HV_MAPS(), createdirc(), createdirc_prism(), createRootGeoFileFwEndCap_2011(), createRootGeometry_RICH(), PndFastSim::cutAndSmear(), PndFsmEmcBwCap::dE(), PndFsmEmcFwCap::dE(), PndFsmEmcFS::dE(), PndFsmEmcBarrel::dE(), PndGiBuuJPsiEE::DecayTrack(), dedx_p_chain(), PndFsmRich::detected(), PndFsmDrcDisc::detected(), PndFsmDrcBarrel::detected(), PndDrcReco::DetermineCherenkov(), PndDiscTaskReconstruction::deviation(), PndDiscTaskPID::deviation(), PndSdsTotChargeConversion::DigiValueToCharge(), PndTrkPlotMacros::disegnaSciTilHit(), PndTrkPlotMacros2::disegnaSciTilHit(), PndSttTrackFinderReal::disegnaSciTilHit(), PndTrkCTGeometryCalculations::Dist_SZ(), PndLmdLinFitTask::distance_MS(), PndSttGeomPoint::DistanceTo(), PndSttTrackFinderReal::DoFind(), PndFsmMdcFS::dp(), PndFsmMdcTS::dp(), PndFsmStt::dp(), PndTrkPlotMacros::DrawBiHexagonInMacro(), PndTrkPlotMacros2::DrawBiHexagonInMacro(), PndFTSCADisplay::DrawGBHits(), PndFTSCADisplay::DrawGBLine(), PndFTSCADisplay::DrawGBPoint(), PndFTSCADisplay::DrawGBPoints(), PndTrkPlotMacros::DrawHexagonCircleInMacro(), PndTrkPlotMacros2::DrawHexagonCircleInMacro(), PndFTSCADisplay::DrawParticleGlobal(), PndFTSCADisplay::DrawRecoTrack(), PndFTSCADisplay::DrawTPC(), PndFsmEmcFS::dtheta(), PndTrkTracking2::EliminateSpuriousSZ_bis(), PndTrkTracking2::EliminateSpuriousSZ_ter(), emc_correction_QA(), PndEmcClusterSimpleCalibrator::Energy(), GFMaterialEffects::energyLossBetheBloch(), GFMaterialEffects::energyLossBrems(), DecayTreeFitter::FitParams::err(), PndFTSCAGBTracker::EstimatePV(), PndSdsChargeWeightingAlgorithms::EtaValue(), PndLmdPixelClusterTask::Exec(), PndDiscTaskReconstruction::Exec(), PndLmdStripClusterTask::Exec(), PndPmtTask::Exec(), PndFtsDataAccessor::Exec(), PndHypGeCOSYBackgroundAna::Exec(), PndRichHitProducer::Exec(), PndFtsCATracking::Exec(), PndSttHelixHitProducer::Exec(), PndSttTrackFitterQATask::Exec(), PndLLbarAnaTask::Exec(), PndEmcFWEndcapTimebasedWaveforms::Exec(), PndLmdBPRungeKuttaTask::Exec(), PndDiscTaskDigitization::Exec(), PndEmcMakeDigi::Exec(), PndCATracking::Exec(), PndEmcHitsToWaveform::Exec(), PndHypStripClusterTask::Exec(), PndLmdBPtestTask::Exec(), PndLmdGeaneTask::Exec(), PndDrcHitProducerIdeal::Exec(), PndSciTHitProducerIdeal::Exec(), PndDskFLGHitProducerIdeal::Exec(), PndTrkTracking2::Exec(), PndSimpleCombinerTask::Exec(), PndSciTAnaIdeal::Exec(), PndSciTDigiTask::Exec(), PndLmdKalmanTask::Exec(), PndSdsStripClusterTask::Exec(), PndEmcXClMoments::Fast_AbsZernikeMoment(), PndLmdLinFitTask::FCN_MS(), fcnHelix(), fcnHelix2(), FCSfc(), PndFTSCATrackParamVector::FilterWithMaterial(), KFParticleFinder::Find2DaughterDecay(), PndKFParticleFinderQA::FindClosestMCTrackToBump(), PndTrkCTGeometryCalculations::FindDistance(), PndTrkComparisonMCtruth::FindDistance(), PndLmdTrackFinderTask::FindHitsI(), PndStraightLineTrackFinderTask::FindHitsI(), PndLmdTrackFinderTask::FindHitsII(), PndStraightLineTrackFinderTask::FindHitsII(), PndLmdTrackFinderTask::FindHitsIII(), PndStraightLineTrackFinderTask::FindHitsIII(), PndTrkCTGeometryCalculations::FindingParallelTrackAngularRange(), PndTrkCTGeometryCalculations::FindingParallelTrackAngularRange2(), PndTrkCTGeometryCalculations::FindIntersectionsOuterCircle(), PndSttTrackFinderReal::FindIntersectionsOuterCircle(), PndDrcReco::FindPdg(), PndDrcLutReco::FindPdg(), PndHypGeGammaAna::FindPeaks(), KFPTopoReconstructor::FindPrimaryClusters(), PndTrkCTGeometryCalculations::FindTrackEntranceExitHexagonCircleLeft(), PndSttTrackFinderReal::FindTrackEntranceExitHexagonCircleLeft(), PndTrkCTGeometryCalculations::FindTrackEntranceExitHexagonCircleLeft2(), PndTrkCTGeometryCalculations::FindTrackEntranceExitHexagonCircleRight(), PndSttTrackFinderReal::FindTrackEntranceExitHexagonCircleRight(), PndTrkCTGeometryCalculations::FindTrackEntranceExitHexagonCircleRight2(), PndTrkCTFindTrackInXY::FindTrackInXYProjection(), PndTrkCTFindTrackInXY2::FindTrackInXYProjection(), PndSttTrackFinderReal::FindTrackInXYProjection(), KFParticleFinder::FindTrackV0Decay(), PndSttMvdGemTracking::Fit(), FitFunction2(), FitGammaSpectra(), PndTrkChi2Fits::FitHelixCylinder(), PndHypGeSpectrumAnalyser::FitPeaks(), fitsb(), PndFTSCAGBTracker::FitTrack(), for(), PndTrkLegendreSecTask::FromConformalToRealTrack(), PndTrkLegendreTask::FromConformalToRealTrack(), PndTrkLegendreSecTask2::FromConformalToRealTrack(), PndTrkLegendreNew::FromConformalToRealTrack(), PndTrkCombiLegendreTask::FromConformalToRealTrack(), PndTrkTrackFinder::FromConformalToRealTrack(), PndTrkTrackFinder::FromConformalToRealTrackParabola(), PndDrcTimeDigiTask::FuncD1(), GammaSpectraAnalysis_CableTest(), GammaSpectraAnalysis_NoH(), PndDiscTaskReconstruction::gauss(), PndDiscTaskPID::gauss(), PndFsmRich::gauss(), PndFsmDrcDisc::gauss(), PndFsmSttPid::gauss(), PndFsmDrcBarrel::gauss(), PndFsmMvd::gauss(), PndFsmStt::gauss(), PndFsmEffTracker::gauss(), PndFsmTof::gauss_t(), KFParticle::GetAngle(), KFParticleSIMD::GetAngle(), KFParticle::GetAngleRZ(), KFParticleSIMD::GetAngleRZ(), KFParticle::GetAngleXY(), KFParticleSIMD::GetAngleXY(), KFParticleBase::GetArmenterosPodolanski(), KFParticleBaseSIMD::GetArmenterosPodolanski(), PndMvdRecoCharge::GetCharge(), PndFTSTopoReconstructor::GetChiToPrimVertex(), PndSttHitProducerIdeal::GetClostestApproachToWire(), PndFtsHitProducerIdeal::GetClostestApproachToWire(), PndMQSdsChargeWeightedPixelMapping::GetCluster(), PndSdsChargeWeightedPixelMapping::GetCluster(), PndSdsStripCorrelator::getCombinations(), PndSimpleNtuple::GetCurrentValue(), PndCATrackParam::GetDCAPoint(), PndCATrackParamVector::GetDCAPoint(), PndFTSCATrackParam::GetDCAPoint(), PndFTSCATrackParamVector::GetDCAPoint(), KFParticleBase::GetDecayLength(), KFParticleBaseSIMD::GetDecayLength(), KFParticleBase::GetDecayLengthXY(), KFParticleBaseSIMD::GetDecayLengthXY(), KFParticleBase::GetDeviationFromParticle(), KFParticleBaseSIMD::GetDeviationFromParticle(), KFParticle::GetDeviationFromParticleXY(), KFParticleSIMD::GetDeviationFromParticleXY(), KFParticleBase::GetDeviationFromVertex(), KFParticleBaseSIMD::GetDeviationFromVertex(), KFParticleBase::GetDistanceFromParticle(), KFParticleBaseSIMD::GetDistanceFromParticle(), KFParticle::GetDistanceFromParticleXY(), KFParticleSIMD::GetDistanceFromParticleXY(), KFParticleBase::GetDistanceFromVertex(), KFParticleBaseSIMD::GetDistanceFromVertex(), KFParticle::GetDistanceFromVertexXY(), KFParticleSIMD::GetDistanceFromVertexXY(), KFParticleBaseSIMD::GetDistanceToVertexLine(), KFParticleBase::GetDStoParticleBy(), KFParticleBaseSIMD::GetDStoParticleBy(), KFParticleBase::GetDStoParticleBz(), KFParticleBaseSIMD::GetDStoParticleBz(), KFParticleBase::GetDStoPointBz(), PndEmcCluster::GetEnergyCorrected(), GetEntriesFast(), KFParticle::GetErrE(), KFParticleSIMD::GetErrE(), KFParticle::GetErrPx(), KFParticleSIMD::GetErrPx(), KFParticle::GetErrPy(), KFParticleSIMD::GetErrPy(), KFParticle::GetErrPz(), KFParticleSIMD::GetErrPz(), KFParticle::GetErrS(), KFParticleSIMD::GetErrS(), KFParticle::GetErrX(), KFParticleSIMD::GetErrX(), KFParticle::GetErrY(), KFParticleSIMD::GetErrY(), KFParticle::GetErrZ(), KFParticleSIMD::GetErrZ(), KFParticleBase::GetEta(), KFParticleBaseSIMD::GetEta(), KFParticle::GetExternalTrackParam(), KFParticleSIMD::GetExternalTrackParam(), PndMQTopixHitProducer::GetHit(), KFParticleBase::GetLifeTime(), KFParticleBaseSIMD::GetLifeTime(), KFParticleBase::GetMass(), KFParticleBaseSIMD::GetMass(), PndTrkComparisonMCtruth::getMCInfo(), KFParticleBase::GetMomentum(), KFParticleBaseSIMD::GetMomentum(), KFPTrack::GetP(), Photospp::PhotosParticle::getP(), PndPidSciTAssociatorTask::GetPdf(), PndHypGeGammaAna::GetPeakContent(), KFParticleBase::GetPhi(), KFParticleBaseSIMD::GetPhi(), RhoVtxPoca::GetPocaTwoCharged(), KFPTrack::GetPt(), KFParticleBase::GetPt(), KFParticleBaseSIMD::GetPt(), KFParticleBase::GetR(), KFParticleBaseSIMD::GetR(), PndSdsTotChargeConversion::GetRelativeError(), PndPidCorrelator::GetRichInfo(), KFParticleBase::GetSCorrection(), KFParticleBaseSIMD::GetSCorrection(), PndSdsCalcStrip::GetStripsDif(), PndEmcApdPoint::GetTheta(), PndEmcApdHit::GetTheta(), PndEmcPoint::GetTheta(), PndEmcHit::GetTheta(), PndSdsTotChargeConversion::GetTimeStampErrorAfterCorrection(), PndSttTrackFinderIdeal::GetTrack(), PndSttTrackFinderIdeal::GetTrackletCircular(), Photospp::PhotosParticle::getVirtuality(), PndFtsHoughTrackCand::getXLabForParabola(), PndTrkCleanup::GoodTrack(), PndSdsChargeWeightingAlgorithms::HeadTail(), hit_noise_studies(), PndTrkTracking2::InfoXYZParal(), PndRichGeo::init(), PndCATrackParamVector::InitDirection(), PndCATrackParam::InitDirection(), PndFTSCATrackParamVector::InitDirection(), KFParticleBaseSIMD::Initialize(), KFParticleBase::Initialize(), DecayTreeFitter::InternalParticle::initMom(), PndTrkCTGeometryCalculations::IntersectionCircle_Segment(), PndSttTrackFinderReal::IntersectionCircle_Segment(), PndTrkCTGeometryCalculations::IntersectionCircle_Segment_forScitil(), PndSttHelixTrackFitter::IntersectionFinder(), PndSttMvdGemTracking::IntersectionFinder(), PndTrkLegendreNew::IntersectionFinder(), PndTrkCombiLegendreTask::IntersectionFinder(), PndTrkTrackFinder::IntersectionFinder(), PndTrkCTGeometryCalculations::IntersectionSciTil_Circle(), PndSttTrackFinderReal::IntersectionSciTil_Circle(), PndTrkCTGeometryCalculations::IntersectionsWithClosedbiHexagonLeft(), PndSttTrackFinderReal::IntersectionsWithClosedbiHexagonLeft(), PndTrkCTGeometryCalculations::IntersectionsWithClosedbiHexagonRight(), PndSttTrackFinderReal::IntersectionsWithClosedbiHexagonRight(), PndTrkCTGeometryCalculations::IntersectionsWithClosedPolygon(), PndSttTrackFinderReal::IntersectionsWithClosedPolygon(), PndTrkCTGeometryCalculations::IntersectionsWithGapSemicircle(), PndSttTrackFinderReal::IntersectionsWithGapSemicircle(), PndCAGBTracker::InvertCholetsky(), PndFTSCAGBTracker::InvertCholetsky(), KFParticleBaseSIMD::InvertCholetsky3(), PndTrkCTGeometryCalculations::IsInTargetPipe(), PndCANPlet::IsRightNeighbour(), FTSCANPlet::IsRightNeighbour(), IsRightNeighbour(), PndRich::lhcbaerindex(), LimitsAlign_misalignConstsSUM(), PndLmdLinFitTask::line3DfitMS(), PndGeoDskFLG::LineCylinderInteraction(), PndTrkLegendreFits::LoadMatrix_FindMaximum(), PndTrkLegendreFits::LoadMatrix_FindMaximum2(), PndTrkTracking2::LoadPndTrack_TrackCand(), magnitude(), main(), RhoFindOmittedParticle::MakeCone(), makeDoubleLayerSkewedLeft(), makeDoubleLayerSkewedRight(), makeDoubleLayerStraightExact(), MakeHoughParabolaFitwithBfield(), makeIni4Vector(), makeSingleLayerStraightExact(), PndEmcWaveform::MakeWaveform(), PndEmcClusterProperties::Mass(), PndTrkTracking2::MatchMvdHitsToSttTracks(), PndTrkTracking2::MatchMvdHitsToSttTracks2(), PndTrkTracking2::MatchMvdHitsToSttTracksagain(), PndSdsChargeWeightingAlgorithms::Median(), ModulesStat(), PndTrkCleanup::MvdCleanup(), n_phase_sellmeier(), PndHypGePeakFitFunction::NewSkewedOnly(), GFMaterialEffects::noiseCoulomb(), normalised_cross_product(), OmegaQuadrupoleFourEnergiesCombination(), online_monitoring_studies(), PndEmcWaveform::operator+=(), PndFTSCAMCTrack::operator=(), RhoCalculationTools::P6FromTrajectory(), RhoCalculationTools::P7toHelix(), RhoCalculationTools::P7toPRG(), PndSttTrack::PCAToPoint(), placeSingleLayerSkewedLeft(), placeSingleLayerSkewedRight(), placeSingleLayerStraightExact(), plot_radmap(), PndSttTrackFinderIdeal::plotAllStraws(), plotmyhistos(), PndAnaWithTrigger::PndAnaWithTrigger(), chigen::PndChiGenExclusive::PndChiGenExclusive(), PndEvtGenDirect::PndEvtGenDirect(), PndLmdDim::PndLmdDim(), PndRhoTupleQA::PndRhoTupleQA(), PndScrutAnaTask::PndScrutAnaTask(), PndSimpleCombinerTask::PndSimpleCombinerTask(), PndSoftTriggerTask::PndSoftTriggerTask(), PndSttTrackFinderReal::PndSttBoxConformalFilling(), PndSttTrackFinderReal::PndSttFindingParallelTrackAngularRange(), PndSttTrackFinderReal::PndSttInfoXYZParal(), PndSttTrackFinderReal::PndSttTrkAssociatedParallelHitsToHelix(), PndSttTrackFinderReal::PndSttTrkAssociatedParallelHitsToHelix5(), PndSttTrackFinderReal::PndSttTrkAssociatedParallelHitsToHelixQuater(), PndSttTrackFinderReal::PndSttTrkFindCircles(), PndTripleAnaTask::PndTripleAnaTask(), PndTutAnaTask::PndTutAnaTask(), PndTutAnaTaskD0::PndTutAnaTaskD0(), poormantracks(), DecayTreeFitter::ParticleBase::print(), DecayTreeFitter::FitParams::print(), DrawHits::ProcessBarHit(), PndDrcHitProducerReal::ProcessBarPoint(), PndFtfDirect::ProcessEvent(), PndDrc::ProcessHits(), PndDsk::ProcessHitsParticle(), DrawHits::ProcessPhotonHit(), PndDrcRecoLookupMapS::ProcessPhotonHit(), PndDrcRecoLookupMap::ProcessPhotonHit(), DrawHits::ProcessPhotonMC(), PndDrcHitProducerReal::ProcessPhotonPoint(), prod_ana(), prod_fsim(), prod_sim(), DecayTreeFitter::InternalParticle::projectConversionConstraint(), DecayTreeFitter::ParticleBase::projectGeoConstraint(), DecayTreeFitter::InternalParticle::projectKineConstraint(), DecayTreeFitter::InternalParticle::projectMassConstraintTwoBody(), DecayTreeFitter::RecoPhoton::projectRecoConstraint(), DecayTreeFitter::RecoTrack::projectRecoConstraint(), PndGeoDskFLG::Propagate(), propagate(), PndAnalysis::Propagator(), PndSttTrackFinderIdeal::putStraw(), putStraw(), chigen::PythiaChiGen::PythiaChiGen(), qadalitz(), QAmacro_mvd_1(), PndRhoTupleQA::qaMcDiff(), PndRhoTupleQA::qaPull(), PndCANPlet::QMomentumErr(), FTSCANPlet::QMomentumErr(), PndFTSCATrackParam::QP(), quickana(), quickfsimana(), PndRiemannTrack::r(), RhoKinFitter::Read4MomKinMatrix(), RhoKinHyperonFitter::Read4MomKinMatrix(), RhoKinVtxFitter::ReadKinMatrix(), RhoKinHyperonVtxFitter::ReadKinMatrix(), RhoKinVtxFitter::ReadMatrix(), RhoKinFitter::ReadMatrix(), RhoKinHyperonVtxFitter::ReadMatrix(), RhoKinFitter::ReadTotEKinMatrix(), RhoKinHyperonFitter::ReadTotEKinMatrix(), RhoKinFitter::ReadTotMomKinMatrix(), RhoKinHyperonFitter::ReadTotMomKinMatrix(), PndFTSCAGBTracker::Refit_1(), PndLmdQATask::ResoAndPulls(), PndFsmCmpDet::respond(), PndFsmCombiDet::respond(), PndFsmRich::respond(), PndFsmTof::respond(), PndFsmDrcDisc::respond(), PndFsmDrcBarrel::respond(), RhoRhoPHOTOSUserTreeAnalysis(), PndRichReco::RichFullReconstruction(), RKTrackRep::RKutta(), CAMath::RSqrt(), run_sim(), runMC_dpm(), s2max(), s2min(), SamplesSummaryAlign(), scattered_particles(), PndTrkCleanup::SeparateInnerOuterParallel(), PndSttTrackFinderReal::SeparateInnerOuterParallel(), PndTrkCleanup::SeparateInnerOuterRightLeftAxialStt(), chigen::models::ColorSingletPartonicModel::setKin(), RhoCandidate::SetMassAndEnergy(), KFParticleBase::SetMassConstraint(), KFParticleBaseSIMD::SetMassConstraint(), PndFTSCAMCTrack::SetMCTrack(), RhoKinHyperonFitter::SetOutput(), RhoCandidate::SetP4(), PndFTSCALocalMCPoint::SetPoint(), PndSciTAnaIdeal::SetSciTEventCorr(), chigen::models::ColorSingletPartonicModel::setTrialKin(), PndMasterRunSim::Setup(), PndFtfDirect::Setup(), PndSimpleAnalysis::SetupAnalysis(), PndRichResolution::Sigma(), sim(), sim_complete(), sim_complete_pbarA(), sim_complete_runs(), sim_evtgen(), sim_rich(), sim_scit(), sim_test(), simfast_dpm(), simfast_dpm_cmp(), simfast_opt(), simInclusive(), PndFastSim::smearEnergy(), PndEmcWaveformToDigi::SmearFakeOnline(), RhoKinFitter::Solve(), CAMath::Sqrt(), PndTrkPrintouts::stampaMvdHits(), PndTrkPrintouts::stampaMvdHits2(), PndTrkPrintouts::stampaSttHits(), PndTrkPrintouts::stampaSttHits2(), RhoCalculationTools::StateFromTrajectory(), PndTrkPlotMacros::SttInfoXYZParal(), PndTrkPlotMacros2::SttInfoXYZParal(), PndTrkCleanup::SttParalCleanup(), PndTrkCleanup::SttSkewCleanup(), PndTrkBoundaryParStraws2::SttTubeList(), PndFastSim::sumResponse(), symdiag(), tb_sim_complete(), tb_sim_scit(), PndSttSingleStraw::TDirCos(), PndFtsSingleStraw::TDirCos(), test_check(), PndSttSingleStraw::TInit(), PndFtsSingleStraw::TInit(), transform_jost_fieldmap(), KFParticleBase::TransportBz(), KFParticleBaseSIMD::TransportBz(), RhoKinHyperonVtxFitter::TransportToPoca(), RhoKinVtxFitter::TransportToVertex(), RhoKinHyperonVtxFitter::TransportToVertex(), PndFTSCATrackParamVector::TransportToX0WithMaterial(), PndCATrackParamVector::TransportToXWithMaterial(), RhoCalculationTools::TransportToZ(), trapmap_barrel(), trapmap_disc(), PndTrkCTFindTrackInXY2::TrkAssociatedParallelHitsToHelix5(), PndTrkCTFindTrackInXY::TrkAssociatedParallelHitsToHelix5(), PndTrkCTFindTrackInXY2::TrkAssociatedParallelHitsToHelix6(), PndTrkCTFindTrackInXY::TrkAssociatedParallelHitsToHelixQuater(), PndSttSingleStraw::TrueDist(), PndFtsSingleStraw::TrueDist(), tut_ana_d0(), tut_ana_d0_qahelper(), tut_fastsim(), PndCATrackParamVector::Tx1(), PndFTSCATrackParamVector::Tx1(), PndCATrackParamVector::Tx2(), PndFTSCATrackParamVector::Tx2(), DecayTreeFitter::Fitter::updateCand(), DecayTreeFitter::RecoTrack::updCache(), visualize_fieldmaps(), PndSttSingleStraw::WDistCalc(), PndFtsSingleStraw::WDistCalc(), PndFtsCATracking::WriteFTSHits(), PndTrkPlotMacros::WriteMacroParallel_MvdHitsGeneralConformalwithMC(), PndTrkPlotMacros2::WriteMacroParallel_MvdHitsGeneralConformalwithMC(), PndSttTrackFinderReal::WriteMacroParallelAssociatedHitswithMC(), PndSttTrackFinderReal::WriteMacroParallelHitsConformalwithMCspecial(), PndTrkPlotMacros::WriteMacroParallelHitsGeneral(), PndTrkPlotMacros2::WriteMacroParallelHitsGeneral(), PndSttTrackFinderReal::WriteMacroParallelHitsGeneral(), PndTrkPlotMacros::WriteMacroParallelHitsGeneralConformalwithMC(), PndTrkPlotMacros2::WriteMacroParallelHitsGeneralConformalwithMC(), PndSttTrackFinderReal::WriteMacroParallelHitsGeneralConformalwithMC(), PndSttTrackFinderReal::WriteMacroParallelHitswithRfromMC(), PndSttTrackFinderReal::WriteMacroSkewAssociatedHits(), PndTrkPlotMacros::WriteMacroSkewAssociatedHitswithMC(), PndTrkPlotMacros2::WriteMacroSkewAssociatedHitswithMC(), PndSttTrackFinderReal::WriteMacroSkewAssociatedHitswithMC(), PndTrkPlotMacros2::WriteMacroSkewAssociatedHitswithMC_Degree(), PndSttTrackFinderReal::WriteMacroSkewAssociatedHitswithRfromMC(), PndTrkPlotMacros::WriteMacroSttParallelAssociatedHitsandMvdwithMC(), PndTrkPlotMacros2::WriteMacroSttParallelAssociatedHitsandMvdwithMC(), PndSttHelixTrackFitter::XYFit(), PndSttHelixTrackFitter::XYFitThroughOrigin(), ZeeAnalysis(), ZmumuAnalysis(), and ZtautauAnalysis().

30 {{0x7fffffff, 0x7fffffff, 0x7fffffff, 0x7fffffff}},
__attribute__::vec_arithmetic ( F32vec4  ,
float   
)

Variable Documentation

const { ... } __f32vec4_abs_mask_cheat
const { ... } __f32vec4_false_cheat
const { ... } __f32vec4_one_cheat
const { ... } __f32vec4_sgn_mask_cheat
const { ... } __f32vec4_true_cheat
const { ... } __f32vec4_zero_cheat
const { ... } __f_one
float f

Definition at line 21 of file P4_F32vec4.h.

const int fvecLen = 4
unsigned int i[4]

Definition at line 22 of file P4_F32vec4.h.

Referenced by asgnb(), max(), and sgn().

__m128 m

Definition at line 28 of file P4_F32vec4.h.

Referenced by Photospp::PhotosHEPEVTParticle::addDaughter(), KFParticleBase::AddDaughterWithEnergyCalc(), KFParticleBaseSIMD::AddDaughterWithEnergyCalc(), KFParticleBase::AddDaughterWithEnergyFit(), KFParticleBaseSIMD::AddDaughterWithEnergyFit(), KFParticleBase::AddDaughterWithEnergyFitMC(), KFParticleBaseSIMD::AddDaughterWithEnergyFitMC(), PndHypDKalmanTask::AddHitBranch(), PndHypKalmanTask::AddHitBranch(), PndHypDPatternRecoTask::AddHitBranch(), PndHypIdealPRTask::AddHitBranch(), AllNeutronAnalysis_job(), AllNeutronAnalysis_job_edit(), analyse_phi(), analyse_phi2(), PndAnalysisForwardTask::analyzeMCTracks(), PndEmcXClMoments::Calc_AbsZernikeMoment(), PndFTSCAParam::CalculateFieldSlice(), PndSttGeometryMap::CalculateStrawPoca(), GFDaf::calcWeights(), checkMomentumConservationInEvent(), PndTrkTools::ComputePocaToPointOnCircle2(), PndTrkTools::ComputeSegmentCircleIntersection(), Config(), config_graph(), KFParticleBase::ConstructGammaBz(), KFParticleBaseSIMD::ConstructGammaBz(), PndTrkLegendreSecTask::CorrectZ(), PndTrkLegendreTask::CorrectZ(), PndTrkLegendreSecTask2::CorrectZ(), create_half_geo(), create_HypSTxy3Cmic_RootGeo5LayExt(), create_misalignment_lmd_pixel(), create_scit_rootgeo_201505(), create_scit_rootgeo_201508(), create_scit_rootgeo_201601(), create_scit_rootgeo_201601_plot(), create_scit_rootgeo_pSuperModule(), Photospp::PhotosBranch::createBranches(), createdirc(), createdirc_prism(), createdircPix(), createRootGeometry_DIRC(), createRootGeometry_DIRC_fsEVdroplens_MCPs(), createRootGeometry_DIRC_sepEV_06_2013(), createRootGeometry_DIRC_sepEV_MCPs(), createRootGeometry_DIRC_updated_06_2013(), Rho4CFitter::Do4CFitWithMassConservation(), PndTrkTracking2::EliminateSpuriousSZ_bis(), eventAccepted(), PndFtsDataAccessor::Exec(), PndSttHelixHitProducer::Exec(), PndLmdTrkQTask::Exec(), PndSciTAnaIdeal::Exec(), fillHisto(), PndCATrackParamVector::Filter(), PndTrkCTGeometryCalculations::FindDistance(), PndTrkComparisonMCtruth::FindDistance(), PndDrcTimeDigiTask::FindOutPoint(), PndDrcHitProducerReal::FindOutPoint(), PndDrcRecoLookupMapS::FindOutPoint(), PndDrcRecoLookupMap::FindOutPoint(), PndDrc::FindOutPoint(), PndTrkCTFindTrackInXY::FindTrackInXYProjection(), PndTrkCTFindTrackInXY2::FindTrackInXYProjection(), PndSttTrackFinderReal::FindTrackInXYProjection(), PndRiemannTrackFinder::FindTracksWithSimilarHits(), KFParticleBase::GetDSIter(), GetEntriesFast(), PndPidCorrelator::GetFtsInfo(), KFParticleBase::GetLifeTime(), KFParticleBaseSIMD::GetLifeTime(), RhoCandidate::GetMarker(), KFParticleBase::GetMass(), PndForwardTrackFinderTask::getMcId(), GFTools::getSmoothedChiSqu(), PndPidCorrelator::GetSttInfo(), PndDrcReco::Init(), init(), PndHyp::Initialize(), PndSttHelixTrackFitter::IntersectionFinder(), PndSttMvdGemTracking::IntersectionFinder(), PndTrkLegendreNew::IntersectionFinder(), PndTrkCombiLegendreTask::IntersectionFinder(), PndTrkTrackFinder::IntersectionFinder(), main(), makeTMVADemoData(), PndSttTrack::MomentumAtPoint(), mzboost(), NeutronAnalysis_COSY(), NeutronAnalysis_COSY_CrossSec(), chigen::PartonicModel::PartonicModel(), PndSttTrack::PCAToPoint(), Photospp::PhotosHEPEVTParticle::PhotosHEPEVTParticle(), GFBookkeeping::Print(), RhoCalculationTools::PrintMatrix(), DecayTreeFitter::RecoPhoton::projectRecoConstraint(), RhoKinFitter::Read4MomKinMatrix(), RhoKinHyperonFitter::Read4MomKinMatrix(), PndRichCalDb::ReadAsciiFile(), RhoKinVtxFitter::ReadMassKinMatrix(), RhoKinFitter::ReadMassKinMatrix(), RhoKinHyperonVtxFitter::ReadMassKinMatrix(), RhoKinVtxFitter::ReadMatrix(), RhoKinHyperonVtxFitter::ReadMatrix(), RhoKinFitter::ReadMomKinMatrix(), RhoKinHyperonFitter::ReadMomKinMatrix(), MyMainFrame::ReadParameters(), RhoKinFitter::ReadTotEKinMatrix(), RhoKinHyperonFitter::ReadTotEKinMatrix(), RhoKinFitter::ReadTotMomKinMatrix(), RhoKinHyperonFitter::ReadTotMomKinMatrix(), PndTrkComparisonMCtruth::SciTilMatchtoMC(), KFParticleBase::SetConstructMethod(), KFParticleBaseSIMD::SetConstructMethod(), PndCATrackParamVector::SetCov(), PndFTSCATrackParamVector::SetCov(), SimpleCand::SetDau(), PndCATrackParamVector::SetDzDs(), PndFTSCATrackParamVector::SetDzDs(), PndStack::SetGeneratorFlags(), PndSmpCand::SetM(), RhoCandidate::SetMarker(), KFParticleBase::SetMassHypo(), KFParticleBaseSIMD::SetMassHypo(), RhoKinVtxFitter::SetMinDChisq(), RhoKinHyperonVtxFitter::SetMinDChisq(), DecayTreeFitter::ParticleBase::setMother(), RhoCandidate::SetMotherLink(), RhoKinVtxFitter::SetOutput(), RhoKinFitter::SetOutput(), RhoKinHyperonFitter::SetOutput(), RhoKinHyperonVtxFitter::SetOutput(), PndCATrackParamVector::SetPar(), PndFTSCATrackParamVector::SetPar(), KFParticleBase::SetProductionVertex(), KFParticleBaseSIMD::SetProductionVertex(), PndCATrackParamVector::SetQPt(), PndFTSCATrackParamVector::SetQPt(), PndCATrackParamVector::SetSinPhi(), PndFTSCATrackParamVector::SetSinPhi(), PndCATrackParamVector::SetTrackParam(), PndFTSCATrackParamVector::SetTrackParam(), PndCATrackParamVector::SetY(), PndFTSCATrackParamVector::SetY(), PndCATrackParamVector::SetZ(), PndFTSCATrackParamVector::SetZ(), PndFastSim::smearEnergy(), smearMom(), softtrigger_kin5(), softtrigger_toy12(), KFParticleBaseSIMD::SubtractFromParticle(), KFParticleBase::SubtractFromVertex(), KFParticleBaseSIMD::SubtractFromVertex(), symdiag(), toy_core(), KFParticleBase::TransportCBM(), KFParticleBaseSIMD::TransportCBM(), and PndSttMvdGemTracking::ZFind().

__m128 v

Definition at line 4 of file P4_F32vec4.h.

Referenced by RhoGoodTrackSelector::Accept(), RhoKinFitter::AddMomConstraint(), RhoKinHyperonFitter::AddMomConstraint(), PndHypIdealRecoTask::CalcDetPlane(), PndMvdIdealRecoTask::CalcDetPlane(), PndSdsRecoTask::CalcDetPlane(), PndSdsIdealRecoTask::CalcDetPlane(), PndGemSmearingTask::CalcGFDetPlane(), PndSoftTriggerTask::CodeVariable(), compSphericity(), PndTrkTrack::ComputePhi(), PndTrkLegendreNew::ComputePlaneExtremities(), PndTrkCombiLegendreTask::ComputePlaneExtremities(), PndTrkTrackFinder::ComputePlaneExtremities(), RhoEventShapes::ComputeSphericity(), EventShape::ComputeSphericity(), PndEventShape::ComputeSphericity(), Photospp::PhotosHepMCParticle::createSelfDecayVertex(), GFDetPlane::distance(), PndFTSCADisplay::DrawGBHits(), PndFTSCADisplay::DrawTrack(), eventDisplay(), FairGeaneTrKalStt::Exec(), FairGeaneTrT::Exec(), PndLmdBPRungeKuttaTask::Exec(), PndMvdMSAnaTask::Exec(), PndGemSmearingTask::Exec(), PndHypIdealRecoTask::Exec(), PndMvdIdealRecoTask::Exec(), PndTrkTrackFinder::Exec(), PndHypDPatternRecoTask::Exec(), PndSdsIdealRecoTask::Exec(), expandnode(), PndEmc::ExpandNode(), GeaneTrackRep::extrapolate(), RKTrackRep::extrapolate(), RKTrackRep::extrapolateToLine(), RKTrackRep::extrapolateToPoint(), PndTrkClean::FindMvdLayer(), PndSttMvdGemTracking::Fit(), Photospp::Photos::forceBremForBranch(), Photospp::Photos::forceBremForDecay(), PndTrkConformalTransform::GetConformalHit(), PndTrkConformalTransform::GetConformalSttHit(), KFParticle::GetDeviationFromVertexXY(), KFParticleSIMD::GetDeviationFromVertexXY(), HypStatDecay::GetFragment(), getFromCut(), getFromWeightFile(), PndSttMvdGemTracking::GetInitialParams(), PndTrackCollection::getPndTrack(), RhoVtxPoca::GetPocaTwoNeutral(), genfit::HMatrixUnit::Hv(), genfit::AbsHMatrix::Hv(), PndDrcAccuDigiPixelDraw::Init(), init(), genfit::DetPlane::isInActive(), PndCAHitV::IStation(), FTSCAHitV::IStation(), lutmean(), PndCorrDistGenerator::MaxBoltDistP(), operator<<(), PndLine::plot(), PndLineApproximation::plot(), PndGemRecoHit::PndGemRecoHit(), PndGemRecoHit2::PndGemRecoHit2(), PndHypRecoHit::PndHypRecoHit(), PndSdsRecoHit::PndSdsRecoHit(), PndSdsRecoHit2::PndSdsRecoHit2(), PndSttMvdGemTracking::Prefit(), prod_ana(), propagate_mclist(), PndSttMvdGemTracking::PropagateToGemPlaneAsHelix(), PndRhoTupleQA::qaMcDiff(), PndRhoTupleQA::qaVtx(), RhoBoolArrColumn::RhoBoolArrColumn(), RhoBoolDynArrColumn::RhoBoolDynArrColumn(), RhoDoubleArrColumn::RhoDoubleArrColumn(), RhoDoubleDynArrColumn::RhoDoubleDynArrColumn(), RhoFloatArrColumn::RhoFloatArrColumn(), RhoFloatDynArrColumn::RhoFloatDynArrColumn(), RhoIntArrColumn::RhoIntArrColumn(), RhoIntDynArrColumn::RhoIntDynArrColumn(), RKTrackRep::RKTrackRep(), rotate(), GFDetPlane::sane(), PndForwardTrackFinderTask::saveCombined(), PndForwardTrackFinderTask::saveCorrectedTracklets(), PndForwardTrackFinderTask::saveTrackCollection(), GFDetPlane::set(), PndCAGBHit::SetAngle(), PndFTSCAGBHit::SetAngle(), PndFTSCALocalMCPoint::SetAngle(), PndCATrackParam::SetAngle(), PndCATrackParamVector::SetAngle(), PndFTSCATrackParamVector::SetAngle(), PndCAParam::SetBz(), PndFTSCAParam::SetBz(), PndCAGBHit::SetC(), PndCATrackParam::SetChi2(), PndCATrackParamVector::SetChi2(), PndFTSCATrackParamVector::SetChi2(), PndCATrackLinearisation::SetCosPhi(), PndCATrackLinearisationVector::SetCosPhi(), PndFTSCATrackLinearisationVector::SetCosPhi(), PndCATrackParam::SetCov(), PndCATrackParamVector::SetCov(), PndFTSCATrackParamVector::SetCov(), RhoVector3Err::SetCovMatrix(), PndCAGBTrack::SetDeDx(), PndFTSCAGBTrack::SetDeDx(), PndFsmResponse::setdV(), PndCATrackLinearisation::SetDzDs(), PndCATrackLinearisationVector::SetDzDs(), PndFTSCATrackLinearisationVector::SetDzDs(), PndCATrackParam::SetDzDs(), PndCATrackParamVector::SetDzDs(), PndFTSCATrackParamVector::SetDzDs(), PndCATrackParam::SetErr2QPt(), PndCATrackParamVector::SetErr2QPt(), PndFTSCATrackParamVector::SetErr2QPt(), PndCAGBHit::SetErr2R(), PndCAGBHit::SetErr2X(), PndFTSCAGBHit::SetErr2X(), PndCAGBHit::SetErr2X0(), PndFTSCAGBHit::SetErr2X0(), PndCAGBHit::SetErr2X1(), PndFTSCAGBHit::SetErr2X1(), PndCAGBHit::SetErr2X2(), PndFTSCAGBHit::SetErr2X2(), PndCAGBHit::SetErr2Y(), PndFTSCAGBHit::SetErr2Y(), PndFTSCALocalMCPoint::SetErr2Y(), PndCATrackParamVector::SetErr2Y(), PndFTSCATrackParamVector::SetErr2Y(), PndCAGBHit::SetErr2Z(), PndFTSCAGBHit::SetErr2Z(), PndFTSCALocalMCPoint::SetErr2Z(), PndCATrackParamVector::SetErr2Z(), PndFTSCATrackParamVector::SetErr2Z(), PndCATarget::SetErrQMom(), FTSCATarget::SetErrQMom(), PndCAGBHit::SetErrX12(), PndFTSCAGBHit::SetErrX12(), PndFTSCAGBHit::SetErrYZ(), PndCAGBTrack::SetFirstHitRef(), PndFTSCAGBTrack::SetFirstHitRef(), PndCAMCTrack::SetFirstMCPointID(), PndFTSCAMCTrack::SetFirstMCPointID(), PndMdtTrkProducer::SetGeometry(), PndCAGBHit::SetGlobalX(), PndCAGBHit::SetGlobalY(), PndFTSCADisplay::PndFTSCADisplayTmpHit::SetID(), PndCAGBHit::SetID(), PndFTSCAGBHit::SetID(), PndCAGBTrack::SetInnerParam(), PndFTSCAGBTrack::SetInnerParam(), PndCAGBHit::SetIRow(), PndFTSCAGBHit::SetIRow(), PndFTSCALocalMCPoint::SetIRow(), PndCATrackParam::SetISec(), PndCATrackParamVector::SetISec(), PndFTSCAMCTrack::SetIsForwardTrack(), PndCAGBHit::SetIsLeft(), PndFTSCAMCPoint::SetISlice(), PndFTSCALocalMCPoint::SetISlice(), PndCAMCTrack::SetMotherId(), PndFTSCAMCTrack::SetMotherId(), PndCATrackParam::SetNDF(), PndCATrackParamVector::SetNDF(), PndFTSCATrackParamVector::SetNDF(), PndCAMCTrack::SetNHitContRows(), PndFTSCAMCTrack::SetNHitContRows(), PndCAMCTrack::SetNHitRows(), PndFTSCAMCTrack::SetNHitRows(), PndCAGBTrack::SetNHits(), PndFTSCAGBTrack::SetNHits(), PndCAMCTrack::SetNHits(), PndFTSCAMCTrack::SetNHits(), PndCAMCTrack::SetNMCContRows(), PndFTSCAMCTrack::SetNMCContRows(), PndCAMCTrack::SetNMCPoints(), PndFTSCAMCTrack::SetNMCPoints(), PndCAMCTrack::SetNMCRows(), PndFTSCAMCTrack::SetNMCRows(), PndCAMCTrack::SetNReconstructed(), PndFTSCAMCTrack::SetNReconstructed(), PndCAMCTrack::SetNTurns(), PndFTSCAMCTrack::SetNTurns(), PndCAGBTrack::SetOuterParam(), PndFTSCAGBTrack::SetOuterParam(), PndCAMCTrack::SetP(), PndFTSCAMCTrack::SetP(), PndCAMCVertex::SetPar(), PndFTSCAMCVertex::SetPar(), PndCAMCTrack::SetPar(), PndFTSCAMCTrack::SetPar(), PndCATrackParam::SetPar(), PndCATrackParamVector::SetPar(), PndFTSCATrackParamVector::SetPar(), PndCAMCTrack::SetPDG(), PndFTSCAMCTrack::SetPDG(), PndDrc::SetPersistency(), PndCAGBHit::SetPndDetID(), PndFTSCAGBHit::SetPndDetID(), PndCAGBHit::SetPndHitID(), PndFTSCAGBHit::SetPndHitID(), PndCAMCTrack::SetPt(), PndFTSCAMCTrack::SetPt(), PndFTSCALocalMCPoint::SetPx(), PndFTSCALocalMCPoint::SetPy(), PndFTSCALocalMCPoint::SetPz(), PndFTSCALocalMCPoint::SetQP(), PndCATrackLinearisation::SetQPt(), PndCATrackLinearisationVector::SetQPt(), PndFTSCATrackLinearisationVector::SetQPt(), PndCATrackParam::SetQPt(), PndCATrackParamVector::SetQPt(), PndFTSCATrackParamVector::SetQPt(), PndCAGBHit::SetR(), PndFTSCADisplay::PndFTSCADisplayTmpHit::SetS(), PndCAMCTrack::SetSet(), PndFTSCAMCTrack::SetSet(), PndCATrackParam::SetSignCosPhi(), PndCATrackParamVector::SetSignCosPhi(), PndFTSCATrackParamVector::SetSignCosPhi(), PndFTSCATrackLinearisationVector::SetSinPhi(), PndCATrackLinearisation::SetSinPhi(), PndCATrackLinearisationVector::SetSinPhi(), PndCATrackParam::SetSinPhi(), PndCATrackParamVector::SetSinPhi(), PndFTSCATrackParam::SetSinPhi(), PndFTSCATrackParamVector::SetSinPhi(), PndFsmTrack::setStartVtx(), PndFsmTrack::setStopVtx(), genfit::PlanarMeasurement::setStripV(), PndFTSCAMCPoint::SetSx(), PndFTSCAMCPoint::SetSy(), PndFTSCAMCPoint::SetSz(), PndFTSCAMCPoint::SetTime(), PndCAMCTrack::SetTPCPar(), PndFTSCAMCTrack::SetTPCPar(), PndFTSCALocalMCPoint::SetTrackI(), PndFTSCAMCPoint::SetTrackID(), PndFTSCALocalMCPoint::SetTrackID(), PndCAGBHit::SetTubeHalfLength(), PndCAGBHit::SetTubeR(), PndFastSim::SetUseFlatCov(), GFDetPlane::setUV(), GFDetPlane::setV(), PndCANPletV::SetValid(), PndFileNameCreator::SetVerbose(), PndMdtParamDigi::SetVerbose(), PndPythia6Direct::SetVerbose(), PndEvtGenDirect::SetVerbose(), RhoFitterBase::SetVerbose(), PndHypGeoHandling::SetVerbose(), PndSimpleCombinerTask::SetVerbose(), PndFtfDirect::SetVerbose(), PndGeoHandling::SetVerbose(), PndFTSCAMCVertex::SetX(), PndCAMCVertex::SetX(), PndFTSCAMCPoint::SetX(), PndFTSCAGBHit::SetX(), PndFTSCALocalMCPoint::SetX(), PndCATrackParam::SetX(), PndCATrackParamVector::SetX(), PndFTSCATrackParamVector::SetX(), PndCAGBHit::SetXW(), PndCAMCVertex::SetY(), PndFTSCAMCVertex::SetY(), PndFTSCAMCPoint::SetY(), PndFTSCAGBHit::SetY(), PndFTSCALocalMCPoint::SetY(), PndCATrackParam::SetY(), PndCATrackParamVector::SetY(), PndFTSCATrackParamVector::SetY(), PndCAGBHit::SetYW(), PndFTSCAMCVertex::SetZ(), PndCAMCVertex::SetZ(), PndFTSCAMCPoint::SetZ(), PndFTSCADisplay::PndFTSCADisplayTmpHit::SetZ(), PndCAGBHit::SetZ(), PndFTSCAGBHit::SetZ(), PndFTSCALocalMCPoint::SetZ(), PndCATrackParam::SetZ(), PndCATrackParamVector::SetZ(), PndFTSCATrackParamVector::SetZ(), PndCAGBHit::SetZW(), SplitString(), RKTrackRep::stepalong(), Photospp::Photos::suppressBremForBranch(), Photospp::Photos::suppressBremForDecay(), switch_history_entries_status(), validHitIndexes(), PndSttHelixTrackFitter::XYFit(), PndSttHelixTrackFitter::XYFitThroughOrigin(), and PndSttMvdGemTracking::ZFit().