16#if defined(JPH_USE_AVX)
17 mValue = _mm256_cvtps_pd(inRHS.mValue);
18#elif defined(JPH_USE_SSE)
19 mValue.mLow = _mm_cvtps_pd(inRHS.mValue);
20 mValue.mHigh = _mm_cvtps_pd(_mm_shuffle_ps(inRHS.mValue, inRHS.mValue, _MM_SHUFFLE(2, 2, 2, 2)));
21#elif defined(JPH_USE_NEON)
22 mValue.val[0] = vcvt_f64_f32(vget_low_f32(inRHS.mValue));
23 mValue.val[1] = vcvt_high_f64_f32(inRHS.mValue);
25 mF64[0] = (double)inRHS.GetX();
26 mF64[1] = (double)inRHS.GetY();
27 mF64[2] = (double)inRHS.GetZ();
28 #ifdef JPH_FLOATING_POINT_EXCEPTIONS_ENABLED
41#if defined(JPH_USE_AVX)
42 mValue = _mm256_set_pd(inZ, inZ, inY, inX);
43#elif defined(JPH_USE_SSE)
44 mValue.mLow = _mm_set_pd(inY, inX);
45 mValue.mHigh = _mm_set_pd1(inZ);
46#elif defined(JPH_USE_NEON)
47 mValue.val[0] = vcombine_f64(vcreate_f64(*
reinterpret_cast<uint64 *
>(&inX)), vcreate_f64(*
reinterpret_cast<uint64 *
>(&inY)));
48 mValue.val[1] = vdupq_n_f64(inZ);
53 #ifdef JPH_FLOATING_POINT_EXCEPTIONS_ENABLED
61#if defined(JPH_USE_AVX)
62 Type x = _mm256_castpd128_pd256(_mm_load_sd(&inV.
x));
63 Type y = _mm256_castpd128_pd256(_mm_load_sd(&inV.
y));
64 Type z = _mm256_broadcast_sd(&inV.
z);
65 Type xy = _mm256_unpacklo_pd(x, y);
66 mValue = _mm256_blend_pd(xy, z, 0b1100);
67#elif defined(JPH_USE_SSE)
68 mValue.mLow = _mm_load_pd(&inV.
x);
69 mValue.mHigh = _mm_set_pd1(inV.
z);
70#elif defined(JPH_USE_NEON)
71 mValue.val[0] = vld1q_f64(&inV.
x);
72 mValue.val[1] = vdupq_n_f64(inV.
z);
77 #ifdef JPH_FLOATING_POINT_EXCEPTIONS_ENABLED
85#ifdef JPH_FLOATING_POINT_EXCEPTIONS_ENABLED
94#ifdef JPH_FLOATING_POINT_EXCEPTIONS_ENABLED
95 #if defined(JPH_USE_AVX)
96 return _mm256_shuffle_pd(inValue, inValue, 2);
97 #elif defined(JPH_USE_SSE)
99 value.mLow = inValue.mLow;
100 value.mHigh = _mm_shuffle_pd(inValue.mHigh, inValue.mHigh, 0);
102 #elif defined(JPH_USE_NEON)
104 value.val[0] = inValue.val[0];
105 value.val[1] = vdupq_laneq_f64(inValue.val[1], 0);
109 value.mData[0] = inValue.mData[0];
110 value.mData[1] = inValue.mData[1];
111 value.mData[2] = inValue.mData[2];
112 value.mData[3] = inValue.mData[2];
122#if defined(JPH_USE_AVX)
123 return _mm256_setzero_pd();
124#elif defined(JPH_USE_SSE)
125 __m128d zero = _mm_setzero_pd();
126 return DVec3({ zero, zero });
127#elif defined(JPH_USE_NEON)
128 float64x2_t zero = vdupq_n_f64(0.0);
129 return DVec3({ zero, zero });
131 return DVec3(0, 0, 0);
137#if defined(JPH_USE_AVX)
138 return _mm256_set1_pd(inV);
139#elif defined(JPH_USE_SSE)
140 __m128d value = _mm_set1_pd(inV);
141 return DVec3({ value, value });
142#elif defined(JPH_USE_NEON)
143 float64x2_t value = vdupq_n_f64(inV);
144 return DVec3({ value, value });
146 return DVec3(inV, inV, inV);
152 return sReplicate(numeric_limits<double>::quiet_NaN());
157#if defined(JPH_USE_AVX)
158 Type v = _mm256_loadu_pd(&inV.
x);
159#elif defined(JPH_USE_SSE)
161 v.mLow = _mm_loadu_pd(&inV.
x);
162 v.mHigh = _mm_set1_pd(inV.
z);
163#elif defined(JPH_USE_NEON)
164 Type v = vld1q_f64_x2(&inV.
x);
166 Type v = { inV.
x, inV.
y, inV.
z };
180#if defined(JPH_USE_AVX)
181 return _mm256_cvtpd_ps(mValue);
182#elif defined(JPH_USE_SSE)
183 __m128 low = _mm_cvtpd_ps(mValue.mLow);
184 __m128 high = _mm_cvtpd_ps(mValue.mHigh);
185 return _mm_shuffle_ps(low, high, _MM_SHUFFLE(1, 0, 1, 0));
186#elif defined(JPH_USE_NEON)
187 return vcvt_high_f32_f64(vcvtx_f32_f64(mValue.val[0]), mValue.val[1]);
189 return Vec3((
float)GetX(), (
float)GetY(), (
float)GetZ());
195#if defined(JPH_USE_AVX)
197#elif defined(JPH_USE_SSE)
199#elif defined(JPH_USE_NEON)
210#if defined(JPH_USE_AVX)
212#elif defined(JPH_USE_SSE)
214#elif defined(JPH_USE_NEON)
225 return sMax(
sMin(inV, inMax), inMin);
230#if defined(JPH_USE_AVX)
231 return _mm256_cmp_pd(inV1.
mValue, inV2.
mValue, _CMP_EQ_OQ);
232#elif defined(JPH_USE_SSE)
234#elif defined(JPH_USE_NEON)
235 return DVec3({ vreinterpretq_u64_f64(vceqq_f64(inV1.
mValue.val[0], inV2.
mValue.val[0])), vreinterpretq_u64_f64(vceqq_f64(inV1.
mValue.val[1], inV2.
mValue.val[1])) });
245#if defined(JPH_USE_AVX)
246 return _mm256_cmp_pd(inV1.
mValue, inV2.
mValue, _CMP_LT_OQ);
247#elif defined(JPH_USE_SSE)
249#elif defined(JPH_USE_NEON)
250 return DVec3({ vreinterpretq_u64_f64(vcltq_f64(inV1.
mValue.val[0], inV2.
mValue.val[0])), vreinterpretq_u64_f64(vcltq_f64(inV1.
mValue.val[1], inV2.
mValue.val[1])) });
260#if defined(JPH_USE_AVX)
261 return _mm256_cmp_pd(inV1.
mValue, inV2.
mValue, _CMP_LE_OQ);
262#elif defined(JPH_USE_SSE)
264#elif defined(JPH_USE_NEON)
265 return DVec3({ vreinterpretq_u64_f64(vcleq_f64(inV1.
mValue.val[0], inV2.
mValue.val[0])), vreinterpretq_u64_f64(vcleq_f64(inV1.
mValue.val[1], inV2.
mValue.val[1])) });
275#if defined(JPH_USE_AVX)
276 return _mm256_cmp_pd(inV1.
mValue, inV2.
mValue, _CMP_GT_OQ);
277#elif defined(JPH_USE_SSE)
279#elif defined(JPH_USE_NEON)
280 return DVec3({ vreinterpretq_u64_f64(vcgtq_f64(inV1.
mValue.val[0], inV2.
mValue.val[0])), vreinterpretq_u64_f64(vcgtq_f64(inV1.
mValue.val[1], inV2.
mValue.val[1])) });
290#if defined(JPH_USE_AVX)
291 return _mm256_cmp_pd(inV1.
mValue, inV2.
mValue, _CMP_GE_OQ);
292#elif defined(JPH_USE_SSE)
294#elif defined(JPH_USE_NEON)
295 return DVec3({ vreinterpretq_u64_f64(vcgeq_f64(inV1.
mValue.val[0], inV2.
mValue.val[0])), vreinterpretq_u64_f64(vcgeq_f64(inV1.
mValue.val[1], inV2.
mValue.val[1])) });
305#if defined(JPH_USE_AVX)
311#elif defined(JPH_USE_NEON)
314 return inMul1 * inMul2 + inAdd;
320#if defined(JPH_USE_AVX)
322#elif defined(JPH_USE_SSE4_1)
325#elif defined(JPH_USE_NEON)
326 Type v = { vbslq_f64(vshrq_n_s64(inControl.
mValue.val[0], 63), inV2.
mValue.val[0], inV1.
mValue.val[0]), vbslq_f64(vshrq_n_s64(inControl.
mValue.val[1], 63), inV2.
mValue.val[1], inV1.
mValue.val[1]) };
330 for (
int i = 0; i < 3; i++)
331 result.
mF64[i] = BitCast<uint64>(inControl.
mF64[i])? inV2.
mF64[i] : inV1.
mF64[i];
332#ifdef JPH_FLOATING_POINT_EXCEPTIONS_ENABLED
341#if defined(JPH_USE_AVX)
343#elif defined(JPH_USE_SSE)
345#elif defined(JPH_USE_NEON)
348 return DVec3(BitCast<double>(BitCast<uint64>(inV1.
mF64[0]) | BitCast<uint64>(inV2.
mF64[0])),
349 BitCast<double>(BitCast<uint64>(inV1.
mF64[1]) | BitCast<uint64>(inV2.
mF64[1])),
350 BitCast<double>(BitCast<uint64>(inV1.
mF64[2]) | BitCast<uint64>(inV2.
mF64[2])));
356#if defined(JPH_USE_AVX)
358#elif defined(JPH_USE_SSE)
360#elif defined(JPH_USE_NEON)
363 return DVec3(BitCast<double>(BitCast<uint64>(inV1.
mF64[0]) ^ BitCast<uint64>(inV2.
mF64[0])),
364 BitCast<double>(BitCast<uint64>(inV1.
mF64[1]) ^ BitCast<uint64>(inV2.
mF64[1])),
365 BitCast<double>(BitCast<uint64>(inV1.
mF64[2]) ^ BitCast<uint64>(inV2.
mF64[2])));
371#if defined(JPH_USE_AVX)
373#elif defined(JPH_USE_SSE)
375#elif defined(JPH_USE_NEON)
378 return DVec3(BitCast<double>(BitCast<uint64>(inV1.
mF64[0]) & BitCast<uint64>(inV2.
mF64[0])),
379 BitCast<double>(BitCast<uint64>(inV1.
mF64[1]) & BitCast<uint64>(inV2.
mF64[1])),
380 BitCast<double>(BitCast<uint64>(inV1.
mF64[2]) & BitCast<uint64>(inV2.
mF64[2])));
386#if defined(JPH_USE_AVX)
387 return _mm256_movemask_pd(
mValue) & 0x7;
388#elif defined(JPH_USE_SSE)
389 return (_mm_movemask_pd(
mValue.mLow) + (_mm_movemask_pd(
mValue.mHigh) << 2)) & 0x7;
391 return int((BitCast<uint64>(
mF64[0]) >> 63) | ((BitCast<uint64>(
mF64[1]) >> 63) << 1) | ((BitCast<uint64>(
mF64[2]) >> 63) << 2));
412 return (inV2 - *
this).LengthSq() <= inMaxDistSq;
422#if defined(JPH_USE_AVX)
424#elif defined(JPH_USE_SSE)
426#elif defined(JPH_USE_NEON)
435#if defined(JPH_USE_AVX)
436 return _mm256_mul_pd(
mValue, _mm256_set1_pd(inV2));
437#elif defined(JPH_USE_SSE)
438 __m128d v = _mm_set1_pd(inV2);
440#elif defined(JPH_USE_NEON)
441 return DVec3({ vmulq_n_f64(
mValue.val[0], inV2), vmulq_n_f64(
mValue.val[1], inV2) });
449#if defined(JPH_USE_AVX)
450 return _mm256_mul_pd(_mm256_set1_pd(inV1), inV2.
mValue);
451#elif defined(JPH_USE_SSE)
452 __m128d v = _mm_set1_pd(inV1);
453 return DVec3({ _mm_mul_pd(v, inV2.
mValue.mLow), _mm_mul_pd(v, inV2.
mValue.mHigh) });
454#elif defined(JPH_USE_NEON)
455 return DVec3({ vmulq_n_f64(inV2.
mValue.val[0], inV1), vmulq_n_f64(inV2.
mValue.val[1], inV1) });
463#if defined(JPH_USE_AVX)
464 return _mm256_div_pd(
mValue, _mm256_set1_pd(inV2));
465#elif defined(JPH_USE_SSE)
466 __m128d v = _mm_set1_pd(inV2);
468#elif defined(JPH_USE_NEON)
469 float64x2_t v = vdupq_n_f64(inV2);
478#if defined(JPH_USE_AVX)
480#elif defined(JPH_USE_SSE)
481 __m128d v = _mm_set1_pd(inV2);
484#elif defined(JPH_USE_NEON)
488 for (
int i = 0; i < 3; ++i)
490 #ifdef JPH_FLOATING_POINT_EXCEPTIONS_ENABLED
499#if defined(JPH_USE_AVX)
501#elif defined(JPH_USE_SSE)
504#elif defined(JPH_USE_NEON)
508 for (
int i = 0; i < 3; ++i)
510 #ifdef JPH_FLOATING_POINT_EXCEPTIONS_ENABLED
519#if defined(JPH_USE_AVX)
521#elif defined(JPH_USE_SSE)
522 __m128d v = _mm_set1_pd(inV2);
525#elif defined(JPH_USE_NEON)
526 float64x2_t v = vdupq_n_f64(inV2);
530 for (
int i = 0; i < 3; ++i)
532 #ifdef JPH_FLOATING_POINT_EXCEPTIONS_ENABLED
541#if defined(JPH_USE_AVX)
542 return _mm256_add_pd(
mValue, _mm256_cvtps_pd(inV2.
mValue));
543#elif defined(JPH_USE_SSE)
544 return DVec3({ _mm_add_pd(
mValue.mLow, _mm_cvtps_pd(inV2.
mValue)), _mm_add_pd(
mValue.mHigh, _mm_cvtps_pd(_mm_shuffle_ps(inV2.
mValue, inV2.
mValue, _MM_SHUFFLE(2, 2, 2, 2)))) });
545#elif defined(JPH_USE_NEON)
546 return DVec3({ vaddq_f64(
mValue.val[0], vcvt_f64_f32(vget_low_f32(inV2.
mValue))), vaddq_f64(
mValue.val[1], vcvt_high_f64_f32(inV2.
mValue)) });
554#if defined(JPH_USE_AVX)
556#elif defined(JPH_USE_SSE)
558#elif defined(JPH_USE_NEON)
567#if defined(JPH_USE_AVX)
569#elif defined(JPH_USE_SSE)
571 mValue.mHigh = _mm_add_pd(
mValue.mHigh, _mm_cvtps_pd(_mm_shuffle_ps(inV2.
mValue, inV2.
mValue, _MM_SHUFFLE(2, 2, 2, 2))));
572#elif defined(JPH_USE_NEON)
576 for (
int i = 0; i < 3; ++i)
578 #ifdef JPH_FLOATING_POINT_EXCEPTIONS_ENABLED
587#if defined(JPH_USE_AVX)
589#elif defined(JPH_USE_SSE)
592#elif defined(JPH_USE_NEON)
596 for (
int i = 0; i < 3; ++i)
598 #ifdef JPH_FLOATING_POINT_EXCEPTIONS_ENABLED
607#if defined(JPH_USE_AVX)
608 return _mm256_sub_pd(_mm256_setzero_pd(),
mValue);
609#elif defined(JPH_USE_SSE)
610 __m128d zero = _mm_setzero_pd();
612#elif defined(JPH_USE_NEON)
621#if defined(JPH_USE_AVX)
622 return _mm256_sub_pd(
mValue, _mm256_cvtps_pd(inV2.
mValue));
623#elif defined(JPH_USE_SSE)
624 return DVec3({ _mm_sub_pd(
mValue.mLow, _mm_cvtps_pd(inV2.
mValue)), _mm_sub_pd(
mValue.mHigh, _mm_cvtps_pd(_mm_shuffle_ps(inV2.
mValue, inV2.
mValue, _MM_SHUFFLE(2, 2, 2, 2)))) });
625#elif defined(JPH_USE_NEON)
626 return DVec3({ vsubq_f64(
mValue.val[0], vcvt_f64_f32(vget_low_f32(inV2.
mValue))), vsubq_f64(
mValue.val[1], vcvt_high_f64_f32(inV2.
mValue)) });
634#if defined(JPH_USE_AVX)
636#elif defined(JPH_USE_SSE)
638#elif defined(JPH_USE_NEON)
647#if defined(JPH_USE_AVX)
649#elif defined(JPH_USE_SSE)
651 mValue.mHigh = _mm_sub_pd(
mValue.mHigh, _mm_cvtps_pd(_mm_shuffle_ps(inV2.
mValue, inV2.
mValue, _MM_SHUFFLE(2, 2, 2, 2))));
652#elif defined(JPH_USE_NEON)
656 for (
int i = 0; i < 3; ++i)
658 #ifdef JPH_FLOATING_POINT_EXCEPTIONS_ENABLED
667#if defined(JPH_USE_AVX)
669#elif defined(JPH_USE_SSE)
672#elif defined(JPH_USE_NEON)
676 for (
int i = 0; i < 3; ++i)
678 #ifdef JPH_FLOATING_POINT_EXCEPTIONS_ENABLED
688#if defined(JPH_USE_AVX)
690#elif defined(JPH_USE_SSE)
692#elif defined(JPH_USE_NEON)
701#if defined(JPH_USE_AVX512)
703#elif defined(JPH_USE_AVX)
704 return _mm256_max_pd(_mm256_sub_pd(_mm256_setzero_pd(),
mValue),
mValue);
705#elif defined(JPH_USE_SSE)
706 __m128d zero = _mm_setzero_pd();
708#elif defined(JPH_USE_NEON)
722#if defined(JPH_USE_AVX2)
723 __m256d t1 = _mm256_permute4x64_pd(inV2.
mValue, _MM_SHUFFLE(0, 0, 2, 1));
724 t1 = _mm256_mul_pd(t1,
mValue);
725 __m256d t2 = _mm256_permute4x64_pd(
mValue, _MM_SHUFFLE(0, 0, 2, 1));
726 t2 = _mm256_mul_pd(t2, inV2.
mValue);
727 __m256d t3 = _mm256_sub_pd(t1, t2);
728 return _mm256_permute4x64_pd(t3, _MM_SHUFFLE(0, 0, 2, 1));
738#if defined(JPH_USE_AVX)
740 __m128d xy = _mm256_castpd256_pd128(mul);
741 __m128d yx = _mm_shuffle_pd(xy, xy, 1);
742 __m128d sum = _mm_add_pd(xy, yx);
743 __m128d zw = _mm256_extractf128_pd(mul, 1);
744 sum = _mm_add_pd(sum, zw);
745 return _mm_cvtsd_f64(sum);
746#elif defined(JPH_USE_SSE)
748 __m128d yx = _mm_shuffle_pd(xy, xy, 1);
749 __m128d sum = _mm_add_pd(xy, yx);
750 __m128d z = _mm_mul_sd(
mValue.mHigh, inV2.
mValue.mHigh);
751 sum = _mm_add_pd(sum, z);
752 return _mm_cvtsd_f64(sum);
753#elif defined(JPH_USE_NEON)
754 float64x2_t mul_low = vmulq_f64(
mValue.val[0], inV2.
mValue.val[0]);
755 float64x2_t mul_high = vmulq_f64(
mValue.val[1], inV2.
mValue.val[1]);
756 return vaddvq_f64(mul_low) + vgetq_lane_f64(mul_high, 0);
759 for (
int i = 0; i < 3; i++)
772#if defined(JPH_USE_AVX)
773 return _mm256_sqrt_pd(
mValue);
774#elif defined(JPH_USE_SSE)
776#elif defined(JPH_USE_NEON)
785 return sqrt(
Dot(*
this));
795 return abs(
LengthSq() - 1.0) <= inTolerance;
800#if defined(JPH_USE_AVX)
801 return (_mm256_movemask_pd(_mm256_cmp_pd(
mValue,
mValue, _CMP_UNORD_Q)) & 0x7) != 0;
802#elif defined(JPH_USE_SSE)
803 return ((_mm_movemask_pd(_mm_cmpunord_pd(
mValue.mLow,
mValue.mLow)) + (_mm_movemask_pd(_mm_cmpunord_pd(
mValue.mHigh,
mValue.mHigh)) << 2)) & 0x7) != 0;
805 return isnan(
mF64[0]) || isnan(
mF64[1]) || isnan(
mF64[2]);
811#if defined(JPH_USE_AVX)
812 __m256d minus_one = _mm256_set1_pd(-1.0);
813 __m256d one = _mm256_set1_pd(1.0);
814 return _mm256_or_pd(_mm256_and_pd(
mValue, minus_one), one);
815#elif defined(JPH_USE_SSE)
816 __m128d minus_one = _mm_set1_pd(-1.0);
817 __m128d one = _mm_set1_pd(1.0);
818 return DVec3({ _mm_or_pd(_mm_and_pd(
mValue.mLow, minus_one), one), _mm_or_pd(_mm_and_pd(
mValue.mHigh, minus_one), one) });
819#elif defined(JPH_USE_NEON)
820 float64x2_t minus_one = vdupq_n_f64(-1.0f);
821 float64x2_t one = vdupq_n_f64(1.0f);
822 return DVec3({ vorrq_s64(vandq_s64(
mValue.val[0], minus_one), one), vorrq_s64(vandq_s64(
mValue.val[1], minus_one), one) });
824 return DVec3(std::signbit(
mF64[0])? -1.0 : 1.0,
825 std::signbit(
mF64[1])? -1.0 : 1.0,
826 std::signbit(
mF64[2])? -1.0 : 1.0);
833 constexpr uint64 cDoubleToFloatMantissaLoss = (1U << 29) - 1;
835#if defined(JPH_USE_AVX)
836 return _mm256_and_pd(
mValue, _mm256_castsi256_pd(_mm256_set1_epi64x(int64_t(~cDoubleToFloatMantissaLoss))));
837#elif defined(JPH_USE_SSE)
838 __m128d mask = _mm_castsi128_pd(_mm_set1_epi64x(int64_t(~cDoubleToFloatMantissaLoss)));
840#elif defined(JPH_USE_NEON)
841 float64x2_t mask = vreinterpretq_f64_u64(vdupq_n_u64(~cDoubleToFloatMantissaLoss));
842 return DVec3({ vandq_s64(
mValue.val[0], mask), vandq_s64(
mValue.val[1], mask) });
844 double x = BitCast<double>(BitCast<uint64>(
mF64[0]) & ~cDoubleToFloatMantissaLoss);
845 double y = BitCast<double>(BitCast<uint64>(
mF64[1]) & ~cDoubleToFloatMantissaLoss);
846 double z = BitCast<double>(BitCast<uint64>(
mF64[2]) & ~cDoubleToFloatMantissaLoss);
848 return DVec3(x, y, z);
855 constexpr uint64 cDoubleToFloatMantissaLoss = (1U << 29) - 1;
857#if defined(JPH_USE_AVX)
858 __m256i mantissa_loss = _mm256_set1_epi64x(cDoubleToFloatMantissaLoss);
859 __m256d value_and_mantissa_loss = _mm256_and_pd(
mValue, _mm256_castsi256_pd(mantissa_loss));
860 __m256d is_zero = _mm256_cmp_pd(value_and_mantissa_loss, _mm256_setzero_pd(), _CMP_EQ_OQ);
861 __m256d value_or_mantissa_loss = _mm256_or_pd(
mValue, _mm256_castsi256_pd(mantissa_loss));
862 return _mm256_blendv_pd(value_or_mantissa_loss,
mValue, is_zero);
863#elif defined(JPH_USE_SSE4_1)
864 __m128i mantissa_loss = _mm_set1_epi64x(cDoubleToFloatMantissaLoss);
865 __m128d zero = _mm_setzero_pd();
866 __m128d value_and_mantissa_loss_low = _mm_and_pd(
mValue.mLow, _mm_castsi128_pd(mantissa_loss));
867 __m128d is_zero_low = _mm_cmpeq_pd(value_and_mantissa_loss_low, zero);
868 __m128d value_or_mantissa_loss_low = _mm_or_pd(
mValue.mLow, _mm_castsi128_pd(mantissa_loss));
869 __m128d value_and_mantissa_loss_high = _mm_and_pd(
mValue.mHigh, _mm_castsi128_pd(mantissa_loss));
870 __m128d is_zero_high = _mm_cmpeq_pd(value_and_mantissa_loss_high, zero);
871 __m128d value_or_mantissa_loss_high = _mm_or_pd(
mValue.mHigh, _mm_castsi128_pd(mantissa_loss));
872 return DVec3({ _mm_blendv_pd(value_or_mantissa_loss_low,
mValue.mLow, is_zero_low), _mm_blendv_pd(value_or_mantissa_loss_high,
mValue.mHigh, is_zero_high) });
873#elif defined(JPH_USE_NEON)
874 float64x2_t mantissa_loss = vreinterpretq_f64_u64(vdupq_n_u64(cDoubleToFloatMantissaLoss));
875 float64x2_t zero = vdupq_n_f64(0.0);
876 float64x2_t value_and_mantissa_loss_low = vandq_s64(
mValue.val[0], mantissa_loss);
877 float64x2_t is_zero_low = vceqq_f64(value_and_mantissa_loss_low, zero);
878 float64x2_t value_or_mantissa_loss_low = vorrq_s64(
mValue.val[0], mantissa_loss);
879 float64x2_t value_and_mantissa_loss_high = vandq_s64(
mValue.val[1], mantissa_loss);
880 float64x2_t value_low = vbslq_f64(is_zero_low,
mValue.val[0], value_or_mantissa_loss_low);
881 float64x2_t is_zero_high = vceqq_f64(value_and_mantissa_loss_high, zero);
882 float64x2_t value_or_mantissa_loss_high = vorrq_s64(
mValue.val[1], mantissa_loss);
883 float64x2_t value_high = vbslq_f64(is_zero_high,
mValue.val[1], value_or_mantissa_loss_high);
884 return DVec3({ value_low, value_high });
890 double x = BitCast<double>((ux & cDoubleToFloatMantissaLoss) == 0? ux : (ux | cDoubleToFloatMantissaLoss));
891 double y = BitCast<double>((uy & cDoubleToFloatMantissaLoss) == 0? uy : (uy | cDoubleToFloatMantissaLoss));
892 double z = BitCast<double>((uz & cDoubleToFloatMantissaLoss) == 0? uz : (uz | cDoubleToFloatMantissaLoss));
894 return DVec3(x, y, z);
#define JPH_NAMESPACE_END
Definition Core.h:240
uint64_t uint64
Definition Core.h:313
#define JPH_NAMESPACE_BEGIN
Definition Core.h:234
DVec3 operator*(double inV1, DVec3Arg inV2)
Definition DVec3.inl:447
#define JPH_MAKE_HASHABLE(type,...)
Definition HashCombine.h:87
#define JPH_ASSERT(...)
Definition IssueReporting.h:33
static JPH_INLINE DVec3 sLess(DVec3Arg inV1, DVec3Arg inV2)
Less than (component wise)
Definition DVec3.inl:243
double mF64[4]
Definition DVec3.h:276
static JPH_INLINE DVec3 sMax(DVec3Arg inV1, DVec3Arg inV2)
Return the maximum of each of the components.
Definition DVec3.inl:208
JPH_INLINE bool TestAnyTrue() const
Test if any of the components are true (true is when highest bit of component is set)
Definition DVec3.inl:395
JPH_INLINE Vec3 ToVec3RoundDown() const
Convert to float vector 3 rounding down.
Definition DVec3.inl:898
static JPH_INLINE DVec3 sClamp(DVec3Arg inV, DVec3Arg inMin, DVec3Arg inMax)
Clamp a vector between min and max (component wise)
Definition DVec3.inl:223
static JPH_INLINE DVec3 sMin(DVec3Arg inV1, DVec3Arg inV2)
Return the minimum value of each of the components.
Definition DVec3.inl:193
JPH_INLINE int GetTrues() const
Store if X is true in bit 0, Y in bit 1, Z in bit 2 and W in bit 3 (true is when highest bit of compo...
Definition DVec3.inl:384
static JPH_INLINE DVec3 sAnd(DVec3Arg inV1, DVec3Arg inV2)
Logical and (component wise)
Definition DVec3.inl:369
JPH_INLINE DVec3 & operator*=(double inV2)
Multiply vector with double.
Definition DVec3.inl:476
JPH_INLINE DVec3 Abs() const
Return the absolute value of each of the components.
Definition DVec3.inl:699
static JPH_INLINE DVec3 sFusedMultiplyAdd(DVec3Arg inMul1, DVec3Arg inMul2, DVec3Arg inAdd)
Calculates inMul1 * inMul2 + inAdd.
Definition DVec3.inl:303
static JPH_INLINE Type sFixW(TypeArg inValue)
Internal helper function that ensures that the Z component is replicated to the W component to preven...
Definition DVec3.inl:92
JPH_INLINE DVec3 Sqrt() const
Component wise square root.
Definition DVec3.inl:770
JPH_INLINE DVec3 GetSign() const
Get vector that contains the sign of each element (returns 1 if positive, -1 if negative)
Definition DVec3.inl:809
Type mValue
Definition DVec3.h:275
static JPH_INLINE DVec3 sXor(DVec3Arg inV1, DVec3Arg inV2)
Logical xor (component wise)
Definition DVec3.inl:354
static JPH_INLINE DVec3 sGreaterOrEqual(DVec3Arg inV1, DVec3Arg inV2)
Greater than or equal (component wise)
Definition DVec3.inl:288
JPH_INLINE DVec3 operator+(Vec3Arg inV2) const
Add two vectors (component wise)
Definition DVec3.inl:539
JPH_INLINE bool IsClose(DVec3Arg inV2, double inMaxDistSq=1.0e-24) const
Test if two vectors are close.
Definition DVec3.inl:410
JPH_INLINE bool IsNormalized(double inTolerance=1.0e-12) const
Test if vector is normalized.
Definition DVec3.inl:793
const Type & TypeArg
Definition DVec3.h:30
static JPH_INLINE DVec3 sNaN()
Vector with all NaN's.
Definition DVec3.inl:150
friend JPH_INLINE DVec3 operator*(double inV1, DVec3Arg inV2)
Multiply vector with double.
Definition DVec3.inl:447
static JPH_INLINE DVec3 sGreater(DVec3Arg inV1, DVec3Arg inV2)
Greater than (component wise)
Definition DVec3.inl:273
JPH_INLINE void StoreDouble3(Double3 *outV) const
Store 3 doubles to memory.
Definition DVec3.inl:171
static JPH_INLINE DVec3 sOr(DVec3Arg inV1, DVec3Arg inV2)
Logical or (component wise)
Definition DVec3.inl:339
static JPH_INLINE DVec3 sSelect(DVec3Arg inV1, DVec3Arg inV2, DVec3Arg inControl)
Component wise select, returns inV1 when highest bit of inControl = 0 and inV2 when highest bit of in...
Definition DVec3.inl:318
static JPH_INLINE DVec3 sZero()
Vector with all zeros.
Definition DVec3.inl:120
JPH_INLINE bool TestAllTrue() const
Test if all components are true (true is when highest bit of component is set)
Definition DVec3.inl:400
JPH_INLINE double Length() const
Length of vector.
Definition DVec3.inl:783
JPH_INLINE DVec3 operator-() const
Negate.
Definition DVec3.inl:605
JPH_INLINE bool IsNaN() const
Test if vector contains NaN elements.
Definition DVec3.inl:798
JPH_INLINE Vec3 ToVec3RoundUp() const
Convert to float vector 3 rounding up.
Definition DVec3.inl:905
static const double cTrue
Representations of true and false for boolean operations.
Definition DVec3.h:270
DVec3()=default
Constructor.
JPH_INLINE void CheckW() const
Internal helper function that checks that W is equal to Z, so e.g. dividing by it should not generate...
Definition DVec3.inl:83
JPH_INLINE double LengthSq() const
Squared length of vector.
Definition DVec3.inl:765
JPH_INLINE DVec3 Normalized() const
Normalize vector.
Definition DVec3.inl:788
JPH_INLINE DVec3 operator/(double inV2) const
Divide vector by double.
Definition DVec3.inl:461
JPH_INLINE double Dot(DVec3Arg inV2) const
Dot product.
Definition DVec3.inl:736
static JPH_INLINE DVec3 sReplicate(double inV)
Replicate inV across all components.
Definition DVec3.inl:135
static JPH_INLINE DVec3 sLessOrEqual(DVec3Arg inV1, DVec3Arg inV2)
Less than or equal (component wise)
Definition DVec3.inl:258
JPH_INLINE DVec3 PrepareRoundToInf() const
Prepare to convert to float vector 3 rounding towards positive/negative inf (returns DVec3 that can b...
Definition DVec3.inl:852
JPH_INLINE DVec3 & operator+=(Vec3Arg inV2)
Add two vectors (component wise)
Definition DVec3.inl:565
static JPH_INLINE DVec3 sLoadDouble3Unsafe(const Double3 &inV)
Load 3 doubles from memory (reads 64 bits extra which it doesn't use)
Definition DVec3.inl:155
JPH_INLINE DVec3 & operator/=(double inV2)
Divide vector by double.
Definition DVec3.inl:517
JPH_INLINE DVec3 Cross(DVec3Arg inV2) const
Cross product.
Definition DVec3.inl:720
JPH_INLINE DVec3 & operator-=(Vec3Arg inV2)
Add two vectors (component wise)
Definition DVec3.inl:645
JPH_INLINE DVec3 PrepareRoundToZero() const
Prepare to convert to float vector 3 rounding towards zero (returns DVec3 that can be converted to a ...
Definition DVec3.inl:830
JPH_INLINE DVec3 Reciprocal() const
Reciprocal vector (1 / value) for each of the components.
Definition DVec3.inl:715
static JPH_INLINE DVec3 sEquals(DVec3Arg inV1, DVec3Arg inV2)
Equals (component wise)
Definition DVec3.inl:228
struct { double mData[4];} Type
Definition DVec3.h:29
JPH_INLINE bool IsNearZero(double inMaxDistSq=1.0e-24) const
Test if vector is near zero.
Definition DVec3.inl:415
JPH_INLINE bool operator==(DVec3Arg inV2) const
Comparison.
Definition DVec3.inl:405
static const double cFalse
Definition DVec3.h:271
Class that holds 3 doubles. Used as a storage class. Convert to DVec3 for calculations.
Definition Double3.h:13
double z
Definition Double3.h:39
double y
Definition Double3.h:38
double x
Definition Double3.h:37
Type mValue
Definition Vec3.h:281
float mF32[4]
Definition Vec3.h:282